Algebraic Multigrid Methods for the Oseen Problem

Size: px
Start display at page:

Download "Algebraic Multigrid Methods for the Oseen Problem"

Transcription

1 Algebraic Multigrid Methods for the Oseen Problem Markus Wabro Joint work with: Walter Zulehner, Linz This work has been supported by the Austrian Science Foundation Fonds zur Förderung der wissenschaftlichen Forschung (FWF) under the grant P14953 Robust Algebraic Multigrid Methods and their Parallelization p.1/27

2 Overview Introduction (Navier-Stokes / Oseen equations) p.2/27

3 Overview Introduction (Navier-Stokes / Oseen equations) Multigrid Methods for the solution of the Oseen equations p.2/27

4 Overview Introduction (Navier-Stokes / Oseen equations) Multigrid Methods for the solution of the Oseen equations Algebraic Multigrid for the Oseen equations Decoupled Approach Coupled Approach Prolongation, AMGe Smoothing p.2/27

5 Overview Introduction (Navier-Stokes / Oseen equations) Multigrid Methods for the solution of the Oseen equations Algebraic Multigrid for the Oseen equations Decoupled Approach Coupled Approach Prolongation, AMGe Smoothing Numerical results p.2/27

6 Complex 3D domain Ω, Aim p.3/27

7 Complex 3D domain Ω, Aim the incompressible Navier-Stokes equations t u ν u + (u )u + p = f, + boundary/initial conditions, div u = 0, p.3/27

8 Complex 3D domain Ω, Aim the incompressible Navier-Stokes equations t u ν u + (u )u + p = f, + boundary/initial conditions, Finite Element Discretization A(u) B BT u = C p div u = 0, f g p.3/27

9 Complex 3D domain Ω, Aim the incompressible Navier-Stokes equations t u ν u + (u )u + p = f, + boundary/initial conditions, Finite Element Discretization A(u) B BT u = C p div u = 0, f g We want an efficient Solver. p.3/27

10 Convective Term Linearization: Fixed point iteration Oseen equation ν u + (w )u + p = f p.4/27

11 Convective Term Linearization: Fixed point iteration Oseen equation ν u + (w )u + p = f Stabilization (SUPG): ((w )u, v)+β h (w u, w v), with β h = O(h). p.4/27

12 Convective Term Linearization: Fixed point iteration Oseen equation ν u + (w )u + p = f Stabilization (SUPG): ((w )u, v)+β h (w u, w v), with β h = O(h). Solution of linear problem? p.4/27

13 MGM for Saddle-Point-Problems p.5/27

14 MGM for Saddle-Point-Problems Iterative Decoupling Pressure correction methods: SIMPLE, Uzawa Precond. Krylov space methods (e.g. GMRES, BiCGstab) MG for the elliptic systems. p.5/27

15 MGM for Saddle-Point-Problems Iterative Decoupling Pressure correction methods: SIMPLE, Uzawa Precond. Krylov space methods (e.g. GMRES, BiCGstab) Coupled MG for the whole system. Needs appropriate MG components (smoother, inter-grid-transfer). MG for the elliptic systems. p.5/27

16 Decoupled Approach Examples p.6/27

17 Decoupled Approach Examples SIMPLE: Aũ = f B T p k, Ŝ p = Bũ Cp k g, u k+1 = ũ D 1 B T p, p k+1 = p k + p, with D A, Ŝ = C + BD 1 B T. p.6/27

18 Decoupled Approach Examples SIMPLE: Aũ = f B T p k, Ŝ p = Bũ Cp k g, u k+1 = ũ D 1 B T p, p k+1 = p k + p, with D A, Ŝ = C + BD 1 B T. Preconditioner of Silvester, Wathen et.al.: P 1 = A 1 0 I BT I 0, 0 I 0 I 0 Q 1 A p L 1 A A, Q pressure mass matrix, A p... pressure conv.-diff. operator, L pressure Laplacian ( C. Powell) p.6/27

19 Algebraic Multigrid Complex geometry discretization No further refinement possible. many unknowns. p.7/27

20 Algebraic Multigrid Complex geometry discretization No further refinement possible. many unknowns. Algebraic Multigrid. Starting from the finest levels generate the coarse levels (almost) only from matrix information. p.7/27

21 Algebraic Multigrid Complex geometry discretization No further refinement possible. many unknowns. Algebraic Multigrid. Starting from the finest levels generate the coarse levels (almost) only from matrix information. O.K. for elliptic problems, application to the decoupled approach is straightforward. What about coupled AMG? p.7/27

22 Coupled Approach Strategy p.8/27

23 Coupled Approach Strategy Separate pressure and velocity-component unknowns. p.8/27

24 Coupled Approach Strategy Separate pressure and velocity-component unknowns. Keep interaction of u and p the same. p.8/27

25 Coupled Approach Strategy Separate pressure and velocity-component unknowns. Keep interaction of u and p the same. Try to translate as much as possible from geometric MG for saddle point problems. p.8/27

26 Coupled Approach Strategy Separate pressure and velocity-component unknowns. Keep interaction of u and p the same. Try to translate as much as possible from geometric MG for saddle point problems. Try to use as much as possible from elliptic AMG. p.8/27

27 Coupled Approach Strategy Separate pressure and velocity-component unknowns. Keep interaction of u and p the same. Try to translate as much as possible from geometric MG for saddle point problems. Try to use as much as possible from elliptic AMG. AMG as black box? p.8/27

28 Coupled Approach Strategy Separate pressure and velocity-component unknowns. Keep interaction of u and p the same. Try to translate as much as possible from geometric MG for saddle point problems. Try to use as much as possible from elliptic AMG. AMG as black box? p.8/27

29 Notation Grid transfer: ( Prolongators Pi+1 i = Ĩi i+1 Ji+1 ) i Ĩ i i+1 = ( I i i+1 I i i+1 Restrictors P i+1 i Coarse level systems: K i = ( ) A i Bi T B i C i I i i+1, (= P i i+1t ). = P i i 1 K i 1P i 1 i ), p.9/27

