Efficient Solvers for the Navier Stokes Equations in Rotation Form

Size: px
Start display at page:

Download "Efficient Solvers for the Navier Stokes Equations in Rotation Form"

Transcription

1 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 Math) J. Liu (Emory) G. Golub (Stanford), V. Simoncini (Bologna), M. Gander (McGill)

2 Outline The classical problem Rotation form of the Navier-Stokes equations Preconditioned Krylov methods Block preconditioners HSS preconditioner Some numerical results Conclusions Papers and preprints available at benzi

3 The Classical Problem The primitive variables formulation of the Navier Stokes equations for a viscous, incompressible Newtonian fluid in a bounded domain Ω with boundary Γ reads: u t ν u + (u ) u + p = f in Ω t 0, T u = 0 in Ω t 0, T Bu = g on Γ t 0, T, u(x, t 0 ) = u 0 in Ω where u = (u, v, w) is the velocity field, p the pressure f is a known forcing term (e.g., gravity) ν > 0 is the kinematic viscosity coefficient, ν = O(Re 1 ) is the Laplace operator is the gradient, the divergence B is some type of boundary operator

4 The Classical Problem The pressure field, p, is determined up to an additive constant. To uniquely determine p we may impose some additional condition, such as Ω p d x = 0. Thes equations were first derived by Claude-Louis Navier and independently by George Gabriel Stokes. C.-L. Navier, Mémoire su le lois du mouvement des fluides, Mémoires de l Académie Royale des Sciences, VI (1823), pp G. G. Stokes, On the theories of the internal friction of fluids in motion, and of the equilibrium and motion of elastic solids, Transactions of the Cambridge Philosophical Society, VIII (1846), pp

5 The Stokes Equations The Navier Stokes equations are nonlinear. When ν is sufficiently large (highly viscous fluid) they can be approximated by the following linear equations: u t ν u + p = f u = 0 with appropriate initial and boundary conditions. The Stokes problem also arises when solving the Navier Stokes equations by operator splitting methods. The steady-case corresponds to u t = 0.

6 The Stokes Equations The steady-state Stokes equations can also be interpreted as the Euler Lagrange PDEs for the constrained variational problem 1 2 Minimize Ω u 2 dx subject to u = 0. Ω f u dx Note that the pressure p plays the role of the Lagrange multiplier.

7 Discretization of the Stokes Equations Consider for simplicity the case of zero Dirichlet boundary conditions, Bu = 0, and assume f (L 2 (Ω)) d, d = 2 or d = 3. Letting V = (H 1 0 (Ω))d and Q = { q L 2 (Ω) Ω p dx = 0} the weak formulation of the steady Stokes problem is:

8 Discretization of the Stokes Equations Consider for simplicity the case of zero Dirichlet boundary conditions, Bu = 0, and assume f (L 2 (Ω)) d, d = 2 or d = 3. Letting V = (H 1 0 (Ω))d and Q = { q L 2 (Ω) Ω p dx = 0} the weak formulation of the steady Stokes problem is: Find u = (u 1,..., u d ) T V and p Q such that d i=1 Ω u i v i dx Ω Ω p div v dx = Ω q div u dx = 0 q Q. f v dx v V,

9 Discretization of the Stokes Equations Consider for simplicity the case of zero Dirichlet boundary conditions, Bu = 0, and assume f (L 2 (Ω)) d, d = 2 or d = 3. Letting V = (H 1 0 (Ω))d and Q = { q L 2 (Ω) Ω p dx = 0} the weak formulation of the steady Stokes problem is: Find u = (u 1,..., u d ) T V and p Q such that d i=1 Ω u i v i dx Ω Ω p div v dx = Ω q div u dx = 0 q Q. f v dx v V, Discretization using mixed finite elements leads to large, sparse linear algebraic systems.

10 Discretization of the Stokes Equations The discrete equations have the following block form: A B T B O u p = f 0 where (2D case) L O A = O L and B = B 1 B 2. Here L B 1 x, B 2 y A is symmetric positive definite, n n B is m n, m < n In the unsteady case: L + α, α = O(δt 1 ) saddle point problem

