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

Size: px
Start display at page:

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

Transcription

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

2 The problem A BT B C u v = f g A = A T, C = C T 0 Mx = b with M large, real indefinite symmetric matrix Computational Fluid Dynamics (Elman, Silvester, Wathen 2005) Elasticity problems Mixed (FE) formulations of II and IV order elliptic PDEs Linearly Constrained Programs Linear Regression in Statistics Image restoration and registration... Survey: Benzi, Golub and Liesen, Acta Num

3 Iterative solver. Convergence considerations. Mx = b M is symmetric and indefinite MINRES (Paige & Saunders, 75) x k x 0 +K k (M,r 0 ), s.t. min b Mx k r k = b Mx k, k = 0,1,..., x 0 starting guess If spec(m) [ a, b] [c,d], with b a = d c, then ( ) k ad bc b Mx 2k 2 b Mx 0 ad+ bc Note: more general but less tractable bounds available 3

4 Iterative solver. Convergence considerations. Mx = b M is symmetric and indefinite MINRES (Paige & Saunders, 75) x k x 0 +K k (M,r 0 ), s.t. min b Mx k r k = b Mx k, k = 0,1,..., x 0 starting guess If spec(m) [ a, b] [c,d], with b a = d c, then ( ) k ad bc b Mx 2k 2 b Mx 0 ad+ bc Note: more general but less tractable bounds available 4

5 Features of MINRES Residual minimizing solver for indefinite linear systems Short-term recurrence (possibly with Lanczos recurrence) Positive definite preconditioner, but not necessarily factorized (not as LL T ) Outline Harmonic Ritz values and superlinear convergence Enhancing MINRES convergence Estimating the Saddle-point problem inf-sup constant and stopping criteria 5

6 Features of MINRES Residual minimizing solver for indefinite linear systems Short-term recurrence (possibly with Lanczos recurrence) Positive definite preconditioner, but not necessarily factorized (not as LL T ) Outline Harmonic Ritz values and superlinear convergence Enhancing MINRES convergence Estimating the Saddle-point problem inf-sup constant and stopping criteria 6

7 Harmonic Ritz values K k (M,r 0 ) = span{r 0,Mr 0,...,M k 1 r 0 } (x 0 = 0) x k = φ k 1 (M)r 0 K k (M,r 0 ), φ k 1 polyn. of deg k 1 Therefore r k = r 0 Mx k = ϕ k (M)r 0, ϕ k polyn. of deg k,ϕ k (0) = 1 Harmonic Ritz values: roots of ϕ m (residual polynomial) Remark: Harmonic Ritz values approximate eigenvalues of M (Paige, Parlett & van der Vorst, 95) 7

8 Harmonic Ritz values K k (M,r 0 ) = span{r 0,Mr 0,...,M k 1 r 0 } (x 0 = 0) x k = φ k 1 (M)r 0 K k (M,r 0 ), φ k 1 polyn. of deg k 1 Therefore r k = r 0 Mx k = ϕ k (M)r 0, ϕ k polyn. of deg k,ϕ k (0) = 1 Harmonic Ritz values: roots of ϕ k (residual polynomial) Remark: Harmonic Ritz values approximate eigenvalues of M (Paige, Parlett & van der Vorst, 95) 8

9 Typical convergence pattern Harmonic Ritz values number of MINRES iterations Harmonic Ritz values as iterations proceed 9

10 Typical convergence pattern Harmonic Ritz values number of MINRES iterations Harmonic Ritz values as iterations proceed 10

11 Typical convergence pattern Harmonic Ritz values number of MINRES iterations Harmonic Ritz values as iterations proceed 11

12 Typical convergence pattern Harmonic Ritz values number of MINRES iterations Harmonic Ritz values as iterations proceed 12

13 Typical convergence pattern Harmonic Ritz values number of MINRES iterations Harmonic Ritz values as iterations proceed 13

14 Typical convergence pattern Harmonic Ritz values number of MINRES iterations Harmonic Ritz values as iterations proceed 14

15 Typical convergence pattern Harmonic Ritz values number of MINRES iterations Harmonic Ritz values as iterations proceed 15

16 Typical convergence pattern Harmonic Ritz values number of MINRES iterations Harmonic Ritz values as iterations proceed 16

17 Typical convergence pattern Harmonic Ritz values number of MINRES iterations Harmonic Ritz values as iterations proceed 17