30 Notation Grid transfer: ( Prolongators Pi+1 i = Ĩi i+1 Ji+1 ) i Ĩ i i+1 = ( I i i+1 I i i+1 Restrictors P i+1 i Coarse level systems: K i = ( ) A i Bi T B i C i I i i+1, (= P i i+1t ). = P i i 1 K i 1P i 1 i With two exceptions (h-dependence in conv. stab.)! ), p.9/27

31 Some Mixed Finite Elements P1-P1-stab: C = α elts K h 2 K ( p, q) 0,K p.10/27

32 Some Mixed Finite Elements P1-P1-stab: modified Taylor-Hood: C = α elts K h 2 K ( p, q) 0,K p.10/27

33 Some Mixed Finite Elements P1-P1-stab: modified Taylor-Hood: C = α elts K h 2 K ( p, q) 0,K Crouzeix-Raviart: p.10/27

34 PSfrag replacements Coarsening Strategy P1-P1-stab: same hierarchy Coarsening fine mesh 1st level u, p 2nd level u, p. N -th level u, p p.11/27

35 PSfrag replacements Coarsening Strategy P1-P1-stab: same hierarchy PSfrag replacements Coarsening fine mesh 1st level u, p 2nd level u, p. N -th level u, p mod. Taylor-Hood: shifted hierarchy (first try) Refinement Coarsening fine (u) mesh coarse (p) mesh 1st level u p 2nd level u p u p... N th level u p p.11/27

36 Stability P1-P1-stab (1) Geometric case: Franca, Stenberg (1991) using idea of Verfürth (1984): (div v, p) sup 0 v V h v 1 γ p 0 δ ( elts K Stability h 2 K p 2 0,K ) 1 2 p Q h p.12/27

37 Stability P1-P1-stab (1) Geometric case: Franca, Stenberg (1991) using idea of Verfürth (1984): (div v, p) sup 0 v V h v 1 (In the form γ p 0 δ sup (v,q) V Q ( elts K Stability h 2 K p 2 0,K ) 1 2 B((w,r),(v,q)) (v,q) X c (w, r) X, p Q h B((w, r), (v, q)) = a(w, v) b(v, r) b(w, q) c(r, q)) p.12/27

38 Stability P1-P1-stab (2) AMG case: Assume A i is of essentially positive type i.e. for all v i V i ( a kj )(v k v j ) 2 γ ( a kj )(v k v j ) 2. k,j k,j For all v i V i we can find a Π i+1 i v i V i+1 such that v i Ĩ i i+1π i+1 i v i 2 D i β 1 v i 2 A i. (Ii+1 i... e.g. Ruge, Stüben, 87, 01; Vaněk et al., 95) p.13/27

39 Stability P1-P1-stab (2) AMG case: Assume A i is of essentially positive type i.e. for all v i V i ( a kj )(v k v j ) 2 γ ( a kj )(v k v j ) 2. k,j k,j For all v i V i we can find a Π i+1 i v i V i+1 such that v i Ĩ i i+1π i+1 i v i 2 D i β 1 v i 2 A i. (Ii+1 i... e.g. Ruge, Stüben, 87, 01; Vaněk et al., 95) Then for all levels i sup vbt i p γ p Mi δ ( p T C i p ) 1 2 p Q i. 0 v V i v Ai p.13/27

40 Stability mod. Taylor-Hood (1) arbitrary grid-transfer problems. p.14/27

41 Stability mod. Taylor-Hood (1) arbitrary grid-transfer problems. Example: I i i+1 P1-P1 situation. locally equal I unstabilized p.14/27

42 Stability mod. Taylor-Hood (1) arbitrary grid-transfer problems. Example: Ii+1 i locally equal I unstabilized P1-P1 situation. More restrictive coarsening leads to poor approximation. p.14/27

43 Stability mod. Taylor-Hood (1) arbitrary grid-transfer problems. Example: Ii+1 i locally equal I unstabilized P1-P1 situation. More restrictive coarsening leads to poor approximation. Drop idea of same hierarchy. Guarantee that there are enough velocity unknowns. How? p.14/27

44 Stability mod. Taylor-Hood (2) First try (brute force): double shift. 1st level 1st level 2nd level 2nd level PSfrag replacements N th level N th level fine (u) mesh coarse (p) mesh fine (u) mesh coarse (p) mesh u p u p u p u p u u p p u p u p Refinement Refinement Coarsening Coarsening p.15/27

45 Problems Stability Arbitrary elements? p.16/27

46 AMGe Stability Arbitrary elements? One possibility AMGe (Jones, Vassilevski et.al.): element agglomeration minimal energy basis functions p.16/27

47 AMGe for Crouzeix-Raviart (1) Nonconf. geometric prolongation: p.17/27

48 AMGe for Crouzeix-Raviart (1) Nonconf. geometric prolongation: Conforming AMGe: A E C 0 C T x f = 0 λ z C = (0 I), z = x b f. p.17/27

49 AMGe for Crouzeix-Raviart (2) Nonconforming AMGe: A E C T C 0 x f = 0 λ z C, z s.t. x f = 1 on 1-edge, average 0 on 0-edges. p.18/27

50 AMGe for Crouzeix-Raviart (2) Nonconforming AMGe: A E C T C 0 x f = 0 λ z C, z s.t. x f = 1 on 1-edge, average 0 on 0-edges. (in num. practice: truncate small entries to reduce fill-in) p.18/27

51 Stability Crouzeix-Raviart Lemma: Assume existence of lin.op. Π k k 1 : U k 1 U k with and b(π k k 1v k 1, q k ) = b(v k 1, J k 1 k q k ) q k Q k, v k 1 U k 1 (1) Π k k 1v k 1 A C v k 1 A v k 1 U k 1. (2) Then inf-sup in U k 1 Q k 1 implies inf-sup in U k Q k. p.19/27

52 Stability Crouzeix-Raviart Lemma: Assume existence of lin.op. Π k k 1 : U k 1 U k with and b(π k k 1v k 1, q k ) = b(v k 1, J k 1 k q k ) q k Q k, v k 1 U k 1 (1) Π k k 1v k 1 A C v k 1 A v k 1 U k 1. (2) Then inf-sup in U k 1 Q k 1 implies inf-sup in U k Q k. (1), (2) can be shown using purely geometric arguments. p.19/27