11 Steady Navier Stokes Equations Consider now the steady-state Navier Stokes equations ν u + (u grad) u + p = f in Ω div u = 0 in Ω u = 0 on Γ To solve these equations we use a linearization process, in which the nonlinear system is replaced by a sequence of linear problems. Under certain assumptions, the solutions of the linear problems converge to the solution of the nonlinear problem.

12 Steady Navier Stokes Equations Consider now the steady-state Navier Stokes equations ν u + (u grad) u + p = f in Ω div u = 0 in Ω u = 0 on Γ To solve these equations we use a linearization process, in which the nonlinear system is replaced by a sequence of linear problems. Under certain assumptions, the solutions of the linear problems converge to the solution of the nonlinear problem. Two main options: Picard or Newton iteration.

13 Steady Navier Stokes Equations Picard linearization Oseen problem: ν u k+1 + (u k ) u k+1 + p k+1 = f k, div u k+1 = 0 where div u k = 0 (k = 0, 1,...). Often u 0 = 0. Under some restrictions involving ν and f 1, the iterates (u k, p k ) converge to the unique solution (u, p ) of the Navier-Stokes equations (Karakashian, SINUM 82; Girault & Raviart, 1986).

14 Steady Navier Stokes Equations Picard linearization Oseen problem: ν u k+1 + (u k ) u k+1 + p k+1 = f k, div u k+1 = 0 where div u k = 0 (k = 0, 1,...). Often u 0 = 0. Under some restrictions involving ν and f 1, the iterates (u k, p k ) converge to the unique solution (u, p ) of the Navier-Stokes equations (Karakashian, SINUM 82; Girault & Raviart, 1986). Letting u := u k+1, f k+1 := f and v := u k, the Oseen problem becomes ν u + (v ) u + p = f, div u = 0 where v is known (and divergence-free). For v = 0 we have a Stokes problem.

15 Rotation Form of the Navier-Stokes Equations Alternative: rotation form of the linearized N-S system u t ν u + w u + P = f, div u = 0 where (2D case): (w ) = ( 0 w w 0 ) w = v = v 1 x 2 + v 2 x 1 P = p v 2 (Bernoulli pressure). Based on the identity (u )u = 1 2 ( u 2 2 ) u ( u)

16 Rotation Form of the Navier-Stokes Equations In the 3D case: (w ) = 0 w 3 w 2 w 3 0 w 1 w 2 w 1 0 (w 1, w 2, w 3 ) = w = v See for example: Landau & Lifschitz, Fluid Mechanics, Addison Wesley, Chorin & Marsden, A Mathematical Introduction to Fluid Mechanics, Springer, Various papers by M. Olshanskii (e.g. NLAA 1999, SISC 2002).

17 Discretized Navier-Stokes Equations Weak formulation + Discretization nonsymmetric saddle point system: A B T B O u p = f 0 where now A A T but A is positive real: H = 1 2 (A + AT ) is positive definite

18 Discretized Navier-Stokes Equations Weak formulation + Discretization nonsymmetric saddle point system: A B T B O u p = f 0 where now A A T but A is positive real: H = 1 2 (A + AT ) is positive definite Stabilization a slightly more general problem: A B T u f = B C p 0 where C is symmetric positive semidefinite.

19 Discretized Navier Stokes Equations For the standard (convection) form of Navier Stokes we have, in 2D: L O A = O L and B = B 1 B 2. where L + (v ) B 1 x, B 2 y A = H + K, H symmetric positive definite, K = K T B is m n, m < n Unsteady case: L + (v ) + α, α = O(δt 1 )

20 Discretized Navier Stokes Equations For the rotation form of Navier Stokes we have, in 2D: L D A = D L and B = B 1 B 2. where L D is diagonal or a mass matrix B 1 x, B 2 y A = H + K, H symmetric positive definite, K = K T B is m n, m < n Unsteady case: L + α, α = O(δt 1 )

21 Sparsity Pattern: 2D Navier Stokes, convection form nz = 7426 Without stabilization (C = O)

22 Sparsity Pattern: 2D Navier Stokes, convection form nz = 8194 With stabilization (C O)

23 Sparsity Pattern: 2D Navier Stokes, rotation form nz = 8004 Without stabilization (C = O)

