Scientific Computing I

Size: px
Start display at page:

Download "Scientific Computing I"

Transcription

1 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

2 Part I: Introduction to Finite Element Methods The Model Problem FEM Main Ingredients Weak Forms and Weak Solutions FEM and the Residual Equation Test and Shape Functions Assembling the System of Equations Example Problem: 1D Poisson Stiffness Matrix for Linear Nodal Basis Functions A Road to Theory Time-Dependent Problems Module 8: An Introduction to Finite Element Methods, Winter 2013/2014 2

3 The Model Problem: Poisson Equation 2D Poisson Equation on unit square: 2 2 u(x, y) + u(x, y) = f (x, y) in Ω = (0, 1)2 x 2 y 2 Dirichlet boundary conditions: u(x, y) = g(x, y) on Ω new for FEM: compute a function to approximate u(x, y) (instead of approximate values at certain grid points) Module 8: An Introduction to Finite Element Methods, Winter 2013/2014 3

4 Finite Elements Main Ingredients 1. solve weak form of PDE to reduce regularity properties u = f v u dx = vf dx allows additional weak solutions 2. compute a function as numerical solution search in a function space W h : u h = j u j ϕ j (x), span{ϕ 1,..., ϕ J } = W h 3. find weak solutions of simple form: for example piecewise linear functions and choose basis functions with local support ( hat functions ) leads to system of linear equations Module 8: An Introduction to Finite Element Methods, Winter 2013/2014 4

5 Weak Forms and Weak Solutions consider a PDE Lu = f (e.g. Lu = u or Lu = u ) transformation to the weak form: Lu, v = vlu dx = vf dx = f, v V a certain class of functions real solution u also solves the weak form however, additional, weak solutions are now allowed Lu, v a bilinear form; often written as: v V a (u, v) = f, v v V Module 8: An Introduction to Finite Element Methods, Winter 2013/2014 5

6 Weak Form of the Poisson Equation Poisson equation with Dirichlet conditions: weak form: apply divergence theorem: v u dω = Ω u = f in Ω, u = 0 on δω v u dω = vf dω Ω Ω Ω v v u dω v u ds Ω choose functions v such that v = 0 on Ω: v u dω = vf dω Ω Ω v Module 8: An Introduction to Finite Element Methods, Winter 2013/2014 6

7 Weak Form of the Poisson Equation (2) Poisson equation with Dirichlet conditions: u = f in Ω, u = 0 on δω transformed into weak form: v u dω = vf dω Ω Ω v weaker requirements for a solution u: twice differentiabale first derivative integrable Module 8: An Introduction to Finite Element Methods, Winter 2013/2014 7

8 FEM and the Residual Equation for a general PDE Lu = f, the residual is defined as r(x) := f (x) Lu(x)! = 0 in the weak form (multiply with test function an integrate) we obtain v(x) r(x) = v(x) ( f (x) Lu(x) ) dx = 0 for all v remember that f (x)g(x) dx is the standard scalar product on functions hence: the residual of the weak solution has to be orthogonal to all test functions Module 8: An Introduction to Finite Element Methods, Winter 2013/2014 8

9 Test and Shape Functions search for solution functions u h of the form u h = j u j ϕ j (x) the ϕ j (x) are typically called shape or ansatz functions the basis functions ϕ j (x) build a vector space (i.e., a function space) W h span{ϕ 1,..., ϕ J } = W h insert into weak formulation ( ) vl u j ϕ j (x) dx = j vf dx v V Module 8: An Introduction to Finite Element Methods, Winter 2013/2014 9

10 Test and Shape Functions (2) choose a basis {ψ i } of the test space V h then: if all basis functions ψ i satisfy ( ) ψ i L u j ϕ j (x) dx = j ψ i f dx ψ i then all v V h satisfy the equation the {ψ i } are therefore often called test functions we obtain a system of equations for unknowns u j : one equation for each test function ψ i V h is often chosen to be identical to W h (Ritz-Galerkin method) we then have as many equations as unknowns Module 8: An Introduction to Finite Element Methods, Winter 2013/

