A Review of Preconditioning Techniques for Steady Incompressible Flow

Size: px
Start display at page:

Download "A Review of Preconditioning Techniques for Steady Incompressible Flow"

Transcription

1 Zeist 2009 p. 1/43 A Review of Preconditioning Techniques for Steady Incompressible Flow David Silvester School of Mathematics University of Manchester

2 Zeist 2009 p. 2/43 PDEs Review : Update : Outline

3 Zeist 2009 p. 3/43 Outline PDEs } u u ν 2 u + p 0 u 0 Navier Stokes

4 Zeist 2009 p. 4/43 Outline PDEs } u u ν 2 u + p 0 u 0 Navier Stokes 2 u + p 0 u 0 } Stokes

5 Zeist 2009 p. 5/43 Outline PDEs } u u ν 2 u + p 0 u 0 Navier Stokes 2 } u + p 0 u 0 A 1 } u + p 0 u 0 Stokes Darcy

6 Zeist 2009 p. 6/43 PDEs Review : Update : Outline

7 Zeist 2009 p. 7/43 PDEs Outline Review :

8 Zeist 2009 p. 8/43 PDEs Outline Review :

9 Zeist 2009 p. 9/43

10 Zeist 2009 p. 10/43 Steady-state Navier-Stokes equations Boundary conditions: u u ν 2 u + p 0 u w on Ω D, in Ω u 0 in Ω. Picard linearization: Given u 0, compute u 1, u 2,..., u k via ν u n np 0 on Ω N. u k u k+1 ν 2 u k+1 + p k+1 0, u k+1 0 in Ω together with appropriate boundary conditions.

11 Example: Flow over a Step Zeist 2009 p. 11/43

12 Zeist 2009 p. 12/43 Finite element matrix formulation Introducing the basis sets X h span{ φ i } n u i1, Velocity basis functions; M h span{ψ j } n p j1, Pressure basis functions. gives the discretized system: ( N + νa B T B 0 with associated matrices ) ( ) u p f, g N ij (w h φ i, φ j ), convection A ij ( φ i, φ j ), diffusion B ij ( φ j,ψ i ), divergence.

13 Zeist 2009 p. 13/43 In the Stokes limit ν, we obtain the saddle-point problem A B T B 0 u p f, 0 with A R n u n u, B R n p n u, and for a stable approximation A A T, u T Au > 0, u 0, rank(b) n p if Ω N, otherwise null(b T ) {1}.

14 Zeist 2009 p. 13/43 In the Stokes limit ν, we obtain the saddle-point problem A B T B 0 u p f, 0 with A R n u n u, B R n p n u, and for a stable approximation A A T, u T Au > 0, u 0, rank(b) n p if Ω N, otherwise null(b T ) {1}. Note that the Stokes system matrix is highly indefinite : ( A B T A B 0 I 0 BA 1 I A 0 0 BA 1 B T ) ( I A 1 B T 0 I where S BA 1 B T is the Schur complement of A in A. )

15 Zeist 2009 p. 14/43 A Simple Iterative Solver... Given scalar parameter α Algorithm: Arrow, Hurwicz, Uzawa, 1958 for k 0, 1,... solve Au k+1 f B T p k compute p k+1 p k + αbu k+1 end

16 Zeist 2009 p. 14/43 A Simple Iterative Solver... Given scalar parameter α Algorithm: Arrow, Hurwicz, Uzawa, 1958 for k 0, 1,... solve Au k+1 f B T p k compute p k+1 p k + αbu k+1 end Eliminating u k+1 gives p k+1 p k + α(ba 1 f BA 1 B T p k ). This is simple (first order) Richardson iteration for the Schur Complement problem BA 1 B T p BA 1 f.

17 Zeist 2009 p. 15/43 ( A B T B 0 ) ( ) u p f,

18 Zeist 2009 p. 16/43 Idea I : Introduce the pressure mass matrix Q I and use an iterated penalty approach: for k 0, 1,... end Au k+1 + B T p k+1 f Bu k+1 ǫ Qp k+1 ǫ Qp k

19 Zeist 2009 p. 16/43 Idea I : Introduce the pressure mass matrix Q I and use an iterated penalty approach: for k 0, 1,... end Au k+1 + B T p k+1 f Bu k+1 ǫ Qp k+1 ǫ Qp k Eliminating p k+1 gives (A + 1 ǫ BT Q 1 B)u k+1 f B T p k p k+1 p k + 1 ǫ Q 1 Bu k+1 Michel Fortin & Roland Glowinski Augmented Lagrangian Methods North-Holland, 1984.

20 Zeist 2009 p. 17/43 Idea II : Apply CG to the Schur Complement system, but replace inversion of A with n A multigrid V-cycles A 1 : BA 1 B T p BA 1 f. Rudiger Verfürth A Combined Conjugate Gradient-Multigrid algorithm for the Numerical Solution of the Stokes Problem IMA J. Numer. Anal., 4, where it is established that this approach leads to textbook (grid independent) convergence if n A is sufficiently big.

21 Zeist 2009 p. 18/43 ( A B T B 0 ) ( ) u p f,

22 Zeist 2009 p. 19/43 Silvester & Wathen : A Fledgling-Fast Solver We introduce the pressure mass matrix Q and solve the (symmetric ) system Ax f A B T B 0 u p f 0 with the Conjugate Residual method and the diagonal preconditioning P 1 D 1 A 0 0 DQ 1. Analysis is elegant...

