(f P Ω hf) vdx = 0 for all v V h, if and only if Ω (f P hf) φ i dx = 0, for i = 0, 1,..., n, where {φ i } V h is set of hat functions.

Size: px
Start display at page:

Download "(f P Ω hf) vdx = 0 for all v V h, if and only if Ω (f P hf) φ i dx = 0, for i = 0, 1,..., n, where {φ i } V h is set of hat functions."

Transcription

1 Answer ALL FOUR Questions Question 1 Let I = [, 2] and f(x) = (x 1) 3 for x I. (a) Let V h be the continous space of linear piecewise function P 1 (I) on I. Write a MATLAB code to compute the L 2 -projection P h f V h of f. [8 Marks] (b) Show that (f P Ω hf) vdx = for all v V h, if and only if Ω (f P hf) φ i dx =, for i =, 1,..., n, where {φ i } V h is set of hat functions. [2 Marks] Solution 1 (a) function [Pf]=L2Projector1D() n = 5; % number of subintervals h = 2/n; % mesh size x = :h:2; % mesh f=@(x) (x-1)^3; M = MassAssembler1D(x); % assemble mass b = LoadAssembler1D(x,f); % assemble load Pf = M\b; % solve linear system function M = MassAssembler1D(x) n = length(x)-1; % number of subintervals M = zeros(n+1,n+1); % allocate mass matrix for i = 1:n % loop over subintervals h = x(i+1) - x(i); % interval length M(i,i) = M(i,i) + h/3; % add h/3 to M(i,i) M(i,i+1) = M(i,i+1) + h/6; M(i+1,i) = M(i+1,i) + h/6; M(i+1,i+1) = M(i+1,i+1) + h/3; function b = LoadAssembler1D(x,f) n = length(x)-1; b = zeros(n+1,1); for i = 1:n h = x(i+1) - x(i); b(i) = b(i) + f(x(i))*h/2; b(i+1) = b(i+1) + f(x(i+1))*h/2; 2