11 Example: Nodal Basis 1 h (x x i 1) x i 1 < x < x i 1 ϕ i (x) := h (x i+1 x) x i < x < x i+1 0 otherwise 1 0,8 0,6 0,4 0, ,2 0,4 0,6 0,8 x Module 8: An Introduction to Finite Element Methods, Winter 2013/

12 Assembling the System of Equations L linear system of linear equations ( ) ψ i Lϕ j (x) dx u j = j } {{ } =:A ij ψ i f dx ψ i aim: make matrix A sparse most A ij = 0 approach: local basis functions on a discretisation grid ψ j, ϕ j zero everywhere except in grid cells adjacent to grid point x j A ij = 0, if ψ i and ϕ j don t overlap Module 8: An Introduction to Finite Element Methods, Winter 2013/

13 Example Problem: 1D Poisson in 1D: u (x) = f (x) on Ω = (0, 1), hom. Dirichlet boundary cond.: u(0) = u(1) = 0 weak form: 1 v (x) u (x) dx = v(x)f (x) dx v computational grid: x i = ih, (for i = 1,..., n 1); mesh size h = 1/n V h = W h : piecewise linear functions (on intervals [x i, x i+1 ]) Module 8: An Introduction to Finite Element Methods, Winter 2013/

14 Nodal Basis 1 h (x x i 1) x i 1 < x < x i 1 ϕ i (x) := h (x i+1 x) x i < x < x i+1 0 otherwise 1 0,8 0,6 0,4 0, ,2 0,4 0,6 0,8 x Module 8: An Introduction to Finite Element Methods, Winter 2013/

15 Nodal Basis Derivatives and Integrals Compute derivative of basis functions: 1 h ϕ i (x) := x i 1 < x < x i 1 h x i < x < x i+1 0 otherwise Compute integrals of weak form: xi ϕ i (x)ϕ i (x) dx = 1 x i 1 h 1 xi+1 ( h dx + 1 ) ( 1 ) dx = 2 x i h h h xi+1 ( ϕ i (x)ϕ i+1 (x) dx = 1 ) 1 x i h h dx = 1 h ϕ i (x)ϕ i 1 (x) dx = 1 (same computation) h ϕ i (x)ϕ j (x) dx = 0 for all j i, i ± 1 (supports of basis functions do not overlap!) Module 8: An Introduction to Finite Element Methods, Winter 2013/

16 Nodal Basis System of Equations stiffness matrix: 1 h right hand sides (assume f (x) = α R): 1 ϕ i (x)f (x) dx = ϕ i (x)α dx = αh system of equations very similar to finite differences exercise: compute right-hand-side vector, if f (x) := f j φ j (x) Module 8: An Introduction to Finite Element Methods, Winter 2013/

17 Outlook: A Road to Theory weak formulation is equivalent to variational approach: solution u minimises an energy functional best approximation property: u uh FE inf u u h a a u h V in terms of the norm induced by the bilinear form a (energy norm) thus: error bounded by interpolation error (in energy norm) (details in lecture Numerical Programming II... ) Module 8: An Introduction to Finite Element Methods, Winter 2013/

18 Time-Dependent Problems Example: 1D Heat Equation u t = u xx + f on domain Ω = [0, 1] for t [0, t end ] spatial discretisation: weak form vu t dx = ) vu dx = ( t spatial discretisation finite elements: vu xx dx + vu xx dx + t (M hu h ) = A h u h + f h M h : mass matrix, A h : stiffness matrix, u h = u h (t) vf dx vf dx Module 8: An Introduction to Finite Element Methods, Winter 2013/

19 Time-Dependent Problems (2) Solve a system of ordinary differential equations: after spatial discretisation (M h constant): t M h (u h ) = A h u h + f h u h a vector of time-dependent functions: u h = (u 1 (t),..., u i (t),..., u n (t)) T usually: approximate M h by a simpler matrix (diagonal matrix, e.g.) mass lumping Module 8: An Introduction to Finite Element Methods, Winter 2013/

20 Part II: Implementation of Finite Element Methods Element Stiffness Matrices Element-Oriented Computation of Stiffness Matrices Example: 1D Poisson Example: 2D Poisson Typical Workflow Reference Elements and Stiffness Matrices Element-Oriented Computation on Unstructured Meshes Accumulation of Global Stiffness Matrix Simple Example: 1D Poisson Outlook: Extension to 2D and 3D Outlook: Further Components and Aspects of FEM Module 8: An Introduction to Finite Element Methods, Winter 2013/

21 Element Stiffness Matrices Finite Element methods are often used for complicated meshes: Questions: how to set up the system of equations efficiently? is it possible to use stencil notation?? Switch to element stiffness matrices! Module 8: An Introduction to Finite Element Methods, Winter 2013/

22 Element Stiffness Matrices (2) domain Ω subdivided into finite elements Ω (k) : Ω = Ω (1) Ω (2) Ω (n) observation: basis functions are defined element-wisely use: b a f (x) dx = c a f (x) dx + b f (x) dx c element-wise evaluation of the integrals: v u dx = Ω k Ω vf dx = k v u dx Ω (k) vf dx Ω (k) Module 8: An Introduction to Finite Element Methods, Winter 2013/

23 Element Stiffness Matrices (3) leads to local stiffness matrices for each element: φ i φ j dx Ω (k) } {{ } =:A (k) ij and respective element systems: A (k) x = b (k) accumulate to obtain global system: A (k) x = k k }{{} =:A b (k) Module 8: An Introduction to Finite Element Methods, Winter 2013/

24 Element Stiffness Matrices (4) Some comments on notation: assume: 1D problem, n elements (i.e. intervals) in each element only two basis functions are non-zero! hence, almost all A (k) ij are zero: A (k) ij = φ i φ j dx Ω (k) only 2 2 elements of A (k) are non-zero therefore convention to omit zero columns/rows leaves only unknowns that are in Ω (k) notation: write this matrix as Â(k) Module 8: An Introduction to Finite Element Methods, Winter 2013/

25 Example: 1D Poisson Ω = [0, 1] splitted into Ω (k) = [x k 1, x k ] nodal basis; leads to element stiffness matrix: ( ) Â (k) 1 1 = 1 1 consider case with only three unknowns (i.e., 3 basis functions): A (1) + A (2) = in stencil notation: [ 1 1 ] + [ 1 1 ] [ ] Module 8: An Introduction to Finite Element Methods, Winter 2013/

26 Example: 2D Poisson u = f on domain Ω = [0, 1] 2 splitted into Ω (i,j) = [x i 1, x i ] [x j 1, x j ] bilinear basis functions pagoda functions ϕ ij (x, y) = ϕ i (x)ϕ j (y) Module 8: An Introduction to Finite Element Methods, Winter 2013/

27 Example: 2D Poisson (2) leads to element stiffness matrix: Â (k) = accumulation leads to 9-point stencil exercise at home: compute Â(k) and assemble global matrix (and compare with stencil) Module 8: An Introduction to Finite Element Methods, Winter 2013/

28 Typical Workflow 1. choose elements: quadratic or cubic cells triangles (structured, unstructured) tetrahedra, etc. 2. set up basis functions for each element Ω (k) ; for example, at all nodes x i Ω (k) ϕ i (x i ) = 1 ϕ i (x j ) = 0 for all j i 3. for element stiffness matrix, compute all  (k) ij = ϕ i Lϕ j dω Ω (k) 4. accumulate global stiffness matrix A (and rhs) Module 8: An Introduction to Finite Element Methods, Winter 2013/

29 Element-Oriented Computation on Unstructured Meshes Recall: FEM often used for complicated meshes: (Re-)computation of element matrices required for each element? left grid: no (up to scaling with mesh size) right grid: yes? requires a closer look at the computation of element matrices Module 8: An Introduction to Finite Element Methods, Winter 2013/

30 Element Stiffness Matrices Notation Revisited recall notation for local stiffness matrices A (k) ij : A (k) ij = φ i (x) φ j (x) dx Ω (k) which basis functions φ i, φ j belong to element k? switch to element-local numbering of basis functions: Â (k) (k) µν = φµ (x) φ (k) ν (x) dx Ω (k) where φ (k) µ (x) = φ i (x) and φ (k) ν = φ j (x) in Ω (k) requires a mapping φ (k) µ φ i (and φ (k) ν φ j ), i.e., a function ι (k) with i = ι (k) (µ) and j = ι (k) (ν) Module 8: An Introduction to Finite Element Methods, Winter 2013/

31 Accumulation of Global Stiffness Matrix note the different dimensions of A (k) and Â(k) :  (k) omits zero rows and columns of A (k) formulated via a projection matrix: A (k) = ( P (k))t  (k) P (k) with P (k) µ,i := recall computation of global stiffness matrix: { 1 if i = ι (k) (µ) 0 otherwise A := k A (k) = k ( P (k) )T  (k) P (k) hence, for each element: 1. compute element stiffness matrix Â(k) 2. determine position of matrix elements Â(k) in A (k) based on mapping ι (k) (µ) 3. add non-zero elements of A (k) = ( P (k))t  (k) P (k) to global matrix A Module 8: An Introduction to Finite Element Methods, Winter 2013/

32 Element Stiffness Matrices and Meshes Recall our initial question: (Re-)computation of Â(k) required for each element? left grid: no (up to scaling with mesh size) right grid: yes? efficient computation of Â(k) via reference elements Module 8: An Introduction to Finite Element Methods, Winter 2013/

33 Simple Example: 1D Poisson Consider FEM for 1D Poisson on an adaptive grid: grid points given as x i, not necessarily equidistant; define elements Ω (k) = [x k, x k+1 ] piecewise linear basis functions ( hat functions ) φ i (x); φ i (x) non-zero only on two elements: Ω (i 1) and Ω (i) mapping local to global indices: ι (k) (1) := k and ι (k) (2) := k + 1 wanted: Â(k) µ,ν := Ω (k) x φ(k) µ (x) x φ(k) ν (x) dx for every element k Introduce reference element Ω ref with linear basis functions Φ µ : Φ 1 (ξ) := ξ Φ 2 (ξ) := 1 ξ ξ Ω ref := [0, 1] and a mapping x = χ (k) (ξ) for each Ω (k) defined as χ (k) (ξ) := x k + ξ(x k+1 x k ) such that φ (k) µ (x) = φ (k) ( µ χ (k) (ξ) ) := Φ µ (ξ) for x Ω (k). Module 8: An Introduction to Finite Element Methods, Winter 2013/

34 Simple Example: 1D Poisson (2) We need to compute  (k) µ,ν := x k+1 x k x φ(k) µ (x) x φ(k) ν (x) dx = Compare integration by substitution: g(b) g(a) χ (k) (1) χ (k) (0) x φ(k) µ (x) f (x) dx = x φ(k) ν (x) dx b f (g(t))g (t) dt 1  (k) ( µ,ν = x φ(k) µ χ (k) (ξ) ) ( x φ(k) ν χ (k) (ξ) ) (x k+1 x k ) dξ. 0 Note that: ξ χ k(ξ) = (x k+1 x k ) corresponds to the factor g (t) in the substitution rule we still have to deal with the partial derivatives in x Module 8: An Introduction to Finite Element Methods, Winter 2013/ a

35 Simple Example: 1D Poisson (3) We require the chain rule, f x = f g g x, to obtain: ( x φ(k) µ χ (k) (ξ) ) = x Φ µ(ξ) = ξ Φ µ(ξ) ξ x As x = χ (k) (ξ) := x k + ξ(x k+1 x k ), we have ξ = x x k and thus: x k+1 x k Finally, we get: ξ Φ µ(ξ) ξ x = ξ Φ 1 µ(ξ) x k+1 x k 1 Â (k) ( µ,ν = x φ(k) µ χ (k) (ξ) ) ( x φ(k) ν χ (k) (ξ) ) (x k+1 x k ) dξ = ξ Φ µ(ξ) ξ Φ 1 ν(ξ) (x k+1 x k ) 2 (x k+1 x k ) dξ. Module 8: An Introduction to Finite Element Methods, Winter 2013/

36 Simple Example: 1D Poisson (4) Altogether, element stiffness matrices are computed as: Â (k) µ,ν = 1 x k+1 x k 1 0 ξ Φ µ(ξ) ξ Φ ν(ξ) dξ With Φ 1 (ξ) = ξ and Φ 2 (ξ) = 1 ξ, we obtain that ( ) Â (k) = x k+1 x k 1 1 Observations: the integral values only depend on the reference element Ω ref = [0, 1] and the reference basis functions Φ µ, Φ ν all other element matrices are obtained by simple scaling we did not use that Φ µ, Φ ν are linear functions; same computation for more complicated basis functions! Module 8: An Introduction to Finite Element Methods, Winter 2013/

37 Outlook: Extension to 2D and 3D For 2D, 3D, etc., we require the multidimensional substitution rule: f (x, y, z) dω = f (x(ξ, η, ζ), y(ξ, η, ζ), z(ξ, η, ζ)) J dξ dη dζ Ω (k) Ω ref where J is the determinant of the Jacobian: x x x ξ η ζ J = y y y ξ η ζ z ξ z η and also the multidimensional chain rule. Result: similar, element-wise computation of stiffness matrices via reference elements Jacobian instead of factor 1 x k+1 x k ; more complicated, in general Module 8: An Introduction to Finite Element Methods, Winter 2013/ z ζ

38 Outlook: Further Components and Aspects of FEM Additional components and features of Finite Element Methods: mesh generation: structured/unstructured meshes consisting of triangles, tetrahedra, rectangles, cuboids, quadrilaterals, hexahedrals, prisms,... higher-order basis functions: polynomials of higher degree in various dimensions; nodal vs. spectral elements,... quadrature rules for integration: Gaussian quadrature, e.g., to compute integrals of weak forms; resp. choice of quadrature points for certain elements? solving the system of equations: e.g., set up a global system of equations explicitly, or work directly on element representation?... and many more... Module 8: An Introduction to Finite Element Methods, Winter 2013/

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

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

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

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

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

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

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

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

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

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

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

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

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

1. Differential Equations (ODE and PDE)

1. Differential Equations (ODE and PDE) 1. Differential Equations (ODE and PDE) 1.1. Ordinary Differential Equations (ODE) So far we have dealt with Ordinary Differential Equations (ODE): involve derivatives with respect to only one variable

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

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

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

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

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

Chapter 6. Finite Element Method. Literature: (tiny selection from an enormous number of publications)

Chapter 6. Finite Element Method. Literature: (tiny selection from an enormous number of publications) Chapter 6 Finite Element Method Literature: (tiny selection from an enormous number of publications) K.J. Bathe, Finite Element procedures, 2nd edition, Pearson 2014 (1043 pages, comprehensive). Available

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

[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

Part I. Discrete Models. Part I: Discrete Models. Scientific Computing I. Motivation: Heat Transfer. A Wiremesh Model (2) A Wiremesh Model

Part I. Discrete Models. Part I: Discrete Models. Scientific Computing I. Motivation: Heat Transfer. A Wiremesh Model (2) A Wiremesh Model Part I: iscrete Models Scientific Computing I Module 5: Heat Transfer iscrete and Continuous Models Tobias Neckel Winter 04/05 Motivation: Heat Transfer Wiremesh Model A Finite Volume Model Time ependent

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

Algorithms for Scientific Computing

Algorithms for Scientific Computing Algorithms for Scientific Computing Hierarchical Methods and Sparse Grids d-dimensional Hierarchical Basis Michael Bader Technical University of Munich Summer 208 Intermezzo/ Big Picture : Archimedes Quadrature

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

Introduction. J.M. Burgers Center Graduate Course CFD I January Least-Squares Spectral Element Methods

Introduction. J.M. Burgers Center Graduate Course CFD I January Least-Squares Spectral Element Methods Introduction In this workshop we will introduce you to the least-squares spectral element method. As you can see from the lecture notes, this method is a combination of the weak formulation derived from

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

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

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

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

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

Finite Difference Methods for Boundary Value Problems

Finite Difference Methods for Boundary Value Problems Finite Difference Methods for Boundary Value Problems October 2, 2013 () Finite Differences October 2, 2013 1 / 52 Goals Learn steps to approximate BVPs using the Finite Difference Method Start with two-point

More information

Chapter 2. General concepts. 2.1 The Navier-Stokes equations

Chapter 2. General concepts. 2.1 The Navier-Stokes equations Chapter 2 General concepts 2.1 The Navier-Stokes equations The Navier-Stokes equations model the fluid mechanics. This set of differential equations describes the motion of a fluid. In the present work

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

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

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

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

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

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

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

LECTURE NOTES ELEMENTARY NUMERICAL METHODS. Eusebius Doedel

LECTURE NOTES ELEMENTARY NUMERICAL METHODS. Eusebius Doedel LECTURE NOTES on ELEMENTARY NUMERICAL METHODS Eusebius Doedel TABLE OF CONTENTS Vector and Matrix Norms 1 Banach Lemma 20 The Numerical Solution of Linear Systems 25 Gauss Elimination 25 Operation Count

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

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

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

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

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

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

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

The Spectral-Element Method: Introduction

The Spectral-Element Method: Introduction The Spectral-Element Method: Introduction Heiner Igel Department of Earth and Environmental Sciences Ludwig-Maximilians-University Munich Computational Seismology 1 / 59 Outline 1 Introduction 2 Lagrange

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

Computational Methods for Engineering Applications II. Homework Problem Sheet 4

Computational Methods for Engineering Applications II. Homework Problem Sheet 4 S. Mishra K. O. Lye L. Scarabosio Autumn Term 2015 Computational Methods for Engineering Applications II ETH Zürich D-MATH Homework Problem Sheet 4 This assignment sheet contains some tasks marked as Core

More information

PIECEWISE LINEAR FINITE ELEMENT METHODS ARE NOT LOCALIZED

PIECEWISE LINEAR FINITE ELEMENT METHODS ARE NOT LOCALIZED PIECEWISE LINEAR FINITE ELEMENT METHODS ARE NOT LOCALIZED ALAN DEMLOW Abstract. Recent results of Schatz show that standard Galerkin finite element methods employing piecewise polynomial elements of degree

More information

Weak form of Boundary Value Problems. Simulation Methods in Acoustics

Weak form of Boundary Value Problems. Simulation Methods in Acoustics Weak form of Boundary Value Problems Simulation Methods in Acoustics Note on finite dimensional description of functions Approximation: N f (x) ˆf (x) = q j φ j (x) j=1 Residual function: r(x) = f (x)

More information

Space-time Finite Element Methods for Parabolic Evolution Problems

Space-time Finite Element Methods for Parabolic Evolution Problems Space-time Finite Element Methods for Parabolic Evolution Problems with Variable Coefficients Ulrich Langer, Martin Neumüller, Andreas Schafelner Johannes Kepler University, Linz Doctoral Program Computational

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

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

Hierarchical Parallel Solution of Stochastic Systems

Hierarchical Parallel Solution of Stochastic Systems Hierarchical Parallel Solution of Stochastic Systems Second M.I.T. Conference on Computational Fluid and Solid Mechanics Contents: Simple Model of Stochastic Flow Stochastic Galerkin Scheme Resulting Equations

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

Fast Sparse Spectral Methods for Higher Dimensional PDEs

Fast Sparse Spectral Methods for Higher Dimensional PDEs Fast Sparse Spectral Methods for Higher Dimensional PDEs Jie Shen Purdue University Collaborators: Li-Lian Wang, Haijun Yu and Alexander Alekseenko Research supported by AFOSR and NSF ICERM workshop, June

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

Conservation Laws & Applications

Conservation Laws & Applications Rocky Mountain Mathematics Consortium Summer School Conservation Laws & Applications Lecture V: Discontinuous Galerkin Methods James A. Rossmanith Department of Mathematics University of Wisconsin Madison

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

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

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

The Convergence of Mimetic Discretization

The Convergence of Mimetic Discretization The Convergence of Mimetic Discretization for Rough Grids James M. Hyman Los Alamos National Laboratory T-7, MS-B84 Los Alamos NM 87545 and Stanly Steinberg Department of Mathematics and Statistics University

More information

CONVERGENCE THEORY. G. ALLAIRE CMAP, Ecole Polytechnique. 1. Maximum principle. 2. Oscillating test function. 3. Two-scale convergence

CONVERGENCE THEORY. G. ALLAIRE CMAP, Ecole Polytechnique. 1. Maximum principle. 2. Oscillating test function. 3. Two-scale convergence 1 CONVERGENCE THEOR G. ALLAIRE CMAP, Ecole Polytechnique 1. Maximum principle 2. Oscillating test function 3. Two-scale convergence 4. Application to homogenization 5. General theory H-convergence) 6.

More information

Iterative methods for positive definite linear systems with a complex shift

Iterative methods for positive definite linear systems with a complex shift Iterative methods for positive definite linear systems with a complex shift William McLean, University of New South Wales Vidar Thomée, Chalmers University November 4, 2011 Outline 1. Numerical solution

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

Numerical Analysis and Methods for PDE I

Numerical Analysis and Methods for PDE I Numerical Analysis and Methods for PDE I A. J. Meir Department of Mathematics and Statistics Auburn University US-Africa Advanced Study Institute on Analysis, Dynamical Systems, and Mathematical Modeling

More information

SOLVING ELLIPTIC PDES

SOLVING ELLIPTIC PDES university-logo SOLVING ELLIPTIC PDES School of Mathematics Semester 1 2008 OUTLINE 1 REVIEW 2 POISSON S EQUATION Equation and Boundary Conditions Solving the Model Problem 3 THE LINEAR ALGEBRA PROBLEM

More information

Solving the steady state diffusion equation with uncertainty Final Presentation

Solving the steady state diffusion equation with uncertainty Final Presentation Solving the steady state diffusion equation with uncertainty Final Presentation Virginia Forstall vhfors@gmail.com Advisor: Howard Elman elman@cs.umd.edu Department of Computer Science May 6, 2012 Problem

More information

ACM/CMS 107 Linear Analysis & Applications Fall 2017 Assignment 2: PDEs and Finite Element Methods Due: 7th November 2017

ACM/CMS 107 Linear Analysis & Applications Fall 2017 Assignment 2: PDEs and Finite Element Methods Due: 7th November 2017 ACM/CMS 17 Linear Analysis & Applications Fall 217 Assignment 2: PDEs and Finite Element Methods Due: 7th November 217 For this assignment the following MATLAB code will be required: Introduction http://wwwmdunloporg/cms17/assignment2zip

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

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

8 A pseudo-spectral solution to the Stokes Problem

8 A pseudo-spectral solution to the Stokes Problem 8 A pseudo-spectral solution to the Stokes Problem 8.1 The Method 8.1.1 Generalities We are interested in setting up a pseudo-spectral method for the following Stokes Problem u σu p = f in Ω u = 0 in Ω,

More information

The Finite Element Method

The Finite Element Method Chapter 1 The Finite Element Method 1.1 Introduction This document provides a brief introduction to the finite element method and illustrates how the method is implemented in oomph-lib. The first few sections

More information

Block-Structured Adaptive Mesh Refinement

Block-Structured Adaptive Mesh Refinement Block-Structured Adaptive Mesh Refinement Lecture 2 Incompressible Navier-Stokes Equations Fractional Step Scheme 1-D AMR for classical PDE s hyperbolic elliptic parabolic Accuracy considerations Bell

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

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

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

Key words. preconditioned conjugate gradient method, saddle point problems, optimal control of PDEs, control and state constraints, multigrid method

Key words. preconditioned conjugate gradient method, saddle point problems, optimal control of PDEs, control and state constraints, multigrid method PRECONDITIONED CONJUGATE GRADIENT METHOD FOR OPTIMAL CONTROL PROBLEMS WITH CONTROL AND STATE CONSTRAINTS ROLAND HERZOG AND EKKEHARD SACHS Abstract. Optimality systems and their linearizations arising in

More information

The Discontinuous Galerkin Method for Hyperbolic Problems

The Discontinuous Galerkin Method for Hyperbolic Problems Chapter 2 The Discontinuous Galerkin Method for Hyperbolic Problems In this chapter we shall specify the types of problems we consider, introduce most of our notation, and recall some theory on the DG

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

Sparse Linear Systems. Iterative Methods for Sparse Linear Systems. Motivation for Studying Sparse Linear Systems. Partial Differential Equations

Sparse Linear Systems. Iterative Methods for Sparse Linear Systems. Motivation for Studying Sparse Linear Systems. Partial Differential Equations Sparse Linear Systems Iterative Methods for Sparse Linear Systems Matrix Computations and Applications, Lecture C11 Fredrik Bengzon, Robert Söderlund We consider the problem of solving the linear system

More information

A Discontinuous Galerkin Moving Mesh Method for Hamilton-Jacobi Equations

A Discontinuous Galerkin Moving Mesh Method for Hamilton-Jacobi Equations Int. Conference on Boundary and Interior Layers BAIL 6 G. Lube, G. Rapin Eds c University of Göttingen, Germany, 6 A Discontinuous Galerkin Moving Mesh Method for Hamilton-Jacobi Equations. Introduction

More information

Implementation of test scenarios for incompressible flow using a divergence free finite element approach

Implementation of test scenarios for incompressible flow using a divergence free finite element approach Bachelor s Thesis Implementation of test scenarios for incompressible flow using a divergence free finite element approach Author: Benjamin Rüth Maistraße 54 8337 München Field of Studies: Informatics,

More information

Finite Element Method-Part II Isoparametric FE Formulation and some numerical examples Lecture 29 Smart and Micro Systems

Finite Element Method-Part II Isoparametric FE Formulation and some numerical examples Lecture 29 Smart and Micro Systems Finite Element Method-Part II Isoparametric FE Formulation and some numerical examples Lecture 29 Smart and Micro Systems Introduction Till now we dealt only with finite elements having straight edges.

More information

Divergence Formulation of Source Term

Divergence Formulation of Source Term Preprint accepted for publication in Journal of Computational Physics, 2012 http://dx.doi.org/10.1016/j.jcp.2012.05.032 Divergence Formulation of Source Term Hiroaki Nishikawa National Institute of Aerospace,

More information

Nodal O(h 4 )-superconvergence of piecewise trilinear FE approximations

Nodal O(h 4 )-superconvergence of piecewise trilinear FE approximations Preprint, Institute of Mathematics, AS CR, Prague. 2007-12-12 INSTITTE of MATHEMATICS Academy of Sciences Czech Republic Nodal O(h 4 )-superconvergence of piecewise trilinear FE approximations Antti Hannukainen

More information

Preconditioned space-time boundary element methods for the heat equation

Preconditioned space-time boundary element methods for the heat equation W I S S E N T E C H N I K L E I D E N S C H A F T Preconditioned space-time boundary element methods for the heat equation S. Dohr and O. Steinbach Institut für Numerische Mathematik Space-Time Methods

More information

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

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

SINC PACK, and Separation of Variables

SINC PACK, and Separation of Variables SINC PACK, and Separation of Variables Frank Stenger Abstract This talk consists of a proof of part of Stenger s SINC-PACK computer package (an approx. 400-page tutorial + about 250 Matlab programs) that

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

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

Concepts. 3.1 Numerical Analysis. Chapter Numerical Analysis Scheme

Concepts. 3.1 Numerical Analysis. Chapter Numerical Analysis Scheme Chapter 3 Concepts The objective of this work is to create a framework to implement multi-disciplinary finite element applications. Before starting, it is necessary to explain some basic concepts of the

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

Yongdeok Kim and Seki Kim

Yongdeok Kim and Seki Kim J. Korean Math. Soc. 39 (00), No. 3, pp. 363 376 STABLE LOW ORDER NONCONFORMING QUADRILATERAL FINITE ELEMENTS FOR THE STOKES PROBLEM Yongdeok Kim and Seki Kim Abstract. Stability result is obtained for

More information

Semi-Lagrangian Formulations for Linear Advection Equations and Applications to Kinetic Equations

Semi-Lagrangian Formulations for Linear Advection Equations and Applications to Kinetic Equations Semi-Lagrangian Formulations for Linear Advection and Applications to Kinetic Department of Mathematical and Computer Science Colorado School of Mines joint work w/ Chi-Wang Shu Supported by NSF and AFOSR.

More information