Iterative methods for positive definite linear systems with a complex shift

Size: px
Start display at page:

Download "Iterative methods for positive definite linear systems with a complex shift"

Transcription

1 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

2 Outline 1. Numerical solution of the heat equation 2. Richardson iteration 3. Conjugate gradients 4. Preconditioning

3 Part I Numerical solution of the heat equation

4 Initial-boundary value problem Spatial domain Ω R d. Seek u = u(x, t) such that t u (a u) = f (x, t) for x Ω and t > 0, u(x, 0) = u 0 (x) for x Ω, u(x, t) = 0 for x Ω and t > 0. L 2 inner product (u, v) = Ω u v dx. Weak formulation: seek u : [0, T ] H0 1 (Ω) such that (u t, v) + (a u, v) = ( f (t), v ) for all v H 1 0 (Ω), with u(0) = u 0.

5 Laplace transformation Write Since w(z) û(z) = L{u(t)} = 0 e zt u(t) dt, Rz > 0. L{( t u, v)} = ( zû(z) u(0), v ) = z ( w(z), v ) (u 0, v), define g(z) = u 0 + ˆf (z) then w(z) H0 1 (Ω) satisfies z ( w(z), v) + ( a w(z), v ) = ( g(z), v ) for all v H0 1 (Ω). Spectrum σ(a) on positive real axis, so if 0 < δ < π then w(z) C δ g(z) 1 + z for arg z > π δ.

6 The contour Γ

7 Laplace inversion formula For simplicity, choose Γ = { x + iy : (x 1) 2 y 2 = 1 and x 0 }. Assume ˆf (z) bounded and analytic, on and to the right of Γ, then u(t) = 1 e zt w(z) dz for t > 0, w = û. 2πi Parametric representation gives u(t) = Γ z(ξ) = 1 cosh ξ + i sinh ξ for < ξ <, v(ξ, t) dξ where v(ξ, t) = ez(ξ)t 2πi w ( z(ξ) ) z (ξ).

8 Quadrature Step size k = log q/q > 0. For j q, ξ j = jk, z j = z(ξ j ), z j = z (ξ j ). Equal-weight quadrature approximation u(t) = v(ξ, t) dξ U q (t) = k q v(ξ j, t), j= q that is, U q (t) = k 2πi q e z j t w(z j )z j. j= q Points furthest from 0: z ±q = (q + q 1 ) ± 1 2 i(q q 1 ) 1 2 ( 1 ± i)q.

9 Spatial discretization Weak solution u(t) H0 1 (Ω) satisfies (u t, v) + (a u, v) = ( f (t), v ) for all v H 1 0 (Ω), with u(0) = u 0. Conforming, piecewise-linear finite element space V h H 1 0 (Ω). Spatially discrete solution u h (t) V h satisfies (u h,t, χ) + (a u h, χ) = ( f (t), χ ) for all χ V h, subject to u h (0) = L 2 -projection of u 0 onto V h, so ( uh (0), χ ) = (u 0, χ) for all χ V h.

10 Fully-discrete solution Recall z ( w(z), v) + ( a w(z), v ) = ( g(z), v ) for all v H 1 0 (Ω). Similarly, w h (z) = û h (z) V h satisfies z ( w h (z), χ) + ( a w h (z), χ ) = ( g(z), χ ) for all χ V h. Put U q,h (t) = k 2πi q e z j t w h (z j )z j. j= q

11 Linear system Interior (free) nodes: P 1, P 2,..., P N. Nodal basis functions: Φ 1, Φ 2,..., Φ N satisfying Φ n (P m ) = δ mn. Then w h (x, z j ) = N w n (z j )Φ n (x) with w n (z j ) = w h (P n, z j ). n=1 Mass matrix, stiffness matrix, load vector: M mn = (Φ n, Φ m ), S mn = (a Φ n, Φ m ), g m = ( g(z j ), Φ m ). Need to solve (z j M + S)w = g or (z j I + M 1 S)w = M 1 g, where w = [w n ] C N and g = [g n ] C N.

12 Accuracy required for an iterative solver Iterative solver computes w h (z j ) w h (z j ), leading to The error is Ũ q,h (t) = k 2πi q e z j t w h (z j )z j. j= q Ũ q,h (t) u(t) = [ Ũ q,h (t) U q,h (t) ] + [ U q,h (t) u h (t) ] + [ u h (t) u(t) ] = k q e z j t [ w h (z j ) w h (z j ) ] z j 2πi j= q + O(e cq/ log q ) + O(h 2 ), so we desire w h (z j ) w h (z j ) ɛ j with k 2π q e x j t ɛ j z j e cq/ log q h 2. j= q

13 Part II Richardson iteration

14 The setting Finite dimensional complex vector space V with inner product (, ). Hermitian positive-definite operator A : V V, Equation with complex shift, (Av, w) = (v, Aw). A z w = b where A z = zi + A and arg z < π δ. In our example, V = C N with A = M 1 S, b = M 1 g, and so N (v, w) = Mv, w, v, w = v l w l, l=1 (Av, w) = Sv, w = v, Sw = (v, Aw).

15 The basic iteration Sheen, Sloan and Thomée (2003). For any α C, exact solution satisfies Initial guess w 0. Richardson iteration w = (I αa z )w + αb, w n+1 = (I αa z )w n + αb for n = 0, 1, 2,.... Optimal choice of the acceleration parameter α? Error e n = w n w satisfies e n+1 = (I αa z )e n, so choose α = α to minimise the error reduction ratio I αa z V V = max 1 α(z + λ). λ σ(a)