2 (b) Assume that Ω (f P hf) vdx = for all v V h and {φ i } V h. Thus φ i V h for i =,..., n and therefore (f P Ω hf) φ i dx =. If Ω (f P hf) φ i dx = is first assumed, we know that {φ i } is a set of basis functions as such v = n i=1 α iφ i and so Ω (f P hf) vdx = (f P Ω hf) φ i dx =. Question 2 Consider the following one-dimensional boundary value problem u = 7, x I = [, 1] u () =, u (1) = 3 (a) Define a suitable finite element space V h? Formulate a finite element method for this problem based on variational method. [3 Marks] (b) Derive the discrete system of equations (the global stiffness matrix and the load vector) using a uniform mesh with 4 nodes. [7 Marks] Solution 2 (a) Let s first consider the generalized problem of the BVP in the question (au ) = f, x I = [, L] au () = κ (u () g ) au (L) = κ L (u (L) g L ) It follows treatment under the variational method fvdx = = = av u dx + κ L u (L) + κ u () = (au ) vdx av u dx au (L) v (L) + au () v () av u dx + κ L (u (L) g L ) + κ (u () g ) fvdx + κ L g L + κ g The suitable finite element space follows } V h = {v : v L 2(I) <, v L 2(I) <. The finite element problem is to find u h V h such that av u hdx + κ L u h (L) + κ u h () = 3 fvdx + κ L g L + κ g, v V h

3 and for specific BVP in the question, set a = 1, L = 1, κ = κ L = 1 6, g = and g L = 3. (b) A basis for V h is given by a set of n + 1 hat functions {φ i } n i=. function n u h = ξ i φ i i= Inserting the trial into the finite element problem and choosing v = φ i s up with a linear system (A + R) ξ = b + r where the entries of the (n + 1) (n + 1) matrices A and R, and the n + 1 vectors b and r are given by ˆ A ij = aφ jφ idx and Hence the derivative I R ij = κ L φ j (L) φ i (L) + κ φ j () φ i () ˆ b i = fφ i dx I r i = κ L g L φ i (L) + κ g φ i () (x x i 1 ) /h i, if x I i φ i = (x i+1 x) /h i+1, if x I i+1, otherwise. 1/h i, if x I i φ i = 1/h i+1, if x I i+1, otherwise. It can be shown that for four nodes the linear system for specific BVP where a = 1, κ = κ L = 1 6, g =, g 1 = 3 and h i = h = 1/3 is A + R = b + r = 7/6 7/3 7/

4 Question 3 Consider the triangulation by Figure 1 Figure 1: Triangulation of a unit square (a) Write down the point matrix P and the connectivity matrix T. Express the area of an arbitrary triangle in terms of its corner coordinates (x 1, y 1 ), (x 2, y 2 ), (x 3, y 3 ). [4 Marks] (b) Determine the basis functions for piecewise linear functions on an arbitrary triangle with corner coordinates (x 1, y 1 ), (x 2, y 2 ), (x 3, y 3 ). [6 Marks] Solution 3 (a) The point matrix is P = [ ] and the connectivity matrix is T = Area for a triangle with corner coordinates (x 1, y 1 ), (x 2, y 2 ), (x 3, y 3 ) is = 1 1 x 1 y x 2 y 2 1 x 3 y 3. = 1 2 x 1y 2 + x 2 y 3 + x 3 y 1 (x 1 y 3 + x 2 y 1 + x 3 y 2 ) 5

5 (b) Let K be a triangle and let P 1 (K) be the space of linear functions on K, defined by P 1 (K) = {v : v = c + c 1 x + c 2 y, (x, y) K, c, c 1, c 2 R}. Suppose the evaluation at each corner i = 1, 2, 3 gives nodal values α i = v (x i, y i ) thus 1 x 1 y 1 c α 1 1 x 2 y 2 c 1 = α 2 1 x 3 y 3 c 2 α 3 c c 1 c 2 = 1 2 x 2 y 3 x 3 y 2 x 3 y 1 x 1 y 3 x 1 y 2 x 2 y 1 y 2 y 3 y 3 y 1 y 1 y 2 x 3 x 2 x 1 x 3 x 2 x 1 α 1 α 2 α 3 Therefore in terms of nodal values v = [ 1 x y ] c c 1 = 1 2 c 2 [ 1 x ] y x 2 y 3 x 3 y 2 x 3 y 1 x 1 y 3 x 1 y 2 x 2 y 1 y 2 y 3 y 3 y 1 y 1 y 2 x 3 x 2 x 1 x 3 x 2 x 1 α 1 α 2 α 3 = λ 1 (x, y) α 1 + λ 2 (x, y) α 2 + λ 3 (x, y) α 3 where the basis functions are λ 1 (x, y) = 1 2 [(x 2y 3 x 3 y 2 ) + (y 2 y 3 ) x + (x 3 x 2 ) y] λ 2 (x, y) = 1 2 [(x 3y 1 x 1 y 3 ) + (y 3 y 1 ) x + (x 1 x 3 ) y] λ 3 (x, y) = 1 2 [(x 1y 2 x 2 y 1 ) + (y 1 y 2 ) x + (x 2 x 1 ) y] Question 4 Based on finite element method, write a MATLAB code to solve with Dirichlet boundary conditions u = in Ω = [ 2, 2] [ 2π, 2π] u = exp (x) arctan (y) on Ω. Construct the appropriate geometry matrix and call initmesh function from the PDE- Toolbox to generate mesh. (Hint: Consider Robin boundary condition approximation) [1 Marks] 6

6 Solution 4 function LaplaceSolver2D() a=@(x,y) 1; g = Rectg(-2,-2*pi,2,2*pi); [p,e,t] = initmesh(g, hmax,.5); A = StiffnessAssembler2D(p,t,a); kappa=@(x,y) 1^6; gd=@(x,y) exp(x).*atan(y); gn=@(x,y) ; [R,r] = RobinAssembler2D(p,e,kappa,gD,gN); phi = (A+R)\r; pdecont(p,t,phi) function r = Rectg(xmin,ymin,xmax,ymax) r=[2 xmin xmax ymin ymin 1 ; 2 xmax xmax ymin ymax 1 ; 2 xmax xmin ymax ymax 1 ; 2 xmin xmin ymax ymin 1 ] ; function A = StiffnessAssembler2D(p,t,a) np = size(p,2); nt = size(t,2); A = sparse(np,np); % allocate stiffness matrix for K = 1:nt loc2glb = t(1:3,k); % local-to-global map x = p(1,loc2glb); % node x-coordinates y = p(2,loc2glb); % node y- [area,b,c] = HatGradients(x,y); xc = mean(x); yc = mean(y); % element centroid abar = a(xc,yc); % value of a(x,y) at centroid AK = abar*(b*b... +c*c )*area; % element stiffness matrix A(loc2glb,loc2glb) = A(loc2glb,loc2glb)... + AK; % add element stiffnesses to A function [area,b,c] = HatGradients(x,y) area=polyarea(x,y); b=[y(2)-y(3); y(3)-y(1); y(1)-y(2)]/2/area; c=[x(3)-x(2); x(1)-x(3); x(2)-x(1)]/2/area; 7

7 function [R,r] = RobinAssembler2D(p,e,kappa,gD,gN) R = RobinMassMatrix2D(p,e,kappa); r = RobinLoadVector2D(p,e,kappa,gD,gN); function R = RobinMassMatrix2D(p,e,kappa) np = size(p,2); % number of nodes ne = size(e,2); % number of boundary edges R = sparse(np,np); % allocate boundary matrix for E = 1:ne loc2glb = e(1:2,e); % boundary nodes x = p(1,loc2glb); % node x-coordinates y = p(2,loc2glb); % node y-coordinates len = sqrt((x(1)-x(2))^2+(y(1)-y(2))^2); % edge length xc = mean(x); yc = mean(y); % edge mid-point k = kappa(xc,yc); % value of kappa at mid-point RE = k/6*[2 1; 1 2]*len; % edge boundary matrix R(loc2glb,loc2glb) = R(loc2glb,loc2glb) + RE; function r = RobinLoadVector2D(p,e,kappa,gD,gN) np = size(p,2); ne = size(e,2); r = zeros(np,1); for E = 1:ne loc2glb = e(1:2,e); x = p(1,loc2glb); y = p(2,loc2glb); len = sqrt((x(1)-x(2))^2+(y(1)-y(2))^2); xc = mean(x); yc = mean(y); tmp = kappa(xc,yc)*gd(xc,yc)+gn(xc,yc); re = tmp*[1; 1]*len/2; r(loc2glb) = r(loc2glb) + re; END 8

1. Let a(x) > 0, and assume that u and u h are the solutions of the Dirichlet problem:

1. Let a(x) > 0, and assume that u and u h are the solutions of the Dirichlet problem: Mathematics Chalmers & GU TMA37/MMG800: Partial Differential Equations, 011 08 4; kl 8.30-13.30. Telephone: Ida Säfström: 0703-088304 Calculators, formula notes and other subject related material are not

More information

Chapter 1 Piecewise Polynomial Approximation in 1D

Chapter 1 Piecewise Polynomial Approximation in 1D Chapter 1 Piecewise Polynomial Approximation in 1D Abstract n this chapter we introduce a type of functions called piecewise polynomials that can be used to approximate other more general functions, and

More information

Finite Elements for Nonlinear Problems

Finite Elements for Nonlinear Problems Finite Elements for Nonlinear Problems Computer Lab 2 In this computer lab we apply finite element method to nonlinear model problems and study two of the most common techniques for solving the resulting

More information

A brief introduction to finite element methods

A brief introduction to finite element methods CHAPTER A brief introduction to finite element methods 1. Two-point boundary value problem and the variational formulation 1.1. The model problem. Consider the two-point boundary value problem: Given a

More information

Lecture 26: Putting it all together #5... Galerkin Finite Element Methods for ODE BVPs

Lecture 26: Putting it all together #5... Galerkin Finite Element Methods for ODE BVPs Lecture 26: Putting it all together #5... Galerkin Finite Element Methods for ODE BVPs Outline 1) : Review 2) A specific Example: Piecewise linear elements 3) Computational Issues and Algorithms A) Calculation

More information

A very short introduction to the Finite Element Method

A very short introduction to the Finite Element Method A very short introduction to the Finite Element Method Till Mathis Wagner Technical University of Munich JASS 2004, St Petersburg May 4, 2004 1 Introduction This is a short introduction to the finite element

More information

1 Discretizing BVP with Finite Element Methods.

1 Discretizing BVP with Finite Element Methods. 1 Discretizing BVP with Finite Element Methods In this section, we will discuss a process for solving boundary value problems numerically, the Finite Element Method (FEM) We note that such method is a

More information

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs Chapter Two: Numerical Methods for Elliptic PDEs Finite Difference Methods for Elliptic PDEs.. Finite difference scheme. We consider a simple example u := subject to Dirichlet boundary conditions ( ) u

More information

Scientific Computing WS 2017/2018. Lecture 18. Jürgen Fuhrmann Lecture 18 Slide 1

Scientific Computing WS 2017/2018. Lecture 18. Jürgen Fuhrmann Lecture 18 Slide 1 Scientific Computing WS 2017/2018 Lecture 18 Jürgen Fuhrmann juergen.fuhrmann@wias-berlin.de Lecture 18 Slide 1 Lecture 18 Slide 2 Weak formulation of homogeneous Dirichlet problem Search u H0 1 (Ω) (here,

More information

Chapter 1: The Finite Element Method

Chapter 1: The Finite Element Method Chapter 1: The Finite Element Method Michael Hanke Read: Strang, p 428 436 A Model Problem Mathematical Models, Analysis and Simulation, Part Applications: u = fx), < x < 1 u) = u1) = D) axial deformation