24 Solvability conditions (general case) Theorem Assume H = 1 2 (A + AT ) is positive semidefinite B has full rank: rank (B) = m C is symmetric positive semidefinite (possibly C = O) Consider the coefficient matrix A B T A = B C. Then (i) ker (H) ker (B) = {0} A invertible. (ii) A invertible ker (A) ker (B) = {0}.

25 Solvability conditions (general case) Theorem Assume H = 1 2 (A + AT ) is positive semidefinite B has full rank: rank (B) = m C is symmetric positive semidefinite (possibly C = O) Consider the coefficient matrix A B T A = B C. Then (i) ker (H) ker (B) = {0} A invertible. (ii) A invertible ker (A) ker (B) = {0}. Note that A is indefinite: it has eigenvalues on either side of the imaginary axis.

26 Positive Definite Formulation Changing the sign to the last m equations we obtain the equivalent system A B T B O u p = f 0 where the coefficient matrix is now positive definite, with eigenvalues lying in the right half-plane (positive real part). If stabilization is used, the system becomes: A B T u f = B C p 0 where C is symmetric positive semidefinite.

27 Eigenvalues for the Oseen problem Indefinite form of A

28 Eigenvalues for the Oseen problem Positive definite form of A

29 Coupled Solvers: direct vs. iterative 1. Direct methods: based on factorization of A High-quality software exists (Duff and coworkers) Stability issues (indefiniteness) Large amounts of fill-in Fairly competitive for 2D problems Too expensive for 3D problems

30 Coupled Solvers: direct vs. iterative 1. Direct methods: based on factorization of A High-quality software exists (Duff and coworkers) Stability issues (indefiniteness) Large amounts of fill-in Fairly competitive for 2D problems Too expensive for 3D problems 2. Iterative Krylov subspace methods Tend to converge slowly Effective preconditioners a must

31 Coupled Solvers: direct vs. iterative 1. Direct methods: based on factorization of A High-quality software exists (Duff and coworkers) Stability issues (indefiniteness) Large amounts of fill-in Fairly competitive for 2D problems Too expensive for 3D problems 2. Iterative Krylov subspace methods Tend to converge slowly Effective preconditioners a must Current research focus is on preconditioners A comprehensive survey is now available: M. Benzi, G. Golub and J. Liesen, Numerical solution of saddle point problems, Acta Numerica 2005,

32 Preconditioned Krylov methods Preconditioning: Find an invertible matrix P such that Krylov methods applied to the preconditioned system will converge rapidly. P 1 A x = P 1 b

33 Preconditioned Krylov methods Preconditioning: Find an invertible matrix P such that Krylov methods applied to the preconditioned system will converge rapidly. P 1 A x = P 1 b Rapid convergence is often associated with a clustered spectrum of P 1 A. However, characterizing the rate of convergence in general is not an easy matter.

34 Preconditioned Krylov methods Preconditioning: Find an invertible matrix P such that Krylov methods applied to the preconditioned system will converge rapidly. P 1 A x = P 1 b Rapid convergence is often associated with a clustered spectrum of P 1 A. However, characterizing the rate of convergence in general is not an easy matter. To be effective, a preconditioner must significantly reduce the total amount of work: P must be easy to compute Evaluating z = P 1 r must be cheap

35 Preconditioned Krylov methods Available options: 1. Symmetric A: MINRES (Paige & Saunders, SINUM 76) SQMR (Freund & Nachtigal, APNUM 95) Preconditioner must be SPD for MINRES Preconditioner can be symm. indefinite for SQMR

36 Preconditioned Krylov methods Available options: 1. Symmetric A: MINRES (Paige & Saunders, SINUM 76) SQMR (Freund & Nachtigal, APNUM 95) Preconditioner must be SPD for MINRES Preconditioner can be symm. indefinite for SQMR 2. Nonsymmetric A: GMRES (Saad & Schultz, SISSC 86) Bi-CGSTAB (van der Vorst, SSISC 91) Preconditioner can be anything

