Numerical Solution I

Size: px
Start display at page:

Download "Numerical Solution I"

Transcription

1 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

2 Schedule Classical Solutions (Finite Differences) The Conservation Principle (Finite Volumes) Principle of Minimal Energy (Finite Elements) Adaptive Finite Elements (Fast) Solvers for Linear Systems Random Partial Differential Equations

3 Saturated Groundwater Flow (Darcy Equation) p: pressure S 0 p t = div(k p)+f S 0 = ρg n p 0: specific storage coefficient K = (K 1,K 2,K 3 ) : Ω R 3,3 : hydraulic permeability f = ρgdivk 3 +gf: gravity and source terms

4 Darcy s equation: Darcy s and Poisson s Equation S 0 = 0: pressure-stable granular structure Poisson s equation: div(k p) = f K R 3,3 constant: K p(x) = p(kx) transformation of variables: p(x) p(kx) =: u(x) u = f Laplace operator: u = 3 i=1 u x i x i = u x1 x 1 +u x2 x 2 +u x3 x 3

5 Darcy s and Poisson s Equation Darcy s equation: S 0 = 0: pressure-stable granular structure div(k p) = f Poisson s equation: homogeneous soil: K R 3,3 K p(x) = p(kx) transformation of variables: p(x) p(kx) =: u(x) u = f Laplace operator: u = 3 i=1 u x i x i = u x1 x 1 +u x2 x 2 +u x3 x 3

6 Classical Solution of Poisson s Equation Poisson s equation: Ω R d (bounded domain) u = f on Ω + boundary conditions on Ω boundary conditions (BC): u = g pressure BC (Dirichlet BC, 1. kind) αu+β nu = g transmission BC (Robin BC, 3. kind) Theorem (well-posedness) Assumption: Ω, f, g sufficiently smooth. Assertion: There exists a unique solution u C 2 (Ω) C(Ω) and u depends continuously on f, g.

7 flux boundary conditions: Ill-Posed Problems n u = g outflow BC (Neumann BC, 2. kind) no uniqueness: u solution = u+c solution for all c R necessary for existence: Ω f dx+ Ω g dσ = 0 (Green s formula) different BCs on disjoint subsets Γ D Γ N Γ R = Ω allowed Caution: Γ D too small, e.g. Γ D = {x 0,x 1,..,x m }, no uniqueness!!

8 flux boundary conditions: Ill-Posed Problems n u = g outflow BC (Neumann BC, 2. kind) no uniqueness: u solution = u+c solution for all c R necessary for existence: Ω f dx+ Ω g dσ = 0 (Green s formula) different BCs on disjoint subsets Γ D Γ N Γ R = Ω allowed Caution: Γ D too small, e.g. Γ D = {x 0,x 1,..,x m }, no uniqueness!!

9 flux boundary conditions: Ill-Posed Problems n u = g outflow BC (Neumann BC, 2. kind) no uniqueness: u solution = u+c solution for all c R necessary for existence: Ω f dx+ Ω g dσ = 0 (Green s formula) different BCs on disjoint subsets Γ D Γ N Γ R = Ω allowed Caution: Γ D too small, e.g. Γ D = {x 0,x 1,..,x m }, no uniqueness!!

10 rectangular mesh with mesh size h: Finite Differences Ω h Ω h o

11 Finite Difference Approximations x N 1. order forward and backward: x W x Z x O D + 1 U(x Z) = U(x O) U(x Z ) x O x Z x S D 1 U(x Z) = U(x Z) U(x W ) x Z x W δω 2. order central finite differences: ( 2 D 11 U(x Z ) = x O x W D + 1 U(x Z ) D1 U(x Z) )

12 Finite Difference Discretization (Shortley/Weller) discrete Laplacian: h U(x) = D 11 U(x)+D 22 U(x) discrete problem: h U = f on Ω h, U(x) = g on Ω h linear system: A FD U = b Theorem (Convergence): Assumption: u C 3 (Ω). Assertion: max U(x) u(x) = O(h) x Ω h