More information

The Finite Element Method for the Wave Equation

The Finite Element Method for the Wave Equation The Finite Element Method for the Wave Equation 1 The Wave Equation We consider the scalar wave equation modelling acoustic wave propagation in a bounded domain 3, with boundary Γ : 1 2 u c(x) 2 u 0, in

More information

New class of finite element methods: weak Galerkin methods

New class of finite element methods: weak Galerkin methods New class of finite element methods: weak Galerkin methods Xiu Ye University of Arkansas at Little Rock Second order elliptic equation Consider second order elliptic problem: a u = f, in Ω (1) u = 0, on

More information

TMA4220 Numerical Solution of Partial Differential Equations Using Element Methods Høst 2014

TMA4220 Numerical Solution of Partial Differential Equations Using Element Methods Høst 2014 Norwegian University of Science and Technology Department of Mathematical Sciences TMA422 Numerical Solution of Partial Differential Equations Using Element Methods Høst 214 Exercise set 2 1 Consider the

More information

Scientific Computing WS 2018/2019. Lecture 15. Jürgen Fuhrmann Lecture 15 Slide 1

Scientific Computing WS 2018/2019. Lecture 15. Jürgen Fuhrmann Lecture 15 Slide 1 Scientific Computing WS 2018/2019 Lecture 15 Jürgen Fuhrmann juergen.fuhrmann@wias-berlin.de Lecture 15 Slide 1 Lecture 15 Slide 2 Problems with strong formulation Writing the PDE with divergence and gradient

More information

LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES)

LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES) LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES) RAYTCHO LAZAROV 1 Notations and Basic Functional Spaces Scalar function in R d, d 1 will be denoted by u,

More information

MOX Report No. 49/2013. Fast simulations in Matlab for Scientific Computing. Micheletti, S.

MOX Report No. 49/2013. Fast simulations in Matlab for Scientific Computing. Micheletti, S. MOX Report No. 49/2013 Fast simulations in Matlab for Scientific Computing Micheletti, S. MOX, Dipartimento di Matematica F. Brioschi Politecnico di Milano, Via Bonardi 9-20133 Milano (Italy) mox@mate.polimi.it

More information

DISCRETE MAXIMUM PRINCIPLES in THE FINITE ELEMENT SIMULATIONS

DISCRETE MAXIMUM PRINCIPLES in THE FINITE ELEMENT SIMULATIONS DISCRETE MAXIMUM PRINCIPLES in THE FINITE ELEMENT SIMULATIONS Sergey Korotov BCAM Basque Center for Applied Mathematics http://www.bcamath.org 1 The presentation is based on my collaboration with several

More information

Numerical Methods for Partial Differential Equations

Numerical Methods for Partial Differential Equations Numerical Methods for Partial Differential Equations Eric de Sturler University of Illinois at Urbana-Champaign Read section 8. to see where equations of type (au x ) x = f show up and their (exact) solution

More information

Finite difference method for elliptic problems: I

Finite difference method for elliptic problems: I Finite difference method for elliptic problems: I Praveen. C praveen@math.tifrbng.res.in Tata Institute of Fundamental Research Center for Applicable Mathematics Bangalore 560065 http://math.tifrbng.res.in/~praveen

More information