37 Preconditioned Krylov methods Available options: 1. Symmetric A: MINRES (Paige & Saunders, SINUM 76) SQMR (Freund & Nachtigal, APNUM 95) Preconditioner must be SPD for MINRES Preconditioner can be symm. indefinite for SQMR 2. Nonsymmetric A: GMRES (Saad & Schultz, SISSC 86) Bi-CGSTAB (van der Vorst, SSISC 91) Preconditioner can be anything Recent trend: Use GMRES or Bi-CGSTAB with a nonsymmetric preconditioner, even when A is symmetric (Stokes).

38 Preconditioners for saddle point systems Options include: 1. Multigrid methods

39 Preconditioners for saddle point systems Options include: 1. Multigrid methods 2. Schur complement-based methods Block diagonal preconditioning Block triangular preconditioning Uzawa preconditioning

40 Preconditioners for saddle point systems Options include: 1. Multigrid methods 2. Schur complement-based methods Block diagonal preconditioning Block triangular preconditioning Uzawa preconditioning 3. Constraint preconditioning

41 Preconditioners for saddle point systems Options include: 1. Multigrid methods 2. Schur complement-based methods Block diagonal preconditioning Block triangular preconditioning Uzawa preconditioning 3. Constraint preconditioning 4. Hermitian/Skew-Hermitian splitting (HSS)

42 Preconditioners for saddle point systems Options include: 1. Multigrid methods 2. Schur complement-based methods Block diagonal preconditioning Block triangular preconditioning Uzawa preconditioning 3. Constraint preconditioning 4. Hermitian/Skew-Hermitian splitting (HSS) The choice of an appropriate preconditioner is highly problem-dependent.

43 Block Preconditioners If A is invertible, A has the block LU factorization A = A B T B O = I BA 1 O I A B T O S.

44 Block Preconditioners If A is invertible, A has the block LU factorization A = A B T B O = I BA 1 O I A B T O S. Letting A O A B T P D = O S, P T = O S

45 Block Preconditioners If A is invertible, A has the block LU factorization A = A B T B O = I BA 1 O I A B T O S. Letting A O A B T P D = O S, P T = O S one can readily show that The spectrum of P 1 D A is σ(p 1 D A) = {1, 1± 5 2 } The spectrum of P 1 T A is σ(p 1A) = {1} T

46 Block Preconditioners In practice, A and S are replaced by approximations: Â O Â B T P D = O Ŝ, P T = O Ŝ

47 Block Preconditioners In practice, A and S are replaced by approximations: Â O Â B T P D = O Ŝ, P T = O Ŝ Â should be spectrally equivalent to A Often, a multigrid V-cycle will do (e.g., for Stokes)

48 Block Preconditioners In practice, A and S are replaced by approximations: Â O Â B T P D = O Ŝ, P T = O Ŝ Â should be spectrally equivalent to A Often, a multigrid V-cycle will do (e.g., for Stokes) Approximating S is a tricky business, except for Stokes: S ( ) 1 S is spectrally equivalent to the identity!

49 Block Preconditioners Other methods include: Uzawa and its variants (similar to block triangular) SIMPLE (Patankar & Spalding, IJHMT 72): Â O I D 1 B T P = B BD 1 B T O I, where D = diag (A) SIMPLE often used as a smoother for MG Stokes as a preconditioner for Oseen (Golub & Wathen, SISC 98; Baggag & Sameh, CMAME 04) More recent methods for Oseen (Elman, Kay, Loghin, Silvester, Wathen,...) Needed: good approximations to S = BA 1 B T

50 Example: 2D Stokes 2D Steady problem, unit square Dirichlet BCs Uniform grid MAC discretization (stable C = O) GMRES, stopping criterion b A x k < 10 6 b BD = Block Diagonal Preconditioner BT = Block Triangular Preconditioner  = A, Ŝ = I (Ŝ = pressure mass matrix in FEM) Grid BD BT Uzawa SIMPLE

51 Example: 2D Oseen (convection form) 2D Oseen problems, constant wind, variable ν 1. Uzawa: Grid ν = 0.1 ν = 0.01 ν = > 300 > > 300 > > 300 > SIMPLE: Grid ν = 0.1 ν = 0.01 ν =