18 Typical convergence pattern Harmonic Ritz values number of MINRES iterations Harmonic Ritz values as iterations proceed 18

19 Typical convergence pattern Harmonic Ritz values number of MINRES iterations Harmonic Ritz values as iterations proceed 19

20 Typical convergence pattern Harmonic Ritz values number of MINRES iterations Harmonic Ritz values as iterations proceed 20

21 Typical convergence pattern Harmonic Ritz values number of MINRES iterations Harmonic Ritz values as iterations proceed 21

22 Typical convergence pattern Harmonic Ritz values number of MINRES iterations Harmonic Ritz values as iterations proceed 22

23 Typical convergence pattern Harmonic Ritz values number of MINRES iterations Harmonic Ritz values as iterations proceed 23

24 Superlinear convergence residual norm number of iterations 24

25 Superlinear convergence Generalization of CG well-known result (van der Sluis & van der Vorst 86) MINRES: (van der Vorst and Vuik 93, van der Vorst 03) (λ i,z i ) eigenpairs of M TH: Assume r k = r 0 +s with r 0 z 1 Let r j be the MINRES residual after j iterations with r 0. Then r k+j F k r j, where F k = max k 2 θ (k) 1 λ 1 θ (k) 1 λ k λ 1 λ k and θ (k) 1 is the harmonic Ritz value closest to λ 1 in K k (A,r 0 ). (for a proof, Simoncini & Szyld 11, unpublished) 25

26 Superlinear convergence. A simple example. M = M δ M + δ = 10 3, spec(m ) R,spec(M + ) R + both well clustered b = 1 26

27 Superlinear convergence. An experiment. M, b data with one tiny negative eigenvalue min i θ k (i) δ residual norm min i θ k (i) δ number of iterations number of iterations M 1,b 1 data with negative eigenvalue closest to zero removed 27

28 Superlinear convergence. An experiment. M, b data with one tiny negative eigenvalue MINRES(M, b) r j min i θ k (i) δ residual norm MINRES(M 1, b 1 ) min i θ k (i) δ number of iterations number of iterations M 1,b 1 data with negative eigenvalue closest to zero removed 28

29 Enhancing MINRES convergence for Saddle Point Problems Spectral properties M = A BT B O 0 < λ n λ 1 eigs of A 0 < σ m σ 1 sing. vals of B spec(m) subset of (Rusten & Winther 1992) [ 1 2 (λ n λ 2 n +4σ1 2), 1 ] 2 (λ 1 λ σ2 m) [ λ n, 1 ] 2 (λ 1 + λ 21 +4σ21 ) More results under different hypotheses 29

30 Block diagonal Preconditioner P ideal = A 0 0 BA 1 B T MINRES converges in at most 3 its. A more practical choice: P = Ã 0 spd. Ã A S BA 1 B T 0 S spectrum in [ a, b] [c,d], a,b,c,d > 0 Robust preconditioners for PDE systems (Survey, Mardal & Winther, 11) 30

31 Block diagonal Preconditioner P ideal = A 0 0 BA 1 B T MINRES converges in at most 3 its. A more practical choice: P = Ã 0 spd. Ã A S BA 1 B T 0 S spectrum in [ a, b] [c,d], a,b,c,d > 0 Robust preconditioners for PDE systems (Survey, Mardal & Winther, 11) 31

32 A quasi-optimal approximate Schur complement (joint with M. Olshanskii) S BA 1 B T For certain operators, S is quasi-optimal: spec(ba 1 B T S 1 ) well clustered except for few eigenvalues O Note: well clustered eigs mesh-independent 32

33 A quasi-optimal approximate Schur complement (joint with M. Olshanskii) S BA 1 B T For certain operators, S is quasi-optimal: spec(ba 1 B T S 1 ) well clustered except for few eigenvalues O Often: well clustered eigs also mesh/parameter-independent 33

34 The role of S Claim: The presence of outliers in BA 1 B T S 1 is accurately inherited by the preconditioned matrix MP 1 O spec(ba 1 B T S 1 ) O spec(mp 1 ) (for a proof, see Olshanskii & Simoncini, SIMAX 10) 34

35 Side effects These spectral peculiarities have an effect on the preconditioned problem MP 1... and influence the convergence of MINRES on MP 1 Can we eliminate this influence? 35