16 Slow convergence Order the eigenvalues of A as 0 < λ 1 < λ 2 < < λ N. Classical case z = 0: ɛ 0 = I α A 0 = λ N λ 1 λ N + λ 1 if α = For general z with arg z < π, can compute and find α = α (z, λ 1, λ N ) 2 λ 1 + λ N. ɛ z = I α A z 1 cλ 1 N, c = c(z, λ 1). In our case, λ N (M 1 S) = O(h 2 ) so ɛ z = I α (zi + M 1 S) 1 ch 2.

17 Preconditioning Hermitian positive-definite operator B z : V V ; mimics A 1 z. Preconditioned equation B z A z w = B z b. Preconditioned Richardson iteration w n+1 = (I αb z A z )w n + αb z b. Again seek optimal acceleration parameter α to minimize ɛ z I αb z A z.

18 Implementation without preconditioning Recall or equivalently, (zm + S)w = g, or equivalently, (zi + A)w = M 1 g, A = M 1 S, A z w = g, A z = MA z = M(zI + A) = zm + S. Residual r n = g z A z w n. Richardson iteration: w n+1 = (I αm 1 A z )w n + αm 1 g z = w n + αm 1 r n,

19 Implementation with preconditioning Let B z = B z M, with B z positive-definite and Hermitian with respect to the standard inner product, on C N, so B z is Hermitian with respect to (, ): Residual r n = g A z w n. (B z v, w) = B z Mv, Mw = (v, B z w), Preconditioned Richardson iteration w n+1 = (I αb z A z )w n + αb z M 1 g = (I αb z MA z )w n + αb z MM 1 g = (I αb z A z )w n + αb z g = w n + αb z r n.

20 Model problem finite element mesh Triangulation of Ω has N = 2663 free nodes, with maximum element diameter h =

21 Model problem other details Constant diffusivity a = 1/15 chosen to normalize the minimum eigenvalue of A = M 1 S: λ 1 (A) = and λ N (A) = Errors U h,q (t) u(t) h using a direct solver: t q = 10 q = 20 q = 30 u(t) h e e e e e e e e e e e e

22 Effect of special preconditioner B z = (µ z I + A) 1 Using optimal acceleration parameter α = ρe iϕ. Without B z With B z j x j y j ρ ϕ ɛ z ρ ϕ µ z ɛ z e e e e e e e e e e e e

23 Related literature Freund (1990): Krylov methods for (zi + A)w = b with A Hermitian and possibly indefinite. Motivated by the Helmholtz equation ω 2 u + iσu 2 u = f. Benzi and Bertaccini (2003), Bellavia et al. (2011): preconditioners in the special case of real z = x > 0, with efficient updates for different x. Motivated by implicit finite difference timestepping for parabolic PDEs. Simoncini (2003): full orthogonalization method for z = x R and xi + A nonsingular. Meerbergen (2003), Meerbergen and Bai (2010): Krylov methods for S αm, α [α min, α max ].

24 Part III Conjugate gradients

25 The setting Finite dimensional complex Hilbert space V with inner product (v, w). Positive-definite Hermitian linear operator A : V V. Seek w V satisfying where A z w = b, A z = zi + A, z = x + iy, arg z < π.

26 Krylov subspaces Initial guess w 0. Initial residual r 0 = b A z w 0 0. Krylov subspace V n = span{r 0, A z r 0,..., A n 1 z r 0 } for n 1. Notice but r 0 still depends on z. V n = span{r 0, Ar 0,..., A n 1 r 0 },

27 Galerkin method Exact solution satisfies (A z w, ϕ) = (b, ϕ) for all ϕ V. Conjugate gradient (CG) solution w n = w 0 + v n, v n V n, determined by (A z w n, ϕ) = (b, ϕ) for all ϕ V n. Thus, or ( Az (w n w 0 ), ϕ ) = (b A z w 0, ϕ), v n V n and (A z v n, ϕ) = (r 0, ϕ) for all ϕ V n.

28 Uniqueness and existence If (A z v n, ϕ) = 0 for all ϕ V n, then taking ϕ = v n gives (A z v n, v n ) = z v n 2 + (Av n, v n ) = 0, or in other words, x v n 2 + (Av n, v n ) = 0 and y v n 2 = 0, so v n = 0, by our assumption arg z < π. Hence, v n is unique. Hence, v n exists (because V is finite dimensional).

29 Key tools Put v 2 = z v 2 + (Av, v) for v V. Sesquilinear form (A z v, w) not an inner product if Rz 0, but... Lemma If θ z = arg z ( π, π) then, for all v, ϕ V, (A z v, ϕ) v ϕ and (A z v, v) cos( 1 2 θ z) v 2 Lemma (Galerkin orthogonality) The CG error e n = w n w satisfies (A z e n, ϕ) = 0 for all ϕ V n.

30 CG solution is quasi-optimal Theorem The CG solution w n satisfies w n w sec( 1 2 θ z) inf v w. v w 0 +V n Proof. Error e n = w n w satisfies cos( 1 2 θ z) e n 2 ( A z e n, w n w ) = ( A z e n, (w n v) + (v w) ) = (A z e n, w n v) + (A }{{} z e n, v w) V n = 0 + (A z e n, v w) e n v w