52 Example: 2D Oseen (convection form) 3. Stokes as a preconditioner: P = H B T B O, H = 1 2 (A+AT ) Grid ν = 0.1 ν = 0.01 ν = > > > 300 Optimal preconditioners exist for Stokes Oseen with small ν is a much tougher problem Poor approximations to S = BA 1 B T poor performance

53 Better preconditioners for Oseen  B T P = O Ŝ where Ŝ 1 = (BB T ) 1 BAB T (BB T ) 1. Based on S 1 = (BA 1 B T ) 1 (B T ) AB, where B = B T (BB T ) 1 (pseudoinverse). Proposed by Elman (SISC 99). Main cost: two Poisson solves, plus 2 or 3 convectiondiffusion solves per step. It still suffers from some degradation as h, ν 0 Can we do better?

54 HSS Preconditioner We now use the alternative form the saddle point system: A B T B C u p = f 0.

55 HSS Preconditioner We now use the alternative form the saddle point system: A B T B C u p = f 0. Recall that the eigenvalues of the matrix A B T A = B C satisfy R(λ) > 0.

56 HSS Preconditioner We now use the alternative form the saddle point system: A B T B C u p = f 0. Recall that the eigenvalues of the matrix A B T A = B C satisfy R(λ) > 0. Consider the splitting A = H + K, H = 1 2 (A + AT ), K = 1 2 (A AT ).

57 HSS Preconditioner Therefore A B T H O K B T A = B C = O C + B O = H + K.

58 HSS Preconditioner Therefore A B T H O K B T A = B C = O C + B O = H + K. The HSS preconditioner is defined as P r = 1 2r (H + ri)(k + ri) where r > 0. Note that A = A T K = O (Stokes case).

59 HSS Preconditioner Therefore A B T H O K B T A = B C = O C + B O = H + K. The HSS preconditioner is defined as P r = 1 2r (H + ri)(k + ri) where r > 0. Note that A = A T K = O (Stokes case). First studied in Bai, Golub & Ng (SIMAX 03); B. & Golub (SIMAX 04) Spectral analysis: B., Gander & Golub, BIT 03; Simoncini & B. (SIMAX 04)

60 HSS Preconditioner Preconditioner action: requires solving (H + ri)(k + ri) z = r at each Krylov subspace iteration, or (H + ri) v = r followed by (K + ri) z = v.

61 HSS Preconditioner Preconditioner action: requires solving (H + ri)(k + ri) z = r at each Krylov subspace iteration, or (H + ri) v = r followed by (K + ri) z = v. Similar in spirit to ADI method The first system can be efficiently solved with MG The second one is a shifted skew-symmetric system: can be efficiently solved if rotation form is used In practice, exact solves may be replaced by inexact ones

62 HSS Preconditioner Note that (K + ri) z = v can be explicitly written as K + ri B T z1 v1 B ri z 2 = v 2 where K = O D D O, D = diag(w 1, w 2,..., w n ). This is relatively easy to solve since the Schur complement ri + B(K + αi) 1 B T is sparse (since (K + ri) 1 is sparse).

63 Example: Stokes, Oseen problem Stokes (ν = ), Oseen problems on unit square Constant wind, Dirichlet BCs Uniform grids MAC discretization (stable C = O) Full GMRES, stopping criterion 10 6 Exact solves Grid ν = ν = 0.1 ν = 0.01 ν =

64 Oseen Problem: Spectra of Preconditioned Matrices (a) Spectrum for ν = 0.01 (b) Spectrum for ν = 0.001

65 Example: 2D Oseen problem A (steady) recirculating flow problem Rotation form of the equations used HSS preconditioning (r = r best 0.1): Grid ν = 0.1 ν = 0.01 ν = Block triangular preconditioning (Elman): Grid ν = 0.1 ν = 0.01 ν =

66 Example: 3D unsteady problem Unsteady, linearized, 3D problem, rotation form, ν = 0.1. HSS preconditioning: Grid t = 1 t = 1/10 t = 1/20 t = 1/50 t = 1/ Block triangular preconditioning (Elman): Grid t = 1 t = 1/10 t = 1/20 t = 1/50 t = 1/