36 Effect on MINRES convergence number of iterations Stokes-type problem 36

37 Eliminating the stagnation phase: Deflated MINRES Y = [y 1,...,y s ]: approximate eigenbasis of M * Approximation space: Augmented Lanczos sequence v j+1 span{y,v 1,v 2,...,v j }, v j+1 = 1 obtained by standard Lanczos method with coeff.matrix G := M MY(Y T MY) 1 Y T M * MINRES method: r j =ˆb Mû j GK j (G,v 1 ) û j obtained with a short-term recurrence 37

38 Augmented MINRES: Given M, b, maxit, tol, P, and Y with orthonormal columns u = Y(Y T MY) 1 Y T b starting approx, r = b Mu, r 1 = r, y = P 1 r, etc while (i < maxit) i = i+1 v = y/β; y = Mv MY(Y T MY) 1 Y T Mv if i 2, y = y (β/β 0 )r 1 α = v T y, y = y r 2 α/β r 1 = r 2, r 2 = y y = P 1 r 2 β 0 = β, β = r2 Ty e 0 = e, δ = c d+sα ḡ = s d cα e = sβ d = cβ γ = [ḡ, β] c = ḡ/γ, s = β/γ, φ = c φ, φ = s φ w 1 = w 2, w 2 = w w = (v e 0 w 1 δw 2 )γ 1 g = Y(Y T MY) 1 Y T Mwφ u = u g +φw ζ = χ 1 /γ, χ 1 = χ 2 δz, χ 2 = eζ Check preconditioned residual norm ( φ) for convergence end 38

39 Stokes-type problem with variable viscosity in Ω R d divν(x)du+ p = f in Ω, div u = 0 in Ω, u = 0 on Ω, with 0 < ν min ν(x) ν max <. (Here, ν(x) = 2µ+ τ s ε 2 + Du(x) 2) u : velocity vector field p : pressure Du = 1 2 ( u+ T u) rate of deformation tensor Prec. S: pressure mass matrix wrto weighted product (ν 1, ) L2 (Ω) (BA 1 B)S 1 well clustered spectrum, Except for few small negative eigenvalues (Grinevich & Olshanskii, 09) 39

40 Stokes-type problem with variable viscosity in Ω R d divν(x)du+ p = f in Ω, div u = 0 in Ω, u = 0 on Ω, with 0 < ν min ν(x) ν max <. (Here, ν(x) = 2µ+ τ s ε 2 + Du(x) 2) u : velocity vector field p : pressure Du = 1 2 ( u+ T u) rate of deformation tensor Prec. S: pressure mass matrix wrto weighted product (ν 1, ) L2 (Ω) (BA 1 B T )S 1 well clustered spectrum, except for few small positive eigenvalues (Grinevich & Olshanskii, 09) 40

41 Bercovier-Engelman regularized model of Bingham viscoplastic fluid * One zero pressure mode (eigvec easy to approx) * One small eigenvalue of precon d Schur Complement rough eigvec approximation : {ũ 2, p 2 } T {u 2,p 2 } T p 2 = 0 if 1 2 τ s y 1 2 +τ s, 1 if 0 y < 1 2 τ s, 1 if 1 y > 1 2 +τ s, and ũ 2 = Ã 1 B T p 2 41

42 Original and Deflated convergence histories 10 0 MINRES vs. Deflated MINRES, δ=1e 3 non deflated deflated iteration number à = IC(A,δ),δ = 10 3 (same with δ = 0) 42

43 A stopping criterion for Stokes mixed approximation (joint with D. Silvester) M = A BT B 0, P = Ã 0 0 S Ã A, S BA 1 B T Natural norm for the problem: energy norm in the u-space and p-space, x x k Pideal For stable discretization, heuristic relation between error and residual: x x k Pideal 2 γ 2 b Mx k P 1 ideal 2 γ 2 b Mx k P 1 < tol γ inf-sup constant: γ 2 qt BA 1 B T q q T Qq, q 0 43

44 A stopping criterion for Stokes mixed approximation (joint with D. Silvester) M = A BT B 0, P = Ã 0 0 S Ã A, S BA 1 B T Natural norm for the problem: energy norm in the u-space and p-space, x x k Pideal For stable discretization, heuristic relation between error and residual: x x k Pideal 2 γ 2 b Mx k P 1 ideal 2 γ 2 b Mx k P 1 < tol γ inf-sup constant: γ 2 qt BA 1 B T q q T Qq, q 0 44