Math 660-Lecture 15: Finite element spaces (I)

Math 660-Lecture 15: Finite element spaces (I) Math 660-Lecture 15: Finite element spaces (I) (Chapter 3, 4.2, 4.3) Before we introduce the concrete spaces, let s first of all introduce the following important lemma. Theorem 1. Let V h consists of

More information

Finite Element Method for Ordinary Differential Equations

Finite Element Method for Ordinary Differential Equations 52 Chapter 4 Finite Element Method for Ordinary Differential Equations In this chapter we consider some simple examples of the finite element method for the approximate solution of ordinary differential

More information

AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends

AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends Lecture 3: Finite Elements in 2-D Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Finite Element Methods 1 / 18 Outline 1 Boundary

More information

TMA4220: Programming project - part 1

TMA4220: Programming project - part 1 TMA4220: Programming project - part 1 TMA4220 - Numerical solution of partial differential equations using the finite element method The programming project will be split into two parts. This is the first

More information

Finite Element Methods for Microelectromechanical Systems

Finite Element Methods for Microelectromechanical Systems IT 09 060 Examensarbete 30 hp November 2009 Finite Element Methods for Microelectromechanical Systems Yang Zeng Institutionen för informationsteknologi Department of Information Technology ii Abstract

More information

Scientific Computing I

Scientific Computing I Scientific Computing I Module 8: An Introduction to Finite Element Methods Tobias Neckel Winter 2013/2014 Module 8: An Introduction to Finite Element Methods, Winter 2013/2014 1 Part I: Introduction to

More information

arxiv: v1 [math.ap] 6 Dec 2011

arxiv: v1 [math.ap] 6 Dec 2011 LECTURE NOTES: THE GALERKIN METHOD arxiv:1112.1176v1 [math.ap] 6 Dec 211 Raghavendra Venkatraman 1 In these notes, we consider the analysis of Galerkin Method and its application to computing approximate

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University Variational Problems of the Dirichlet BVP of the Poisson Equation 1 For the homogeneous

More information

Texts in Computational Science and Engineering 10

Texts in Computational Science and Engineering 10 Texts in Computational Science and Engineering 10 Editors Timothy J. Barth Michael Griebel David E. Keyes Risto M. Nieminen Dirk Roose Tamar Schlick For further volumes: http://www.springer.com/series/5151

More information

CIV-E1060 Engineering Computation and Simulation Examination, December 12, 2017 / Niiranen

CIV-E1060 Engineering Computation and Simulation Examination, December 12, 2017 / Niiranen CIV-E16 Engineering Computation and Simulation Examination, December 12, 217 / Niiranen This examination consists of 3 problems rated by the standard scale 1...6. Problem 1 Let us consider a long and tall

More information

Numerical methods for PDEs FEM convergence, error estimates, piecewise polynomials

Numerical methods for PDEs FEM convergence, error estimates, piecewise polynomials Platzhalter für Bild, Bild auf Titelfolie hinter das Logo einsetzen Numerical methods for PDEs FEM convergence, error estimates, piecewise polynomials Dr. Noemi Friedman Contents of the course Fundamentals

More information

Question 9: PDEs Given the function f(x, y), consider the problem: = f(x, y) 2 y2 for 0 < x < 1 and 0 < x < 1. x 2 u. u(x, 0) = u(x, 1) = 0 for 0 x 1

Question 9: PDEs Given the function f(x, y), consider the problem: = f(x, y) 2 y2 for 0 < x < 1 and 0 < x < 1. x 2 u. u(x, 0) = u(x, 1) = 0 for 0 x 1 Question 9: PDEs Given the function f(x, y), consider the problem: 2 u x 2 u = f(x, y) 2 y2 for 0 < x < 1 and 0 < x < 1 u(x, 0) = u(x, 1) = 0 for 0 x 1 u(0, y) = u(1, y) = 0 for 0 y 1. a. Discuss how you

More information

Input: A set (x i -yy i ) data. Output: Function value at arbitrary point x. What for x = 1.2?

Input: A set (x i -yy i ) data. Output: Function value at arbitrary point x. What for x = 1.2? Applied Numerical Analysis Interpolation Lecturer: Emad Fatemizadeh Interpolation Input: A set (x i -yy i ) data. Output: Function value at arbitrary point x. 0 1 4 1-3 3 9 What for x = 1.? Interpolation

More information

LibMesh Experience and Usage

LibMesh Experience and Usage LibMesh Experience and Usage John W. Peterson peterson@cfdlab.ae.utexas.edu Univ. of Texas at Austin January 12, 2007 1 Introduction 2 Weighted Residuals 3 Poisson Equation 4 Other Examples 5 Essential

More information

Finite-Elements Method 2

Finite-Elements Method 2 Finite-Elements Method 2 January 29, 2014 2 From Applied Numerical Analysis Gerald-Wheatley (2004), Chapter 9. Finite-Elements Method 3 Introduction Finite-element methods (FEM) are based on some mathematical

More information

INTRODUCTION TO FINITE ELEMENT METHODS

INTRODUCTION TO FINITE ELEMENT METHODS INTRODUCTION TO FINITE ELEMENT METHODS LONG CHEN Finite element methods are based on the variational formulation of partial differential equations which only need to compute the gradient of a function.

More information

FEniCS Course. Lecture 0: Introduction to FEM. Contributors Anders Logg, Kent-Andre Mardal

FEniCS Course. Lecture 0: Introduction to FEM. Contributors Anders Logg, Kent-Andre Mardal FEniCS Course Lecture 0: Introduction to FEM Contributors Anders Logg, Kent-Andre Mardal 1 / 46 What is FEM? The finite element method is a framework and a recipe for discretization of mathematical problems