67 Example: 3D unsteady problem Unsteady, linearized, 3D problem, rotation form, ν = HSS preconditioning: Grid t = 1 t = 1/10 t = 1/20 t = 1/50 t = 1/ Block triangular preconditioning (Elman): Grid t = 1 t = 1/10 t = 1/20 t = 1/50 t = 1/

68 Example: 3D unsteady problem Unsteady, linearized, 3D problem, rotation form, ν = HSS preconditioning: Grid t = 1 t = 1/10 t = 1/20 t = 1/50 t = 1/ Block triangular preconditioning (Elman): Grid t = 1 t = 1/10 t = 1/20 t = 1/50 t = 1/

69 Conclusions Iterative solvers for incompressible flow remain an active research area Considerable progress made in the last few years A new approach: HSS preconditioning The rotation form of the equations is advantageous! (h, ν)-independent behavior observed for unsteady problems with δt sufficiently small. Steady case: HSS as a smoother for MG?

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

Splitting Iteration Methods for Positive Definite Linear Systems

Splitting Iteration Methods for Positive Definite Linear Systems Splitting Iteration Methods for Positive Definite Linear Systems Zhong-Zhi Bai a State Key Lab. of Sci./Engrg. Computing Inst. of Comput. Math. & Sci./Engrg. Computing Academy of Mathematics and System

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

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

ON AUGMENTED LAGRANGIAN METHODS FOR SADDLE-POINT LINEAR SYSTEMS WITH SINGULAR OR SEMIDEFINITE (1,1) BLOCKS * 1. Introduction

ON AUGMENTED LAGRANGIAN METHODS FOR SADDLE-POINT LINEAR SYSTEMS WITH SINGULAR OR SEMIDEFINITE (1,1) BLOCKS * 1. Introduction Journal of Computational Mathematics Vol.xx, No.x, 200x, 1 9. http://www.global-sci.org/jcm doi:10.4208/jcm.1401-cr7 ON AUGMENED LAGRANGIAN MEHODS FOR SADDLE-POIN LINEAR SYSEMS WIH SINGULAR OR SEMIDEFINIE

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

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

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

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

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

Using Python to Solve the Navier-Stokes Equations - Applications in the Preconditioned Iterative Methods

Using Python to Solve the Navier-Stokes Equations - Applications in the Preconditioned Iterative Methods Journal of Scientific Research & Reports 7(3): 207-217 2015 Article no.jsrr.2015.202 ISSN: 2320-0227 SCIENCEDOMAIN international www.sciencedomain.org Using Python to Solve the Navier-Stokes Equations

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

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

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

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

c 2004 Society for Industrial and Applied Mathematics

c 2004 Society for Industrial and Applied Mathematics SIAM J. MATRIX ANAL. APPL. Vol. 6, No., pp. 377 389 c 004 Society for Industrial and Applied Mathematics SPECTRAL PROPERTIES OF THE HERMITIAN AND SKEW-HERMITIAN SPLITTING PRECONDITIONER FOR SADDLE POINT

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

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

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

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

X. He and M. Neytcheva. Preconditioning the incompressible Navier-Stokes equations with variable viscosity. J. Comput. Math., in press, 2012.

X. He and M. Neytcheva. Preconditioning the incompressible Navier-Stokes equations with variable viscosity. J. Comput. Math., in press, 2012. List of papers This thesis is based on the following papers, which are referred to in the text by their Roman numerals. I II III IV V VI M. Neytcheva, M. Do-Quang and X. He. Element-by-element Schur complement

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

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

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

Block preconditioners for saddle point systems arising from liquid crystal directors modeling

Block preconditioners for saddle point systems arising from liquid crystal directors modeling Noname manuscript No. (will be inserted by the editor) Block preconditioners for saddle point systems arising from liquid crystal directors modeling Fatemeh Panjeh Ali Beik Michele Benzi Received: date

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

Preconditioning Techniques for Large Linear Systems Part III: General-Purpose Algebraic Preconditioners

Preconditioning Techniques for Large Linear Systems Part III: General-Purpose Algebraic Preconditioners Preconditioning Techniques for Large Linear Systems Part III: General-Purpose Algebraic Preconditioners Michele Benzi Department of Mathematics and Computer Science Emory University Atlanta, Georgia, USA

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

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

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

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