45 Estimating the inf-sup constant For the preconditioned problem (Elman etal, 05): λ 1 2 (δ δ 2 +4δγ 2 ) δ λ + with δ = λ min (AÃ 1 ). If these bounds are tight (equalities), then γ 2 = λ2 λ λ + λ + In practice, adaptive estimate with Harmonic Ritz values: γ 2 γk 2 = (θ(k) ) 2 θ (k) θ (k) +, kth MINRES iteration θ (k) + Corresponding analogous results for Potential flow problem 45

46 Estimating the inf-sup constant For the preconditioned problem (Elman etal, 05): λ 1 2 (δ δ 2 +4δγ 2 ) δ λ + with δ = λ min (AÃ 1 ). If these bounds are tight (equalities), then γ 2 = λ2 λ λ + λ + In practice, adaptive estimate with Harmonic Ritz values: γ 2 γk 2 = (θ(k) ) 2 θ (k) θ (k) +, kth MINRES iteration θ (k) + Corresponding analogous results for Potential flow problem 46

47 IFISS Problem: smooth colliding flow with quartic polyn velocity soln k γ k λ k ց λ Optimal gamma=

48 Another IFISS example. Flow over a step. Optimal γ e k : error at iteration k r k : residual at iteration k 10 2 nv= nv= /γ 2 r k M /γ 2 r k M e k E e k E 10 6 r k M 10 6 r k M iteration number k iteration number k E = P ideal, M = P 1 48

49 Another IFISS example. Flow over a step. Adaptive γ k e k : error at iteration k r k : residual at iteration k 10 2 nv= nv= /γ 2 k r k M /γ 2 k r k M e k E e k E 10 6 r k M 10 6 r k M iteration number k iteration number k E = P ideal, M = P 1 49

50 Conclusions MINRES is rich in information to be exploited Adaptive problem-related stopping criteria available References: * Maxim A. Olshanskii and V. Simoncini Acquired clustering properties and solution of certain saddle point systems. SIMAX, * David J. Silvester and V. Simoncini An Optimal Iterative Solver for Symmetric Indefinite Systems stemming from Mixed Approximation. ACM TOMS, * V. Simoncini and Daniel B. Szyld, unpublished,

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

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

Ax + B T y = f or Au = b, (1.2) Bx = 0

Ax + B T y = f or Au = b, (1.2) Bx = 0 ACQUIRED CLUSTERING PROPERTIES AND SOLUTION OF CERTAIN SADDLE POINT SYSTEMS M.A. OLSHANSKII AND V. SIMONCINI Abstract. Many mathematical models involve flow equations characterized by nonconstant viscosity,

More information

c 2010 Society for Industrial and Applied Mathematics

c 2010 Society for Industrial and Applied Mathematics SIAM J. MATRIX ANAL. APPL. Vol. 3, No. 5, pp. 2754 2768 c 200 Society for Industrial and Applied Mathematics ACQUIRED CLUSTERING PROPERTIES AND SOLUTION OF CERTAIN SADDLE POINT SYSTEMS M. A. OLSHANSKII

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

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

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

Recent advances in approximation using Krylov subspaces. V. Simoncini. Dipartimento di Matematica, Università di Bologna.

Recent advances in approximation using Krylov subspaces. V. Simoncini. Dipartimento di Matematica, Università di Bologna. Recent advances in approximation using Krylov subspaces V. Simoncini Dipartimento di Matematica, Università di Bologna and CIRSA, Ravenna, Italy valeria@dm.unibo.it 1 The framework It is given an operator

More information

The Nullspace free eigenvalue problem and the inexact Shift and invert Lanczos method. V. Simoncini. Dipartimento di Matematica, Università di Bologna

The Nullspace free eigenvalue problem and the inexact Shift and invert Lanczos method. V. Simoncini. Dipartimento di Matematica, Università di Bologna The Nullspace free eigenvalue problem and the inexact Shift and invert Lanczos method V. Simoncini Dipartimento di Matematica, Università di Bologna and CIRSA, Ravenna, Italy valeria@dm.unibo.it 1 The

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

A Chebyshev-based two-stage iterative method as an alternative to the direct solution of linear systems