More information

At right: Closeups of the graphs of. with WINDOW settings Xmin=-1, Xmax=1, Xscl=0.1, Ymin=-1, Ymax=1, Yscl=0.1

At right: Closeups of the graphs of. with WINDOW settings Xmin=-1, Xmax=1, Xscl=0.1, Ymin=-1, Ymax=1, Yscl=0.1 Know the graphs of f(x) = x n for n = odd, positive: 1, 3, 5, The Domain is All Real Numbers, (, ), or R. The Range is All Real Numbers, (, ), or R. It is an Odd function because f( x) = f(x). It is symmetric

More information

Optimal multilevel preconditioning of strongly anisotropic problems.part II: non-conforming FEM. p. 1/36

Optimal multilevel preconditioning of strongly anisotropic problems.part II: non-conforming FEM. p. 1/36 Optimal multilevel preconditioning of strongly anisotropic problems. Part II: non-conforming FEM. Svetozar Margenov margenov@parallel.bas.bg Institute for Parallel Processing, Bulgarian Academy of Sciences,

More information

Higher-Order Compact Finite Element Method

Higher-Order Compact Finite Element Method Higher-Order Compact Finite Element Method Major Qualifying Project Advisor: Professor Marcus Sarkis Amorn Chokchaisiripakdee Worcester Polytechnic Institute Abstract The Finite Element Method (FEM) is

More information

Numerical Solution I

Numerical Solution I Numerical Solution I Stationary Flow R. Kornhuber (FU Berlin) Summerschool Modelling of mass and energy transport in porous media with practical applications October 8-12, 2018 Schedule Classical Solutions

More information

Lecture 1. Finite difference and finite element methods. Partial differential equations (PDEs) Solving the heat equation numerically

Lecture 1. Finite difference and finite element methods. Partial differential equations (PDEs) Solving the heat equation numerically Finite difference and finite element methods Lecture 1 Scope of the course Analysis and implementation of numerical methods for pricing options. Models: Black-Scholes, stochastic volatility, exponential

More information

Motivation: Sparse matrices and numerical PDE's

Motivation: Sparse matrices and numerical PDE's Lecture 20: Numerical Linear Algebra #4 Iterative methods and Eigenproblems Outline 1) Motivation: beyond LU for Ax=b A little PDE's and sparse matrices A) Temperature Equation B) Poisson Equation 2) Splitting

More information

A Hybrid Method for the Wave Equation. beilina

A Hybrid Method for the Wave Equation.   beilina A Hybrid Method for the Wave Equation http://www.math.unibas.ch/ beilina 1 The mathematical model The model problem is the wave equation 2 u t 2 = (a 2 u) + f, x Ω R 3, t > 0, (1) u(x, 0) = 0, x Ω, (2)

More information

Implementation of the dg method

Implementation of the dg method Implementation of the dg method Matteo Cicuttin CERMICS - École Nationale des Ponts et Chaussées Marne-la-Vallée March 6, 2017 Outline Model problem, fix notation Representing polynomials Computing integrals

More information

Applied Numerical Analysis Quiz #2

Applied Numerical Analysis Quiz #2 Applied Numerical Analysis Quiz #2 Modules 3 and 4 Name: Student number: DO NOT OPEN UNTIL ASKED Instructions: Make sure you have a machine-readable answer form. Write your name and student number in the

More information

[2] (a) Develop and describe the piecewise linear Galerkin finite element approximation of,