31 Error reduction ratio Theorem The CG error satisfies where e n 2 sec( 1 2 θ z) η n z + η n z e 0 λn + z λ 1 + z η z = λn + z + λ 1 + z and η z 1 c(z, λ 1 )λ 1/2 N. Thus, for A = M 1 S, e n 2 sec( 1 2 θ z) η z n e 0 with η z 1 ch.

32 Model problem (z = z 15 )

33 Orthogonal basis of residuals Residual r n = b A z w n. There exists N N = dim V such that r n 0 for 0 n < N but r n = 0 for n N. Furthermore r n V n+1 and (r n, ϕ) = 0 for all ϕ V n and n 0. so r 0, r 1,..., r n 1 form an orthogonal basis for V n if n N. Thus, V 0 V 1 V N = V N +1 =.

34 Conjugate search directions Put p 0 = r 0 and, for 0 n < N, p n+1 = r n+1 + In this way, n k=0 β nk p k where β nk = (A zr n+1, p k ) (A z p k, p k ). p n V n+1 and (A z p n, p j ) = 0 for 0 j < n. If n N then p 0, p 1,..., p n 1 form a basis for V n. Find β nk = 0 for 0 k < n so If Iz 0 and 0 j < n, then p n+1 = r n+1 + β n p n, β n = β nn. (A z p j, p n ) = (A z p j, p n ) (p j, A z p n ) = (z z)(p j, p n ) 0.

35 Abstract CG algorithm p 0 = r 0 = b A z w 0 for n = 0, 1, 2,... do if converged then break end if α n = r n 2 /(A z p n, p n ) w n+1 = w n + α n p n r n+1 = r n α n A z p n β n = (r n+1, A z p n )/(A z p n, p n ) p n+1 = r n+1 + β n p n end for In the classical CG algorithm, α n is real and α n (r n+1, A z p n ) = (r n+1, r n α n A z p n ) = r n+1 2 so β n = r n+1 2 / r n 2.

36 Concrete CG algorithm Recall A z = MA z = zm + S, A z w = g, (v, w) = Mv, w. p 0 = r 0 = M 1 (g A z w 0 ) for n = 0, 1, 2,... do if converged then break end if α n = Mr n, r n / A z p n, p n w n+1 = w n + α n p n r n+1 = r n α n M 1 A z p n β n = r n+1, A z p n / A z p n, p n p n+1 = r n+1 + β n p n end for Can use lumped mass approximation M D, with D diagonal.

37 Part IV Preconditioning

38 Special preconditioner Consider B z = (µ z I + A) 1, µ z > λ 1 (A). Since A z = zi + A = (z µ z )I + (µ z I + A) the equation (zi + A)w = b is equivalent to one of the same form: ( zi + B z )w = zb z b, z = (z µ z ) 1.

39 Error reduction ratio Norm Error e n = w n w satisfies v 2 = z v 2 + (B z v, v). e n 2 sec( 1 2 θ z) η n z + η n z e 0 2 sec( 1 2 θ z) η z n e 0, with η z c(z, λ 1, µ z ) < 1 uniformly as λ N. Optimal choice for preconditioner parameter µ z = λ 1 + q z 1 q z (λ N λ 1 ) > λ 1, q z = z + λ 1 λ 1 as λ N. z + λ 1 z + λ N,

40 Results for model problem j x j y j η z η z µ z η z µ z

41 General preconditioning Arbitrary Hermitian positive-definite B z. Preconditioned equation B z A z w = B z b. Both B z and B z A are Hermitian with respect to [v, w] = (Bz 1 v, w), but B z A z = zb z + B z A is not of the form zi + Hermitian. Preconditioned residual Krylov subspaces r n = B z b B z A z w n = B z (b A z w n ) = B z r n. Ṽ n = span{ r 0, B z A z r 0,..., (B z A z ) n 1 r 0 }.

42 Quasi-optimality Preconditioned CG iterates w n = w 0 + v n, with v n Ṽ n, defined by (A z w n, ϕ) = (b, ϕ) for all ϕ Ṽ n. Equivalently [B z A z w n, ϕ] = [B z b, ϕ] for all ϕ Ṽ n. Galerkin orthogonality: (A z e n, ϕ) = [B z A z e n, ϕ] = 0 for all ϕ Ṽ n. Theorem w n w sec( 1 2 θ z) inf v w. v w 0 +Ṽn But no error bound.

43 Recursion involves all previous iterates Preconditioned residual r n = B z (b A z w n ) = B z r n satisfies r n Ṽ n+1 and [ r n, ϕ] = (r n, ϕ) = 0 for all ϕ Ṽ n. Set n p 0 = r 0 and p n+1 = r n+1 + β nk p k for n 0, k=0 where the β nk satisfy the (n + 1) (n + 1) lower-triangular system j (A z p k, p j )β nk = (A z r n, p j ) for 0 j n, k=0 so that 0 p n Ṽ n+1 and (A z p n, p j ) = 0 for 0 k < n < N.

44 Abstract preconditioned CG algorithm r 0 = b A z w 0 p 0 = r 0 = B z r 0 for n = 0, 1, 2,... do if converged then break end if α n = (r n, r n )/(A z p n, p n ) w n+1 = w n + α n p n r n+1 = r n α n A z p n r n+1 = B z r n Solve j k=0 (A zp k, p j )β nk = (A z r n, p j ), 0 j n p n+1 = r n+1 + n k=0 β nkp k end for In practice, restart the iteration after every m steps.