A Chebyshev-based two-stage iterative method as an alternative to the direct solution of linear systems A Chebyshev-based two-stage iterative method as an alternative to the direct solution of linear systems Mario Arioli m.arioli@rl.ac.uk CCLRC-Rutherford Appleton Laboratory with Daniel Ruiz (E.N.S.E.E.I.H.T)

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

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

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

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

Approximation of functions of large matrices. Part I. Computational aspects. V. Simoncini

Approximation of functions of large matrices. Part I. Computational aspects. V. Simoncini Approximation of functions of large matrices. Part I. Computational aspects V. Simoncini Dipartimento di Matematica, Università di Bologna and CIRSA, Ravenna, Italy valeria@dm.unibo.it 1 The problem Given

More information

Iterative methods for positive definite linear systems with a complex shift

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

More information

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

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

Sensitivity of Gauss-Christoffel quadrature and sensitivity of Jacobi matrices to small changes of spectral data

Sensitivity of Gauss-Christoffel quadrature and sensitivity of Jacobi matrices to small changes of spectral data Sensitivity of Gauss-Christoffel quadrature and sensitivity of Jacobi matrices to small changes of spectral data Zdeněk Strakoš Academy of Sciences and Charles University, Prague http://www.cs.cas.cz/

More information

Iterative methods for Linear System of Equations. Joint Advanced Student School (JASS-2009)

Iterative methods for Linear System of Equations. Joint Advanced Student School (JASS-2009) Iterative methods for Linear System of Equations Joint Advanced Student School (JASS-2009) Course #2: Numerical Simulation - from Models to Software Introduction In numerical simulation, Partial Differential

More information

Krylov Space Solvers

Krylov Space Solvers Seminar for Applied Mathematics ETH Zurich International Symposium on Frontiers of Computational Science Nagoya, 12/13 Dec. 2005 Sparse Matrices Large sparse linear systems of equations or large sparse

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

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

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

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

M.A. Botchev. September 5, 2014

M.A. Botchev. September 5, 2014 Rome-Moscow school of Matrix Methods and Applied Linear Algebra 2014 A short introduction to Krylov subspaces for linear systems, matrix functions and inexact Newton methods. Plan and exercises. M.A. Botchev

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

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

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

Iterative methods for Linear System

Iterative methods for Linear System Iterative methods for Linear System JASS 2009 Student: Rishi Patil Advisor: Prof. Thomas Huckle Outline Basics: Matrices and their properties Eigenvalues, Condition Number Iterative Methods Direct and

More information

FEM and sparse linear system solving

FEM and sparse linear system solving FEM & sparse linear system solving, Lecture 9, Nov 19, 2017 1/36 Lecture 9, Nov 17, 2017: Krylov space methods http://people.inf.ethz.ch/arbenz/fem17 Peter Arbenz Computer Science Department, ETH Zürich

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

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

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

More information

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

LARGE SPARSE EIGENVALUE PROBLEMS. General Tools for Solving Large Eigen-Problems

LARGE SPARSE EIGENVALUE PROBLEMS. General Tools for Solving Large Eigen-Problems LARGE SPARSE EIGENVALUE PROBLEMS Projection methods The subspace iteration Krylov subspace methods: Arnoldi and Lanczos Golub-Kahan-Lanczos bidiagonalization General Tools for Solving Large Eigen-Problems

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

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

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

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

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

More information

LARGE SPARSE EIGENVALUE PROBLEMS

LARGE SPARSE EIGENVALUE PROBLEMS LARGE SPARSE EIGENVALUE PROBLEMS Projection methods The subspace iteration Krylov subspace methods: Arnoldi and Lanczos Golub-Kahan-Lanczos bidiagonalization 14-1 General Tools for Solving Large Eigen-Problems

More information

Jae Heon Yun and Yu Du Han

Jae Heon Yun and Yu Du Han Bull. Korean Math. Soc. 39 (2002), No. 3, pp. 495 509 MODIFIED INCOMPLETE CHOLESKY FACTORIZATION PRECONDITIONERS FOR A SYMMETRIC POSITIVE DEFINITE MATRIX Jae Heon Yun and Yu Du Han Abstract. We propose

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

Iterative Methods for Linear Systems of Equations