13 piecewise constant permeabilities: Heterogeneous Media K = { k1 x Ω 1 k 2 x Ω 2 Ω = Ω 1 Ω 2 Γ no classical solution of: div(k u) = f on Ω finite difference discretizations lead to interface problems interface problems require finite difference approximations of flux across the interface

14 piecewise constant permeabilities: Heterogeneous Media K = { k1 x Ω 1 k 2 x Ω 2 Ω = Ω 1 Ω 2 Γ no classical solution of: div(k u) = f on Ω finite difference discretizations lead to interface problems interface problems require finite difference approximations of flux across the interface

15 Conservation Principle conservation of mass in Ω Ω: K(x) u(x) dσ + f(x) dx = 0 Ω n Ω regularity condition: K u C 1 (Ω) d Green s formula: K(x) Ω n Ω u(x) dσ = div(k(x) u(x)) 1 dx+ K(x) u(x) 1 dx Ω Darcy s equation: Ω div(k(x) u(x))+f(x) dx = 0 Ω Ω

16 Finite Volumes finite dimensional ansatz space: S h, dim S h = n, v Ω = 0 v S h finite decomposition of Ω into control volumes Ω i : Ω = n i=1 Ω i finite volume discretization: u h S h : K n u h dσ = f dx i = 1,...,n Ω i Ω i linear system: choice of basis: S h = span{ϕ i i = 1,...,n} Au h = b, a ij = K n ϕ j dσ, b i = f dx Ω i Ω i solution: u h = n i=1 u iϕ i, u h = (u i )

17 Choice of Ansatz Space triangulation: T h = {T T triangle}, Ω = T T h T p q linear finite elements: S h := {v C(Ω) v T linear T T h, v Ω = 0} nodal basis: λ p (q) = δ p,q, p,q N h

18 Vertex-Centered Finite Volumes control volumes: linear connection of barycenters Ω p p linear system: A FV u h = b FV, u h = p N h u p λ p

19 Principle of Minimal Energy quadratic energy functional: J(v) = 1 2 a(v,v) l(v), minimization problem: a(v,w) = Ω K v w dx, l(v) = Ω fv dx variational formulation: u H 1 0(Ω) : J(u) J(v) v H 1 0(Ω) u H 1 0(Ω) : J (u)(v) = a(u,v) l(v) = 0 v H 1 0(Ω) weak solution u H 1 0(Ω) (Sobolev space)

20 Weak Versus Classical Solution regularity condition: K u C 1 (Ω) d Green s formula: 0 = a(u,v) l(v) = Ω (div(k u)+f)v dx+ Ω ( K n u) v dσ suitable choice of test functions v C 1 0(Ω): div(k u) = f on Ω

21 Ritz-Galerkin Method finite dimensional ansatz space: S h H 1 0(Ω), dim S h = n Ritz-Galerkin method linear system: u h S h : J (u h )(v) = a(u h,v) l(v) = 0 v S h choice of basis: S h = span{ϕ i i = 1,...,n} Au h = b, a ij = a(ϕ j,ϕ i ), b i = l(ϕ i ) solution: u h = n i=1 u iϕ i, u h = (u i )

22 Finite Element Discretization triangulation: T h = {T T triangle}, Ω = T T h T p q linear finite elements: S h := {v C(Ω) v T linear T T h, v Ω = 0} nodal basis: λ p (q) = δ p,q, p,q N h linear system: A FE u h = b FE

23 Finite Elements Versus Finite Volumes Theorem (Hackbusch 89) A FV = A FE, b FV b FE 1 = O(h 2 ) Corollary: u FV h u FE h 1 = O(h 2 ), v 2 1 = Ω v 2 + v 2 dx in general: finite volumes: finite element discretization with suitable test functions finite elements: finite volume discretization with suitable numerical flux

24 Stability maximum principle: u 1 = f 1, u 2 = f 2 on Ω, u 1 = u 2 = 0 on Ω no discrete maximum principle: f 1 f 2 = u 1 u 2 A FE u 1 = b FE 1, A FE u 2 = b FE 2 b FE 1 b FE 2 u 1 u 2 bad angles of triangles might cause oscillations! remedy: Delaunay triangulation T h

25 Stability maximum principle: u 1 = f 1, u 2 = f 2 on Ω, u 1 = u 2 = 0 on Ω no discrete maximum principle: f 1 f 2 = u 1 u 2 A FE u 1 = b FE 1, A FE u 2 = b FE 2 b FE 1 b FE 2 u 1 u 2 bad angles of triangles might cause oscillations! remedy: Delaunay triangulation T h

26 Stability maximum principle: u 1 = f 1, u 2 = f 2 on Ω, u 1 = u 2 = 0 on Ω no discrete maximum principle: f 1 f 2 = u 1 u 2 A FE u 1 = b FE 1, A FE u 2 = b FE 2 b FE 1 b FE 2 u 1 u 2 bad angles of triangles might cause oscillations! remedy: Delaunay triangulation T h

27 Stability maximum principle: u 1 = f 1, u 2 = f 2 on Ω, u 1 = u 2 = 0 on Ω no discrete maximum principle: f 1 f 2 = u 1 u 2 A FE u 1 = b FE 1, A FE u 2 = b FE 2 b FE 1 b FE 2 = u 1 u 2 bad angles of triangles might cause oscillations! remedy: Delaunay triangulation T h

28 Discretization Error Galerkin orthogonality: a(u u h,v) = 0 v S optimal error estimate: u u h = inf v S h u v, v 2 = a(v,v) (energy norm) ellipticity: α v 1 v β v 1, α,β > 0, v H 1 0(Ω) quasioptimal error estimate: u u h 1 β α inf v S h u v 1 estimate of the discretization error inf u v 1 c u 2 h = O(h), c = c(t h ) v S h

29 Adaptive Multilevel Methods Mesh T := T 0 Local refinement T := Ref (T ) no Discretization w.r.t. T Multigrid solution Error < TOL yes coarse grid generator finite element discretisation (iterative) algebraic solver a posteriori error estimate local refinement indicators local marking and refinement strategy quasioptimal error estimate: u u j 1 cn 1/d j

30 Adaptive Multilevel Methods Mesh T := T 0 Local refinement T := Ref (T ) no Discretization w.r.t. T Multigrid solution Error < TOL yes coarse grid generator finite element discretisation (iterative) algebraic solver a posteriori error estimate local refinement indicators local marking and refinement strategy quasioptimal error estimate: u u j 1 cn 1/d j

31 Phase Transition

32 Hierarchical A Posteriori Error Estimators extended ansatz space: Q h = S V h (hopefully) better discretization: u Q h Q h : a(u Q h,v) = l(v) v Q h basic idea: u Q h u h 1 u u h 1 algorithmic realization: basis of V h : V h = span{µ e e E h } (quadratic bubbles) weighted residuals: η e = r(µ e) a(µ e,µ e ), r(µ e) = l(µ e ) a(µ e,µ e ), e E h Theorem (Deuflhard, Leinen & Yserentant 88) The saturation assumption: u u Q h 1 q u u h 1, q < 1, implies the error bounds: cη u u h 1 Cη, η = e E h η e

33 Adaptive Refinement Strategy local errors have local origin (wrong for transport equations!): η e θ = mark all T with T e for red refinement! e e green closures:

34 Stable Refinement in 3D red refinement: What to do with the remaining octahedron? Learn from crystallography (Bey 91)!

35 Stable Refinement in 3D red refinement: What to do with the remaining octahedron? Learn from crystallography (Bey 91)!

36 Linear Algebraic Solvers stiffness matrix A = (a(λ p,λ q )) p,q Nh A is symmetric, positive definite and sparse condition number: 1 o(1) κ(a) = λ max(a) λ min (A) O(h 2 ) A is arbitrarily ill-conditioned for h 0 Corollary: Use iterative solvers for small h or, equivalently, large n (n )

37 Conjugate Gradient (CG) Iteration Underlying idea: inductive construction of an A-orthogonal basis of R n Algorithm (Hestenes und Stiefel, 1952) initialization: U 0 R n, r 0 = b AU 0, e 0 = r 0 iteration: U k+1 = U k +α k e k, α k = r k,r k e k,ae k update: r k r k+1, e k e k+1 error estimate: U U k 2ρ k U U 0, ρ = κ(a) 1 κ(a)+1 Corollary: Slow convergence for κ(a) 1 Vorkonditionierer: B leicht invertierbar, κ(b 1 A) κ(a)

38 Preconditioned Conjugate Gradient (CG) Iteration Underlying idea: inductive construction of an A-orthogonal basis of R n Algorithm (Hestenes und Stiefel 1952) initialization: U 0 R n, r 0 = B(b AU 0 ), e 0 = r 0 iteration: U k+1 = U k +α k e k, α k = r k,br k e k,ae k update: r k r k+1, e k e k+1 error estimate: U U k 2ρ k U U 0, ρ = κ(ba) 1 κ(ba)+1 Corollary: Fast convergence for κ(ba) 1 preconditioner B: optimal complexity O(n j ) and B A 1

39 Subspace Correction Methods basic idea: solve many small problems instead of one large problem subspace decomposition: S h = V 0 +V 1 + +V m Algorithm (sucessive subspace correction) Xu 92 w 1 = u k v l V l : a(v l,v) = l(v) a(w l 1,v) v V l w l = w l 1 +v l u k+1 = w m Gauß-Seidel iteration: V p = span{λ p } ρ h = 1 O(h 2 ) Jacobi-iteration: parallel subspace correction ρ h = 1 O(h 2 ) domain decomposition, multigrid,... ρ h ρ < 1 BPXW 93

40 Multigrid Methods hierarchy of grids (adaptive refinement!): T 0 T 1 T j = T h hierarchy of frequencies: S 0 S 1 S j = S h λ (k) p λ (j) p multilevel decomposition: S h = j k=0 p N k V p (k), V (k) p = span{λ (k) p } multigrid method with Gauß-Seidel smoothing and Galerkin restriction

41 Poisson s Equation on the Unit Square Ω = (0,1) (0,1), f 1, V(1,0) cycle, symmetric Gauß-Seidel smoother coarse grid T 0 approximate solution convergence rates: j=2 j=3 j=4 j=5 j=6 j=7 ρ j

42 Approximation History (L-Shaped Domain) levels nodes iterations est. error est. error/n 1/2 j

43 Uncertain Data uncertainty of permeability, source terms, boundary conditions,... by lack of sufficiently accurate measurements by external sources random Darcy equation: S 0 p t (t,x,θ) = div(k(x,θ) p(t,x,θ))+f(x,θ), θ Θ, probability space (Θ,A,P).

44 Random Partial Differential Equations random Darcy equation: S 0 p t (t,x,θ) = div(k(x,θ) p(t,x,θ))+f(x,θ) desired statistics of solutions: expectation value E[p] := Θ pdp variance E[(p E[p]) 2 ] probability of particular events P[ p(t,x,θ)dx < 0 for t < 1] Ω

45 Numerical Approximation of Random PDEs Monte-Carlo Method: (i) generate N independent, P-equidistributed samples θ 1,...,θ N. (ii) compute approximations of the N solutions for the samples θ 1,...,θ N. (iii) compute the corresponding expectation value, variance,... advantage: always feasible and simple disadvantage: convergence rate 1 N = N has to be very large multilevel Monte Carlo methods: solve stochastic problems with deterministic computational cost

46 Numerical Approximation of Random PDEs Monte-Carlo Method: (i) generate N independent, P-equidistributed samples θ 1,...,θ N. (ii) compute approximations of the N solutions for the samples θ 1,...,θ N. (iii) compute the corresponding expectation value, variance,... advantage: always feasible and simple disadvantage: convergence rate 1 N = N has to be very large Multilevel Monte Carlo methods: solve random PDEs with almost deterministic computational cost!

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

On Multigrid for Phase Field

On Multigrid for Phase Field On Multigrid for Phase Field Carsten Gräser (FU Berlin), Ralf Kornhuber (FU Berlin), Rolf Krause (Uni Bonn), and Vanessa Styles (University of Sussex) Interphase 04 Rome, September, 13-16, 2004 Synopsis

More information

1. Fast Iterative Solvers of SLE

1. Fast Iterative Solvers of SLE 1. Fast Iterative Solvers of crucial drawback of solvers discussed so far: they become slower if we discretize more accurate! now: look for possible remedies relaxation: explicit application of the multigrid

More information

On Nonlinear Dirichlet Neumann Algorithms for Jumping Nonlinearities

On Nonlinear Dirichlet Neumann Algorithms for Jumping Nonlinearities On Nonlinear Dirichlet Neumann Algorithms for Jumping Nonlinearities Heiko Berninger, Ralf Kornhuber, and Oliver Sander FU Berlin, FB Mathematik und Informatik (http://www.math.fu-berlin.de/rd/we-02/numerik/)

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

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

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

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

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

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

Constrained Minimization and Multigrid

Constrained Minimization and Multigrid Constrained Minimization and Multigrid C. Gräser (FU Berlin), R. Kornhuber (FU Berlin), and O. Sander (FU Berlin) Workshop on PDE Constrained Optimization Hamburg, March 27-29, 2008 Matheon Outline Successive

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

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

Multigrid finite element methods on semi-structured triangular grids

Multigrid finite element methods on semi-structured triangular grids XXI Congreso de Ecuaciones Diferenciales y Aplicaciones XI Congreso de Matemática Aplicada Ciudad Real, -5 septiembre 009 (pp. 8) Multigrid finite element methods on semi-structured triangular grids F.J.

More information

Algebraic Multigrid as Solvers and as Preconditioner

Algebraic Multigrid as Solvers and as Preconditioner Ò Algebraic Multigrid as Solvers and as Preconditioner Domenico Lahaye domenico.lahaye@cs.kuleuven.ac.be http://www.cs.kuleuven.ac.be/ domenico/ Department of Computer Science Katholieke Universiteit Leuven

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

INTRODUCTION TO MULTIGRID METHODS

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

More information

INTRODUCTION TO FINITE ELEMENT METHODS ON ELLIPTIC EQUATIONS LONG CHEN

INTRODUCTION TO FINITE ELEMENT METHODS ON ELLIPTIC EQUATIONS LONG CHEN INTROUCTION TO FINITE ELEMENT METHOS ON ELLIPTIC EQUATIONS LONG CHEN CONTENTS 1. Poisson Equation 1 2. Outline of Topics 3 2.1. Finite ifference Method 3 2.2. Finite Element Method 3 2.3. Finite Volume

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

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

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

A MULTILEVEL SUCCESSIVE ITERATION METHOD FOR NONLINEAR ELLIPTIC PROBLEMS

A MULTILEVEL SUCCESSIVE ITERATION METHOD FOR NONLINEAR ELLIPTIC PROBLEMS MATHEMATICS OF COMPUTATION Volume 73, Number 246, Pages 525 539 S 0025-5718(03)01566-7 Article electronically published on July 14, 2003 A MULTILEVEL SUCCESSIVE ITERATION METHOD FOR NONLINEAR ELLIPTIC

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

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

Capacitance Matrix Method

Capacitance Matrix Method Capacitance Matrix Method Marcus Sarkis New England Numerical Analysis Day at WPI, 2019 Thanks to Maksymilian Dryja, University of Warsaw 1 Outline 1 Timeline 2 Capacitance Matrix Method-CMM 3 Applications

More information

ITERATIVE METHODS BASED ON KRYLOV SUBSPACES

ITERATIVE METHODS BASED ON KRYLOV SUBSPACES ITERATIVE METHODS BASED ON KRYLOV SUBSPACES LONG CHEN We shall present iterative methods for solving linear algebraic equation Au = b based on Krylov subspaces We derive conjugate gradient (CG) method

More information

Goal-oriented error control of the iterative solution of finite element equations

Goal-oriented error control of the iterative solution of finite element equations J. Numer. Math., Vol. 0, No. 0, pp. 1 31 (2009) DOI 10.1515/ JNUM.2009.000 c de Gruyter 2009 Prepared using jnm.sty [Version: 20.02.2007 v1.3] Goal-oriented error control of the iterative solution of finite

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

One-dimensional and nonlinear problems

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

More information

The Discontinuous Galerkin Finite Element Method

The Discontinuous Galerkin Finite Element Method The Discontinuous Galerkin Finite Element Method Michael A. Saum msaum@math.utk.edu Department of Mathematics University of Tennessee, Knoxville The Discontinuous Galerkin Finite Element Method p.1/41

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

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

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

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

Aspects of Multigrid

Aspects of Multigrid Aspects of Multigrid Kees Oosterlee 1,2 1 Delft University of Technology, Delft. 2 CWI, Center for Mathematics and Computer Science, Amsterdam, SIAM Chapter Workshop Day, May 30th 2018 C.W.Oosterlee (CWI)

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

The Conjugate Gradient Method

The Conjugate Gradient Method The Conjugate Gradient Method Classical Iterations We have a problem, We assume that the matrix comes from a discretization of a PDE. The best and most popular model problem is, The matrix will be as large

More information

A MULTIGRID ALGORITHM FOR. Richard E. Ewing and Jian Shen. Institute for Scientic Computation. Texas A&M University. College Station, Texas SUMMARY

A MULTIGRID ALGORITHM FOR. Richard E. Ewing and Jian Shen. Institute for Scientic Computation. Texas A&M University. College Station, Texas SUMMARY A MULTIGRID ALGORITHM FOR THE CELL-CENTERED FINITE DIFFERENCE SCHEME Richard E. Ewing and Jian Shen Institute for Scientic Computation Texas A&M University College Station, Texas SUMMARY In this article,

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

An additive average Schwarz method for the plate bending problem

An additive average Schwarz method for the plate bending problem J. Numer. Math., Vol. 10, No. 2, pp. 109 125 (2002) c VSP 2002 Prepared using jnm.sty [Version: 02.02.2002 v1.2] An additive average Schwarz method for the plate bending problem X. Feng and T. Rahman Abstract

More information

Scientific Computing I

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

More information

Xingye Yue. Soochow University, Suzhou, China.

Xingye Yue. Soochow University, Suzhou, China. Relations between the multiscale methods p. 1/30 Relationships beteween multiscale methods for elliptic homogenization problems Xingye Yue Soochow University, Suzhou, China xyyue@suda.edu.cn Relations

More information

Goal-oriented error control of the iterative solution of finite element equations

Goal-oriented error control of the iterative solution of finite element equations J. Numer. Math., Vol. 17, No. 2, pp. 143 172 (2009) DOI 10.1515/ JNUM.2009.009 c de Gruyter 2009 Goal-oriented error control of the iterative solution of finite element equations D. MEIDNER, R. RANNACHER,

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

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

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

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

A Robust Preconditioner for the Hessian System in Elliptic Optimal Control Problems

A Robust Preconditioner for the Hessian System in Elliptic Optimal Control Problems A Robust Preconditioner for the Hessian System in Elliptic Optimal Control Problems Etereldes Gonçalves 1, Tarek P. Mathew 1, Markus Sarkis 1,2, and Christian E. Schaerer 1 1 Instituto de Matemática Pura

More information

Preface to the Second Edition. Preface to the First Edition

Preface to the Second Edition. Preface to the First Edition n page v Preface to the Second Edition Preface to the First Edition xiii xvii 1 Background in Linear Algebra 1 1.1 Matrices................................. 1 1.2 Square Matrices and Eigenvalues....................

More information

Stabilization and Acceleration of Algebraic Multigrid Method

Stabilization and Acceleration of Algebraic Multigrid Method Stabilization and Acceleration of Algebraic Multigrid Method Recursive Projection Algorithm A. Jemcov J.P. Maruszewski Fluent Inc. October 24, 2006 Outline 1 Need for Algorithm Stabilization and Acceleration

More information

Mathematics Research Report No. MRR 003{96, HIGH RESOLUTION POTENTIAL FLOW METHODS IN OIL EXPLORATION Stephen Roberts 1 and Stephan Matthai 2 3rd Febr

Mathematics Research Report No. MRR 003{96, HIGH RESOLUTION POTENTIAL FLOW METHODS IN OIL EXPLORATION Stephen Roberts 1 and Stephan Matthai 2 3rd Febr HIGH RESOLUTION POTENTIAL FLOW METHODS IN OIL EXPLORATION Stephen Roberts and Stephan Matthai Mathematics Research Report No. MRR 003{96, Mathematics Research Report No. MRR 003{96, HIGH RESOLUTION POTENTIAL

More information

INTERGRID OPERATORS FOR THE CELL CENTERED FINITE DIFFERENCE MULTIGRID ALGORITHM ON RECTANGULAR GRIDS. 1. Introduction

INTERGRID OPERATORS FOR THE CELL CENTERED FINITE DIFFERENCE MULTIGRID ALGORITHM ON RECTANGULAR GRIDS. 1. Introduction Trends in Mathematics Information Center for Mathematical Sciences Volume 9 Number 2 December 2006 Pages 0 INTERGRID OPERATORS FOR THE CELL CENTERED FINITE DIFFERENCE MULTIGRID ALGORITHM ON RECTANGULAR

More information

Introduction to Aspects of Multiscale Modeling as Applied to Porous Media

Introduction to Aspects of Multiscale Modeling as Applied to Porous Media Introduction to Aspects of Multiscale Modeling as Applied to Porous Media Part IV Todd Arbogast Department of Mathematics and Center for Subsurface Modeling, Institute for Computational Engineering and

More information

The Mortar Boundary Element Method

The Mortar Boundary Element Method The Mortar Boundary Element Method A Thesis submitted for the degree of Doctor of Philosophy by Martin Healey School of Information Systems, Computing and Mathematics Brunel University March 2010 Abstract

More information

An Adaptive Mixed Finite Element Method using the Lagrange Multiplier Technique

An Adaptive Mixed Finite Element Method using the Lagrange Multiplier Technique An Adaptive Mixed Finite Element Method using the Lagrange Multiplier Technique by Michael Gagnon A Project Report Submitted to the Faculty of the WORCESTER POLYTECHNIC INSTITUTE In partial fulfillment

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

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

A Framework for Analyzing and Constructing Hierarchical-Type A Posteriori Error Estimators

A Framework for Analyzing and Constructing Hierarchical-Type A Posteriori Error Estimators A Framework for Analyzing and Constructing Hierarchical-Type A Posteriori Error Estimators Jeff Ovall University of Kentucky Mathematics www.math.uky.edu/ jovall jovall@ms.uky.edu Kentucky Applied and

More information

Solving PDEs with Multigrid Methods p.1

Solving PDEs with Multigrid Methods p.1 Solving PDEs with Multigrid Methods Scott MacLachlan maclachl@colorado.edu Department of Applied Mathematics, University of Colorado at Boulder Solving PDEs with Multigrid Methods p.1 Support and Collaboration

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

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

Multigrid Methods for Elliptic Obstacle Problems on 2D Bisection Grids

Multigrid Methods for Elliptic Obstacle Problems on 2D Bisection Grids Multigrid Methods for Elliptic Obstacle Problems on 2D Bisection Grids Long Chen 1, Ricardo H. Nochetto 2, and Chen-Song Zhang 3 1 Department of Mathematics, University of California at Irvine. chenlong@math.uci.edu

More information

Geometric Multigrid Methods

Geometric Multigrid Methods Geometric Multigrid Methods Susanne C. Brenner Department of Mathematics and Center for Computation & Technology Louisiana State University IMA Tutorial: Fast Solution Techniques November 28, 2010 Ideas

More information

Multigrid Methods and their application in CFD

Multigrid Methods and their application in CFD Multigrid Methods and their application in CFD Michael Wurst TU München 16.06.2009 1 Multigrid Methods Definition Multigrid (MG) methods in numerical analysis are a group of algorithms for solving differential

More information

VARIATIONAL AND NON-VARIATIONAL MULTIGRID ALGORITHMS FOR THE LAPLACE-BELTRAMI OPERATOR.

VARIATIONAL AND NON-VARIATIONAL MULTIGRID ALGORITHMS FOR THE LAPLACE-BELTRAMI OPERATOR. VARIATIONAL AND NON-VARIATIONAL MULTIGRID ALGORITHMS FOR THE LAPLACE-BELTRAMI OPERATOR. ANDREA BONITO AND JOSEPH E. PASCIAK Abstract. We design and analyze variational and non-variational multigrid algorithms

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

New class of finite element methods: weak Galerkin methods

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

More information

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

Optimal Left and Right Additive Schwarz Preconditioning for Minimal Residual Methods with Euclidean and Energy Norms

Optimal Left and Right Additive Schwarz Preconditioning for Minimal Residual Methods with Euclidean and Energy Norms Optimal Left and Right Additive Schwarz Preconditioning for Minimal Residual Methods with Euclidean and Energy Norms Marcus Sarkis Worcester Polytechnic Inst., Mass. and IMPA, Rio de Janeiro and Daniel

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

Lecture 18 Classical Iterative Methods

Lecture 18 Classical Iterative Methods Lecture 18 Classical Iterative Methods MIT 18.335J / 6.337J Introduction to Numerical Methods Per-Olof Persson November 14, 2006 1 Iterative Methods for Linear Systems Direct methods for solving Ax = b,

More information

Institut für Mathematik

Institut für Mathematik U n i v e r s i t ä t A u g s b u r g Institut für Mathematik Xuejun Xu, Huangxin Chen, Ronald H.W. Hoppe Local Multilevel Methods for Adaptive Nonconforming Finite Element Methods Preprint Nr. 21/2009

More information

Adaptive algebraic multigrid methods in lattice computations

Adaptive algebraic multigrid methods in lattice computations Adaptive algebraic multigrid methods in lattice computations Karsten Kahl Bergische Universität Wuppertal January 8, 2009 Acknowledgements Matthias Bolten, University of Wuppertal Achi Brandt, Weizmann

More information

Partial Differential Equations

Partial Differential Equations Partial Differential Equations Introduction Deng Li Discretization Methods Chunfang Chen, Danny Thorne, Adam Zornes CS521 Feb.,7, 2006 What do You Stand For? A PDE is a Partial Differential Equation This

More information

Numerik 2 Motivation

Numerik 2 Motivation Numerik 2 Motivation P. Bastian Universität Heidelberg Interdisziplinäres Zentrum für Wissenschaftliches Rechnen Im Neuenheimer Feld 368, D-69120 Heidelberg email: Peter.Bastian@iwr.uni-heidelberg.de April

More information

Chapter 7 Iterative Techniques in Matrix Algebra

Chapter 7 Iterative Techniques in Matrix Algebra Chapter 7 Iterative Techniques in Matrix Algebra Per-Olof Persson persson@berkeley.edu Department of Mathematics University of California, Berkeley Math 128B Numerical Analysis Vector Norms Definition

More information

Solving the Stochastic Steady-State Diffusion Problem Using Multigrid

Solving the Stochastic Steady-State Diffusion Problem Using Multigrid Solving the Stochastic Steady-State Diffusion Problem Using Multigrid Tengfei Su Applied Mathematics and Scientific Computing Advisor: Howard Elman Department of Computer Science Sept. 29, 2015 Tengfei

More information

Elliptic Problems / Multigrid. PHY 604: Computational Methods for Physics and Astrophysics II

Elliptic Problems / Multigrid. PHY 604: Computational Methods for Physics and Astrophysics II Elliptic Problems / Multigrid Summary of Hyperbolic PDEs We looked at a simple linear and a nonlinear scalar hyperbolic PDE There is a speed associated with the change of the solution Explicit methods

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

Space-time sparse discretization of linear parabolic equations

Space-time sparse discretization of linear parabolic equations Space-time sparse discretization of linear parabolic equations Roman Andreev August 2, 200 Seminar for Applied Mathematics, ETH Zürich, Switzerland Support by SNF Grant No. PDFMP2-27034/ Part of PhD thesis

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

AMG for a Peta-scale Navier Stokes Code

AMG for a Peta-scale Navier Stokes Code AMG for a Peta-scale Navier Stokes Code James Lottes Argonne National Laboratory October 18, 2007 The Challenge Develop an AMG iterative method to solve Poisson 2 u = f discretized on highly irregular

More information

Subdiffusion in a nonconvex polygon

Subdiffusion in a nonconvex polygon Subdiffusion in a nonconvex polygon Kim Ngan Le and William McLean The University of New South Wales Bishnu Lamichhane University of Newcastle Monash Workshop on Numerical PDEs, February 2016 Outline Time-fractional

More information

On solving linear systems arising from Shishkin mesh discretizations

On solving linear systems arising from Shishkin mesh discretizations On solving linear systems arising from Shishkin mesh discretizations Petr Tichý Faculty of Mathematics and Physics, Charles University joint work with Carlos Echeverría, Jörg Liesen, and Daniel Szyld October

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

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 Finite Element Method Using Singular Functions for Poisson Equations: Mixed Boundary Conditions

A Finite Element Method Using Singular Functions for Poisson Equations: Mixed Boundary Conditions A Finite Element Method Using Singular Functions for Poisson Equations: Mixed Boundary Conditions Zhiqiang Cai Seokchan Kim Sangdong Kim Sooryun Kong Abstract In [7], we proposed a new finite element method

More information

Multigrid Method ZHONG-CI SHI. Institute of Computational Mathematics Chinese Academy of Sciences, Beijing, China. Joint work: Xuejun Xu

Multigrid Method ZHONG-CI SHI. Institute of Computational Mathematics Chinese Academy of Sciences, Beijing, China. Joint work: Xuejun Xu Multigrid Method ZHONG-CI SHI Institute of Computational Mathematics Chinese Academy of Sciences, Beijing, China Joint work: Xuejun Xu Outline Introduction Standard Cascadic Multigrid method(cmg) Economical

More information

Local Inexact Newton Multilevel FEM for Nonlinear Elliptic Problems

Local Inexact Newton Multilevel FEM for Nonlinear Elliptic Problems Konrad-Zuse-Zentrum für Informationstechnik Berlin Heilbronner Str. 10, D-10711 Berlin-Wilmersdorf Peter Deuflhard Martin Weiser Local Inexact Newton Multilevel FEM for Nonlinear Elliptic Problems Preprint

More information

arxiv: v2 [math.na] 17 Jun 2010

arxiv: v2 [math.na] 17 Jun 2010 Numerische Mathematik manuscript No. (will be inserted by the editor) Local Multilevel Preconditioners for Elliptic Equations with Jump Coefficients on Bisection Grids Long Chen 1, Michael Holst 2, Jinchao

More information

OUTLINE ffl CFD: elliptic pde's! Ax = b ffl Basic iterative methods ffl Krylov subspace methods ffl Preconditioning techniques: Iterative methods ILU

OUTLINE ffl CFD: elliptic pde's! Ax = b ffl Basic iterative methods ffl Krylov subspace methods ffl Preconditioning techniques: Iterative methods ILU Preconditioning Techniques for Solving Large Sparse Linear Systems Arnold Reusken Institut für Geometrie und Praktische Mathematik RWTH-Aachen OUTLINE ffl CFD: elliptic pde's! Ax = b ffl Basic iterative

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

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

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

Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners

Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners Eugene Vecharynski 1 Andrew Knyazev 2 1 Department of Computer Science and Engineering University of Minnesota 2 Department

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

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

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