Numerical Solutions to Partial Differential Equations

Size: px
Start display at page:

Download "Numerical Solutions to Partial Differential Equations"

Transcription

1 Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University

2 Variational Problems of the Dirichlet BVP of the Poisson Equation 1 For the homogeneous Dirichlet BVP of the Poisson equation { u = f, x Ω, u = 0, x Ω, 2 The weak form w.r.t. the virtual work principle: { Find u H 1 0 (Ω), such that a(u, v) = (f, v), v H 1 0 (Ω), where a(u, v) = Ω u v dx, (f, v) = Ω fv dx. 3 The weak form w.r.t. the minimum potential energy principle: { Find u H 1 0 (Ω), such that J(u) = min v H 1 0 (Ω) J(v), where J(v) = 1 2 a(v, v) (f, v).

3 Use Finite Dimensional Trial, Test and Admissible Function Spaces 1 Replace the trial and test function spaces by appropriate finite dimensional subspaces, say V h (0) H 1 0 (Ω), we are led to the discrete problem: { Find u h V h (0) such that a(u h, v h ) = (f, v h ), v h V h (0), Such an approach is called the Galerkin method. 2 Replace the admissible function space by an appropriate finite dimensional subspace, say V h (0) H 1 0 (Ω), we are led to the discrete problem: { Find u h V h (0) such that J(u h ) = min vh V h (0) J(v h ). Such an approach is called the Ritz method. 3 The two methods lead to an equivalent system of linear algebraic equations.

4 Galerkin Method and Ritz Method Algebraic Equations of the Galerkin and Ritz Methods Derivation of Algebraic Equations of the Galerkin Method Let {ϕ i } N h i=1 be a set of basis functions of V h(0), let N h N h u h = u j ϕ j, v h = v i ϕ i, j=1 then, the Galerkin method leads to { Find u h = (u 1,..., u Nh ) T R N h such that Nh i,j=1 a(ϕ j, ϕ i )u j v i = N h i=1 (f, ϕ i)v i, v h = (v 1,..., v Nh ) T R N h, which is equivalent to N h j=1 a(ϕ j, ϕ i )u j = (f, ϕ i ), i = 1, 2,, N h. The stiffness matrix: K = (k ij ) = (a(ϕ j, ϕ i )); the external load vector: f h = (f i ) = ((f, ϕ i )); the displacement vector: u h ; the linear algebraic equation: K u h = f h. i=1 4 / 34

5 Galerkin Method and Ritz Method Algebraic Equations of the Galerkin and Ritz Methods Derivation of Algebraic Equations of the Ritz Method 1 The Ritz method leads to a finite dimensional minimization problem, whose stationary points satisfy the equation given by the Galerkin method, and vice versa. 2 It follows from the symmetry of a(, ) and the Poincaré- Friedrichs inequality (see Theorem 5.4) that stiffness matrix K is a symmetric positive definite matrix, and thus the linear system has a unique solution, which is a minima of the Ritz problem. 3 So, the Ritz method also leads to K u h = f h. 5 / 34

6 The Key Is to Construct Finite Dimensional Subspaces There are many ways to construct finite dimensional subspaces for the Galerkin method and Ritz method. For example 1 For Ω = (0, 1) (0, 1), the functions ϕ mn (x, y) = sin(mπx) sin(nπy), m, n 1, which are the complete family of the eigenfunctions {ϕ i } i=1 of the corresponding eigenvalue problem { u = λu, x Ω, u = 0, and form a set of basis of H 1 0 (Ω). x Ω, 2 Define V N = span{ϕ mn : m N, n N}, the corresponding numerical method is called the spectral method. 3 Finite element method is a systematic way to construct subspaces for more general domains.

7 Finite Element Methods A Typical Example of the Finite Element Method Construction of a Finite Element Function Space for H 1 0([0, 1] 2 ) 1 The Dirichlet boundary value problem of the Poisson equation u = f, x Ω = (0, 1) 2, u = 0, x Ω. 2 We need to construct a finite element subspace of H 1 0 ([0, 1]2 ). 3 Firstly, introduce a triangulation T h (Ω) on the domain Ω: Triangular element {T i } M i=1 ; T i T j =, 1 i j M; If T i T j : it must be a common edge or vertex; h = max i diam(t i ); Nodes {A i } N i=1, which is globally numbered T 17 T 19 T 21 T 23 T 18 T 20 T 22 T T 9 T 11 T 13 T 15 T 10 T 12 T 14 T T 1 T 3 T 5 T 7 T 2 T 4 T 6 T / 34

8 Finite Element Methods A Typical Example of the Finite Element Method Construction of a Finite Element Function Space for H 1 0([0, 1] 2 ) 4 Secondly, define a finite element function space, which is a subspace of H 1 ([0, 1] 2 ), on the triangulation T h (Ω): V h = {u C(Ω) : u Ti P 1 (T i ), T i T h (Ω)}. 5 Then, define finite element trial and test function spaces, which are subspaces of H 1 0 ([0, 1]2 ): V h (0) = {u V h : u(a i ) = 0, A i Ω}. 6 A function u V h is uniquely determined by {u(a i )} N i=1. 7 Basis {ϕ i } N i=1 of V h: ϕ i (A j ) = δ ij, i = 1, 2,..., N. 8 k ij = a(ϕ j, ϕ i ) 0, iff A i A j T e for some 1 e M. 9 supp(ϕ i ) is small the stiffness matrix K is sparse. 8 / 34

9 Finite Element Methods A Typical Example of the Finite Element Method Assemble the Global Stiffness Matrix K from the Element One K e 1 Denote a e (u, v) = T e u v dx, by the definition, then, k ij = a(ϕ j, ϕ i ) = M e=1 ae (ϕ j, ϕ i ) = M e=1 ke ij. 2 k e ij = ae (ϕ j, ϕ i ) 0, iff A i A j T e. For most e, k e ij = 0. 3 It is inefficient to calculate k ij by scanning i, j node by node. 4 Element T e with nodes {A e α} 3 α=1 the global nodes A en(α,e). 5 Area coordinates λ e (A) = (λ e 1 (A), λe 2 (A), λe 3 (A))T for A T e, λ e α(a) = AA e β Ae γ / A e αa e β Ae γ P 1 (T e ), λ e α(a e β ) = δ αβ. 6 ϕ en(α,e) Te (A) = λ e α(a), A T e. 9 / 34

10 Finite Element Methods A Typical Example of the Finite Element Method The Algorithm for Assembling Global K and f h 7 Define the element stiffness matrix K e = (k e αβ ), ke αβ ae (λ e α, λ e β ) = T e λ e α λ e β dx, 8 Then, k ij = k e αβ can be assembled element wise. en(α, e)=i T e en(β, e)=j T e 9 The external load vector f h = (f i ) can also be assembled by scanning through elements f i = f λ e α dx = fα e. T e en(α, e)=i T e en(α, e)=i T e 10 / 34

11 Finite Element Methods A Typical Example of the Finite Element Method The Algorithm for Assembling Global K and f h Algorithm 6.1: K = (k(i, j)) := 0; f = (f (i)) := 0; for e = 1 : M K e = (k e (α, β)); % calculate the element stiffness matrix f e = (f e (α)); % calculate the element external load vector k(en(α, e), en(β, e)) := k(en(α, e), en(β, e)) + k e (α, β); f (en(α, e)) := f (en(α, e)) + f e (α); end 11 / 34

12 Finite Element Methods A Typical Example of the Finite Element Method Calculations of K e and f e Are Carried Out on a Reference Element 1 The standard reference triangle T s = {ˆx = (ˆx 1, ˆx 2 ) R 2 : ˆx 1 0, ˆx 2 0 and ˆx 1 + ˆx 2 1}, with A s 1 = (0, 0)T, A s 2 = (1, 0)T and A s 3 = (0, 1)T. 2 For T e with A e 1 = (x 1 1, x 1 2 )T, A e 2 = (x 2 1, x 2 2 )T, A e 3 = (x 3 1, x 3 2 )T, define A e = (A e 2 Ae 1, Ae 3 Ae 1 ), a e = A e 1. 3 x = L e (ˆx) := A eˆx + a e : T s T e is an affine map. 4 The area coordinates of T e : λ e α(x) = λ s α(l 1 e (x)), since it is an affine function of x, and λ s α(l 1 e (A e β )) = λs α(a s β ) = δ αβ. 5 λ e (x) = λ s (ˆx) L 1 e (x) = λ s (ˆx)A 1 e. 12 / 34

13 Finite Element Methods A Typical Example of the Finite Element Method Calculations of K e and f e Are Carried Out on a Reference Element 6 Change of integral variable ˆx = L 1 e (x) := A 1 e x A 1 e A e 1, K e = λ e (x) ( λ e (x)) T dx = λ s (ˆx)A 1 e ( λ s (ˆx)A 1 e ) T det A e dˆx, T e T s f e = f (x)λ e (x) dx = det A e f (L e (ˆx))λ s (ˆx) dˆx. T e T s 7 λ s 1 (ˆx 1, ˆx 2 ) = 1 ˆx 1 ˆx 2, λ s 2 (ˆx 1, ˆx 2 ) = ˆx 1, λ s 3 (ˆx 1, ˆx 2 ) = ˆx 2, so 1 1 λ s (ˆx) = 1 0, 0 1 A 1 e = 1 deta e ( x 3 2 x 1 2 x 1 1 x 3 1 x 1 2 x 2 2 x 2 1 x 1 1 ). 13 / 34

14 Finite Element Methods A Typical Example of the Finite Element Method Calculations of K e and f e in Terms of λ s and A e 8 The area of T s is 1/2, hence, the element stiffness matrix is x K e x 2 3 x1 3 x 2 1 = x2 3 2 det A x 2 1 x1 1 x 1 3 e x2 1 x 2 2 x1 2 x 1 1 ( x 2 2 x2 3 x2 3 x 2 1 x2 1 x 2 2 x1 3 x 1 2 x1 1 x 1 3 x1 2 x In general, it is necessary to apply a numerical quadrature to the calculation of the element external load vector f e. 10 If f is a constant on T e, then f e = 1 6 f (T e) det A e (1, 1, 1) T = 1 3 f (T e) T e (1, 1, 1) T. ). 14 / 34

15 Finite Element Methods Extension to More General Boundary Conditions Extension of the Example to More General Boundary Conditions For a Dirichlet boundary condition u(x) = u 0 (x) 0, on Ω, FE trial function space V h (0) should be replaced by V h (u 0 ) = {u V h : u(a i ) = u 0 (A i ), A i Ω}. For a more general mixed type boundary condition u(x) = u 0 (x), x Ω 0, u ν + bu = g, x Ω 1, We need to 1 add contributions of Ω 1 buv dx and Ω 1 gv dx to K and f by scanning through edges on Ω 1 ; 15 / 34

16 Finite Element Methods Extension to More General Boundary Conditions Extension of the Example to More General Boundary Conditions 2 Set finite element trial function space: V h (u 0 ; Ω 0 ) = {u V h : u(a i ) = u 0 (A i ), A i Ω 0 }, if Ω 0 (mixed boundary condition); V h, if Ω 0 = but b > 0 (the 3rd type boundary condition); V h (0; A i ) = {u V h : u(a i ) = 0, on a specified node A i Ω}, if Ω 0 = and b = 0 (pure Neumann boundary condition). Note: In the case of pure Neumann boundary condition, the solution is unique up to an additive constant. V h (0; A i ) removes such uncertainty, so the solution in V h (0; A i ) is unique. Likewise, let l be a non-zero linear functional on V h, then we may as well take V h (0; l) = {u V h : l(u) = 0}. 16 / 34

17 Finite Element Methods Extension to More General Boundary Conditions Summary of the Typical Example on FEM 1 introduce a finite element partition (triangulation) T h to the region Ω, such as the triangular partition shown above. 2 Establish finite element trial and test function spaces on T h (Ω), such as continuous piecewise affine function spaces satisfy appropriate boundary conditions shown above. 3 Select a set of basis functions, known as the shape functions, for example, the area coordinates on the triangular element. 4 Calculate the element stiffness matrixes K e and element external load vector fh e, and form the global stiffness matrix K and external load vector f h. 17 / 34

18 Finite Element Methods Extension to More General Boundary Conditions Some General Remarks on the Implementation of FEM Arrays used in the algorithm: 1 en(α, e): assigns a global node number to a node with the local node number α on the eth element. 2 edg0(α, edg): assigns a global node number to a node with the local node number α on the edgth edge on Ω 0. edg1(α, edg), edg2(α, edg) are similar arrays with respect to Neumann and Robin type boundaries. 3 cd(i, nd): assigns the ith component of the spatial coordinates to a node with the global node number nd. 18 / 34

19 Finite Element Methods Extension to More General Boundary Conditions Some General Remarks on the Implementation of FEM Arrays used in the algorithm: 4 In iterative methods for solving Ku h = f h, it is not necessary to form the global stiffness matrix K, since it always appears in the form Kv h = e T h K e vh e. In such cases, we may need: 5 et(i, τ): assigns the global element number to the τth local element of the ith global node. And edgrt(i, τ), etc. 19 / 34

20 Finite Element and Finite Element Function Spaces The General Definition of Finite Element Three Basic Ingredients in a Finite Element Function Space (FEM 1) Introduce a finite element triangulation T h on the region Ω, which divides the region Ω into finite numbers of subsets K, generally called finite element, such that (T h 1) Ω = K Th K; (T h 2) each finite element K T h is a closed set with a nonempty interior set K; (T h 3) K 1 K 2 =, for any two different finite elements K 1, K 2 T h ; (T h 4) every finite element K T h has a Lipschitz continuous boundary. 20 / 34

21 Finite Element and Finite Element Function Spaces The General Definition of Finite Element Three Basic Ingredients in a Finite Element Function Space (FEM 2) Introduce on every finite element K T h a function space P K which consists of some polynomials or other functions having certain approximation properties and at the same time easily manipulated analytically and numerically; (FEM 3) The finite element function space V h has a set of normalized basis functions which are easily computed, and each of the basis function has a small support. Generally speaking, a finite element is not just a subset K, it includes also the finite dimensional function space P K defined on K and the corresponding normalized basis functions. 21 / 34

22 Finite Element and Finite Element Function Spaces The General Definition of Finite Element General Abstract Definition of a Finite Element Definition A triple (K, P K, Σ K ) is called a finite element, if 1 K R n, called an element, is a closed set with non-empty interior and a Lipschitz continuous boundary; 2 P K : K R is a finite dimensional function space consisting of sufficiently smooth functions defined on the element K; 3 Σ K is a set of linearly independent linear functionals {ϕ i } N i=1 defined on C (K), which are called the degrees of freedom of the finite element and form a dual basis corresponding to a normalized basis of P K, meaning that there exists a unique basis {p i } N i=1 of P K such that ϕ i (p j ) = δ ij. 22 / 34

23 Finite Element and Finite Element Function Spaces The General Definition of Finite Element An Additional Requirement on the Partition In applications, an element K is usually taken to be 1 a triangle in R 2 ; a tetrahedron in R 3 ; a n simplex in R n ; 2 a rectangle or parallelogram in R 2 ; a cuboid or a parallelepiped or more generally a convex hexahedron in R 3 ; a parallelepiped or more generally a convex 2n polyhedron in R n ; 3 a triangle with curved edges or a tetrahedron with curved faces, etc.. 23 / 34

24 Finite Element and Finite Element Function Spaces The General Definition of Finite Element An Additional Requirement on the Partition When a region Ω is partitioned into a finite element triangulation T h with such elements, to ensure that (FEM 3) holds, the adjacent elements are required to satisfy the following compatibility condition: (T h 5) For any pair of K 1, K 2 T h, if K 1 K2, then, there must exists an 0 i n 1, such that K 1 K2 is exactly a common i dimensional face of K 1 and K / 34

25 Finite Element and Finite Element Function Spaces The General Definition of Finite Element The Function Space P K Usually Consists of Polynomials 1 The finite element of the n-simplex of type (k): K is a n-simplex, P K = P k (K), which is the space of all polynomials of degree no greater than k defined on K. For example, the piecewise affine triangular element (2-simplex of type (1), or type (1) 2-simplex, or type(1) triangle). 2 The finite element of n-rectangle of type (k) (abbreviated as the n-k element): K is a n-rectangle, P K = Q k (K), which is the space of all polynomials of degree no greater than k with respect to each one of the n variables. For example, the bilinear element (the 2-rectangle of type (1), or type (1) 2-rectangle, or 2-1 rectangle); etc.. 25 / 34

26 Finite Element and Finite Element Function Spaces The General Definition of Finite Element The Nodal Degrees of Freedom Σ K The degrees of freedom in the nodal form: ϕ 0 i : p p (ai 0 ), Lagrange FE, if contains point values only ϕ 1 ij : p ν 1p (a1 ij i ), Hermite FE, if contains at least ϕ 2 ijk : p 2 p (a νij 2ν2 i 2 ), one of the derivatives ik where the points a s i K, s = 0, 1, 2 are called nodes, ν s ij Rn, s = 1, 2 are specified nonzero vectors. 26 / 34

27 Finite Element and Finite Element Function Spaces The General Definition of Finite Element The Nodal and Integral Degrees of Freedom Σ K The degrees of freedom in the integral form: ψi s 1 : p meas s (Ki s) p(x) dx, where Ki s, s = 0, 1,..., n are s-dimensional faces of the element K, and meas s (Ki s ) is the s-dimensional Lebesgue measure of K s i. For example, if s = n, then the corresponding degree of freedom is the average of the element integral. K s i 27 / 34

28 Finite Element and Finite Element Function Spaces Finite Element Interpolation P K Interpolation for a Given Finite Element (K, P K, Σ K ) Definition Let (K, P K, Σ K ) be a finite element, and let {ϕ i } N i=1 be its degrees of freedom with {p i } N i=1 P K being the corresponding dual basis, meaning ϕ i (p j ) = δ ij. Define the P K interpolation operator Π K : C (K) P K by N Π K (v) = ϕ i (v) p i, v C (K), i=1 and define Π K (v) as the P K interpolation function of v. In applications, it is often necessary to extend the domain of the definition of the P K interpolation operator, for example, to extend the domain of the definition of a Lagrange finite element to C(K). 28 / 34

29 Finite Element and Finite Element Function Spaces Finite Element Interpolation The P K Interpolation Operator Is Independent of the Choice of Basis Definition Let two finite elements (K, P K, Σ K ) and (L, P L, Σ L ) satisfy K = L, P K = P L, and Π K = Π L, where Π K and Π L are respectively P K and P L interpolation operators, then the two finite elements are said to be equivalent. 29 / 34

30 Finite Element and Finite Element Function Spaces Finite Element Interpolation Compatibility Conditions for P K and Σ K on Adjacent Elements 1 T h : a finite element triangulation of Ω; {(K, P K, Σ K )} K Th : a given set of corresponding finite elements. 2 V h = {v : K T h K R : v K P K }: FE function space. 3 Compatibility conditions are required to assure V h satisfies (FEM 3), as well as a subspace of V. For example, for polyhedron elements and nodal degrees of freedom, if K 1 K2, then, we require that a point a s i K 1 K2 is a node of K 1, if and only if it is also the same type of node of K / 34

31 Finite Element and Finite Element Function Spaces Finite Element Interpolation V h Interpolation Operator and V h Interpolation Denote Σ h = K T h Σ K as the degrees of freedom of the finite element function space V h. Definition Define the V h interpolation operator Π h : C (Ω) V h by Π h (v) K = Π K (v K ), and define Π h (v) as the V h interpolant of v. v C (Ω), In applications, similar as for the P K interpolation operator, the domain of definition of the V h interpolation operator is often extended to meet certain requirements. 31 / 34

32 Reference Finite Element ( ˆK, ˆP, ˆΣ) and Its Isoparametric Equivalent Family Definition Let ˆK, K R n, ( ˆK, ˆP, ˆΣ) and (K, P K, Σ K ) be two finite elements. Suppose that there exists a sufficiently smooth invertible map F K : ˆK K, such that F K ( ˆK) = K; p i = ˆp i F 1 K, i = 1,..., N; ϕ i (p) = ˆϕ i (p F K ), p P K, i = 1,..., N, where { ˆϕ i } N i=1 and {ϕ i} N i=1 are the basis of the degrees of freedom spaces ˆΣ and Σ K respectively, {ˆp i } N i=1 and {p i} N i=1 are the corresponding dual basis of ˆP and P K respectively. Then, the two finite elements are said to be isoparametrically equivalent. In particular, if F K is an affine mapping, the two finite elements are said to be affine-equivalent.

33 Finite Element and Finite Element Function Spaces Isoparametric and Affine Equivalent Family of Finite Elements An Isoparametric (Affine) Family of Finite Elements If all finite elements in a family are isoparametrically (affine-) equivalent to a given reference finite element, then we call the family an isoparametric (affine) family. For example, the finite elements with triangular elements and piecewise linear function space used in the previous subsection, i.e. finite elements of 2-simplex of type (1), are an affine family. 33 / 34

34 SK 6µ5, 6, 7 Thank You!

Chapter 3 Conforming Finite Element Methods 3.1 Foundations Ritz-Galerkin Method

Chapter 3 Conforming Finite Element Methods 3.1 Foundations Ritz-Galerkin Method Chapter 3 Conforming Finite Element Methods 3.1 Foundations 3.1.1 Ritz-Galerkin Method Let V be a Hilbert space, a(, ) : V V lr a bounded, V-elliptic bilinear form and l : V lr a bounded linear functional.

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 Nonconformity and the Consistency Error First Strang Lemma Abstract Error Estimate

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

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

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

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 The Residual and Error of Finite Element Solutions Mixed BVP of Poisson Equation

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

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

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

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

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 Numerical Methods for Partial Differential Equations Finite Difference Methods

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

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

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: 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

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

Adaptive Finite Element Methods Lecture Notes Winter Term 2017/18. R. Verfürth. Fakultät für Mathematik, Ruhr-Universität Bochum

Adaptive Finite Element Methods Lecture Notes Winter Term 2017/18. R. Verfürth. Fakultät für Mathematik, Ruhr-Universität Bochum Adaptive Finite Element Methods Lecture Notes Winter Term 2017/18 R. Verfürth Fakultät für Mathematik, Ruhr-Universität Bochum Contents Chapter I. Introduction 7 I.1. Motivation 7 I.2. Sobolev and finite

More information

Chapter 5 A priori error estimates for nonconforming finite element approximations 5.1 Strang s first lemma

Chapter 5 A priori error estimates for nonconforming finite element approximations 5.1 Strang s first lemma Chapter 5 A priori error estimates for nonconforming finite element approximations 51 Strang s first lemma We consider the variational equation (51 a(u, v = l(v, v V H 1 (Ω, and assume that the conditions

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 A Framework for Interpolation Error Estimation of Affine Equivalent FEs 1 The

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

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

Variational Formulations

Variational Formulations Chapter 2 Variational Formulations In this chapter we will derive a variational (or weak) formulation of the elliptic boundary value problem (1.4). We will discuss all fundamental theoretical results that

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

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

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

ME FINITE ELEMENT ANALYSIS FORMULAS

ME FINITE ELEMENT ANALYSIS FORMULAS ME 2353 - FINITE ELEMENT ANALYSIS FORMULAS UNIT I FINITE ELEMENT FORMULATION OF BOUNDARY VALUE PROBLEMS 01. Global Equation for Force Vector, {F} = [K] {u} {F} = Global Force Vector [K] = Global Stiffness

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

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

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 Elements. Colin Cotter. February 22, Colin Cotter FEM

Finite Elements. Colin Cotter. February 22, Colin Cotter FEM Finite Elements February 22, 2019 In the previous sections, we introduced the concept of finite element spaces, which contain certain functions defined on a domain. Finite element spaces are examples 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

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

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 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

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 Discretization of Boundary Conditions Discretization of Boundary Conditions On

More information

Solution of Non-Homogeneous Dirichlet Problems with FEM

Solution of Non-Homogeneous Dirichlet Problems with FEM Master Thesis Solution of Non-Homogeneous Dirichlet Problems with FEM Francesco Züger Institut für Mathematik Written under the supervision of Prof. Dr. Stefan Sauter and Dr. Alexander Veit August 27,

More information

Parallel Discontinuous Galerkin Method

Parallel Discontinuous Galerkin Method Parallel Discontinuous Galerkin Method Yin Ki, NG The Chinese University of Hong Kong Aug 5, 2015 Mentors: Dr. Ohannes Karakashian, Dr. Kwai Wong Overview Project Goal Implement parallelization on Discontinuous

More information

Introduction to Finite Element Method

Introduction to Finite Element Method Introduction to Finite Element Method Dr. Rakesh K Kapania Aerospace and Ocean Engineering Department Virginia Polytechnic Institute and State University, Blacksburg, VA AOE 524, Vehicle Structures Summer,

More information

LECTURE 1: SOURCES OF ERRORS MATHEMATICAL TOOLS A PRIORI ERROR ESTIMATES. Sergey Korotov,

LECTURE 1: SOURCES OF ERRORS MATHEMATICAL TOOLS A PRIORI ERROR ESTIMATES. Sergey Korotov, LECTURE 1: SOURCES OF ERRORS MATHEMATICAL TOOLS A PRIORI ERROR ESTIMATES Sergey Korotov, Institute of Mathematics Helsinki University of Technology, Finland Academy of Finland 1 Main Problem in Mathematical

More information

Basic Principles of Weak Galerkin Finite Element Methods for PDEs

Basic Principles of Weak Galerkin Finite Element Methods for PDEs Basic Principles of Weak Galerkin Finite Element Methods for PDEs Junping Wang Computational Mathematics Division of Mathematical Sciences National Science Foundation Arlington, VA 22230 Polytopal Element

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

Decidability of consistency of function and derivative information for a triangle and a convex quadrilateral

Decidability of consistency of function and derivative information for a triangle and a convex quadrilateral Decidability of consistency of function and derivative information for a triangle and a convex quadrilateral Abbas Edalat Department of Computing Imperial College London Abstract Given a triangle in the

More information

Basic Concepts of Adaptive Finite Element Methods for Elliptic Boundary Value Problems

Basic Concepts of Adaptive Finite Element Methods for Elliptic Boundary Value Problems Basic Concepts of Adaptive Finite lement Methods for lliptic Boundary Value Problems Ronald H.W. Hoppe 1,2 1 Department of Mathematics, University of Houston 2 Institute of Mathematics, University of Augsburg

More information

Resources. Introduction to the finite element method. History. Topics

Resources. Introduction to the finite element method. History. Topics Resources Introduction to the finite element method M. M. Sussman sussmanm@math.pitt.edu Office Hours: 11:1AM-12:1PM, Thack 622 May 12 June 19, 214 Strang, G., Fix, G., An Analysis of the Finite Element

More information

Chapter 1 Foundations of Elliptic Boundary Value Problems 1.1 Euler equations of variational problems

Chapter 1 Foundations of Elliptic Boundary Value Problems 1.1 Euler equations of variational problems Chapter 1 Foundations of Elliptic Boundary Value Problems 1.1 Euler equations of variational problems Elliptic boundary value problems often occur as the Euler equations of variational problems the latter

More information

Interpolation in h-version finite element spaces

Interpolation in h-version finite element spaces Interpolation in h-version finite element spaces Thomas Apel Institut für Mathematik und Bauinformatik Fakultät für Bauingenieur- und Vermessungswesen Universität der Bundeswehr München Chemnitzer Seminar

More information

Numerical Analysis Comprehensive Exam Questions

Numerical Analysis Comprehensive Exam Questions Numerical Analysis Comprehensive Exam Questions 1. Let f(x) = (x α) m g(x) where m is an integer and g(x) C (R), g(α). Write down the Newton s method for finding the root α of f(x), and study the order

More information

Chapter 5 Structural Elements: The truss & beam elements

Chapter 5 Structural Elements: The truss & beam elements Institute of Structural Engineering Page 1 Chapter 5 Structural Elements: The truss & beam elements Institute of Structural Engineering Page 2 Chapter Goals Learn how to formulate the Finite Element Equations

More information

Simple Examples on Rectangular Domains

Simple Examples on Rectangular Domains 84 Chapter 5 Simple Examples on Rectangular Domains In this chapter we consider simple elliptic boundary value problems in rectangular domains in R 2 or R 3 ; our prototype example is the Poisson equation

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

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

An introduction to the mathematical theory of finite elements

An introduction to the mathematical theory of finite elements Master in Seismic Engineering E.T.S.I. Industriales (U.P.M.) Discretization Methods in Engineering An introduction to the mathematical theory of finite elements Ignacio Romero ignacio.romero@upm.es October

More information

SPECTRAL PROPERTIES OF THE LAPLACIAN ON BOUNDED DOMAINS

SPECTRAL PROPERTIES OF THE LAPLACIAN ON BOUNDED DOMAINS SPECTRAL PROPERTIES OF THE LAPLACIAN ON BOUNDED DOMAINS TSOGTGEREL GANTUMUR Abstract. After establishing discrete spectra for a large class of elliptic operators, we present some fundamental spectral properties

More information

Second Order Elliptic PDE

Second Order Elliptic PDE Second Order Elliptic PDE T. Muthukumar tmk@iitk.ac.in December 16, 2014 Contents 1 A Quick Introduction to PDE 1 2 Classification of Second Order PDE 3 3 Linear Second Order Elliptic Operators 4 4 Periodic

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

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

Finite Elements. Colin Cotter. January 18, Colin Cotter FEM Finite Elements January 18, 2019 The finite element Given a triangulation T of a domain Ω, finite element spaces are defined according to 1. the form the functions take (usually polynomial) when restricted

More information

Introduction. Finite and Spectral Element Methods Using MATLAB. Second Edition. C. Pozrikidis. University of Massachusetts Amherst, USA

Introduction. Finite and Spectral Element Methods Using MATLAB. Second Edition. C. Pozrikidis. University of Massachusetts Amherst, USA Introduction to Finite and Spectral Element Methods Using MATLAB Second Edition C. Pozrikidis University of Massachusetts Amherst, USA (g) CRC Press Taylor & Francis Group Boca Raton London New York CRC

More information

2 Elliptic Differential Equations

2 Elliptic Differential Equations 2 Elliptic Differential Equations 2.1 Classical solutions As far as existence and uniqueness results for classical solutions are concerned, we restrict ourselves to linear elliptic second order elliptic

More information

Finite Element Spectral Approximation with Numerical Integration for the Biharmonic Eigenvalue Problem

Finite Element Spectral Approximation with Numerical Integration for the Biharmonic Eigenvalue Problem City University of New York (CUNY) CUNY Academic Works Publications and Research Kingsborough Community College 2014 Finite Element Spectral Approximation with Numerical Integration for the Biharmonic

More information

Axioms of Adaptivity (AoA) in Lecture 3 (sufficient for optimal convergence rates)

Axioms of Adaptivity (AoA) in Lecture 3 (sufficient for optimal convergence rates) Axioms of Adaptivity (AoA) in Lecture 3 (sufficient for optimal convergence rates) Carsten Carstensen Humboldt-Universität zu Berlin 2018 International Graduate Summer School on Frontiers of Applied and

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

Index. C 2 ( ), 447 C k [a,b], 37 C0 ( ), 618 ( ), 447 CD 2 CN 2

Index. C 2 ( ), 447 C k [a,b], 37 C0 ( ), 618 ( ), 447 CD 2 CN 2 Index advection equation, 29 in three dimensions, 446 advection-diffusion equation, 31 aluminum, 200 angle between two vectors, 58 area integral, 439 automatic step control, 119 back substitution, 604

More information

PART IV Spectral Methods

PART IV Spectral Methods PART IV Spectral Methods Additional References: R. Peyret, Spectral methods for incompressible viscous flow, Springer (2002), B. Mercier, An introduction to the numerical analysis of spectral methods,

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

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

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

AMS subject classifications. Primary, 65N15, 65N30, 76D07; Secondary, 35B45, 35J50

AMS subject classifications. Primary, 65N15, 65N30, 76D07; Secondary, 35B45, 35J50 A SIMPLE FINITE ELEMENT METHOD FOR THE STOKES EQUATIONS LIN MU AND XIU YE Abstract. The goal of this paper is to introduce a simple finite element method to solve the Stokes equations. This method is in

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

1. Introduction. The Stokes problem seeks unknown functions u and p satisfying

1. Introduction. The Stokes problem seeks unknown functions u and p satisfying A DISCRETE DIVERGENCE FREE WEAK GALERKIN FINITE ELEMENT METHOD FOR THE STOKES EQUATIONS LIN MU, JUNPING WANG, AND XIU YE Abstract. A discrete divergence free weak Galerkin finite element method is developed

More information

PDEs, part 1: Introduction and elliptic PDEs

PDEs, part 1: Introduction and elliptic PDEs PDEs, part 1: Introduction and elliptic PDEs Anna-Karin Tornberg Mathematical Models, Analysis and Simulation Fall semester, 2013 Partial di erential equations The solution depends on several variables,

More information

Linear algebra for computational statistics

Linear algebra for computational statistics University of Seoul May 3, 2018 Vector and Matrix Notation Denote 2-dimensional data array (n p matrix) by X. Denote the element in the ith row and the jth column of X by x ij or (X) ij. Denote by X j

More information

Chapter 12. Partial di erential equations Di erential operators in R n. The gradient and Jacobian. Divergence and rotation

Chapter 12. Partial di erential equations Di erential operators in R n. The gradient and Jacobian. Divergence and rotation Chapter 12 Partial di erential equations 12.1 Di erential operators in R n The gradient and Jacobian We recall the definition of the gradient of a scalar function f : R n! R, as @f grad f = rf =,..., @f

More information

Partial Differential Equations and the Finite Element Method

Partial Differential Equations and the Finite Element Method Partial Differential Equations and the Finite Element Method Pavel Solin The University of Texas at El Paso Academy of Sciences ofthe Czech Republic iwiley- INTERSCIENCE A JOHN WILEY & SONS, INC, PUBLICATION

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

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

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

Jim Lambers MAT 610 Summer Session Lecture 1 Notes

Jim Lambers MAT 610 Summer Session Lecture 1 Notes Jim Lambers MAT 60 Summer Session 2009-0 Lecture Notes Introduction This course is about numerical linear algebra, which is the study of the approximate solution of fundamental problems from linear algebra

More information

Lecture 2: Linear Algebra Review

Lecture 2: Linear Algebra Review EE 227A: Convex Optimization and Applications January 19 Lecture 2: Linear Algebra Review Lecturer: Mert Pilanci Reading assignment: Appendix C of BV. Sections 2-6 of the web textbook 1 2.1 Vectors 2.1.1

More information

ITERATIVE METHODS FOR NONLINEAR ELLIPTIC EQUATIONS

ITERATIVE METHODS FOR NONLINEAR ELLIPTIC EQUATIONS ITERATIVE METHODS FOR NONLINEAR ELLIPTIC EQUATIONS LONG CHEN In this chapter we discuss iterative methods for solving the finite element discretization of semi-linear elliptic equations of the form: find

More information

A primer on Numerical methods for elasticity

A primer on Numerical methods for elasticity A primer on Numerical methods for elasticity Douglas N. Arnold, University of Minnesota Complex materials: Mathematical models and numerical methods Oslo, June 10 12, 2015 One has to resort to the indignity

More information

Applied/Numerical Analysis Qualifying Exam

Applied/Numerical Analysis Qualifying Exam Applied/Numerical Analysis Qualifying Exam August 9, 212 Cover Sheet Applied Analysis Part Policy on misprints: The qualifying exam committee tries to proofread exams as carefully as possible. Nevertheless,

More information

Numerical Solution of a Coefficient Identification Problem in the Poisson equation

Numerical Solution of a Coefficient Identification Problem in the Poisson equation Swiss Federal Institute of Technology Zurich Seminar for Applied Mathematics Department of Mathematics Bachelor Thesis Spring semester 2014 Thomas Haener Numerical Solution of a Coefficient Identification

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

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

Krein-Rutman Theorem and the Principal Eigenvalue

Krein-Rutman Theorem and the Principal Eigenvalue Chapter 1 Krein-Rutman Theorem and the Principal Eigenvalue The Krein-Rutman theorem plays a very important role in nonlinear partial differential equations, as it provides the abstract basis for the proof

More information

Efficient hp-finite elements

Efficient hp-finite elements Efficient hp-finite elements Ammon Washburn July 31, 2015 Abstract Ways to make an hp-finite element method efficient are presented. Standard FEMs and hp-fems with their various strengths and weaknesses

More information

A note on accurate and efficient higher order Galerkin time stepping schemes for the nonstationary Stokes equations

A note on accurate and efficient higher order Galerkin time stepping schemes for the nonstationary Stokes equations A note on accurate and efficient higher order Galerkin time stepping schemes for the nonstationary Stokes equations S. Hussain, F. Schieweck, S. Turek Abstract In this note, we extend our recent work for

More information

Vector Spaces ปร ภ ม เวกเตอร

Vector Spaces ปร ภ ม เวกเตอร Vector Spaces ปร ภ ม เวกเตอร 1 5.1 Real Vector Spaces ปร ภ ม เวกเตอร ของจ านวนจร ง Vector Space Axioms (1/2) Let V be an arbitrary nonempty set of objects on which two operations are defined, addition

More information

2 Two-Point Boundary Value Problems

2 Two-Point Boundary Value Problems 2 Two-Point Boundary Value Problems Another fundamental equation, in addition to the heat eq. and the wave eq., is Poisson s equation: n j=1 2 u x 2 j The unknown is the function u = u(x 1, x 2,..., x

More information

arxiv: v5 [math.na] 1 Sep 2018

arxiv: v5 [math.na] 1 Sep 2018 High-Order Adaptive Extended Stencil FEM (AES-FEM) Part I: Convergence and Superconvergence Xiangmin Jiao Rebecca Conley Tristan J. Delaney arxiv:1603.09325v5 [math.na] 1 Sep 2018 Abstract Finite elements

More information

High order, finite volume method, flux conservation, finite element method

High order, finite volume method, flux conservation, finite element method FLUX-CONSERVING FINITE ELEMENT METHODS SHANGYOU ZHANG, ZHIMIN ZHANG, AND QINGSONG ZOU Abstract. We analyze the flux conservation property of the finite element method. It is shown that the finite element

More information

Vector Spaces, Affine Spaces, and Metric Spaces

Vector Spaces, Affine Spaces, and Metric Spaces Vector Spaces, Affine Spaces, and Metric Spaces 2 This chapter is only meant to give a short overview of the most important concepts in linear algebra, affine spaces, and metric spaces and is not intended

More information

b i (x) u + c(x)u = f in Ω,

b i (x) u + c(x)u = f in Ω, SIAM J. NUMER. ANAL. Vol. 39, No. 6, pp. 1938 1953 c 2002 Society for Industrial and Applied Mathematics SUBOPTIMAL AND OPTIMAL CONVERGENCE IN MIXED FINITE ELEMENT METHODS ALAN DEMLOW Abstract. An elliptic

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

PREPRINT 2010:23. A nonconforming rotated Q 1 approximation on tetrahedra PETER HANSBO

PREPRINT 2010:23. A nonconforming rotated Q 1 approximation on tetrahedra PETER HANSBO PREPRINT 2010:23 A nonconforming rotated Q 1 approximation on tetrahedra PETER HANSBO Department of Mathematical Sciences Division of Mathematics CHALMERS UNIVERSITY OF TECHNOLOGY UNIVERSITY OF GOTHENBURG

More information

Numerische Mathematik

Numerische Mathematik Numer. Math. (2012) 122:61 99 DOI 10.1007/s00211-012-0456-x Numerische Mathematik C 0 elements for generalized indefinite Maxwell equations Huoyuan Duan Ping Lin Roger C. E. Tan Received: 31 July 2010

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

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

10 The Finite Element Method for a Parabolic Problem

10 The Finite Element Method for a Parabolic Problem 1 The Finite Element Method for a Parabolic Problem In this chapter we consider the approximation of solutions of the model heat equation in two space dimensions by means of Galerkin s method, using piecewise

More information

A non-standard Finite Element Method based on boundary integral operators

A non-standard Finite Element Method based on boundary integral operators A non-standard Finite Element Method based on boundary integral operators Clemens Hofreither Ulrich Langer Clemens Pechstein June 30, 2010 supported by Outline 1 Method description Motivation Variational

More information