Iterative Methods for Linear Systems of Equations Iterative Methods for Linear Systems of Equations Projection methods (3) ITMAN PhD-course DTU 20-10-08 till 24-10-08 Martin van Gijzen 1 Delft University of Technology Overview day 4 Bi-Lanczos method

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

Solving Ill-Posed Cauchy Problems in Three Space Dimensions using Krylov Methods

Solving Ill-Posed Cauchy Problems in Three Space Dimensions using Krylov Methods Solving Ill-Posed Cauchy Problems in Three Space Dimensions using Krylov Methods Lars Eldén Department of Mathematics Linköping University, Sweden Joint work with Valeria Simoncini February 21 Lars Eldén

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

Inexactness and flexibility in linear Krylov solvers

Inexactness and flexibility in linear Krylov solvers Inexactness and flexibility in linear Krylov solvers Luc Giraud ENSEEIHT (N7) - IRIT, Toulouse Matrix Analysis and Applications CIRM Luminy - October 15-19, 2007 in honor of Gérard Meurant for his 60 th

More information

Recent computational developments in Krylov Subspace Methods for linear systems. Valeria Simoncini and Daniel B. Szyld

Recent computational developments in Krylov Subspace Methods for linear systems. Valeria Simoncini and Daniel B. Szyld Recent computational developments in Krylov Subspace Methods for linear systems Valeria Simoncini and Daniel B. Szyld A later version appeared in : Numerical Linear Algebra w/appl., 2007, v. 14(1), pp.1-59.

More information

AMG for a Peta-scale Navier Stokes Code

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

More information

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 PROJECTION METHODS FOR SPARSE LINEAR SYSTEMS AND EIGENPROBLEMS CHAPTER 11 : JACOBI DAVIDSON METHOD

ITERATIVE PROJECTION METHODS FOR SPARSE LINEAR SYSTEMS AND EIGENPROBLEMS CHAPTER 11 : JACOBI DAVIDSON METHOD ITERATIVE PROJECTION METHODS FOR SPARSE LINEAR SYSTEMS AND EIGENPROBLEMS CHAPTER 11 : JACOBI DAVIDSON METHOD Heinrich Voss voss@tu-harburg.de Hamburg University of Technology Institute of Numerical Simulation

More information

Uniform inf-sup condition for the Brinkman problem in highly heterogeneous media

Uniform inf-sup condition for the Brinkman problem in highly heterogeneous media Uniform inf-sup condition for the Brinkman problem in highly heterogeneous media Raytcho Lazarov & Aziz Takhirov Texas A&M May 3-4, 2016 R. Lazarov & A.T. (Texas A&M) Brinkman May 3-4, 2016 1 / 30 Outline

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

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

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

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

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

Controlling inner iterations in the Jacobi Davidson method

Controlling inner iterations in the Jacobi Davidson method Controlling inner iterations in the Jacobi Davidson method Michiel E. Hochstenbach and Yvan Notay Service de Métrologie Nucléaire, Université Libre de Bruxelles (C.P. 165/84), 50, Av. F.D. Roosevelt, B-1050

More information

Fast iterative solvers

Fast iterative solvers Utrecht, 15 november 2017 Fast iterative solvers Gerard Sleijpen Department of Mathematics http://www.staff.science.uu.nl/ sleij101/ Review. To simplify, take x 0 = 0, assume b 2 = 1. Solving Ax = b for

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

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

arxiv: v2 [math.na] 1 Feb 2013

arxiv: v2 [math.na] 1 Feb 2013 A FRAMEWORK FOR DEFLATED AND AUGMENTED KRYLOV SUBSPACE METHODS ANDRÉ GAUL, MARTIN H. GUTKNECHT, JÖRG LIESEN AND REINHARD NABBEN arxiv:1206.1506v2 [math.na] 1 Feb 2013 Abstract. We consider deflation and

More information

CONTROLLING INNER ITERATIONS IN THE JACOBI DAVIDSON METHOD

CONTROLLING INNER ITERATIONS IN THE JACOBI DAVIDSON METHOD CONTROLLING INNER ITERATIONS IN THE JACOBI DAVIDSON METHOD MICHIEL E. HOCHSTENBACH AND YVAN NOTAY Abstract. The Jacobi Davidson method is an eigenvalue solver which uses the iterative (and in general inaccurate)

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

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

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

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

ANALYSIS OF THE MINIMAL RESIDUAL METHOD APPLIED TO ILL-POSED OPTIMALITY SYSTEMS