45 Concrete preconditioned CG algorithm Mr 0 = g A z w 0 p 0 = r 0 = B z Mr 0 for n = 0, 1, 2,... do if converged then break end if α n = Mr n, r n / A z p n, p n w n+1 = w n + α n p n Mr n+1 = Mr n α n A z p n r n+1 = B z Mr n Solve j k=0 A zp k, p j β nk = A z r n, p j, 0 j n p n+1 = r n+1 + n k=0 β nkp k end for No need to compute the action of M 1.

46 Iterations for model problem Stopping criterion w h (z j ) w h (z j ) ɛ j. j INV IC AMG(1) w j ɛ j e e e e e e e e e e e e e e e e e e e e e e-03

Subdiffusion in a nonconvex polygon

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

More information

Discontinuous Galerkin methods for fractional diffusion problems

Discontinuous Galerkin methods for fractional diffusion problems Discontinuous Galerkin methods for fractional diffusion problems Bill McLean Kassem Mustapha School of Maths and Stats, University of NSW KFUPM, Dhahran Leipzig, 7 October, 2010 Outline Sub-diffusion Equation

More information

10 The Finite Element Method for a Parabolic Problem

10 The Finite Element Method for a Parabolic Problem 1 The Finite Element Method for a Parabolic Problem In this chapter we consider the approximation of solutions of the model heat equation in two space dimensions by means of Galerkin s method, using piecewise

More information

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

ITERATIVE METHODS BASED ON KRYLOV SUBSPACES

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

More information

Iterative Methods for Linear Systems

Iterative Methods for Linear Systems Iterative Methods for Linear Systems 1. Introduction: Direct solvers versus iterative solvers In many applications we have to solve a linear system Ax = b with A R n n and b R n given. If n is large the

More information

Algebraic Multigrid as Solvers and as Preconditioner

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

More information

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

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

Topics. The CG Algorithm Algorithmic Options CG s Two Main Convergence Theorems

Topics. The CG Algorithm Algorithmic Options CG s Two Main Convergence Theorems Topics The CG Algorithm Algorithmic Options CG s Two Main Convergence Theorems What about non-spd systems? Methods requiring small history Methods requiring large history Summary of solvers 1 / 52 Conjugate

More information

Introduction to Iterative Solvers of Linear Systems

Introduction to Iterative Solvers of Linear Systems Introduction to Iterative Solvers of Linear Systems SFB Training Event January 2012 Prof. Dr. Andreas Frommer Typeset by Lukas Krämer, Simon-Wolfgang Mages and Rudolf Rödl 1 Classes of Matrices and their

More information

Conjugate gradient method. Descent method. Conjugate search direction. Conjugate Gradient Algorithm (294)

Conjugate gradient method. Descent method. Conjugate search direction. Conjugate Gradient Algorithm (294) Conjugate gradient method Descent method Hestenes, Stiefel 1952 For A N N SPD In exact arithmetic, solves in N steps In real arithmetic No guaranteed stopping Often converges in many fewer than N steps

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

Algebra C Numerical Linear Algebra Sample Exam Problems

Algebra C Numerical Linear Algebra Sample Exam Problems Algebra C Numerical Linear Algebra Sample Exam Problems Notation. Denote by V a finite-dimensional Hilbert space with inner product (, ) and corresponding norm. The abbreviation SPD is used for symmetric

More information

Iterative Methods for Sparse Linear Systems

Iterative Methods for Sparse Linear Systems Iterative Methods for Sparse Linear Systems Luca Bergamaschi e-mail: berga@dmsa.unipd.it - http://www.dmsa.unipd.it/ berga Department of Mathematical Methods and Models for Scientific Applications University

More information

Notes on PCG for Sparse Linear Systems

Notes on PCG for Sparse Linear Systems Notes on PCG for Sparse Linear Systems Luca Bergamaschi Department of Civil Environmental and Architectural Engineering University of Padova e-mail luca.bergamaschi@unipd.it webpage www.dmsa.unipd.it/

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

Space-time sparse discretization of linear parabolic equations

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

More information

Applied Mathematics 205. Unit V: Eigenvalue Problems. Lecturer: Dr. David Knezevic

Applied Mathematics 205. Unit V: Eigenvalue Problems. Lecturer: Dr. David Knezevic Applied Mathematics 205 Unit V: Eigenvalue Problems Lecturer: Dr. David Knezevic Unit V: Eigenvalue Problems Chapter V.4: Krylov Subspace Methods 2 / 51 Krylov Subspace Methods In this chapter we give

More information

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs Chapter Two: Numerical Methods for Elliptic PDEs Finite Difference Methods for Elliptic PDEs.. Finite difference scheme. We consider a simple example u := subject to Dirichlet boundary conditions ( ) u

More information

Research Article A Two-Grid Method for Finite Element Solutions of Nonlinear Parabolic Equations

Research Article A Two-Grid Method for Finite Element Solutions of Nonlinear Parabolic Equations Abstract and Applied Analysis Volume 212, Article ID 391918, 11 pages doi:1.1155/212/391918 Research Article A Two-Grid Method for Finite Element Solutions of Nonlinear Parabolic Equations Chuanjun Chen

More information

Domain Decomposition Algorithms for an Indefinite Hypersingular Integral Equation in Three Dimensions