[2] (a) Develop and describe the piecewise linear Galerkin finite element approximation of, 269 C, Vese Practice problems [1] Write the differential equation u + u = f(x, y), (x, y) Ω u = 1 (x, y) Ω 1 n + u = x (x, y) Ω 2, Ω = {(x, y) x 2 + y 2 < 1}, Ω 1 = {(x, y) x 2 + y 2 = 1, x 0}, Ω 2 = {(x,

More information

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C.

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C. Lecture 9 Approximations of Laplace s Equation, Finite Element Method Mathématiques appliquées (MATH54-1) B. Dewals, C. Geuzaine V1.2 23/11/218 1 Learning objectives of this lecture Apply the finite difference

More information

FINITE ELEMENT METHOD: APPROXIMATE SOLUTIONS

FINITE ELEMENT METHOD: APPROXIMATE SOLUTIONS FINITE ELEMENT METHOD: APPROXIMATE SOLUTIONS I Introduction: Most engineering problems which are expressed in a differential form can only be solved in an approximate manner due to their complexity. The

More information

A posteriori error estimation for elliptic problems

A posteriori error estimation for elliptic problems A posteriori error estimation for elliptic problems Praveen. C praveen@math.tifrbng.res.in Tata Institute of Fundamental Research Center for Applicable Mathematics Bangalore 560065 http://math.tifrbng.res.in

More information

A Matlab Tutorial for Diffusion-Convection-Reaction Equations using DGFEM

A Matlab Tutorial for Diffusion-Convection-Reaction Equations using DGFEM MIDDLE EAST TECHNICAL UNIVERSITY Ankara, Turkey INSTITUTE OF APPLIED MATHEMATICS http://iam.metu.edu.tr arxiv:1502.02941v1 [math.na] 10 Feb 2015 A Matlab Tutorial for Diffusion-Convection-Reaction Equations

More information

3. Numerical integration

3. Numerical integration 3. Numerical integration... 3. One-dimensional quadratures... 3. Two- and three-dimensional quadratures... 3.3 Exact Integrals for Straight Sided Triangles... 5 3.4 Reduced and Selected Integration...

More information

WRT in 2D: Poisson Example

WRT in 2D: Poisson Example WRT in 2D: Poisson Example Consider 2 u f on [, L x [, L y with u. WRT: For all v X N, find u X N a(v, u) such that v u dv v f dv. Follows from strong form plus integration by parts: ( ) 2 u v + 2 u dx

More information

3.1: 1, 3, 5, 9, 10, 12, 14, 18

3.1: 1, 3, 5, 9, 10, 12, 14, 18 3.:, 3, 5, 9,,, 4, 8 ) We want to solve d d c() d = f() with c() = c = constant and f() = for different boundary conditions to get w() and u(). dw d = dw d d = ( )d w() w() = w() = w() ( ) c d d = u()

More information

Lecture Notes: African Institute of Mathematics Senegal, January Topic Title: A short introduction to numerical methods for elliptic PDEs

Lecture Notes: African Institute of Mathematics Senegal, January Topic Title: A short introduction to numerical methods for elliptic PDEs Lecture Notes: African Institute of Mathematics Senegal, January 26 opic itle: A short introduction to numerical methods for elliptic PDEs Authors and Lecturers: Gerard Awanou (University of Illinois-Chicago)

More information

Lehrstuhl Informatik V. Lehrstuhl Informatik V. 1. solve weak form of PDE to reduce regularity properties. Lehrstuhl Informatik V

Lehrstuhl Informatik V. Lehrstuhl Informatik V. 1. solve weak form of PDE to reduce regularity properties. Lehrstuhl Informatik V Part I: Introduction to Finite Element Methods Scientific Computing I Module 8: An Introduction to Finite Element Methods Tobias Necel Winter 4/5 The Model Problem FEM Main Ingredients Wea Forms and Wea

More information

EE3210 Lab 3: Periodic Signal Representation by Fourier Series

EE3210 Lab 3: Periodic Signal Representation by Fourier Series City University of Hong Kong Department of Electronic Engineering EE321 Lab 3: Periodic Signal Representation by Fourier Series Prelab: Read the Background section. Complete Section 2.2(b), which asks

More information

Boundary Value Problems and Iterative Methods for Linear Systems

Boundary Value Problems and Iterative Methods for Linear Systems Boundary Value Problems and Iterative Methods for Linear Systems 1. Equilibrium Problems 1.1. Abstract setting We want to find a displacement u V. Here V is a complete vector space with a norm v V. In

More information

Math 148. Polynomial Graphs

Math 148. Polynomial Graphs Math 148 Lab 1 Polynomial Graphs Due: Monday Wednesday, April April 10 5 Directions: Work out each problem on a separate sheet of paper, and write your answers on the answer sheet provided. Submit the

More information

Finite Elements. Colin Cotter. January 15, Colin Cotter FEM

Finite Elements. Colin Cotter. January 15, Colin Cotter FEM Finite Elements January 15, 2018 Why Can solve PDEs on complicated domains. Have flexibility to increase order of accuracy and match the numerics to the physics. has an elegant mathematical formulation

More information

Numerical methods for PDEs FEM convergence, error estimates, piecewise polynomials

Numerical methods for PDEs FEM convergence, error estimates, piecewise polynomials Platzhalter für Bild, Bild auf Titelfolie hinter das Logo einsetzen Numerical methods for PDEs FEM convergence, error estimates, piecewise polynomials Dr. Noemi Friedman Contents of the course Fundamentals

More information

Iterative Methods for Linear Systems

Iterative Methods for Linear Systems Iterative Methods for Linear Systems 1. Introduction: Direct solvers versus iterative solvers In many applications we have to solve a linear system Ax = b with A R n n and b R n given. If n is large the

More information

One-dimensional and nonlinear problems

One-dimensional and nonlinear problems Solving PDE s with FEniCS One-dimensional and nonlinear problems L. Ridgway Scott The Institute for Biophysical Dynamics, The Computation Institute, and the Departments of Computer Science and Mathematics,

More information

LibMesh Experience and Usage

LibMesh Experience and Usage LibMesh Experience and Usage John W. Peterson peterson@cfdlab.ae.utexas.edu and Roy H. Stogner roystgnr@cfdlab.ae.utexas.edu Univ. of Texas at Austin September 9, 2008 1 Introduction 2 Weighted Residuals

More information

Institute of Structural Engineering Page 1. Method of Finite Elements I. Chapter 2. The Direct Stiffness Method. Method of Finite Elements I

Institute of Structural Engineering Page 1. Method of Finite Elements I. Chapter 2. The Direct Stiffness Method. Method of Finite Elements I Institute of Structural Engineering Page 1 Chapter 2 The Direct Stiffness Method Institute of Structural Engineering Page 2 Direct Stiffness Method (DSM) Computational method for structural analysis Matrix

More information

Building a finite element program in MATLAB Linear elements in 1d and 2d

Building a finite element program in MATLAB Linear elements in 1d and 2d Building a finite element program in MATLAB Linear elements in 1d and 2d D. Peschka TU Berlin Supplemental material for the course Numerische Mathematik 2 für Ingenieure at the Technical University Berlin,

More information

Elements of Matlab and Simulink Lecture 7

Elements of Matlab and Simulink Lecture 7 Elements of Matlab and Simulink Lecture 7 Emanuele Ruffaldi 12th May 2009 Copyright 2009,Emanuele Ruffaldi. This work is licensed under the Creative Commons Attribution-ShareAlike License. PARTIAL DIFFERENTIAL

More information

Projected Surface Finite Elements for Elliptic Equations

Projected Surface Finite Elements for Elliptic Equations Available at http://pvamu.edu/aam Appl. Appl. Math. IN: 1932-9466 Vol. 8, Issue 1 (June 2013), pp. 16 33 Applications and Applied Mathematics: An International Journal (AAM) Projected urface Finite Elements

More information

The Finite Line Integration Method (FLIM) - A Fast Variant of Finite Element Modelling

The Finite Line Integration Method (FLIM) - A Fast Variant of Finite Element Modelling www.oeaw.ac.at The Finite Line Integration Method (FLIM) - A Fast Variant of Finite Element Modelling J. Synka RICAM-Report 2007-27 www.ricam.oeaw.ac.at The Finite Line Integration Method (FLIM) - A Fast

More information

Numerical Simulation of Potential Flow using the Finite Element Method

Numerical Simulation of Potential Flow using the Finite Element Method Numerical Simulation of Potential Flow using the Finite Element Method Cynthia Vanessa Flores (CSUN), Eduardo Rogério Fávaro(Ibilce-Unesp) Gilberto Pereira Sassi (ICMC-USP) Leonardo Koller Sacht(UFSC)

More information

A simple FEM solver and its data parallelism

A simple FEM solver and its data parallelism A simple FEM solver and its data parallelism Gundolf Haase Institute for Mathematics and Scientific Computing University of Graz, Austria Chile, Jan. 2015 Partial differential equation Considered Problem

More information

Introduction into Implementation of Optimization problems with PDEs: Sheet 3

Introduction into Implementation of Optimization problems with PDEs: Sheet 3 Technische Universität München Center for Mathematical Sciences, M17 Lucas Bonifacius, Korbinian Singhammer www-m17.ma.tum.de/lehrstuhl/lehresose16labcourseoptpde Summer 216 Introduction into Implementation

More information

Vectorized Matlab Codes for Linear Two-Dimensional Elasticity

Vectorized Matlab Codes for Linear Two-Dimensional Elasticity Vectorized Matlab Codes for Linear Two-Dimensional Elasticity Jonas Koko LIMOS, Université Blaise Pascal CNRS UMR 6158 ISIMA, Campus des Cézeaux BP 1015, 63173 Aubière cedex, France koko@isima.fr Abstract

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University Sobolev Embedding Theorems Embedding Operators and the Sobolev Embedding Theorem

More information

Algorithms for Scientific Computing

Algorithms for Scientific Computing Algorithms for Scientific Computing Finite Element Methods Michael Bader Technical University of Munich Summer 2016 Part I Looking Back: Discrete Models for Heat Transfer and the Poisson Equation Modelling

More information

PDE & FEM TERMINOLOGY. BASIC PRINCIPLES OF FEM.

PDE & FEM TERMINOLOGY. BASIC PRINCIPLES OF FEM. PDE & FEM TERMINOLOGY. BASIC PRINCIPLES OF FEM. Sergey Korotov Basque Center for Applied Mathematics / IKERBASQUE http://www.bcamath.org & http://www.ikerbasque.net 1 Introduction The analytical solution

More information

Lab 5: Post Processing and Solving Conduction Problems. Objective:

Lab 5: Post Processing and Solving Conduction Problems. Objective: Lab 5: Post Processing and Solving Conduction Problems Objective: The objective of this lab is to use the tools we have developed in MATLAB and SolidWorks to solve conduction heat transfer problems that

More information

Time-dependent variational forms

Time-dependent variational forms Time-dependent variational forms Hans Petter Langtangen 1,2 1 Center for Biomedical Computing, Simula Research Laboratory 2 Department of Informatics, University of Oslo Oct 30, 2015 PRELIMINARY VERSION

More information

MATH 333: Partial Differential Equations

MATH 333: Partial Differential Equations MATH 333: Partial Differential Equations Problem Set 9, Final version Due Date: Tues., Nov. 29, 2011 Relevant sources: Farlow s book: Lessons 9, 37 39 MacCluer s book: Chapter 3 44 Show that the Poisson

More information

Condition number estimates for matrices arising in the isogeometric discretizations

Condition number estimates for matrices arising in the isogeometric discretizations www.oeaw.ac.at Condition number estimates for matrices arising in the isogeometric discretizations K. Gahalaut, S. Tomar RICAM-Report -3 www.ricam.oeaw.ac.at Condition number estimates for matrices arising

More information

Finite Element Methods

Finite Element Methods Solving Operator Equations Via Minimization We start with several definitions. Definition. Let V be an inner product space. A linear operator L: D V V is said to be positive definite if v, Lv > for every

More information

The Plane Stress Problem

The Plane Stress Problem The Plane Stress Problem Martin Kronbichler Applied Scientific Computing (Tillämpad beräkningsvetenskap) February 2, 2010 Martin Kronbichler (TDB) The Plane Stress Problem February 2, 2010 1 / 24 Outline

More information

DIFFERENTIAL EQUATIONS

DIFFERENTIAL EQUATIONS NUMERICAL PARTIAL DIFFERENTIAL EQUATIONS Lecture Notes, Winter 2013/14 Christian Clason July 15, 2014 Institute for Mathematics and Scientific Computing Karl-Franzens-Universität Graz CONTENTS I BACKGROUND

More information

NUMERICAL PARTIAL DIFFERENTIAL EQUATIONS

NUMERICAL PARTIAL DIFFERENTIAL EQUATIONS NUMERICAL PARTIAL DIFFERENTIAL EQUATIONS Lecture Notes, Winter 2011/12 Christian Clason January 31, 2012 Institute for Mathematics and Scientific Computing Karl-Franzens-Universität Graz CONTENTS I BACKGROUND

More information

Numerical Integration in Meshfree Methods

Numerical Integration in Meshfree Methods Numerical Integration in Meshfree Methods Pravin Madhavan New College University of Oxford A thesis submitted for the degree of Master of Science in Mathematical Modelling and Scientific Computing Trinity

More information

The Finite Element Method for the Analysis of Non-Linear and Dynamic Systems. Prof. Dr. Eleni Chatzi Lecture 1-20 September, 2017

The Finite Element Method for the Analysis of Non-Linear and Dynamic Systems. Prof. Dr. Eleni Chatzi Lecture 1-20 September, 2017 The Finite Element Method for the Analysis of Non-Linear and Dynamic Systems Prof. Dr. Eleni Chatzi Lecture 1-20 September, 2017 Institute of Structural Engineering Method of Finite Elements II 1 Course

More information

Overlapping Schwarz preconditioners for Fekete spectral elements

Overlapping Schwarz preconditioners for Fekete spectral elements Overlapping Schwarz preconditioners for Fekete spectral elements R. Pasquetti 1, L. F. Pavarino 2, F. Rapetti 1, and E. Zampieri 2 1 Laboratoire J.-A. Dieudonné, CNRS & Université de Nice et Sophia-Antipolis,

More information

CHAPTER 8: Thermal Analysis

CHAPTER 8: Thermal Analysis CHAPER 8: hermal Analysis hermal Analysis: calculation of temperatures in a solid body. Magnitude and direction of heat flow can also be calculated from temperature gradients in the body. Modes of heat

More information

DIFFERENTIAL EQUATIONS

DIFFERENTIAL EQUATIONS DIFFERENTIAL EQUATIONS 1. Basic Terminology A differential equation is an equation that contains an unknown function together with one or more of its derivatives. 1 Examples: 1. y = 2x + cos x 2. dy dt

More information

DIFFERENTIAL EQUATIONS

DIFFERENTIAL EQUATIONS DIFFERENTIAL EQUATIONS Basic Terminology A differential equation is an equation that contains an unknown function together with one or more of its derivatives. 1 Examples: 1. y = 2x + cos x 2. dy dt =

More information

Lesson 6 Practice Problems

Lesson 6 Practice Problems Name: Date: Lesson 6 Section 6.1: Writing Exponential Models 1. Complete the following table. Growth Rate as a % Growth Rate as a decimal Growth Factor 13% 0.13 1.13 21% 7% 0.20 0.05 1.25 1.075 2.03 2.

More information

A repeated root is a root that occurs more than once in a polynomial function.

A repeated root is a root that occurs more than once in a polynomial function. Unit 2A, Lesson 3.3 Finding Zeros Synthetic division, along with your knowledge of end behavior and turning points, can be used to identify the x-intercepts of a polynomial function. This information allows

More information

A FETI-DP Method for Mortar Finite Element Discretization of a Fourth Order Problem

A FETI-DP Method for Mortar Finite Element Discretization of a Fourth Order Problem A FETI-DP Method for Mortar Finite Element Discretization of a Fourth Order Problem Leszek Marcinkowski 1 and Nina Dokeva 2 1 Department of Mathematics, Warsaw University, Banacha 2, 02 097 Warszawa, Poland,

More information

INTRODUCTION TO MULTIGRID METHODS

INTRODUCTION TO MULTIGRID METHODS INTRODUCTION TO MULTIGRID METHODS LONG CHEN 1. ALGEBRAIC EQUATION OF TWO POINT BOUNDARY VALUE PROBLEM We consider the discretization of Poisson equation in one dimension: (1) u = f, x (0, 1) u(0) = u(1)

More information

Stress analysis of a stepped bar

Stress analysis of a stepped bar Stress analysis of a stepped bar Problem Find the stresses induced in the axially loaded stepped bar shown in Figure. The bar has cross-sectional areas of A ) and A ) over the lengths l ) and l ), respectively.