ANALYSIS OF THE MINIMAL RESIDUAL METHOD APPLIED TO ILL-POSED OPTIMALITY SYSTEMS ANALYSIS OF THE MINIMAL RESIDUAL METHOD APPLIED TO ILL-POSED OPTIMALITY SYSTEMS BJØRN FREDRIK NIELSEN 1 AND KENT-ANDRE MARDAL Abstract. We analyze the performance of the Minimal Residual Method applied

More information

Block-triangular preconditioners for PDE-constrained optimization

Block-triangular preconditioners for PDE-constrained optimization NUMERICAL LINEAR ALGEBRA WITH APPLICATIONS Numer. Linear Algebra Appl. () Published online in Wiley InterScience (www.interscience.wiley.com). DOI:./nla.693 Block-triangular preconditioners for PDE-constrained

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

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

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

Davidson Method CHAPTER 3 : JACOBI DAVIDSON METHOD

Davidson Method CHAPTER 3 : JACOBI DAVIDSON METHOD Davidson Method CHAPTER 3 : JACOBI DAVIDSON METHOD Heinrich Voss voss@tu-harburg.de Hamburg University of Technology The Davidson method is a popular technique to compute a few of the smallest (or largest)

More information

Key words. conjugate gradients, normwise backward error, incremental norm estimation.

Key words. conjugate gradients, normwise backward error, incremental norm estimation. Proceedings of ALGORITMY 2016 pp. 323 332 ON ERROR ESTIMATION IN THE CONJUGATE GRADIENT METHOD: NORMWISE BACKWARD ERROR PETR TICHÝ Abstract. Using an idea of Duff and Vömel [BIT, 42 (2002), pp. 300 322

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

On prescribing Ritz values and GMRES residual norms generated by Arnoldi processes

On prescribing Ritz values and GMRES residual norms generated by Arnoldi processes On prescribing Ritz values and GMRES residual norms generated by Arnoldi processes Jurjen Duintjer Tebbens Institute of Computer Science Academy of Sciences of the Czech Republic joint work with Gérard

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

PRECONDITIONED SOLUTION OF STATE GRADIENT CONSTRAINED ELLIPTIC OPTIMAL CONTROL PROBLEMS

PRECONDITIONED SOLUTION OF STATE GRADIENT CONSTRAINED ELLIPTIC OPTIMAL CONTROL PROBLEMS PRECONDITIONED SOLUTION OF STATE GRADIENT CONSTRAINED ELLIPTIC OPTIMAL CONTROL PROBLEMS Roland Herzog Susann Mach January 30, 206 Elliptic optimal control problems with pointwise state gradient constraints

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

University of Maryland Department of Computer Science TR-5009 University of Maryland Institute for Advanced Computer Studies TR April 2012

University of Maryland Department of Computer Science TR-5009 University of Maryland Institute for Advanced Computer Studies TR April 2012 University of Maryland Department of Computer Science TR-5009 University of Maryland Institute for Advanced Computer Studies TR-202-07 April 202 LYAPUNOV INVERSE ITERATION FOR COMPUTING A FEW RIGHTMOST

More information

Computational methods for large-scale matrix equations and application to PDEs. V. Simoncini

Computational methods for large-scale matrix equations and application to PDEs. V. Simoncini Computational methods for large-scale matrix equations and application to PDEs V. Simoncini Dipartimento di Matematica, Università di Bologna valeria.simoncini@unibo.it 1 Some matrix equations Sylvester

More information

Computational methods for large-scale linear matrix equations and application to FDEs. V. Simoncini

Computational methods for large-scale linear matrix equations and application to FDEs. V. Simoncini Computational methods for large-scale linear matrix equations and application to FDEs V. Simoncini Dipartimento di Matematica, Università di Bologna valeria.simoncini@unibo.it Joint work with: Tobias Breiten,

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

CONTROLLING INNER ITERATIONS IN THE JACOBI DAVIDSON METHOD

CONTROLLING INNER ITERATIONS IN THE JACOBI DAVIDSON METHOD CONTROLLING INNER ITERATIONS IN THE JACOBI DAVIDSON METHOD MICHIEL E. HOCHSTENBACH AND YVAN NOTAY Abstract. The Jacobi Davidson method is an eigenvalue solver which uses an inner-outer scheme. In the outer

More information