Domain Decomposition Algorithms for an Indefinite Hypersingular Integral Equation in Three Dimensions Domain Decomposition Algorithms for an Indefinite Hypersingular Integral Equation in Three Dimensions Ernst P. Stephan 1, Matthias Maischak 2, and Thanh Tran 3 1 Institut für Angewandte Mathematik, Leibniz

More information

The amount of work to construct each new guess from the previous one should be a small multiple of the number of nonzeros in A.

The amount of work to construct each new guess from the previous one should be a small multiple of the number of nonzeros in A. AMSC/CMSC 661 Scientific Computing II Spring 2005 Solution of Sparse Linear Systems Part 2: Iterative methods Dianne P. O Leary c 2005 Solving Sparse Linear Systems: Iterative methods The plan: Iterative

More information

Conjugate Gradient algorithm. Storage: fixed, independent of number of steps.

Conjugate Gradient algorithm. Storage: fixed, independent of number of steps. Conjugate Gradient algorithm Need: A symmetric positive definite; Cost: 1 matrix-vector product per step; Storage: fixed, independent of number of steps. The CG method minimizes the A norm of the error,

More information

Overlapping Schwarz preconditioners for Fekete spectral elements

Overlapping Schwarz preconditioners for Fekete spectral elements Overlapping Schwarz preconditioners for Fekete spectral elements R. Pasquetti 1, L. F. Pavarino 2, F. Rapetti 1, and E. Zampieri 2 1 Laboratoire J.-A. Dieudonné, CNRS & Université de Nice et Sophia-Antipolis,

More information

SOLVING SPARSE LINEAR SYSTEMS OF EQUATIONS. Chao Yang Computational Research Division Lawrence Berkeley National Laboratory Berkeley, CA, USA

SOLVING SPARSE LINEAR SYSTEMS OF EQUATIONS. Chao Yang Computational Research Division Lawrence Berkeley National Laboratory Berkeley, CA, USA 1 SOLVING SPARSE LINEAR SYSTEMS OF EQUATIONS Chao Yang Computational Research Division Lawrence Berkeley National Laboratory Berkeley, CA, USA 2 OUTLINE Sparse matrix storage format Basic factorization

More information

Computational Linear Algebra

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

More information

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

Boundary Value Problems and Iterative Methods for Linear Systems

Boundary Value Problems and Iterative Methods for Linear Systems Boundary Value Problems and Iterative Methods for Linear Systems 1. Equilibrium Problems 1.1. Abstract setting We want to find a displacement u V. Here V is a complete vector space with a norm v V. In

More information

Computational Linear Algebra

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

More information

The Lanczos and conjugate gradient algorithms

The Lanczos and conjugate gradient algorithms The Lanczos and conjugate gradient algorithms Gérard MEURANT October, 2008 1 The Lanczos algorithm 2 The Lanczos algorithm in finite precision 3 The nonsymmetric Lanczos algorithm 4 The Golub Kahan bidiagonalization

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

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

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

Tong Sun Department of Mathematics and Statistics Bowling Green State University, Bowling Green, OH

Tong Sun Department of Mathematics and Statistics Bowling Green State University, Bowling Green, OH Consistency & Numerical Smoothing Error Estimation An Alternative of the Lax-Richtmyer Theorem Tong Sun Department of Mathematics and Statistics Bowling Green State University, Bowling Green, OH 43403

More information

Simple Examples on Rectangular Domains

Simple Examples on Rectangular Domains 84 Chapter 5 Simple Examples on Rectangular Domains In this chapter we consider simple elliptic boundary value problems in rectangular domains in R 2 or R 3 ; our prototype example is the Poisson equation

More information

A Newton-Galerkin-ADI Method for Large-Scale Algebraic Riccati Equations

A Newton-Galerkin-ADI Method for Large-Scale Algebraic Riccati Equations A Newton-Galerkin-ADI Method for Large-Scale Algebraic Riccati Equations Peter Benner Max-Planck-Institute for Dynamics of Complex Technical Systems Computational Methods in Systems and Control Theory

More information

Krylov subspace projection methods

Krylov subspace projection methods I.1.(a) Krylov subspace projection methods Orthogonal projection technique : framework Let A be an n n complex matrix and K be an m-dimensional subspace of C n. An orthogonal projection technique seeks

More information

Scientific Computing I

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

More information

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

Numerical Methods for Large-Scale Nonlinear Systems

Numerical Methods for Large-Scale Nonlinear Systems Numerical Methods for Large-Scale Nonlinear Systems Handouts by Ronald H.W. Hoppe following the monograph P. Deuflhard Newton Methods for Nonlinear Problems Springer, Berlin-Heidelberg-New York, 2004 Num.

More information

INTRODUCTION TO FINITE ELEMENT METHODS

INTRODUCTION TO FINITE ELEMENT METHODS INTRODUCTION TO FINITE ELEMENT METHODS LONG CHEN Finite element methods are based on the variational formulation of partial differential equations which only need to compute the gradient of a function.

More information

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

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C.

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C. Lecture 9 Approximations of Laplace s Equation, Finite Element Method Mathématiques appliquées (MATH54-1) B. Dewals, C. Geuzaine V1.2 23/11/218 1 Learning objectives of this lecture Apply the finite difference

More information

Stopping criteria for iterations in finite element methods

Stopping criteria for iterations in finite element methods Stopping criteria for iterations in finite element methods M. Arioli, D. Loghin and A. J. Wathen CERFACS Technical Report TR/PA/03/21 Abstract This work extends the results of Arioli [1], [2] on stopping

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