A decade of fast and robust Helmholtz solvers

A decade of fast and robust Helmholtz solvers A decade of fast and robust Helmholtz solvers Werkgemeenschap Scientific Computing Spring meeting Kees Vuik May 11th, 212 1 Delft University of Technology Contents Introduction Preconditioning (22-28)

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

9.1 Preconditioned Krylov Subspace Methods

9.1 Preconditioned Krylov Subspace Methods Chapter 9 PRECONDITIONING 9.1 Preconditioned Krylov Subspace Methods 9.2 Preconditioned Conjugate Gradient 9.3 Preconditioned Generalized Minimal Residual 9.4 Relaxation Method Preconditioners 9.5 Incomplete

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

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

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

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

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

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

Regularized HSS iteration methods for saddle-point linear systems

Regularized HSS iteration methods for saddle-point linear systems BIT Numer Math DOI 10.1007/s10543-016-0636-7 Regularized HSS iteration methods for saddle-point linear systems Zhong-Zhi Bai 1 Michele Benzi 2 Received: 29 January 2016 / Accepted: 20 October 2016 Springer

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

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

Linear and Non-Linear Preconditioning

Linear and Non-Linear Preconditioning and Non- martin.gander@unige.ch University of Geneva July 2015 Joint work with Victorita Dolean, Walid Kheriji, Felix Kwok and Roland Masson (1845): First Idea of After preconditioning, it takes only three

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

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

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

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

ITERATIVE METHODS FOR DOUBLE SADDLE POINT SYSTEMS

ITERATIVE METHODS FOR DOUBLE SADDLE POINT SYSTEMS IERAIVE MEHODS FOR DOULE SADDLE POIN SYSEMS FAEMEH PANJEH ALI EIK 1 AND MIHELE ENZI Abstract. We consider several iterative methods for solving a class of linear systems with double saddle point structure.

More information

Mathematics and Computer Science

Mathematics and Computer Science Technical Report TR-2010-026 On Preconditioned MHSS Iteration Methods for Complex Symmetric Linear Systems by Zhong-Zhi Bai, Michele Benzi, Fang Chen Mathematics and Computer Science EMORY UNIVERSITY On

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

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

Inexact inverse iteration with preconditioning

Inexact inverse iteration with preconditioning Department of Mathematical Sciences Computational Methods with Applications Harrachov, Czech Republic 24th August 2007 (joint work with M. Robbé and M. Sadkane (Brest)) 1 Introduction 2 Preconditioned

More information

The solution of the discretized incompressible Navier-Stokes equations with iterative methods

The solution of the discretized incompressible Navier-Stokes equations with iterative methods The solution of the discretized incompressible Navier-Stokes equations with iterative methods Report 93-54 C. Vuik Technische Universiteit Delft Delft University of Technology Faculteit der Technische

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

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

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

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

IN this paper, we investigate spectral properties of block

IN this paper, we investigate spectral properties of block On the Eigenvalues Distribution of Preconditioned Block wo-by-two Matrix Mu-Zheng Zhu and a-e Qi Abstract he spectral properties of a class of block matrix are studied, which arise in the numercial solutions

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

DELFT UNIVERSITY OF TECHNOLOGY

DELFT UNIVERSITY OF TECHNOLOGY DELFT UNIVERSITY OF TECHNOLOGY REPORT 16-02 The Induced Dimension Reduction method applied to convection-diffusion-reaction problems R. Astudillo and M. B. van Gijzen ISSN 1389-6520 Reports of the Delft

More information

On solving linear systems arising from Shishkin mesh discretizations

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

More information

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

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

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

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

A TAXONOMY AND COMPARISON OF PARALLEL BLOCK MULTI-LEVEL PRECONDITIONERS FOR THE INCOMPRESSIBLE NAVIER STOKES EQUATIONS

A TAXONOMY AND COMPARISON OF PARALLEL BLOCK MULTI-LEVEL PRECONDITIONERS FOR THE INCOMPRESSIBLE NAVIER STOKES EQUATIONS University of Maryland Department of Computer Science R-4867 University of Maryland Institute for Advanced Computer Studies R-2007-20 A AXONOMY AND COMPARISON OF PARALLEL BLOCK MULI-LEVEL PRECONDIIONERS

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

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