53 Smoothing Use smoothers from GMG for saddle point systems, e.g. Braess-Smoother: Â(û j+1 u j ) = f Au j B T p j, Ŝ(p j+1 p j ) = Bû j+1 Cp j g, Â(u j+1 û j+1 ) = B T (p j+1 p j ), Ŝ C + BÂ 1 B T (AMG). p.20/27

54 Smoothing Use smoothers from GMG for saddle point systems, e.g. Braess-Smoother: Â(û j+1 u j ) = f Au j B T p j, Ŝ(p j+1 p j ) = Bû j+1 Cp j g, Â(u j+1 û j+1 ) = B T (p j+1 p j ), Ŝ C + BÂ 1 B T (AMG). Vanka-Smoother: Solve smaller local problems and combine solutions via (mult.) Schwarz method. Zulehner/Schöberl: theoretical basis for GMG. p.20/27

55 Software package AMuSE All numerical tests were performed using AMuSE Algebraic Multigrid for Stokes type Equations, developed by F. Kickinger ( ), C. Reisinger ( ), M. W. (since 1999). p.21/27

56 Numerical Results P1isoP2-P e-05 1e-06 1e-07 1e-08 1e-09 Coupled, MSM SIMPLE BiCGstab, Silvester-Wathen 1e e-05 1e-06 1e-07 1e-08 1e-09 1e-10 1e-11 Braess Braess, shifted SIMPLE 1e D valve, 10 5 vars, ν = D valves, vars, ν = 0.001, velocity at inlet 0.5, narrowest part p.22/27

57 Numerical Results 3D Valves p.23/27

58 Numerical Results P1-P1-stab e-05 1e-06 1e-07 1e-08 1e-09 Coupled SIMPLE 1e vars, mesh: tets, hexas, pyramids, prisms; ν = p.24/27

59 Numerical Results P1-P1-stab e-05 1e-06 1e-07 1e-08 1e-09 Coupled SIMPLE 1e vars, mesh: tets, hexas, pyramids, prisms; ν = p.24/27

60 Numerical Results Crouzeix-Raviart 2D valve, W-5-5 level faces elem rate (at 4th level: 0.8 reduction/minute) p.25/27

61 Smoothing Comparison 2D and/or less complex problems: Vanka-smoother leads to a fast and stable solver Complex 3D problems: Braess-smoother can compensate stability problems. The patches for the Vanka-smoother grow rapidly (for conforming elements) poor efficiency p.26/27

62 Summary We have a coupled AMG method for saddle point problems originating in the Navier Stokes equations. We can use existing components from AMG for elliptic problems, resp. GMG for saddle point problems. p.27/27

63 Summary We have a coupled AMG method for saddle point problems originating in the Navier Stokes equations. We can use existing components from AMG for elliptic problems, resp. GMG for saddle point problems. BUT It is absolutely no Black-Box method! We have no rigorous prove for most aspects (e.g. convergence)! p.27/27

Fast Iterative Solution of Saddle Point Problems