23 Zeist 2009 p. 20/43 Given inf sup stability: γ 2 pt BA 1 B T p p T Qp Γ 2 p R n p the mass matrix preconditioner satisfies θ 2 pt Qp p T D Q p Θ2, p R n p the vector Laplacian satisfies: g(h) ut Au u T D A u 1 u Rn u with g(h) 0 as h 0.

24 Zeist 2009 p. 21/43 if g(h) 0 as h 0, then the eigenvalues of the preconditioned Stokes operator lie in the union of two real intervals [ Γ 2 Θ 2, γθ ] g(h) [ g(h), 1 + Γ 2 Θ 2] In particular, using simple diagonal scaling g(h) O(h 2 ), and the eigenvalues lie in [ a, bh ] [ ch 2, d ]. Andrew Wathen & David Silvester Fast iterative solution of stabilised Stokes systems Part I: Using simple diagonal preconditioners, Report NA 91 04, Stanford University, SIAM J. Numer. Anal., 30, 1993.

25 Zeist 2009 p. 22/43 ( A B T B 0 ) ( ) u p f,

26 Silvester & Wathen : A Fast Solver We solve the (symmetric ) system Ax f ) A B T B 0 u p ( f 0 using MINRES (due to Bernd Fischer) with the spectrally equivalent preconditioning P 1 A DQ 1, so that the vector Laplacian satisfies λ 2 ut Au u T A u 1 u Rn u with λ λ > 0 as h 0. Zeist 2009 p. 23/43

27 In this case the eigenvalues of the preconditioned Stokes operator lie in the union of two real intervals [ Γ 2 Θ 2, 1 2 (λ ] λ 2 + 4γ 2 θ 2 λ ) [ λ, 1 + Γ 2 Θ 2 ] giving a convergence rate which is bounded away from one independently of the grid. Torgeir Rusten & Ragner Winther A Preconditioned Iterative Method for Saddle-Point Problems, SIAM J. Matrix. Anal. Appl., 13, Andrew Wathen & David Silvester Fast iterative solution of stabilised Stokes systems Part II: Using general block preconditioners, Report NA 92 xx, Stanford University. SIAM J. Numer. Anal., 31, Zeist 2009 p. 24/43

28 Zeist 2009 p. 25/43 ( A B T B 0 ) ( ) u p f,

29 Gene s Idea: Use efficient inexact solve (e.g. multigrid V-cycle) for k 0, 1,... end Au k+1 f B T p k + δ k p k+1 p k + αbu k+1 with stopping criterion δ k τ Bu k. Howard Elman & Gene Golub Inexact and Preconditioned Uzawa Algorithms for Saddle Point Problems SIAM J. Numer. Anal., 31, where it is established that this approach leads to textbook (grid independent) convergence. Zeist 2009 p. 26/43

30 Zeist 2009 p. 27/43 ( F B T B 0 ) ( ) u p f,

31 Zeist 2009 p. 28/43 Elman & Silvester : A Fledgling-Fast Solver Now for the Navier-Stokes Equations. We solve the nonsymmetric system Fx f N + νa B T B 0 u p f 0 using GMRES with the spectrally equivalent preconditioning F 0 P, 0 D Q so that the vector convection-diffusion operator F satisfies λ 2 ut (N + νa)u u T F u Λ 2 u R n u.

32 Zeist 2009 p. 29/43 In this case the eigenvalues of the preconditioned Oseen operator lie in two boxes on either side of the imaginary axis in the complex plane. Gives a convergence rate which is bounded away from one independently of the grid.

33 Zeist 2009 p. 29/43 In this case the eigenvalues of the preconditioned Oseen operator lie in two boxes on either side of the imaginary axis in the complex plane. Gives a convergence rate which is bounded away from one independently of the grid. Convergence deteriorates as ν 0 because of low-quality Schur complement approximation B(N + νa) 1 B T D Q. Howard Elman & David Silvester Fast Nonsymmetric Iterations and Preconditioning for Navier-Stokes Equations, Report UMIACS TR 94 66, University of Maryland. SIAM J. Sci. Comput, 17, 1996.

34 Zeist 2009 p. 30/43 Block triangular preconditioning ( F B T B 0 ) P 1 P u p f 0 A perfect preconditioner is given by ( ) F B T F 1 F 1 B T S 1 B 0 } 0 S 1 {{ } P 1 Here F N + νa and S BF 1 B T. I 0 BF 1 I

35 Zeist 2009 p. 30/43 Block triangular preconditioning ( F B T B 0 ) P 1 P u p f 0 A perfect preconditioner is given by ( ) F B T F 1 F 1 B T S 1 B 0 } 0 S 1 {{ } P 1 I 0 BF 1 I Here F N + νa and S BF 1 B T. Note that ( )( ) F 1 F 1 B T S 1 F B T I 0 0 S 1 0 S 0 I }{{}}{{} P 1 P

36 Zeist 2009 p. 31/43 ( F B T B 0 ) ( ) u p f,

37 Zeist 2009 p. 32/43 A Fast Solver Given ( N + νa B T B 0 ) P 1 P u p f g With discrete matrices N ij ( w h φ i, φ j ), A ij ( φ i, φ j ), B ij ( φ j,ψ i ), convection diffusion divergence For an efficient block diagonal (or triangular) preconditioner P we require a sparse approximation to the exact Schur complement S 1 (B(N + νa) 1 B T ) 1 : (BF 1 B T ) 1

38 Zeist 2009 p. 33/43 Schur complement approximation I Introducing associated pressure matrices A p ( ψ i, ψ j ), N p ( w h ψ i,ψ j ), F p νa p + N p, diffusion convection convection-diffusion gives the pressure convection-diffusion preconditioner : (BF 1 B T ) 1 Q 1 F p A 1 p }{{} amg David Kay & Daniel Loghin (& Andy Wathen) A Green s function preconditioner for the steady-state Navier-Stokes equations Report NA 99/06, Oxford University Computing Lab. SIAM J. Sci. Comput, 24, 2002.

39 Zeist 2009 p. 34/43 Schur complement approximation II Introducing the diagonal of the velocity mass matrix M M ij ( φ i, φ j ), gives the least-squares commutator preconditioner : (BF 1 B T ) 1 (BM 1 B T ) 1 (BM }{{} 1 amg FM 1 B T )(BM 1 B T ) 1 } {{ } amg Howard Elman (& Ray Tuminaro et al.) Preconditioning for the steady-state Navier-Stokes equations with low viscosity, SIAM J. Sci. Comput, 20, Block preconditioners based on approximate commutators, SIAM J. Sci. Comput, 27, 2006.

40 Zeist 2009 p. 35/43 ( F B T B 0 ) ( ) u p f,

41 Zeist 2009 p. 36/43 IFISS2.2 computational results Final step of Oseen iteration : R 2/ν # GMRES iterations using Q 2 Q 1 (Q 1 P 0 ) tol 10 6 Exact Least Squares Commutator 1/h R 10 R 100 R (15) 17 (16) 6 19 (21) 21 (22) 29 (32) 7 23 (31) 29 (32) 29 (30)

42 Zeist 2009 p. 37/43 Update : Howard Elman & Alison Ramage & David Silvester, Algorithm 866 : IFISS, a Matlab toolbox for modelling incompressible flow, ACM Trans. Math. Soft. 33, Howard Elman (& Silvester et al.) Least squares preconditioners for stabilized discretizations of the Navier-Stokes equations, SIAM J. Sci. Comput, 30, Howard Elman & Ray Tuminaro Boundary conditions in approximate commutator preconditioners for the Navier-Stokes equations, Report UMIACS TR , University of Maryland.

43 Zeist 2009 p. 38/43 Darcy Flow Equations Given boundary pressure head data g, and an isotropic permeability matrix A µi 2, such that 0 < µ µ( x) µ < x D R 2 : we want to compute the pair ( u,p) such that A 1 u + p 0 in D, u 0 in D, p g on Γ D ; u n 0 on Γ N.

44 Example: Groundwater Flow Zeist 2009 p. 39/43

45 Zeist 2009 p. 40/43 Finite element matrix formulation Introducing the basis sets X h span{ φ i } n u i1, Flux basis functions; M h span{ψ j } n p j1 ; Pressure basis functions. gives the discretized system ( M B T ) u B 0 p g 0, with associated matrices: M ij (µ 1 φi, φ j ), B ij ( φ j,ψ i ), local mass divergence

46 Zeist 2009 p. 41/43 Fast Saddle-Point Solver We solve the (symmetric ) system Lx f M B T B 0 with M R n u n u, and B R n p n u, using MINRES with the block diagonal preconditioning P 1 M Q 1. u p g 0

47 Zeist 2009 p. 42/43 Given that the blocks M (mass matrix diagonal) and Q (via amg ) satisfy γ 2 ut Mu u T M u Γ2 u R n u, θ 2 pt BM 1 B T p p T Q p Θ 2 p R n p, then the eigenvalues of the preconditioned problem, ( M B T ) ) B 0 u p λ ( M 0 0 Q lie in the union of intervals that are bounded away from zero and ±, independently of h and µ. u p,

48 Zeist 2009 p. 43/43 Catherine Powell & David Silvester Optimal Preconditioning for Raviart-Thomas Mixed Formulation of Second-Order Elliptic Problems SIAM J. Matrix Anal. Appl., 25, David Silvester & Catherine Powell PIFISS Potential (Incompressible) Flow & Iterative Solution Software guide, MIMS Eprint

49 Zeist 2009 p. 43/43 Catherine Powell & David Silvester Optimal Preconditioning for Raviart-Thomas Mixed Formulation of Second-Order Elliptic Problems SIAM J. Matrix Anal. Appl., 25, David Silvester & Catherine Powell PIFISS Potential (Incompressible) Flow & Iterative Solution Software guide, MIMS Eprint For an extension to the more practical case of a random permeability field A 1 : T 1 ( x,ω): Oliver Ernst, Catherine Powell, David Silvester & Elisabeth Ullmann, Efficient Solvers for a Linear Stochastic Galerkin Mixed Formulation of Diffusion Problems with Random Data, SIAM J. Sci. Comput, 31, 2009.

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

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

A Robust Preconditioned Iterative Method for the Navier-Stokes Equations with High Reynolds Numbers

A Robust Preconditioned Iterative Method for the Navier-Stokes Equations with High Reynolds Numbers Applied and Computational Mathematics 2017; 6(4): 202-207 http://www.sciencepublishinggroup.com/j/acm doi: 10.11648/j.acm.20170604.18 ISSN: 2328-5605 (Print); ISSN: 2328-5613 (Online) A Robust Preconditioned

More information

Efficient Solvers for Stochastic Finite Element Saddle Point Problems

Efficient Solvers for Stochastic Finite Element Saddle Point Problems Efficient Solvers for Stochastic Finite Element Saddle Point Problems Catherine E. Powell c.powell@manchester.ac.uk School of Mathematics University of Manchester, UK Efficient Solvers for Stochastic Finite

More information

A Review of Solution Techniques for Unsteady Incompressible Flow

A Review of Solution Techniques for Unsteady Incompressible Flow Zeist 2009 p. 1/57 A Review of Solution Techniques for Unsteady Incompressible Flow David Silvester School of Mathematics University of Manchester Zeist 2009 p. 2/57 PDEs Review : 1966 1999 Update : 2000

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

Fast Solvers for Unsteady Incompressible Flow

Fast Solvers for Unsteady Incompressible Flow ICFD25 Workshop p. 1/39 Fast Solvers for Unsteady Incompressible Flow David Silvester University of Manchester http://www.maths.manchester.ac.uk/~djs/ ICFD25 Workshop p. 2/39 Outline Semi-Discrete Navier-Stokes

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

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

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

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

IFISS: A computational laboratory for investigating incompressible flow problems. Elman, Howard C. and Ramage, Alison and Silvester, David J.

IFISS: A computational laboratory for investigating incompressible flow problems. Elman, Howard C. and Ramage, Alison and Silvester, David J. IFISS: A computational laboratory for investigating incompressible flow problems Elman, Howard C. and Ramage, Alison and Silvester, David J. 22 MIMS EPrint: 22.8 Manchester Institute for Mathematical Sciences

More information

Uncertainty Quantification: Does it need efficient linear algebra?

Uncertainty Quantification: Does it need efficient linear algebra? USA trip October 2014 p. 1/62 Uncertainty Quantification: Does it need efficient linear algebra? David Silvester University of Manchester, UK Catherine Powell University of Manchester,UK Yes. USA trip

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

Finding Rightmost Eigenvalues of Large, Sparse, Nonsymmetric Parameterized Eigenvalue Problems

Finding Rightmost Eigenvalues of Large, Sparse, Nonsymmetric Parameterized Eigenvalue Problems Finding Rightmost Eigenvalues of Large, Sparse, Nonsymmetric Parameterized Eigenvalue Problems AMSC 663-664 Final Report Minghao Wu AMSC Program mwu@math.umd.edu Dr. Howard Elman Department of Computer

More information

Numerische Mathematik

Numerische Mathematik Numer. Math. (2002) 90: 665 688 Digital Object Identifier (DOI) 10.1007/s002110100300 Numerische Mathematik Performance and analysis of saddle point preconditioners for the discrete steady-state Navier-Stokes

More information

Iterative solvers for saddle point algebraic linear systems: tools of the trade. V. Simoncini

Iterative solvers for saddle point algebraic linear systems: tools of the trade. V. Simoncini Iterative solvers for saddle point algebraic linear systems: tools of the trade V. Simoncini Dipartimento di Matematica, Università di Bologna and CIRSA, Ravenna, Italy valeria@dm.unibo.it 1 The problem

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

ON THE GENERALIZED DETERIORATED POSITIVE SEMI-DEFINITE AND SKEW-HERMITIAN SPLITTING PRECONDITIONER *

ON THE GENERALIZED DETERIORATED POSITIVE SEMI-DEFINITE AND SKEW-HERMITIAN SPLITTING PRECONDITIONER * Journal of Computational Mathematics Vol.xx, No.x, 2x, 6. http://www.global-sci.org/jcm doi:?? ON THE GENERALIZED DETERIORATED POSITIVE SEMI-DEFINITE AND SKEW-HERMITIAN SPLITTING PRECONDITIONER * Davod

More information

PRECONDITIONING TECHNIQUES FOR NEWTON S METHOD FOR THE INCOMPRESSIBLE NAVIER STOKES EQUATIONS

PRECONDITIONING TECHNIQUES FOR NEWTON S METHOD FOR THE INCOMPRESSIBLE NAVIER STOKES EQUATIONS BIT Numerical Mathematics 43: 961 974, 2003. 2003 Kluwer Academic Publishers. Printed in the Netherlands. 961 PRECONDITIONING TECHNIQUES FOR NEWTON S METHOD FOR THE INCOMPRESSIBLE NAVIER STOKES EQUATIONS

More information

ON A GENERAL CLASS OF PRECONDITIONERS FOR NONSYMMETRIC GENERALIZED SADDLE POINT PROBLEMS

ON A GENERAL CLASS OF PRECONDITIONERS FOR NONSYMMETRIC GENERALIZED SADDLE POINT PROBLEMS U..B. Sci. Bull., Series A, Vol. 78, Iss. 4, 06 ISSN 3-707 ON A GENERAL CLASS OF RECONDIIONERS FOR NONSYMMERIC GENERALIZED SADDLE OIN ROBLE Fatemeh anjeh Ali BEIK his paper deals with applying a class

More information

UNIVERSITY OF MARYLAND PRECONDITIONERS FOR THE DISCRETE STEADY-STATE NAVIER-STOKES EQUATIONS CS-TR #4164 / UMIACS TR # JULY 2000

UNIVERSITY OF MARYLAND PRECONDITIONERS FOR THE DISCRETE STEADY-STATE NAVIER-STOKES EQUATIONS CS-TR #4164 / UMIACS TR # JULY 2000 UNIVERSITY OF MARYLAND INSTITUTE FOR ADVANCED COMPUTER STUDIES DEPARTMENT OF COMPUTER SCIENCE PERFORMANCE AND ANALYSIS OF SADDLE POINT PRECONDITIONERS FOR THE DISCRETE STEADY-STATE NAVIER-STOKES EQUATIONS

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

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

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

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

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

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

arxiv: v1 [math.na] 26 Dec 2013

arxiv: v1 [math.na] 26 Dec 2013 General constraint preconditioning iteration method for singular saddle-point problems Ai-Li Yang a,, Guo-Feng Zhang a, Yu-Jiang Wu a,b a School of Mathematics and Statistics, Lanzhou University, Lanzhou

More information

Numerical behavior of inexact linear solvers

Numerical behavior of inexact linear solvers Numerical behavior of inexact linear solvers Miro Rozložník joint results with Zhong-zhi Bai and Pavel Jiránek Institute of Computer Science, Czech Academy of Sciences, Prague, Czech Republic The fourth

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

Solving the steady state diffusion equation with uncertainty Final Presentation

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

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 23: GMRES and Other Krylov Subspace Methods; Preconditioning

AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 23: GMRES and Other Krylov Subspace Methods; Preconditioning AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 23: GMRES and Other Krylov Subspace Methods; Preconditioning Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Numerical Analysis I 1 / 18 Outline

More information

Efficient iterative algorithms for linear stability analysis of incompressible flows

Efficient iterative algorithms for linear stability analysis of incompressible flows IMA Journal of Numerical Analysis Advance Access published February 27, 215 IMA Journal of Numerical Analysis (215) Page 1 of 21 doi:1.193/imanum/drv3 Efficient iterative algorithms for linear stability

More information

Department of Computer Science, University of Illinois at Urbana-Champaign

Department of Computer Science, University of Illinois at Urbana-Champaign Department of Computer Science, University of Illinois at Urbana-Champaign Probing for Schur Complements and Preconditioning Generalized Saddle-Point Problems Eric de Sturler, sturler@cs.uiuc.edu, http://www-faculty.cs.uiuc.edu/~sturler

More information

STOPPING CRITERIA FOR MIXED FINITE ELEMENT PROBLEMS

STOPPING CRITERIA FOR MIXED FINITE ELEMENT PROBLEMS STOPPING CRITERIA FOR MIXED FINITE ELEMENT PROBLEMS M. ARIOLI 1,3 AND D. LOGHIN 2 Abstract. We study stopping criteria that are suitable in the solution by Krylov space based methods of linear and non

More information

Indefinite and physics-based preconditioning

Indefinite and physics-based preconditioning Indefinite and physics-based preconditioning Jed Brown VAW, ETH Zürich 2009-01-29 Newton iteration Standard form of a nonlinear system F (u) 0 Iteration Solve: Update: J(ũ)u F (ũ) ũ + ũ + u Example (p-bratu)

More information

1. Introduction. We consider the solution of systems of linear equations with the following block 2 2 structure:

1. Introduction. We consider the solution of systems of linear equations with the following block 2 2 structure: SIAM J. MATRIX ANAL. APPL. Vol. 26, No. 1, pp. 20 41 c 2004 Society for Industrial and Applied Mathematics A PRECONDITIONER FOR GENERALIZED SADDLE POINT PROBLEMS MICHELE BENZI AND GENE H. GOLUB Abstract.

More information

Algebraic Multigrid Methods for the Oseen Problem

Algebraic Multigrid Methods for the Oseen Problem Algebraic Multigrid Methods for the Oseen Problem Markus Wabro Joint work with: Walter Zulehner, Linz www.numa.uni-linz.ac.at This work has been supported by the Austrian Science Foundation Fonds zur Förderung

More information

1. Introduction. Consider the Navier Stokes equations ηu t ν 2 u + (u grad) u + grad p = f div u = 0 (1.1)

1. Introduction. Consider the Navier Stokes equations ηu t ν 2 u + (u grad) u + grad p = f div u = 0 (1.1) University of Maryland Department of Computer Science TR-C4930 University of Maryland Institute for Advanced Computer Studies TR-009-0 BOUNDARY CONDITIONS IN APPROXIMATE COMMUTATOR PRECONDITIONERS FOR

More information

Theoretical advances. To illustrate our approach, consider the scalar ODE model,

Theoretical advances. To illustrate our approach, consider the scalar ODE model, Final Report GR/R69/ : Analysis of Numerical Methods for Incompressible Fluid Dynamics Personnel supported: Professor Philip Gresho (nominated Visiting Fellow; visited UK: 7/6/ 5//). Dr David Kay (visited

More information

SEMI-CONVERGENCE ANALYSIS OF THE INEXACT UZAWA METHOD FOR SINGULAR SADDLE POINT PROBLEMS

SEMI-CONVERGENCE ANALYSIS OF THE INEXACT UZAWA METHOD FOR SINGULAR SADDLE POINT PROBLEMS REVISTA DE LA UNIÓN MATEMÁTICA ARGENTINA Vol. 53, No. 1, 2012, 61 70 SEMI-CONVERGENCE ANALYSIS OF THE INEXACT UZAWA METHOD FOR SINGULAR SADDLE POINT PROBLEMS JIAN-LEI LI AND TING-ZHU HUANG Abstract. Recently,

More information

Preconditioners for reduced saddle point systems arising in elliptic PDE-constrained optimization problems

Preconditioners for reduced saddle point systems arising in elliptic PDE-constrained optimization problems Zeng et al. Journal of Inequalities and Applications 205 205:355 DOI 0.86/s3660-05-0879-x RESEARCH Open Access Preconditioners for reduced saddle point systems arising in elliptic PDE-constrained optimization

More information

Some Preconditioning Techniques for Saddle Point Problems

Some Preconditioning Techniques for Saddle Point Problems Some Preconditioning Techniques for Saddle Point Problems Michele Benzi 1 and Andrew J. Wathen 2 1 Department of Mathematics and Computer Science, Emory University, Atlanta, Georgia 30322, USA. benzi@mathcs.emory.edu

More information

Journal of Computational and Applied Mathematics. Optimization of the parameterized Uzawa preconditioners for saddle point matrices

Journal of Computational and Applied Mathematics. Optimization of the parameterized Uzawa preconditioners for saddle point matrices Journal of Computational Applied Mathematics 6 (009) 136 154 Contents lists available at ScienceDirect Journal of Computational Applied Mathematics journal homepage: wwwelseviercom/locate/cam Optimization

More information

ON A SPLITTING PRECONDITIONER FOR SADDLE POINT PROBLEMS

ON A SPLITTING PRECONDITIONER FOR SADDLE POINT PROBLEMS J. Appl. Math. & Informatics Vol. 36(208, No. 5-6, pp. 459-474 https://doi.org/0.437/jami.208.459 ON A SPLITTING PRECONDITIONER FOR SADDLE POINT PROBLEMS DAVOD KHOJASTEH SALKUYEH, MARYAM ABDOLMALEKI, SAEED

More information

Spectral Properties of Saddle Point Linear Systems and Relations to Iterative Solvers Part I: Spectral Properties. V. Simoncini

Spectral Properties of Saddle Point Linear Systems and Relations to Iterative Solvers Part I: Spectral Properties. V. Simoncini Spectral Properties of Saddle Point Linear Systems and Relations to Iterative Solvers Part I: Spectral Properties V. Simoncini Dipartimento di Matematica, Università di ologna valeria@dm.unibo.it 1 Outline

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

ETNA Kent State University

ETNA Kent State University Electronic Transactions on Numerical Analysis. Volume 35, pp. 57-80, 009. Copyright 009,. ISSN 1068-9613. ETNA BOUNDARY CONDITIONS IN APPROXIMATE COMMUTATOR PRECONDITIONERS FOR THE NAVIER-STOKES EQUATIONS

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

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

Schur Complements on Hilbert Spaces and Saddle Point Systems

Schur Complements on Hilbert Spaces and Saddle Point Systems Schur Complements on Hilbert Spaces and Saddle Point Systems Constantin Bacuta Mathematical Sciences, University of Delaware, 5 Ewing Hall 976 Abstract For any continuous bilinear form defined on a pair

More information

H(div) Preconditioning for a Mixed Finite Element Formulation of the Stochastic Diffusion Problem 1

H(div) Preconditioning for a Mixed Finite Element Formulation of the Stochastic Diffusion Problem 1 University of Maryland Department of Computer Science CS-TR-4918 University of Maryland Institute for Advanced Computer Studies UMIACS-TR-2008-15 H(div) Preconditioning for a Mixed Finite Element Formulation

More information

Adaptive preconditioners for nonlinear systems of equations

Adaptive preconditioners for nonlinear systems of equations Adaptive preconditioners for nonlinear systems of equations L. Loghin D. Ruiz A. Touhami CERFACS Technical Report TR/PA/04/42 Also ENSEEIHT-IRIT Technical Report RT/TLSE/04/02 Abstract The use of preconditioned

More information

arxiv: v1 [math.na] 18 Dec 2017

arxiv: v1 [math.na] 18 Dec 2017 A Bramble-Pasciak conjugate gradient method for discrete Stokes problems with lognormal random viscosity arxiv:1712.06472v1 [math.na] 18 Dec 2017 Christopher Müller 1,2, Sebastian Ullmann 1,2, and Jens

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

c 2006 Society for Industrial and Applied Mathematics

c 2006 Society for Industrial and Applied Mathematics SIAM J. SCI. COMPUT. Vol. 27, No. 5, pp. 1651 1668 c 2006 Society for Industrial and Applied Mathematics BLOCK PRECONDITIONERS BASED ON APPROXIMATE COMMUTATORS HOWARD ELMAN, VICTORIA E. HOWLE, JOHN SHADID,

More information

Combination Preconditioning of saddle-point systems for positive definiteness

Combination Preconditioning of saddle-point systems for positive definiteness Combination Preconditioning of saddle-point systems for positive definiteness Andy Wathen Oxford University, UK joint work with Jen Pestana Eindhoven, 2012 p.1/30 compute iterates with residuals Krylov

More information

CONVERGENCE BOUNDS FOR PRECONDITIONED GMRES USING ELEMENT-BY-ELEMENT ESTIMATES OF THE FIELD OF VALUES

CONVERGENCE BOUNDS FOR PRECONDITIONED GMRES USING ELEMENT-BY-ELEMENT ESTIMATES OF THE FIELD OF VALUES European Conference on Computational Fluid Dynamics ECCOMAS CFD 2006 P. Wesseling, E. Oñate and J. Périaux (Eds) c TU Delft, The Netherlands, 2006 CONVERGENCE BOUNDS FOR PRECONDITIONED GMRES USING ELEMENT-BY-ELEMENT

More information

Unsteady Incompressible Flow Simulation Using Galerkin Finite Elements with Spatial/Temporal Adaptation

Unsteady Incompressible Flow Simulation Using Galerkin Finite Elements with Spatial/Temporal Adaptation Unsteady Incompressible Flow Simulation Using Galerkin Finite Elements with Spatial/Temporal Adaptation Mohamed S. Ebeida Carnegie Mellon University, Pittsburgh, PA 15213 Roger L. Davis and Roland W. Freund

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

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

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

On the Superlinear Convergence of MINRES. Valeria Simoncini and Daniel B. Szyld. Report January 2012

On the Superlinear Convergence of MINRES. Valeria Simoncini and Daniel B. Szyld. Report January 2012 On the Superlinear Convergence of MINRES Valeria Simoncini and Daniel B. Szyld Report 12-01-11 January 2012 This report is available in the World Wide Web at http://www.math.temple.edu/~szyld 0 Chapter

More information

On the interplay between discretization and preconditioning of Krylov subspace methods

On the interplay between discretization and preconditioning of Krylov subspace methods On the interplay between discretization and preconditioning of Krylov subspace methods Josef Málek and Zdeněk Strakoš Nečas Center for Mathematical Modeling Charles University in Prague and Czech Academy

More information

Structured Preconditioners for Saddle Point Problems

Structured Preconditioners for Saddle Point Problems Structured Preconditioners for Saddle Point Problems V. Simoncini Dipartimento di Matematica Università di Bologna valeria@dm.unibo.it p. 1 Collaborators on this project Mario Arioli, RAL, UK Michele Benzi,

More information

UNIVERSITY OF MARYLAND NAVIER-STOKES EQUATIONS CS-TR #4073 / UMIACS TR #99-66 OCTOBER 1999

UNIVERSITY OF MARYLAND NAVIER-STOKES EQUATIONS CS-TR #4073 / UMIACS TR #99-66 OCTOBER 1999 UNIVERSITY OF MARYLAND INSTITUTE FOR ADVANCED COMPUTER STUDIES DEPARTMENT OF COMPUTER SCIENCE EFFICIENT PRECONDITIONING OF THE LINEARIZED NAVIER-STOKES EQUATIONS CS-TR #4073 / UMIACS TR #99-66 DAVID SILVESTER

More information

Preconditioned GMRES Revisited

Preconditioned GMRES Revisited Preconditioned GMRES Revisited Roland Herzog Kirk Soodhalter UBC (visiting) RICAM Linz Preconditioning Conference 2017 Vancouver August 01, 2017 Preconditioned GMRES Revisited Vancouver 1 / 32 Table of

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

DELFT UNIVERSITY OF TECHNOLOGY

DELFT UNIVERSITY OF TECHNOLOGY DELFT UNIVERSITY OF TECHNOLOGY REPORT 13-07 On preconditioning incompressible non-newtonian flow problems Xin He, Maya Neytcheva and Cornelis Vuik ISSN 1389-6520 Reports of the Delft Institute of Applied

More information

FINDING RIGHTMOST EIGENVALUES OF LARGE SPARSE NONSYMMETRIC PARAMETERIZED EIGENVALUE PROBLEMS

FINDING RIGHTMOST EIGENVALUES OF LARGE SPARSE NONSYMMETRIC PARAMETERIZED EIGENVALUE PROBLEMS FINDING RIGHTMOST EIGENVALUES OF LARGE SPARSE NONSYMMETRIC PARAMETERIZED EIGENVALUE PROBLEMS Department of Mathematics University of Maryland, College Park Advisor: Dr. Howard Elman Department of Computer

More information

c 2011 Society for Industrial and Applied Mathematics

c 2011 Society for Industrial and Applied Mathematics IAM J NUMER ANAL Vol 49, No 2, pp 770 788 c 2011 ociety for Industrial and Applied Mathematics FIELD-OF-VALUE CONVERGENCE ANALYI OF AUGMENTED LAGRANGIAN PRECONDITIONER FOR THE LINEARIZED NAVIER TOKE PROBLEM

More information

On the accuracy of saddle point solvers

On the accuracy of saddle point solvers On the accuracy of saddle point solvers Miro Rozložník joint results with Valeria Simoncini and Pavel Jiránek Institute of Computer Science, Czech Academy of Sciences, Prague, Czech Republic Seminar at

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

Convergence Properties of Preconditioned Hermitian and Skew-Hermitian Splitting Methods for Non-Hermitian Positive Semidefinite Matrices

Convergence Properties of Preconditioned Hermitian and Skew-Hermitian Splitting Methods for Non-Hermitian Positive Semidefinite Matrices Convergence Properties of Preconditioned Hermitian and Skew-Hermitian Splitting Methods for Non-Hermitian Positive Semidefinite Matrices Zhong-Zhi Bai 1 Department of Mathematics, Fudan University Shanghai

More information

Solving Large Nonlinear Sparse Systems

Solving Large Nonlinear Sparse Systems Solving Large Nonlinear Sparse Systems Fred W. Wubs and Jonas Thies Computational Mechanics & Numerical Mathematics University of Groningen, the Netherlands f.w.wubs@rug.nl Centre for Interdisciplinary

More information

Preconditioning the incompressible Navier-Stokes equations with variable viscosity

Preconditioning the incompressible Navier-Stokes equations with variable viscosity Preconditioning the incompressible Navier-Stokes equations with variable viscosity Xin He and Maya Neytcheva Abstract This paper deals with preconditioners for the iterative solution of the discrete Oseen

More information

Indefinite Preconditioners for PDE-constrained optimization problems. V. Simoncini

Indefinite Preconditioners for PDE-constrained optimization problems. V. Simoncini Indefinite Preconditioners for PDE-constrained optimization problems V. Simoncini Dipartimento di Matematica, Università di Bologna, Italy valeria.simoncini@unibo.it Partly joint work with Debora Sesana,

More information

ETNA Kent State University

ETNA Kent State University Electronic Transactions on Numerical Analysis. Volume 36, pp. 39-53, 009-010. Copyright 009,. ISSN 1068-9613. ETNA P-REGULAR SPLITTING ITERATIVE METHODS FOR NON-HERMITIAN POSITIVE DEFINITE LINEAR SYSTEMS

More information

EQUATIONS WITH LOW VISCOSITY HOWARD C. ELMAN UMIACS-TR November 1996

EQUATIONS WITH LOW VISCOSITY HOWARD C. ELMAN UMIACS-TR November 1996 PRECONDITIONING FOR THE STEADY-STATE NAVIER-STOKES EQUATIONS WITH LOW VISCOSITY HOWARD C. ELMAN Report CS-TR-372 UMIACS-TR-96-82 November 996 Abstract. We introduce a preconditioner for the linearized

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

Linear algebra issues in Interior Point methods for bound-constrained least-squares problems

Linear algebra issues in Interior Point methods for bound-constrained least-squares problems Linear algebra issues in Interior Point methods for bound-constrained least-squares problems Stefania Bellavia Dipartimento di Energetica S. Stecco Università degli Studi di Firenze Joint work with Jacek

More information

Numerische Mathematik

Numerische Mathematik Numer. Math. (00) 93: 333 359 Digital Object Identifier (DOI) 10.1007/s00110100386 Numerische Mathematik Two new variants of nonlinear inexact Uzawa algorithms for saddle-point problems Qiya Hu 1,, Jun

More information

: 56 (2) ISSN

: 56 (2) ISSN Elman, H.C. and Ramage, Alison and Silvester, D.J. (24) IFISS : a computational laboratory for investigating incompressible flow problems. SIAM Review, 56 (2). pp. 26-273. ISSN 36-445, http://dx.doi.org/.37/289393

More information

Block triangular preconditioner for static Maxwell equations*

Block triangular preconditioner for static Maxwell equations* Volume 3, N. 3, pp. 589 61, 11 Copyright 11 SBMAC ISSN 11-85 www.scielo.br/cam Block triangular preconditioner for static Maxwell equations* SHI-LIANG WU 1, TING-ZHU HUANG and LIANG LI 1 School of Mathematics

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

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

UZAWA TYPE ALGORITHMS FOR NONSYMMETRIC SADDLE POINT PROBLEMS

UZAWA TYPE ALGORITHMS FOR NONSYMMETRIC SADDLE POINT PROBLEMS MATHEMATICS OF COMPUTATION Volume 69, Number 230, Pages 667 689 S 0025-5718(99)01152-7 Article electronically published on May 17, 1999 UZAWA TYPE ALGORITHMS FOR NONSYMMETRIC SADDLE POINT PROBLEMS JAMES

More information

Termination criteria for inexact fixed point methods

Termination criteria for inexact fixed point methods Termination criteria for inexact fixed point methods Philipp Birken 1 October 1, 2013 1 Institute of Mathematics, University of Kassel, Heinrich-Plett-Str. 40, D-34132 Kassel, Germany Department of Mathematics/Computer

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

The antitriangular factorisation of saddle point matrices

The antitriangular factorisation of saddle point matrices The antitriangular factorisation of saddle point matrices J. Pestana and A. J. Wathen August 29, 2013 Abstract Mastronardi and Van Dooren [this journal, 34 (2013) pp. 173 196] recently introduced the block

More information

arxiv: v2 [math.na] 8 Apr 2017

arxiv: v2 [math.na] 8 Apr 2017 A LOW-RANK MULTIGRID METHOD FOR THE STOCHASTIC STEADY-STATE DIFFUSION PROBLEM HOWARD C. ELMAN AND TENGFEI SU arxiv:1612.05496v2 [math.na] 8 Apr 2017 Abstract. We study a multigrid method for solving large

More information

Lecture 3: Inexact inverse iteration with preconditioning

Lecture 3: Inexact inverse iteration with preconditioning Lecture 3: Department of Mathematical Sciences CLAPDE, Durham, July 2008 Joint work with M. Freitag (Bath), and M. Robbé & M. Sadkane (Brest) 1 Introduction 2 Preconditioned GMRES for Inverse Power Method

More information

Linear Solvers. Andrew Hazel

Linear Solvers. Andrew Hazel Linear Solvers Andrew Hazel Introduction Thus far we have talked about the formulation and discretisation of physical problems...... and stopped when we got to a discrete linear system of equations. Introduction

More information

Numerische Mathematik

Numerische Mathematik Numer. Math. 000) 86: 443 470 Digital Object Identifier DOI) 0.007/s00000060 Numerische Mathematik Effective preconditioning of Uzawa type schemes for a generalized Stokes problem Georgij M. Kobelkov,

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

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

A simple iterative linear solver for the 3D incompressible Navier-Stokes equations discretized by the finite element method

A simple iterative linear solver for the 3D incompressible Navier-Stokes equations discretized by the finite element method A simple iterative linear solver for the 3D incompressible Navier-Stokes equations discretized by the finite element method Report 95-64 Guus Segal Kees Vuik Technische Universiteit Delft Delft University

More information

Structured Preconditioners for Saddle Point Problems

Structured Preconditioners for Saddle Point Problems Structured Preconditioners for Saddle Point Problems V. Simoncini Dipartimento di Matematica Università di Bologna valeria@dm.unibo.it. p.1/16 Collaborators on this project Mario Arioli, RAL, UK Michele

More information