Chapter 7 Iterative Techniques in Matrix Algebra

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

More information

Numerical Solution I

Numerical Solution I Numerical Solution I Stationary Flow R. Kornhuber (FU Berlin) Summerschool Modelling of mass and energy transport in porous media with practical applications October 8-12, 2018 Schedule Classical Solutions

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

The quadratic eigenvalue problem (QEP) is to find scalars λ and nonzero vectors u satisfying

The quadratic eigenvalue problem (QEP) is to find scalars λ and nonzero vectors u satisfying I.2 Quadratic Eigenvalue Problems 1 Introduction The quadratic eigenvalue problem QEP is to find scalars λ and nonzero vectors u satisfying where Qλx = 0, 1.1 Qλ = λ 2 M + λd + K, M, D and K are given

More information

A short course on: Preconditioned Krylov subspace methods. Yousef Saad University of Minnesota Dept. of Computer Science and Engineering

A short course on: Preconditioned Krylov subspace methods. Yousef Saad University of Minnesota Dept. of Computer Science and Engineering A short course on: Preconditioned Krylov subspace methods Yousef Saad University of Minnesota Dept. of Computer Science and Engineering Universite du Littoral, Jan 19-3, 25 Outline Part 1 Introd., discretization

More information

Accelerated residual methods for the iterative solution of systems of equations

Accelerated residual methods for the iterative solution of systems of equations Accelerated residual methods for the iterative solution of systems of equations N. C. Nguyen, P. Fernandez, R. M. Freund, and J. Peraire Abstract We develop accelerated residual methods for solving linear

More information

ETNA Kent State University

ETNA Kent State University Electronic Transactions on Numerical Analysis. Volume 18, pp. 49-64, 2004. Copyright 2004,. ISSN 1068-9613. ETNA EFFICIENT PRECONDITIONING FOR SEQUENCES OF PARAMETRIC COMPLEX SYMMETRIC LINEAR SYSTEMS D.

More information

r=1 r=1 argmin Q Jt (20) After computing the descent direction d Jt 2 dt H t d + P (x + d) d i = 0, i / J

r=1 r=1 argmin Q Jt (20) After computing the descent direction d Jt 2 dt H t d + P (x + d) d i = 0, i / J 7 Appendix 7. Proof of Theorem Proof. There are two main difficulties in proving the convergence of our algorithm, and none of them is addressed in previous works. First, the Hessian matrix H is a block-structured

More information

1. The COMPLEX PLANE AND ELEMENTARY FUNCTIONS: Complex numbers; stereographic projection; simple and multiple connectivity, elementary functions.

1. The COMPLEX PLANE AND ELEMENTARY FUNCTIONS: Complex numbers; stereographic projection; simple and multiple connectivity, elementary functions. Complex Analysis Qualifying Examination 1 The COMPLEX PLANE AND ELEMENTARY FUNCTIONS: Complex numbers; stereographic projection; simple and multiple connectivity, elementary functions 2 ANALYTIC FUNCTIONS:

More information

Adaptive Finite Element Methods Lecture Notes Winter Term 2017/18. R. Verfürth. Fakultät für Mathematik, Ruhr-Universität Bochum

Adaptive Finite Element Methods Lecture Notes Winter Term 2017/18. R. Verfürth. Fakultät für Mathematik, Ruhr-Universität Bochum Adaptive Finite Element Methods Lecture Notes Winter Term 2017/18 R. Verfürth Fakultät für Mathematik, Ruhr-Universität Bochum Contents Chapter I. Introduction 7 I.1. Motivation 7 I.2. Sobolev and finite

More information

Parallel Numerics, WT 2016/ Iterative Methods for Sparse Linear Systems of Equations. page 1 of 1

Parallel Numerics, WT 2016/ Iterative Methods for Sparse Linear Systems of Equations. page 1 of 1 Parallel Numerics, WT 2016/2017 5 Iterative Methods for Sparse Linear Systems of Equations page 1 of 1 Contents 1 Introduction 1.1 Computer Science Aspects 1.2 Numerical Problems 1.3 Graphs 1.4 Loop Manipulations

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

Stochastic Spectral Approaches to Bayesian Inference

Stochastic Spectral Approaches to Bayesian Inference Stochastic Spectral Approaches to Bayesian Inference Prof. Nathan L. Gibson Department of Mathematics Applied Mathematics and Computation Seminar March 4, 2011 Prof. Gibson (OSU) Spectral Approaches to

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

Scientific Computing WS 2018/2019. Lecture 15. Jürgen Fuhrmann Lecture 15 Slide 1

Scientific Computing WS 2018/2019. Lecture 15. Jürgen Fuhrmann Lecture 15 Slide 1 Scientific Computing WS 2018/2019 Lecture 15 Jürgen Fuhrmann juergen.fuhrmann@wias-berlin.de Lecture 15 Slide 1 Lecture 15 Slide 2 Problems with strong formulation Writing the PDE with divergence and gradient

More information

6.4 Krylov Subspaces and Conjugate Gradients

6.4 Krylov Subspaces and Conjugate Gradients 6.4 Krylov Subspaces and Conjugate Gradients Our original equation is Ax = b. The preconditioned equation is P Ax = P b. When we write P, we never intend that an inverse will be explicitly computed. P

More information

GALERKIN TIME STEPPING METHODS FOR NONLINEAR PARABOLIC EQUATIONS