More information

Solving Linear Systems of ODEs with Matlab

Solving Linear Systems of ODEs with Matlab Solving Linear Systems of ODEs with Matlab James K. Peterson Department of Biological Sciences and Department of Mathematical Sciences Clemson University October 27, 2013 Outline Linear Systems Numerically

More information

CURRENT SOURCES EXAMPLE 1 Find the source voltage Vs and the current I1 for the circuit shown below SOURCE CONVERSIONS

CURRENT SOURCES EXAMPLE 1 Find the source voltage Vs and the current I1 for the circuit shown below SOURCE CONVERSIONS CURRENT SOURCES EXAMPLE 1 Find the source voltage Vs and the current I1 for the circuit shown below EXAMPLE 2 Find the source voltage Vs and the current I1 for the circuit shown below SOURCE CONVERSIONS

More information

Mathematical methods for engineering. The finite element method

Mathematical methods for engineering. The finite element method . The finite element method University of Trento Trento Winter School on Numerical Methods February 20 th - March 3 rd, 2017 FEM: Remarks on programming Model problem: with a o 0. u + a 0 u = f u = 0 u

More information

DIFFERENTIAL EQUATIONS

DIFFERENTIAL EQUATIONS DIFFERENTIAL EQUATIONS 1. Basic Terminology A differential equation is an equation that contains an unknown function together with one or more of its derivatives. 1 Examples: 1. y = 2x + cos x 2. dy dt

More information

Institute of Structural Engineering Page 1. Method of Finite Elements I. Chapter 2. The Direct Stiffness Method. Method of Finite Elements I

Institute of Structural Engineering Page 1. Method of Finite Elements I. Chapter 2. The Direct Stiffness Method. Method of Finite Elements I Institute of Structural Engineering Page 1 Chapter 2 The Direct Stiffness Method Institute of Structural Engineering Page 2 Direct Stiffness Method (DSM) Computational method for structural analysis Matrix

More information

Lesson 5 Practice Problems

Lesson 5 Practice Problems Name: Date: Lesson 5 Section 5.1: Linear Functions vs. Exponential Functions 1. Complete the table below. Function Linear or Exponential? Linear: Increasing or Decreasing? Exponential: Growth or Decay?

More information