Block-Triangular and Skew-Hermitian Splitting Methods for Positive Definite Linear Systems

Block-Triangular and Skew-Hermitian Splitting Methods for Positive Definite Linear Systems Block-Triangular and Skew-Hermitian Splitting Methods for Positive Definite Linear Systems Zhong-Zhi Bai State Key Laboratory of Scientific/Engineering Computing Institute of Computational Mathematics

More information

Iterative Solution methods

Iterative Solution methods p. 1/28 TDB NLA Parallel Algorithms for Scientific Computing Iterative Solution methods p. 2/28 TDB NLA Parallel Algorithms for Scientific Computing Basic Iterative Solution methods The ideas to use iterative

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

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

Performance Comparison of Relaxation Methods with Singular and Nonsingular Preconditioners for Singular Saddle Point Problems

Performance Comparison of Relaxation Methods with Singular and Nonsingular Preconditioners for Singular Saddle Point Problems Applied Mathematical Sciences, Vol. 10, 2016, no. 30, 1477-1488 HIKARI Ltd, www.m-hikari.com http://dx.doi.org/10.12988/ams.2016.6269 Performance Comparison of Relaxation Methods with Singular and Nonsingular

More information

Stabilization and Acceleration of Algebraic Multigrid Method

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

More information

The semi-convergence of GSI method for singular saddle point problems

The semi-convergence of GSI method for singular saddle point problems Bull. Math. Soc. Sci. Math. Roumanie Tome 57(05 No., 04, 93 00 The semi-convergence of GSI method for singular saddle point problems by Shu-Xin Miao Abstract Recently, Miao Wang considered the GSI method

More information

Assessment of a vorticity based solver for the Navier-Stokes equations

Assessment of a vorticity based solver for the Navier-Stokes equations Assessment of a vorticity based solver for the Navier-Stokes equations Michele Benzi Maxim A. Olshanskii Leo G. Rebholz Zhen Wang Abstract We investigate numerically a recently proposed vorticity based

More information

Prince Chidyagwai, Scott Ladenheim, and Daniel B. Szyld. Report July 2015, Revised October 2015

Prince Chidyagwai, Scott Ladenheim, and Daniel B. Szyld. Report July 2015, Revised October 2015 CONSTRAINT PRECONDITIONING FOR THE COUPLED STOKES-DARCY SYSTEM Prince Chidyagwai, Scott Ladenheim, and Daniel B. Szyld Report 5-07-9 July 05, Revised October 05 This is a report of the Department of Mathematics

More information

PDE Solvers for Fluid Flow

PDE Solvers for Fluid Flow PDE Solvers for Fluid Flow issues and algorithms for the Streaming Supercomputer Eran Guendelman February 5, 2002 Topics Equations for incompressible fluid flow 3 model PDEs: Hyperbolic, Elliptic, Parabolic

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

FEM and Sparse Linear System Solving

FEM and Sparse Linear System Solving FEM & sparse system solving, Lecture 7, Nov 3, 2017 1/46 Lecture 7, Nov 3, 2015: Introduction to Iterative Solvers: Stationary Methods http://people.inf.ethz.ch/arbenz/fem16 Peter Arbenz Computer Science

More information

Journal of Computational and Applied Mathematics. Multigrid method for solving convection-diffusion problems with dominant convection

Journal of Computational and Applied Mathematics. Multigrid method for solving convection-diffusion problems with dominant convection Journal of Computational and Applied Mathematics 226 (2009) 77 83 Contents lists available at ScienceDirect Journal of Computational and Applied Mathematics journal homepage: www.elsevier.com/locate/cam

More information

Multilevel low-rank approximation preconditioners Yousef Saad Department of Computer Science and Engineering University of Minnesota

Multilevel low-rank approximation preconditioners Yousef Saad Department of Computer Science and Engineering University of Minnesota Multilevel low-rank approximation preconditioners Yousef Saad Department of Computer Science and Engineering University of Minnesota SIAM CSE Boston - March 1, 2013 First: Joint work with Ruipeng Li Work

More information