Fast Iterative Solution of Saddle Point Problems Michele Benzi Department of Mathematics and Computer Science Emory University Atlanta, GA Acknowledgments NSF (Computational Mathematics) Maxim Olshanskii (Mech-Math, Moscow State U.) Zhen Wang (PhD student,

More information

Efficient Augmented Lagrangian-type Preconditioning for the Oseen Problem using Grad-Div Stabilization

Efficient Augmented Lagrangian-type Preconditioning for the Oseen Problem using Grad-Div Stabilization Efficient Augmented Lagrangian-type Preconditioning for the Oseen Problem using Grad-Div Stabilization Timo Heister, Texas A&M University 2013-02-28 SIAM CSE 2 Setting Stationary, incompressible flow problems

More information

Fast solvers for steady incompressible flow

Fast solvers for steady incompressible flow ICFD 25 p.1/21 Fast solvers for steady incompressible flow Andy Wathen Oxford University wathen@comlab.ox.ac.uk http://web.comlab.ox.ac.uk/~wathen/ Joint work with: Howard Elman (University of Maryland,

More information

A Review of Preconditioning Techniques for Steady Incompressible Flow

A Review of Preconditioning Techniques for Steady Incompressible Flow Zeist 2009 p. 1/43 A Review of Preconditioning Techniques for Steady Incompressible Flow David Silvester School of Mathematics University of Manchester Zeist 2009 p. 2/43 PDEs Review : 1984 2005 Update

More information

Preconditioners for the incompressible Navier Stokes equations

Preconditioners for the incompressible Navier Stokes equations Preconditioners for the incompressible Navier Stokes equations C. Vuik M. ur Rehman A. Segal Delft Institute of Applied Mathematics, TU Delft, The Netherlands SIAM Conference on Computational Science and

More information

Multigrid Methods for Saddle Point Problems

Multigrid Methods for Saddle Point Problems Multigrid Methods for Saddle Point Problems Susanne C. Brenner Department of Mathematics and Center for Computation & Technology Louisiana State University Advances in Mathematics of Finite Elements (In

More information

Multilevel Preconditioning of Graph-Laplacians: Polynomial Approximation of the Pivot Blocks Inverses

Multilevel Preconditioning of Graph-Laplacians: Polynomial Approximation of the Pivot Blocks Inverses Multilevel Preconditioning of Graph-Laplacians: Polynomial Approximation of the Pivot Blocks Inverses P. Boyanova 1, I. Georgiev 34, S. Margenov, L. Zikatanov 5 1 Uppsala University, Box 337, 751 05 Uppsala,

More information

Efficient Solvers for the Navier Stokes Equations in Rotation Form

Efficient Solvers for the Navier Stokes Equations in Rotation Form Efficient Solvers for the Navier Stokes Equations in Rotation Form Computer Research Institute Seminar Purdue University March 4, 2005 Michele Benzi Emory University Atlanta, GA Thanks to: NSF (MPS/Computational

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

Numerische Mathematik

Numerische Mathematik Numer. Math. (1999) 82: 179 191 Numerische Mathematik c Springer-Verlag 1999 Electronic Edition A cascadic multigrid algorithm for the Stokes equations Dietrich Braess 1, Wolfgang Dahmen 2 1 Fakultät für

More information

The Mixed Finite Element Multigrid Preconditioned Minimum Residual Method for Stokes Equations

The Mixed Finite Element Multigrid Preconditioned Minimum Residual Method for Stokes Equations The Mixed Finite Element Multigrid Preconditioned Minimum Residual Method for Stokes Equations K. Muzhinji, S. Shateyi, and S, S. Motsa 2 University of Venda, Department of Mathematics, P Bag X5050, Thohoyandou

More information

c 2006 Society for Industrial and Applied Mathematics

c 2006 Society for Industrial and Applied Mathematics SIAM J. SCI. COMPUT. Vol. 28, No. 6, pp. 2095 2113 c 2006 Society for Industrial and Applied Mathematics AN AUGMENTED LAGRANGIAN-BASED APPROACH TO THE OSEEN PROBLEM MICHELE BENZI AND MAXIM A. OLSHANSKII

More information

where K e 2 h RN h e N h e is a symmetric positive denite (SPD) sparse system matrix, u h 2 R N h e the solution vector, and fh 2 R N h e the load vec

where K e 2 h RN h e N h e is a symmetric positive denite (SPD) sparse system matrix, u h 2 R N h e the solution vector, and fh 2 R N h e the load vec Algebraic Multigrid for Edge Elements Stefan Reitzinger y Joachim Schoberl z 15th June 2000 Abstract This paper presents an algebraic multigrid method for the ecient solution of the linear system arising

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

ANALYSIS AND COMPARISON OF GEOMETRIC AND ALGEBRAIC MULTIGRID FOR CONVECTION-DIFFUSION EQUATIONS

ANALYSIS AND COMPARISON OF GEOMETRIC AND ALGEBRAIC MULTIGRID FOR CONVECTION-DIFFUSION EQUATIONS ANALYSIS AND COMPARISON OF GEOMETRIC AND ALGEBRAIC MULTIGRID FOR CONVECTION-DIFFUSION EQUATIONS CHIN-TIEN WU AND HOWARD C. ELMAN Abstract. The discrete convection-diffusion equations obtained from streamline

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

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

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

Discretizations & Efficient Linear Solvers for Problems Related to Fluid Flow

Discretizations & Efficient Linear Solvers for Problems Related to Fluid Flow Clemson University TigerPrints All Dissertations Dissertations 8-2017 Discretizations & Efficient Linear Solvers for Problems Related to Fluid Flow Ryan R. Grove Clemson University, rgrove@g.clemson.edu

More information

Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction

Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction Problem Jörg-M. Sautter Mathematisches Institut, Universität Düsseldorf, Germany, sautter@am.uni-duesseldorf.de

More information

Robust solution of Poisson-like problems with aggregation-based AMG

Robust solution of Poisson-like problems with aggregation-based AMG Robust solution of Poisson-like problems with aggregation-based AMG Yvan Notay Université Libre de Bruxelles Service de Métrologie Nucléaire Paris, January 26, 215 Supported by the Belgian FNRS http://homepages.ulb.ac.be/

More information

ON THE ROLE OF COMMUTATOR ARGUMENTS IN THE DEVELOPMENT OF PARAMETER-ROBUST PRECONDITIONERS FOR STOKES CONTROL PROBLEMS

ON THE ROLE OF COMMUTATOR ARGUMENTS IN THE DEVELOPMENT OF PARAMETER-ROBUST PRECONDITIONERS FOR STOKES CONTROL PROBLEMS ON THE ROLE OF COUTATOR ARGUENTS IN THE DEVELOPENT OF PARAETER-ROBUST PRECONDITIONERS FOR STOKES CONTROL PROBLES JOHN W. PEARSON Abstract. The development of preconditioners for PDE-constrained optimization

More information

The Mixed Finite Element Multigrid Preconditioned MINRES Method for Stokes Equations

The Mixed Finite Element Multigrid Preconditioned MINRES Method for Stokes Equations Journal of Applied Fluid Mechanics, Vol. 9, No. 3, pp. 285-296, 206. Available online at www.jafmonline.net, ISSN 735-3572, EISSN 735-3645. DOI: 0.8869/acadpub.jafm.68.228.22805 The Mixed Finite Element

More information

ANALYSIS OF AUGMENTED LAGRANGIAN-BASED PRECONDITIONERS FOR THE STEADY INCOMPRESSIBLE NAVIER-STOKES EQUATIONS

ANALYSIS OF AUGMENTED LAGRANGIAN-BASED PRECONDITIONERS FOR THE STEADY INCOMPRESSIBLE NAVIER-STOKES EQUATIONS ANALYSIS OF AUGMENTED LAGRANGIAN-BASED PRECONDITIONERS FOR THE STEADY INCOMPRESSIBLE NAVIER-STOKES EQUATIONS MICHELE BENZI AND ZHEN WANG Abstract. We analyze a class of modified augmented Lagrangian-based

More information

An advanced ILU preconditioner for the incompressible Navier-Stokes equations

An advanced ILU preconditioner for the incompressible Navier-Stokes equations An advanced ILU preconditioner for the incompressible Navier-Stokes equations M. ur Rehman C. Vuik A. Segal Delft Institute of Applied Mathematics, TU delft The Netherlands Computational Methods with Applications,

More information

An Algebraic Multigrid Method for Eigenvalue Problems

An Algebraic Multigrid Method for Eigenvalue Problems An Algebraic Multigrid Method for Eigenvalue Problems arxiv:1503.08462v1 [math.na] 29 Mar 2015 Xiaole Han, Yunhui He, Hehu Xie and Chunguang You Abstract An algebraic multigrid method is proposed to solve

More information

Computational Linear Algebra

Computational Linear Algebra Computational Linear Algebra PD Dr. rer. nat. habil. Ralf-Peter Mundani Computation in Engineering / BGU Scientific Computing in Computer Science / INF Winter Term 2018/19 Part 4: Iterative Methods PD

More information

Multigrid absolute value preconditioning

Multigrid absolute value preconditioning Multigrid absolute value preconditioning Eugene Vecharynski 1 Andrew Knyazev 2 (speaker) 1 Department of Computer Science and Engineering University of Minnesota 2 Department of Mathematical and Statistical

More information

Using an Auction Algorithm in AMG based on Maximum Weighted Matching in Matrix Graphs

Using an Auction Algorithm in AMG based on Maximum Weighted Matching in Matrix Graphs Using an Auction Algorithm in AMG based on Maximum Weighted Matching in Matrix Graphs Pasqua D Ambra Institute for Applied Computing (IAC) National Research Council of Italy (CNR) pasqua.dambra@cnr.it

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

arxiv: v1 [math.na] 11 Jul 2011

arxiv: v1 [math.na] 11 Jul 2011 Multigrid Preconditioner for Nonconforming Discretization of Elliptic Problems with Jump Coefficients arxiv:07.260v [math.na] Jul 20 Blanca Ayuso De Dios, Michael Holst 2, Yunrong Zhu 2, and Ludmil Zikatanov

More information

Efficient FEM-multigrid solver for granular material

Efficient FEM-multigrid solver for granular material Efficient FEM-multigrid solver for granular material S. Mandal, A. Ouazzi, S. Turek Chair for Applied Mathematics and Numerics (LSIII), TU Dortmund STW user committee meeting Enschede, 25th September,

More information

Efficient smoothers for all-at-once multigrid methods for Poisson and Stokes control problems

Efficient smoothers for all-at-once multigrid methods for Poisson and Stokes control problems Efficient smoothers for all-at-once multigrid methods for Poisson and Stoes control problems Stefan Taacs stefan.taacs@numa.uni-linz.ac.at, WWW home page: http://www.numa.uni-linz.ac.at/~stefant/j3362/

More information

New Multigrid Solver Advances in TOPS

New Multigrid Solver Advances in TOPS New Multigrid Solver Advances in TOPS R D Falgout 1, J Brannick 2, M Brezina 2, T Manteuffel 2 and S McCormick 2 1 Center for Applied Scientific Computing, Lawrence Livermore National Laboratory, P.O.

More information

A DISCRETE PROJECTION METHOD FOR INCOMPRESSIBLE VISCOUS FLOW WITH CORIOLIS FORCE

A DISCRETE PROJECTION METHOD FOR INCOMPRESSIBLE VISCOUS FLOW WITH CORIOLIS FORCE A DISCRETE PROJECTION METHOD FOR INCOMPRESSIBLE VISCOUS FLOW WITH CORIOLIS FORCE ANDRIY SOKOLOV, MAXIM A. OLSHANSKII, AND STEFAN TUREK Abstract. The paper presents a new discrete projection method (DPM)

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

Vector and scalar penalty-projection methods

Vector and scalar penalty-projection methods Numerical Flow Models for Controlled Fusion - April 2007 Vector and scalar penalty-projection methods for incompressible and variable density flows Philippe Angot Université de Provence, LATP - Marseille

More information

Contents. Computational Fluid Dynamics. Fundamentals. Deformation of Materials

Contents. Computational Fluid Dynamics. Fundamentals. Deformation of Materials Contents R. Verfürth www.ruhr-uni-bochum.de/num1 Lecture Series / Bochum / Summer Term 2018 Variational Formulation of the Stokes Equations of the Stokes Equations Stationary Incompressible Navier-Stokes

More information

c 2011 Society for Industrial and Applied Mathematics

c 2011 Society for Industrial and Applied Mathematics SIAM J. SCI. COMPUT. Vol. 33, No. 5, pp. 2761 2784 c 2011 Society for Industrial and Applied Mathematics ANALYSIS OF AUGMENTED LAGRANGIAN-BASED PRECONDITIONERS FOR THE STEADY INCOMPRESSIBLE NAVIER STOKES

More information

A comparison of preconditioners for incompressible Navier Stokes solvers

A comparison of preconditioners for incompressible Navier Stokes solvers INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Meth. Fluids (2007) Published online in Wiley InterScience (www.interscience.wiley.com)..1684 A comparison of preconditioners for incompressible

More information

A STOKES INTERFACE PROBLEM: STABILITY, FINITE ELEMENT ANALYSIS AND A ROBUST SOLVER

A STOKES INTERFACE PROBLEM: STABILITY, FINITE ELEMENT ANALYSIS AND A ROBUST SOLVER European Congress on Computational Methods in Applied Sciences and Engineering ECCOMAS 2004 P. Neittaanmäki, T. Rossi, K. Majava, and O. Pironneau (eds.) O. Nevanlinna and R. Rannacher (assoc. eds.) Jyväskylä,

More information

Multigrid and Iterative Strategies for Optimal Control Problems

Multigrid and Iterative Strategies for Optimal Control Problems Multigrid and Iterative Strategies for Optimal Control Problems John Pearson 1, Stefan Takacs 1 1 Mathematical Institute, 24 29 St. Giles, Oxford, OX1 3LB e-mail: john.pearson@worc.ox.ac.uk, takacs@maths.ox.ac.uk

More information

Aggregation-based algebraic multigrid

Aggregation-based algebraic multigrid Aggregation-based algebraic multigrid from theory to fast solvers Yvan Notay Université Libre de Bruxelles Service de Métrologie Nucléaire CEMRACS, Marseille, July 18, 2012 Supported by the Belgian FNRS

More information

AN AUGMENTED LAGRANGIAN APPROACH TO LINEARIZED PROBLEMS IN HYDRODYNAMIC STABILITY

AN AUGMENTED LAGRANGIAN APPROACH TO LINEARIZED PROBLEMS IN HYDRODYNAMIC STABILITY AN AUGMENTED LAGRANGIAN APPROACH TO LINEARIZED PROBLEMS IN HYDRODYNAMIC STABILITY MAXIM A. OLSHANSKII AND MICHELE BENZI Abstract. The solution of linear systems arising from the linear stability analysis

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

Divergence-conforming multigrid methods for incompressible flow problems

Divergence-conforming multigrid methods for incompressible flow problems Divergence-conforming multigrid methods for incompressible flow problems Guido Kanschat IWR, Universität Heidelberg Prague-Heidelberg-Workshop April 28th, 2015 G. Kanschat (IWR, Uni HD) Hdiv-DG Práha,

More information

Spectral element agglomerate AMGe

Spectral element agglomerate AMGe Spectral element agglomerate AMGe T. Chartier 1, R. Falgout 2, V. E. Henson 2, J. E. Jones 4, T. A. Manteuffel 3, S. F. McCormick 3, J. W. Ruge 3, and P. S. Vassilevski 2 1 Department of Mathematics, Davidson

More information

An efficient multigrid solver based on aggregation

An efficient multigrid solver based on aggregation An efficient multigrid solver based on aggregation Yvan Notay Université Libre de Bruxelles Service de Métrologie Nucléaire Graz, July 4, 2012 Co-worker: Artem Napov Supported by the Belgian FNRS http://homepages.ulb.ac.be/

More information

Kasetsart University Workshop. Multigrid methods: An introduction

Kasetsart University Workshop. Multigrid methods: An introduction Kasetsart University Workshop Multigrid methods: An introduction Dr. Anand Pardhanani Mathematics Department Earlham College Richmond, Indiana USA pardhan@earlham.edu A copy of these slides is available

More information

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

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

More information

Bootstrap AMG. Kailai Xu. July 12, Stanford University

Bootstrap AMG. Kailai Xu. July 12, Stanford University Bootstrap AMG Kailai Xu Stanford University July 12, 2017 AMG Components A general AMG algorithm consists of the following components. A hierarchy of levels. A smoother. A prolongation. A restriction.

More information

Lecture Note III: Least-Squares Method

Lecture Note III: Least-Squares Method Lecture Note III: Least-Squares Method Zhiqiang Cai October 4, 004 In this chapter, we shall present least-squares methods for second-order scalar partial differential equations, elastic equations of solids,

More information

University of Illinois at Urbana-Champaign. Multigrid (MG) methods are used to approximate solutions to elliptic partial differential

University of Illinois at Urbana-Champaign. Multigrid (MG) methods are used to approximate solutions to elliptic partial differential Title: Multigrid Methods Name: Luke Olson 1 Affil./Addr.: Department of Computer Science University of Illinois at Urbana-Champaign Urbana, IL 61801 email: lukeo@illinois.edu url: http://www.cs.uiuc.edu/homes/lukeo/

More information

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

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

More information

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

Mathematics and Computer Science

Mathematics and Computer Science Technical Report TR-2007-002 Block preconditioning for saddle point systems with indefinite (1,1) block by Michele Benzi, Jia Liu Mathematics and Computer Science EMORY UNIVERSITY International Journal

More information

New multigrid smoothers for the Oseen problem

New multigrid smoothers for the Oseen problem NUMERICAL LINEAR ALGEBRA WITH APPLICATIONS Numer. Linear Algebra Appl. (2010) Published online in Wiley InterScience (www.interscience.wiley.com)..707 New multigrid smoothers for the Oseen problem Steven

More information

A parallel block multi-level preconditioner for the 3D incompressible Navier Stokes equations

A parallel block multi-level preconditioner for the 3D incompressible Navier Stokes equations Journal of Computational Physics 187 (2003) 504 523 www.elsevier.com/locate/jcp A parallel block multi-level preconditioner for the 3D incompressible Navier Stokes equations Howard C. Elman a,1, Victoria

More information

Preconditioned Locally Minimal Residual Method for Computing Interior Eigenpairs of Symmetric Operators

Preconditioned Locally Minimal Residual Method for Computing Interior Eigenpairs of Symmetric Operators Preconditioned Locally Minimal Residual Method for Computing Interior Eigenpairs of Symmetric Operators Eugene Vecharynski 1 Andrew Knyazev 2 1 Department of Computer Science and Engineering University

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

Discontinuous Galerkin Methods

Discontinuous Galerkin Methods Discontinuous Galerkin Methods Joachim Schöberl May 20, 206 Discontinuous Galerkin (DG) methods approximate the solution with piecewise functions (polynomials), which are discontinuous across element interfaces.

More information

ALGEBRAIC MULTILEVEL METHODS FOR GRAPH LAPLACIANS

ALGEBRAIC MULTILEVEL METHODS FOR GRAPH LAPLACIANS The Pennsylvania State University The Graduate School Department of Mathematics ALGEBRAIC MULTILEVEL METHODS FOR GRAPH LAPLACIANS A Dissertation in Mathematics by Yao Chen Submitted in Partial Fulfillment

More information

c 2004 Society for Industrial and Applied Mathematics

c 2004 Society for Industrial and Applied Mathematics SIAM J. SCI. COMPUT. Vol. 25, No. 6, pp. 982 23 c 24 Society for Industrial and Applied Mathematics A BOUNDARY CONDITION CAPTURING MULTIGRID APPROAC TO IRREGULAR BOUNDARY PROBLEMS JUSTIN W. L. WAN AND

More information

20. A Dual-Primal FETI Method for solving Stokes/Navier-Stokes Equations

20. A Dual-Primal FETI Method for solving Stokes/Navier-Stokes Equations Fourteenth International Conference on Domain Decomposition Methods Editors: Ismael Herrera, David E. Keyes, Olof B. Widlund, Robert Yates c 23 DDM.org 2. A Dual-Primal FEI Method for solving Stokes/Navier-Stokes

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

PALADINS: Scalable Time-Adaptive Algebraic Splitting and Preconditioners for the Navier-Stokes Equations

PALADINS: Scalable Time-Adaptive Algebraic Splitting and Preconditioners for the Navier-Stokes Equations 2013 SIAM Conference On Computational Science and Engineering Boston, 27 th February 2013 PALADINS: Scalable Time-Adaptive Algebraic Splitting and Preconditioners for the Navier-Stokes Equations U. Villa,

More information

FEM for Stokes Equations

FEM for Stokes Equations FEM for Stokes Equations Kanglin Chen 15. Dezember 2009 Outline 1 Saddle point problem 2 Mixed FEM for Stokes equations 3 Numerical Results 2 / 21 Stokes equations Given (f, g). Find (u, p) s.t. u + p

More information

(bu) = f in Ω, (1.1) u = g on Γ I, (1.2)

(bu) = f in Ω, (1.1) u = g on Γ I, (1.2) A DUAL LEAST-SQUARES FINITE ELEMENT METHOD FOR LINEAR HYPERBOLIC PDES: A NUMERICAL STUDY LUKE OLSON Abstract. In this paper, we develop a least-squares finite element method for linear Partial Differential

More information

Domain Decomposition Algorithms for Saddle Point Problems

Domain Decomposition Algorithms for Saddle Point Problems Contemporary Mathematics Volume 218, 1998 B 0-8218-0988-1-03007-7 Domain Decomposition Algorithms for Saddle Point Problems Luca F. Pavarino 1. Introduction In this paper, we introduce some domain decomposition

More information

A Novel Aggregation Method based on Graph Matching for Algebraic MultiGrid Preconditioning of Sparse Linear Systems

A Novel Aggregation Method based on Graph Matching for Algebraic MultiGrid Preconditioning of Sparse Linear Systems A Novel Aggregation Method based on Graph Matching for Algebraic MultiGrid Preconditioning of Sparse Linear Systems Pasqua D Ambra, Alfredo Buttari, Daniela Di Serafino, Salvatore Filippone, Simone Gentile,

More information

Algebraic Multigrid Preconditioners for Computing Stationary Distributions of Markov Processes

Algebraic Multigrid Preconditioners for Computing Stationary Distributions of Markov Processes Algebraic Multigrid Preconditioners for Computing Stationary Distributions of Markov Processes Elena Virnik, TU BERLIN Algebraic Multigrid Preconditioners for Computing Stationary Distributions of Markov

More information

Newton-Multigrid Least-Squares FEM for S-V-P Formulation of the Navier-Stokes Equations

Newton-Multigrid Least-Squares FEM for S-V-P Formulation of the Navier-Stokes Equations Newton-Multigrid Least-Squares FEM for S-V-P Formulation of the Navier-Stokes Equations A. Ouazzi, M. Nickaeen, S. Turek, and M. Waseem Institut für Angewandte Mathematik, LSIII, TU Dortmund, Vogelpothsweg

More information

Non-Conforming Finite Element Methods for Nonmatching Grids in Three Dimensions

Non-Conforming Finite Element Methods for Nonmatching Grids in Three Dimensions Non-Conforming Finite Element Methods for Nonmatching Grids in Three Dimensions Wayne McGee and Padmanabhan Seshaiyer Texas Tech University, Mathematics and Statistics (padhu@math.ttu.edu) Summary. In

More information

From the Boundary Element DDM to local Trefftz Finite Element Methods on Polyhedral Meshes

From the Boundary Element DDM to local Trefftz Finite Element Methods on Polyhedral Meshes www.oeaw.ac.at From the Boundary Element DDM to local Trefftz Finite Element Methods on Polyhedral Meshes D. Copeland, U. Langer, D. Pusch RICAM-Report 2008-10 www.ricam.oeaw.ac.at From the Boundary Element

More information

7.4 The Saddle Point Stokes Problem

7.4 The Saddle Point Stokes Problem 346 CHAPTER 7. APPLIED FOURIER ANALYSIS 7.4 The Saddle Point Stokes Problem So far the matrix C has been diagonal no trouble to invert. This section jumps to a fluid flow problem that is still linear (simpler

More information

Algebraic Multigrid (AMG) for saddle point systems from meshfree discretizations

Algebraic Multigrid (AMG) for saddle point systems from meshfree discretizations Algebraic Multigrid (AMG) for saddle point systems from meshfree discretizations K. H. Leem 1, S. Oliveira 2, and D. E. Stewart 3 1 Applied Mathematics and Computational Sciences, The University of Iowa,

More information

UNIFORM PRECONDITIONERS FOR A PARAMETER DEPENDENT SADDLE POINT PROBLEM WITH APPLICATION TO GENERALIZED STOKES INTERFACE EQUATIONS

UNIFORM PRECONDITIONERS FOR A PARAMETER DEPENDENT SADDLE POINT PROBLEM WITH APPLICATION TO GENERALIZED STOKES INTERFACE EQUATIONS UNIFORM PRECONDITIONERS FOR A PARAMETER DEPENDENT SADDLE POINT PROBLEM WITH APPLICATION TO GENERALIZED STOKES INTERFACE EQUATIONS MAXIM A. OLSHANSKII, JÖRG PETERS, AND ARNOLD REUSKEN Abstract. We consider

More information

A mixed finite element approximation of the Stokes equations with the boundary condition of type (D+N)

A mixed finite element approximation of the Stokes equations with the boundary condition of type (D+N) wwwijmercom Vol2, Issue1, Jan-Feb 2012 pp-464-472 ISSN: 2249-6645 A mixed finite element approximation of the Stokes equations with the boundary condition of type (D+N) Jaouad El-Mekkaoui 1, Abdeslam Elakkad

More information

Key words. inf-sup constant, iterative solvers, preconditioning, saddle point problems

Key words. inf-sup constant, iterative solvers, preconditioning, saddle point problems NATURAL PRECONDITIONING AND ITERATIVE METHODS FOR SADDLE POINT SYSTEMS JENNIFER PESTANA AND ANDREW J. WATHEN Abstract. The solution of quadratic or locally quadratic extremum problems subject to linear(ized)

More information

Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems

Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems Roy Stogner Computational Fluid Dynamics Lab Institute for Computational Engineering and Sciences University of Texas at Austin March

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

NONSTANDARD NONCONFORMING APPROXIMATION OF THE STOKES PROBLEM, I: PERIODIC BOUNDARY CONDITIONS

NONSTANDARD NONCONFORMING APPROXIMATION OF THE STOKES PROBLEM, I: PERIODIC BOUNDARY CONDITIONS NONSTANDARD NONCONFORMING APPROXIMATION OF THE STOKES PROBLEM, I: PERIODIC BOUNDARY CONDITIONS J.-L. GUERMOND 1, Abstract. This paper analyzes a nonstandard form of the Stokes problem where the mass conservation

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

Contents. Computational Fluid Dynamics. Fundamentals. Deformation of Materials

Contents. Computational Fluid Dynamics. Fundamentals. Deformation of Materials Contents R. Verfürth Fakultät für Mathematik Ruhr-Universität Bochum www.ruhr-uni-bochum.de/num1 Lecture Series / Milan / March 2010 of the Stokes Equations Non-Stationary Incompressible Navier-Stokes

More information

Weierstraß-Institut. für Angewandte Analysis und Stochastik. im Forschungsverbund Berlin e.v. Preprint ISSN

Weierstraß-Institut. für Angewandte Analysis und Stochastik. im Forschungsverbund Berlin e.v. Preprint ISSN Weierstraß-Institut für Angewandte Analysis und Stochastik im Forschungsverbund Berlin e.v. Preprint ISSN 946 8633 Computational comparison between the Taylor Hood and the conforming Crouzeix Raviart element

More information

Adaptive Multigrid for QCD. Lattice University of Regensburg

Adaptive Multigrid for QCD. Lattice University of Regensburg Lattice 2007 University of Regensburg Michael Clark Boston University with J. Brannick, R. Brower, J. Osborn and C. Rebbi -1- Lattice 2007, University of Regensburg Talk Outline Introduction to Multigrid

More information

Chapter 2 Finite Element Spaces for Linear Saddle Point Problems

Chapter 2 Finite Element Spaces for Linear Saddle Point Problems Chapter 2 Finite Element Spaces for Linear Saddle Point Problems Remark 2.1. Motivation. This chapter deals with the first difficulty inherent to the incompressible Navier Stokes equations, see Remark

More information

Chebyshev semi-iteration in Preconditioning

Chebyshev semi-iteration in Preconditioning Report no. 08/14 Chebyshev semi-iteration in Preconditioning Andrew J. Wathen Oxford University Computing Laboratory Tyrone Rees Oxford University Computing Laboratory Dedicated to Victor Pereyra on his

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

From the Boundary Element Domain Decomposition Methods to Local Trefftz Finite Element Methods on Polyhedral Meshes

From the Boundary Element Domain Decomposition Methods to Local Trefftz Finite Element Methods on Polyhedral Meshes From the Boundary Element Domain Decomposition Methods to Local Trefftz Finite Element Methods on Polyhedral Meshes Dylan Copeland 1, Ulrich Langer 2, and David Pusch 3 1 Institute of Computational Mathematics,

More information

JOHANNES KEPLER UNIVERSITY LINZ. A Robust FEM-BEM Solver for Time-Harmonic Eddy Current Problems

JOHANNES KEPLER UNIVERSITY LINZ. A Robust FEM-BEM Solver for Time-Harmonic Eddy Current Problems JOHANNES KEPLER UNIVERSITY LINZ Institute of Computational Mathematics A Robust FEM-BEM Solver for Time-Harmonic Eddy Current Problems Michael Kolmbauer Institute of Computational Mathematics, Johannes

More information

ANALYSIS OF ITERATIVE METHODS FOR SADDLE POINT PROBLEMS: A UNIFIED APPROACH

ANALYSIS OF ITERATIVE METHODS FOR SADDLE POINT PROBLEMS: A UNIFIED APPROACH MATHEMATICS OF COMPUTATION Volume 71, Number 38, Pages 79 505 S 005-571801)013- Article electronically published on May 1, 001 ANALYSIS OF ITERATIVE METHODS FOR SADDLE POINT PROBLEMS: A UNIFIED APPROACH

More information

Preconditioning for Nonsymmetry and Time-dependence

Preconditioning for Nonsymmetry and Time-dependence Preconditioning for Nonsymmetry and Time-dependence Andy Wathen Oxford University, UK joint work with Jen Pestana and Elle McDonald Jeju, Korea, 2015 p.1/24 Iterative methods For self-adjoint problems/symmetric

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

DELFT UNIVERSITY OF TECHNOLOGY

DELFT UNIVERSITY OF TECHNOLOGY DELFT UNIVERSITY OF TECHNOLOGY REPORT 13-10 Comparison of some preconditioners for the incompressible Navier-Stokes equations X. He and C. Vuik ISSN 1389-6520 Reports of the Delft Institute of Applied

More information

Preconditioning of Saddle Point Systems by Substructuring and a Penalty Approach

Preconditioning of Saddle Point Systems by Substructuring and a Penalty Approach Preconditioning of Saddle Point Systems by Substructuring and a Penalty Approach Clark R. Dohrmann 1 Sandia National Laboratories, crdohrm@sandia.gov. Sandia is a multiprogram laboratory operated by Sandia

More information

Lehrstuhl für Informatik 10 (Systemsimulation)

Lehrstuhl für Informatik 10 (Systemsimulation) FRIEDRICH-ALEXANDER-UNIVERSITÄT ERLANGEN-NÜRNBERG INSTITUT FÜR INFORMATIK (MATHEMATISCHE MASCHINEN UND DATENVERARBEITUNG) Lehrstuhl für Informatik 10 (Systemsimulation) Comparison of two implementations

More information

ENERGY NORM A POSTERIORI ERROR ESTIMATES FOR MIXED FINITE ELEMENT METHODS

ENERGY NORM A POSTERIORI ERROR ESTIMATES FOR MIXED FINITE ELEMENT METHODS ENERGY NORM A POSTERIORI ERROR ESTIMATES FOR MIXED FINITE ELEMENT METHODS CARLO LOVADINA AND ROLF STENBERG Abstract The paper deals with the a-posteriori error analysis of mixed finite element methods

More information

Schwarz type solvers forhp-fem discretizations of mixed problems

Schwarz type solvers forhp-fem discretizations of mixed problems Wegelerstraße 6 53115 Bonn Germany phone +49 228 73-3427 fax +49 228 73-7527 www.ins.uni-bonn.de S. Beuchler, M. Purrucker Schwarz type solvers forhp-fem discretizations of mixed problems INS Preprint

More information

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

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

More information