GALERKIN TIME STEPPING METHODS FOR NONLINEAR PARABOLIC EQUATIONS GALERKIN TIME STEPPING METHODS FOR NONLINEAR PARABOLIC EQUATIONS GEORGIOS AKRIVIS AND CHARALAMBOS MAKRIDAKIS Abstract. We consider discontinuous as well as continuous Galerkin methods for the time discretization

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

Implementation of Sparse Wavelet-Galerkin FEM for Stochastic PDEs

Implementation of Sparse Wavelet-Galerkin FEM for Stochastic PDEs Implementation of Sparse Wavelet-Galerkin FEM for Stochastic PDEs Roman Andreev ETH ZÜRICH / 29 JAN 29 TOC of the Talk Motivation & Set-Up Model Problem Stochastic Galerkin FEM Conclusions & Outlook Motivation

More information

FFT-based Galerkin method for homogenization of periodic media

FFT-based Galerkin method for homogenization of periodic media FFT-based Galerkin method for homogenization of periodic media Jaroslav Vondřejc 1,2 Jan Zeman 2,3 Ivo Marek 2 Nachiketa Mishra 4 1 University of West Bohemia in Pilsen, Faculty of Applied Sciences Czech

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

The Conjugate Gradient Method

The Conjugate Gradient Method The Conjugate Gradient Method The minimization problem We are given a symmetric positive definite matrix R n n and a right hand side vector b R n We want to solve the linear system Find u R n such that

More information

Projected Surface Finite Elements for Elliptic Equations

Projected Surface Finite Elements for Elliptic Equations Available at http://pvamu.edu/aam Appl. Appl. Math. IN: 1932-9466 Vol. 8, Issue 1 (June 2013), pp. 16 33 Applications and Applied Mathematics: An International Journal (AAM) Projected urface Finite Elements

More information

On Surface Meshes Induced by Level Set Functions

On Surface Meshes Induced by Level Set Functions On Surface Meshes Induced by Level Set Functions Maxim A. Olshanskii, Arnold Reusken, and Xianmin Xu Bericht Nr. 347 Oktober 01 Key words: surface finite elements, level set function, surface triangulation,

More information

Scientific Computing WS 2017/2018. Lecture 18. Jürgen Fuhrmann Lecture 18 Slide 1

Scientific Computing WS 2017/2018. Lecture 18. Jürgen Fuhrmann Lecture 18 Slide 1 Scientific Computing WS 2017/2018 Lecture 18 Jürgen Fuhrmann juergen.fuhrmann@wias-berlin.de Lecture 18 Slide 1 Lecture 18 Slide 2 Weak formulation of homogeneous Dirichlet problem Search u H0 1 (Ω) (here,

More information

A Finite Element Method for the Surface Stokes Problem

A Finite Element Method for the Surface Stokes Problem J A N U A R Y 2 0 1 8 P R E P R I N T 4 7 5 A Finite Element Method for the Surface Stokes Problem Maxim A. Olshanskii *, Annalisa Quaini, Arnold Reusken and Vladimir Yushutin Institut für Geometrie und

More information

Recycling Bi-Lanczos Algorithms: BiCG, CGS, and BiCGSTAB

Recycling Bi-Lanczos Algorithms: BiCG, CGS, and BiCGSTAB Recycling Bi-Lanczos Algorithms: BiCG, CGS, and BiCGSTAB Kapil Ahuja Thesis submitted to the Faculty of the Virginia Polytechnic Institute and State University in partial fulfillment of the requirements

More information

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

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

More information

ITERATIVE METHODS FOR NONLINEAR ELLIPTIC EQUATIONS

ITERATIVE METHODS FOR NONLINEAR ELLIPTIC EQUATIONS ITERATIVE METHODS FOR NONLINEAR ELLIPTIC EQUATIONS LONG CHEN In this chapter we discuss iterative methods for solving the finite element discretization of semi-linear elliptic equations of the form: find

More information

A space-time Trefftz method for the second order wave equation

A space-time Trefftz method for the second order wave equation A space-time Trefftz method for the second order wave equation Lehel Banjai The Maxwell Institute for Mathematical Sciences Heriot-Watt University, Edinburgh Rome, 10th Apr 2017 Joint work with: Emmanuil

More information

1 Discretizing BVP with Finite Element Methods.

1 Discretizing BVP with Finite Element Methods. 1 Discretizing BVP with Finite Element Methods In this section, we will discuss a process for solving boundary value problems numerically, the Finite Element Method (FEM) We note that such method is a

More information

Spectral Processing. Misha Kazhdan

Spectral Processing. Misha Kazhdan Spectral Processing Misha Kazhdan [Taubin, 1995] A Signal Processing Approach to Fair Surface Design [Desbrun, et al., 1999] Implicit Fairing of Arbitrary Meshes [Vallet and Levy, 2008] Spectral Geometry

More information

Finite element approximation of the stochastic heat equation with additive noise

Finite element approximation of the stochastic heat equation with additive noise p. 1/32 Finite element approximation of the stochastic heat equation with additive noise Stig Larsson p. 2/32 Outline Stochastic heat equation with additive noise du u dt = dw, x D, t > u =, x D, t > u()

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

A Multigrid Method for Two Dimensional Maxwell Interface Problems

A Multigrid Method for Two Dimensional Maxwell Interface Problems A Multigrid Method for Two Dimensional Maxwell Interface Problems Susanne C. Brenner Department of Mathematics and Center for Computation & Technology Louisiana State University USA JSA 2013 Outline A

More information

Some definitions. Math 1080: Numerical Linear Algebra Chapter 5, Solving Ax = b by Optimization. A-inner product. Important facts

Some definitions. Math 1080: Numerical Linear Algebra Chapter 5, Solving Ax = b by Optimization. A-inner product. Important facts Some definitions Math 1080: Numerical Linear Algebra Chapter 5, Solving Ax = b by Optimization M. M. Sussman sussmanm@math.pitt.edu Office Hours: MW 1:45PM-2:45PM, Thack 622 A matrix A is SPD (Symmetric

More information

SECOND ORDER TIME DISCONTINUOUS GALERKIN METHOD FOR NONLINEAR CONVECTION-DIFFUSION PROBLEMS

SECOND ORDER TIME DISCONTINUOUS GALERKIN METHOD FOR NONLINEAR CONVECTION-DIFFUSION PROBLEMS Proceedings of ALGORITMY 2009 pp. 1 10 SECOND ORDER TIME DISCONTINUOUS GALERKIN METHOD FOR NONLINEAR CONVECTION-DIFFUSION PROBLEMS MILOSLAV VLASÁK Abstract. We deal with a numerical solution of a scalar

More information

Lehrstuhl Informatik V. Lehrstuhl Informatik V. 1. solve weak form of PDE to reduce regularity properties. Lehrstuhl Informatik V

Lehrstuhl Informatik V. Lehrstuhl Informatik V. 1. solve weak form of PDE to reduce regularity properties. Lehrstuhl Informatik V Part I: Introduction to Finite Element Methods Scientific Computing I Module 8: An Introduction to Finite Element Methods Tobias Necel Winter 4/5 The Model Problem FEM Main Ingredients Wea Forms and Wea

More information

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

Preface to the Second Edition. Preface to the First Edition

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

More information

ORIE 6334 Spectral Graph Theory October 13, Lecture 15

ORIE 6334 Spectral Graph Theory October 13, Lecture 15 ORIE 6334 Spectral Graph heory October 3, 206 Lecture 5 Lecturer: David P. Williamson Scribe: Shijin Rajakrishnan Iterative Methods We have seen in the previous lectures that given an electrical network,

More information

Solutions to Exercises 6.1

Solutions to Exercises 6.1 34 Chapter 6 Conformal Mappings Solutions to Exercises 6.. An analytic function fz is conformal where f z. If fz = z + e z, then f z =e z z + z. We have f z = z z += z =. Thus f is conformal at all z.

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

PDEs, Matrix Functions and Krylov Subspace Methods

PDEs, Matrix Functions and Krylov Subspace Methods PDEs, Matrix Functions and Krylov Subspace Methods Oliver Ernst Institut für Numerische Mathematik und Optimierung TU Bergakademie Freiberg, Germany LMS Durham Symposium Computational Linear Algebra for

More information

The Newton-ADI Method for Large-Scale Algebraic Riccati Equations. Peter Benner.

The Newton-ADI Method for Large-Scale Algebraic Riccati Equations. Peter Benner. The Newton-ADI Method for Large-Scale Algebraic Riccati Equations Mathematik in Industrie und Technik Fakultät für Mathematik Peter Benner benner@mathematik.tu-chemnitz.de Sonderforschungsbereich 393 S

More information

Lab 1: Iterative Methods for Solving Linear Systems

Lab 1: Iterative Methods for Solving Linear Systems Lab 1: Iterative Methods for Solving Linear Systems January 22, 2017 Introduction Many real world applications require the solution to very large and sparse linear systems where direct methods such as

More information

On the Preconditioning of the Block Tridiagonal Linear System of Equations

On the Preconditioning of the Block Tridiagonal Linear System of Equations On the Preconditioning of the Block Tridiagonal Linear System of Equations Davod Khojasteh Salkuyeh Department of Mathematics, University of Mohaghegh Ardabili, PO Box 179, Ardabil, Iran E-mail: khojaste@umaacir

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 space-time Trefftz method for the second order wave equation

A space-time Trefftz method for the second order wave equation A space-time Trefftz method for the second order wave equation Lehel Banjai The Maxwell Institute for Mathematical Sciences Heriot-Watt University, Edinburgh & Department of Mathematics, University of

More information

Solving Sparse Linear Systems: Iterative methods

Solving Sparse Linear Systems: Iterative methods Scientific Computing with Case Studies SIAM Press, 2009 http://www.cs.umd.edu/users/oleary/sccs Lecture Notes for Unit VII Sparse Matrix Computations Part 2: Iterative Methods Dianne P. O Leary c 2008,2010

More information

Solving Sparse Linear Systems: Iterative methods

Solving Sparse Linear Systems: Iterative methods Scientific Computing with Case Studies SIAM Press, 2009 http://www.cs.umd.edu/users/oleary/sccswebpage Lecture Notes for Unit VII Sparse Matrix Computations Part 2: Iterative Methods Dianne P. O Leary

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

carries the circle w 1 onto the circle z R and sends w = 0 to z = a. The function u(s(w)) is harmonic in the unit circle w 1 and we obtain

carries the circle w 1 onto the circle z R and sends w = 0 to z = a. The function u(s(w)) is harmonic in the unit circle w 1 and we obtain 4. Poisson formula In fact we can write down a formula for the values of u in the interior using only the values on the boundary, in the case when E is a closed disk. First note that (3.5) determines the

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