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

Size: px
Start display at page:

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

Transcription

1 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 B. Szyld Temple University, Philadelphia - NA Day, Bologna, 18 September

2 We want to solve certain PDEs (non-selfadjoint or indefinit elliptic) discretized by FEM (or divided differences) Use GMRES (or other Krylov subspace method) Precondition with Additive Schwarz (with coarse grid correction) Schwarz methods optimality (energy norm) and Minimal Residuals Methods (usually minimizing the 2-norm) Comments on left vs. right preconditioning 2

3 Examples Helmholtz equation u + cu = f Advection diffusion equation u + b. u + cu = f zero Dirichlet b.c. 3

4 General Problem Statement Solve Bx = f B non-hermitian, discretization of b(u, v) = f(v) b(u, v) = a(u, v) + s(u, v) + c(u, v), a(u, v) = u v dx, Ω s(u, v) = (b u)v + ( bu)v dx, b R d, Ω c(u, v) = c uv dx, and f(v) = f v dx. Ω Ω 4

5 General Problem Statement (cont.) b(u, v) = a(u, v) + s(u, v) + c(u, v), a(u, v) = u v dx, Ω Let A be SPD, the discretization of a(, ). So, we have B = A + R. Here A = A T O is the discretization of u 5

6 Standard Finite Element Setting Let Ω R d, with triangulation T h (Ω). Let V be the traditional finite element space formed by piecewise linear and continuous functions vanishing on the boundary of Ω. V H 1 0(Ω). One-to-one correspondence between functions in finite element space and nodal values. We abuse the notation and do not distinguish between them. Let v a = a(v, v), and v A = (v T Av) 1/2 be the corresponding norms in V and in R n, respectively. 6

7 Problem Statement (cont.) Use Krylov subspace iterative methods (e.g., GMRES) Left preconditioning: Right preconditioning: M 1 Bx = M 1 f BM 1 (Mu) = f 7

8 Krylov subspace methods: GMRES K m (B, r 0 ) = span{r 0, Br 0, B 2 r 0,...,B m 1 r 0 }. Given x 0, r 0 = f Bx 0, find approximation x m x 0 + K m (B, r 0 ), x m = x 0 + p(b)r 0 (p(t) polynomial degree m 1) satisfying x m = arg min{ f Bx 2 }, x x 0 + K m (B, r 0 ) 8

9 Krylov subspace methods: GMRES (cont.) Preconditioned case, Implementation Let v 1, v 2,...,v m be an orthonormal basis of K m (M 1 B, r 0 ) = span{r 0, M 1 Br 0, (M 1 B) 2 r 0,...,(M 1 B) m 1 r 0 }. x m = arg min{ f M 1 Bx 2 }, x x 0 + K m (M 1 B, r 0 ) With V m = [v 1, v 2,...,v m ], obtain Arnoldi relation: M 1 BV m = V m+1 H m+1,m H m+1,m is (m + 1) m upper Hessenberg Element in K m (M 1 B, v 1 ) is a linear combination of v 1, v 2,...,v m, i.e., of the form V m y, y R m 9

10 GMRES (cont.) Preconditioned case, Implementation Find y = y m and we have x m = x 0 + V m y m M 1 f M 1 Bx 2 = M 1 r 0 M 1 BV m y 2 = = V m+1 βe 1 V m+1 Hm y 2 = βe 1 H m y 2 find y using QR factorization of H m. 10

11 One convergence bound for GMRES [Elman 1982] (unpreconditioned version) r m = f Bx m (1 c2 C 2 ) m/2 r 0, where c = min x 0 (x, Bx) (x, x) and C = max x 0 Bx x. 11

12 Schwarz Preconditioning Class of Preconditioners based on Domain Decomposition Decomposition of V into a sum of N + 1 subspaces R T i V i V, and V = R T 0 V 0 + R T 1 V R T NV N. R T i : V i V extension operator from V i to V. This decomposition usually NOT a direct sum. Subspaces Ri TV i, i = 1,...,N are related to a decomposition of the domain Ω into overlapping subregions Ω δ i of size O(H) covering Ω. The subspace R0 T V 0 is the coarse space. 12

13 For u i, v i V i define Schwarz Preconditioning (cont.) b i (u i, v i ) = b(r T i u i, R T i v i ), a i (u i, v i ) = a(r T i u i, R T i v i ). Let B i = R i BR T i, A i = R i AR T i be the matrix representations of these local bilinear forms, i.e., the local problems. R i is a restriction operator, R T i is a prolongation (embeding) operator 13

14 Two versions of Additive Schwarz Preconditioning here M 1 = R T 0 B 1 0 R 0 + p i=1 RT i B 1 i R i, or M 1 = R T 0 B 1 0 R 0 + p i=1 RT i A 1 i R i, where B i = R i BR T i and A i = R i AR T i (local problems) R i restriction, R T i prolongation with overlap δ B 0 coarse problem, size O(H), discretization O(h). 14

15 Let P = M 1 B, be the preconditioned problem. Theorem. [Cai and Widlund, 1993] There exist constants H 0 > 0, c(h 0 ) > 0, and C(H 0 ) > 0, such that if H H 0, then for i = 1, 2, and u V, a(u, Pu) a(u, u) c p, and Pu a C p u a, where C p = C(H 0 ) and c p = C 2 0 c(h 0). 15

16 Two-level Schwarz preconditioners are optimal in the sense that bounds for M 1 B (or BM 1 ) are independent of the mesh size and the number of subdomains, or slowly varying with them. In our PDEs, we have optimal bounds: (x, M 1 Bx) A (x, x) A c p and M 1 Bx A C p x A. Cai and Zou [NLAA, 2002] observed: Schwarz bounds use energy norms, while GMRES minimizes l 2 norms. Optimality may be lost! 16

17 In fact, Cai and Zou [NLAA, 2002] showed is that for Additive Schwarz M 1 B is NOT positive real, i.e., there is no c > 0 for which (x, M 1 Bx) (x, x) c. Thus, this GMRES bound cannot be used in this case. We may not have the optimality. 17

18 Krylov Subspace Methods with Energy Norms Proposed solution: Use GMRES minimizing the A-norm of the residual. [Note: many authors mention this, e.g., Ashby-Manteuffel-Saylor, Essai, Greenbaum, Gutknecht, Weiss,... ] In this case, we have that M 1 B is positive real with respect to the A-inner product since (x, M 1 Bx) A (x, x) A c p and M 1 Bx A C p x A. 18

19 Rework convergence bound for GMRES [Elman 1982] (preconditioned version) r m A = M 1 f M 1 Bx m A (1 c2 C 2 ) m/2 M 1 r 0 A, where c = min x 0 (x, M 1 Bx) A and C = max (x, x) A x 0 Bx A x A. 19

20 Implementation: Replace each inner product (x, y) with (x, y) A = x T Ay. Only one matvec with A needed. Basis vectors are A-orthonormal. Arnoldi relation: M 1 BV m = V m+1 H m+1. M 1 b M 1 Bx A = M 1 r 0 M 1 BV m y A = = V m+1 βe 1 V m+1 H m y A = βe 1 H m y 2 Same QR factorization of H m, same code for the minimization. We use this for analysis, but sometimes also valid for computations. 20

21 Left vs. Right preconditioner For right preconditioner BM 1 u = f, M 1 u = x. (x, x) A = (M 1 u, M 1 u) A = (u, u) G, G = M T AM 1. Every left preconditioned system M 1 Bx = M 1 f with the A norm is completely equivalent to a right preconditioned system with the M T AM 1 -norm. r 0 BM 1 Z m y M T AM 1 = M 1 r 0 M 1 BM 1 Z m y A = βz 1 M 1 BV m y A = βe 1 H m y 2. Z m has the G-orthogonal basis of K m (r 0, BM 1 ) 21

22 Left vs. Right preconditioner Converse also holds: for every right preconditioner M with S-norm, this is equivalent to left preconditioning with M using the M T SM-norm. (True in particular for S = I) When using the same inner product (norm), left and right preconditioning produce different upper Hessenberg matrices H m. When using A-inner product for left preconditioning and M T AM 1 -inner product for right preconditioning, we have the same upper Hessenberg matrices H m. The experiments we show with left preconditioning and A-norm minimization are the same as with right preconditioning with G-norm minimization, G = M T AM 1. 22

23 Energy Norms vs. l 2 Norm Now, we have the optimality with energy norms. What can we say about the l 2 norm? Use equivalence of norms: x 2 1 λmin (A) x A, x A λ max (A) x 2 M 1 r L m 2 M 1 r A m 2 1 λmin (A) M 1 r A m A = 1 λmin (A) λmax (A) λmin (A) (1 c2 C 2 (1 c2 κ(a) (1 c2 C 2 C 2 ) m/2 M 1 r 0 A ) m/2 M 1 r 0 2 ) m/2 M 1 r

24 Asymptotic Optimality of l 2 Norm M 1 r L m 2 κ(a) (1 c2 C 2 ) m/2 M 1 r 0 2 For a fixed mesh size h, Additive Schwarz preconditioned GMRES (2-norm) has a bound that goes to zero at the same speed as the optimal bound (energy norm), except for a factor κ(a) (which of course depends on h) 24

25 Numerical Experiments Helmholtz equation u + cu = f, c = 5 or c = 120. Advection diffusion equation u + b. u + cu = f b T = [10, 20], c = 1, upwind finite differences both on unit square, zero Dirichlet b.c., f 1 Discretization: (n = 3969), (n = 16129), or (n = 65025) nodes p = 4 4 or p = 8 8 subdomains Overlap: 0, 1, 2 (1,3 or 5 lines of nodes) Tolerance ε =

26 Relative G norm residual Relative l 2 norm residual Iteration Iteration Figure 1: Helmholtz equation c = 5. GMRES minimizing the l 2 norm (o), and the G-norm (*) grids, 4 4 subdomains. δ = 0 Left: G-norm of both residuals. Right: l 2 norm of both residuals. 26

27 Relative G norm residual Relative l 2 norm residual Iteration Iteration Figure 2: Helmholtz equation c = 120. GMRES minimizing the l 2 norm (o), and the G-norm (*) grids, 8 8 subdomains. δ = 1 Left: G-norm of both residuals. Right: l 2 norm of both residuals. 27

28 Relative G norm residual Relative l 2 norm residual Iteration Iteration Figure 3: Helmholtz equation c = 120. GMRES minimizing the l 2 norm (o), and the G-norm (*) grids, 8 8 subdomains. δ = 0 Left: G-norm of both residuals. Right: l 2 norm of both residuals. 28

29 Relative G norm residual Relative l 2 norm residual Iteration Iteration Figure 4: Advection-diffusion equation. GMRES minimizing the l 2 norm (o), and the G-norm (*) grids, 4 4 subdomains. δ = 2 Left: G-norm of both residuals. Right: l 2 norm of both residuals. 29

30 Relative G norm residual Relative l 2 norm residual Iteration Iteration Figure 5: Advection-diffusion equation. GMRES minimizing the l 2 norm (o), and the G-norm (*) grids, 8 8 subdomains. δ = 0 Left: G-norm of both residuals. Right: l 2 norm of both residuals. 30

31 Conclusions GMRES in energy norm maintains optimality GMRES in l 2 norm achieves asymptotic optimality Observations on left vs. right preconditioning Numerical experiments illustrate this 31

32 Paper to appear in CMAME available at 32

Convergence Behavior of a Two-Level Optimized Schwarz Preconditioner

Convergence Behavior of a Two-Level Optimized Schwarz Preconditioner Convergence Behavior of a Two-Level Optimized Schwarz Preconditioner Olivier Dubois 1 and Martin J. Gander 2 1 IMA, University of Minnesota, 207 Church St. SE, Minneapolis, MN 55455 dubois@ima.umn.edu

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

From Completing the Squares and Orthogonal Projection to Finite Element Methods

From Completing the Squares and Orthogonal Projection to Finite Element Methods From Completing the Squares and Orthogonal Projection to Finite Element Methods Mo MU Background In scientific computing, it is important to start with an appropriate model in order to design effective

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

A Domain Decomposition Based Jacobi-Davidson Algorithm for Quantum Dot Simulation

A Domain Decomposition Based Jacobi-Davidson Algorithm for Quantum Dot Simulation A Domain Decomposition Based Jacobi-Davidson Algorithm for Quantum Dot Simulation Tao Zhao 1, Feng-Nan Hwang 2 and Xiao-Chuan Cai 3 Abstract In this paper, we develop an overlapping domain decomposition

More information

A Robust Preconditioner for the Hessian System in Elliptic Optimal Control Problems

A Robust Preconditioner for the Hessian System in Elliptic Optimal Control Problems A Robust Preconditioner for the Hessian System in Elliptic Optimal Control Problems Etereldes Gonçalves 1, Tarek P. Mathew 1, Markus Sarkis 1,2, and Christian E. Schaerer 1 1 Instituto de Matemática Pura

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

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

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

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

Finite Elements. Colin Cotter. February 22, Colin Cotter FEM

Finite Elements. Colin Cotter. February 22, Colin Cotter FEM Finite Elements February 22, 2019 In the previous sections, we introduced the concept of finite element spaces, which contain certain functions defined on a domain. Finite element spaces are examples of

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

Additive Average Schwarz Method for a Crouzeix-Raviart Finite Volume Element Discretization of Elliptic Problems

Additive Average Schwarz Method for a Crouzeix-Raviart Finite Volume Element Discretization of Elliptic Problems Additive Average Schwarz Method for a Crouzeix-Raviart Finite Volume Element Discretization of Elliptic Problems Atle Loneland 1, Leszek Marcinkowski 2, and Talal Rahman 3 1 Introduction In this paper

More information

Two-level Domain decomposition preconditioning for the high-frequency time-harmonic Maxwell equations

Two-level Domain decomposition preconditioning for the high-frequency time-harmonic Maxwell equations Two-level Domain decomposition preconditioning for the high-frequency time-harmonic Maxwell equations Marcella Bonazzoli 2, Victorita Dolean 1,4, Ivan G. Graham 3, Euan A. Spence 3, Pierre-Henri Tournier

More information

10.6 ITERATIVE METHODS FOR DISCRETIZED LINEAR EQUATIONS

10.6 ITERATIVE METHODS FOR DISCRETIZED LINEAR EQUATIONS 10.6 ITERATIVE METHODS FOR DISCRETIZED LINEAR EQUATIONS 769 EXERCISES 10.5.1 Use Taylor expansion (Theorem 10.1.2) to give a proof of Theorem 10.5.3. 10.5.2 Give an alternative to Theorem 10.5.3 when F

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

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

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

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

PARTITION OF UNITY FOR THE STOKES PROBLEM ON NONMATCHING GRIDS

PARTITION OF UNITY FOR THE STOKES PROBLEM ON NONMATCHING GRIDS PARTITION OF UNITY FOR THE STOES PROBLEM ON NONMATCHING GRIDS CONSTANTIN BACUTA AND JINCHAO XU Abstract. We consider the Stokes Problem on a plane polygonal domain Ω R 2. We propose a finite element method

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

arxiv: v1 [math.na] 11 Jul 2011

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

More information

XIAO-CHUAN CAI AND MAKSYMILIAN DRYJA. strongly elliptic equations discretized by the nite element methods.

XIAO-CHUAN CAI AND MAKSYMILIAN DRYJA. strongly elliptic equations discretized by the nite element methods. Contemporary Mathematics Volume 00, 0000 Domain Decomposition Methods for Monotone Nonlinear Elliptic Problems XIAO-CHUAN CAI AND MAKSYMILIAN DRYJA Abstract. In this paper, we study several overlapping

More information

33 RASHO: A Restricted Additive Schwarz Preconditioner with Harmonic Overlap

33 RASHO: A Restricted Additive Schwarz Preconditioner with Harmonic Overlap Thirteenth International Conference on Domain Decomposition ethods Editors: N. Debit,.Garbey, R. Hoppe, J. Périaux, D. Keyes, Y. Kuznetsov c 001 DD.org 33 RASHO: A Restricted Additive Schwarz Preconditioner

More information

From Direct to Iterative Substructuring: some Parallel Experiences in 2 and 3D

From Direct to Iterative Substructuring: some Parallel Experiences in 2 and 3D From Direct to Iterative Substructuring: some Parallel Experiences in 2 and 3D Luc Giraud N7-IRIT, Toulouse MUMPS Day October 24, 2006, ENS-INRIA, Lyon, France Outline 1 General Framework 2 The direct

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

Multigrid absolute value preconditioning

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

More information

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

OVERLAPPING SCHWARZ ALGORITHMS FOR ALMOST INCOMPRESSIBLE LINEAR ELASTICITY TR

OVERLAPPING SCHWARZ ALGORITHMS FOR ALMOST INCOMPRESSIBLE LINEAR ELASTICITY TR OVERLAPPING SCHWARZ ALGORITHMS FOR ALMOST INCOMPRESSIBLE LINEAR ELASTICITY MINGCHAO CAI, LUCA F. PAVARINO, AND OLOF B. WIDLUND TR2014-969 Abstract. Low order finite element discretizations of the linear

More information

Domain decomposition on different levels of the Jacobi-Davidson method

Domain decomposition on different levels of the Jacobi-Davidson method hapter 5 Domain decomposition on different levels of the Jacobi-Davidson method Abstract Most computational work of Jacobi-Davidson [46], an iterative method suitable for computing solutions of large dimensional

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

An additive average Schwarz method for the plate bending problem

An additive average Schwarz method for the plate bending problem J. Numer. Math., Vol. 10, No. 2, pp. 109 125 (2002) c VSP 2002 Prepared using jnm.sty [Version: 02.02.2002 v1.2] An additive average Schwarz method for the plate bending problem X. Feng and T. Rahman Abstract

More information

Schwarz Preconditioner for the Stochastic Finite Element Method

Schwarz Preconditioner for the Stochastic Finite Element Method Schwarz Preconditioner for the Stochastic Finite Element Method Waad Subber 1 and Sébastien Loisel 2 Preprint submitted to DD22 conference 1 Introduction The intrusive polynomial chaos approach for uncertainty

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

Iterative Methods and Multigrid

Iterative Methods and Multigrid Iterative Methods and Multigrid Part 3: Preconditioning 2 Eric de Sturler Preconditioning The general idea behind preconditioning is that convergence of some method for the linear system Ax = b can be

More information

Preconditioned inverse iteration and shift-invert Arnoldi method

Preconditioned inverse iteration and shift-invert Arnoldi method Preconditioned inverse iteration and shift-invert Arnoldi method Melina Freitag Department of Mathematical Sciences University of Bath CSC Seminar Max-Planck-Institute for Dynamics of Complex Technical

More information

Shifted Laplace and related preconditioning for the Helmholtz equation

Shifted Laplace and related preconditioning for the Helmholtz equation Shifted Laplace and related preconditioning for the Helmholtz equation Ivan Graham and Euan Spence (Bath, UK) Collaborations with: Paul Childs (Schlumberger Gould Research), Martin Gander (Geneva) Douglas

More information

On domain decomposition preconditioners for finite element approximations of the Helmholtz equation using absorption

On domain decomposition preconditioners for finite element approximations of the Helmholtz equation using absorption On domain decomposition preconditioners for finite element approximations of the Helmholtz equation using absorption Ivan Graham and Euan Spence (Bath, UK) Collaborations with: Paul Childs (Emerson Roxar,

More information

An introduction to the mathematical theory of finite elements

An introduction to the mathematical theory of finite elements Master in Seismic Engineering E.T.S.I. Industriales (U.P.M.) Discretization Methods in Engineering An introduction to the mathematical theory of finite elements Ignacio Romero ignacio.romero@upm.es October

More information

A Balancing Algorithm for Mortar Methods

A Balancing Algorithm for Mortar Methods A Balancing Algorithm for Mortar Methods Dan Stefanica Baruch College, City University of New York, NY 11, USA Dan Stefanica@baruch.cuny.edu Summary. The balancing methods are hybrid nonoverlapping Schwarz

More information

Nonlinear Schwarz iterations with Reduced Rank Extrapolation. Sébastien Duminil, Hassane Sadok, and Daniel B. Szyld

Nonlinear Schwarz iterations with Reduced Rank Extrapolation. Sébastien Duminil, Hassane Sadok, and Daniel B. Szyld Nonlinear Schwarz iterations with Reduced Rank Extrapolation Sébastien Duminil, Hassane Sadok, and Daniel B. Szyld Report 14-09-01 September 2014. Revised March 2015 Department of Mathematics Temple University

More information

Parallel sparse linear solvers and applications in CFD

Parallel sparse linear solvers and applications in CFD Parallel sparse linear solvers and applications in CFD Jocelyne Erhel Joint work with Désiré Nuentsa Wakam () and Baptiste Poirriez () SAGE team, Inria Rennes, France journée Calcul Intensif Distribué

More information

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

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

More information

Summary of Iterative Methods for Non-symmetric Linear Equations That Are Related to the Conjugate Gradient (CG) Method

Summary of Iterative Methods for Non-symmetric Linear Equations That Are Related to the Conjugate Gradient (CG) Method Summary of Iterative Methods for Non-symmetric Linear Equations That Are Related to the Conjugate Gradient (CG) Method Leslie Foster 11-5-2012 We will discuss the FOM (full orthogonalization method), CG,

More information

FEniCS Course. Lecture 0: Introduction to FEM. Contributors Anders Logg, Kent-Andre Mardal

FEniCS Course. Lecture 0: Introduction to FEM. Contributors Anders Logg, Kent-Andre Mardal FEniCS Course Lecture 0: Introduction to FEM Contributors Anders Logg, Kent-Andre Mardal 1 / 46 What is FEM? The finite element method is a framework and a recipe for discretization of mathematical problems

More information

AN INTRODUCTION TO DOMAIN DECOMPOSITION METHODS. Gérard MEURANT CEA

AN INTRODUCTION TO DOMAIN DECOMPOSITION METHODS. Gérard MEURANT CEA Marrakech Jan 2003 AN INTRODUCTION TO DOMAIN DECOMPOSITION METHODS Gérard MEURANT CEA Introduction Domain decomposition is a divide and conquer technique Natural framework to introduce parallelism in the

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

Two new enriched multiscale coarse spaces for the Additive Average Schwarz method

Two new enriched multiscale coarse spaces for the Additive Average Schwarz method 346 Two new enriched multiscale coarse spaces for the Additive Average Schwarz method Leszek Marcinkowski 1 and Talal Rahman 2 1 Introduction We propose additive Schwarz methods with spectrally enriched

More information

Domain Decomposition Preconditioners for Spectral Nédélec Elements in Two and Three Dimensions

Domain Decomposition Preconditioners for Spectral Nédélec Elements in Two and Three Dimensions Domain Decomposition Preconditioners for Spectral Nédélec Elements in Two and Three Dimensions Bernhard Hientzsch Courant Institute of Mathematical Sciences, New York University, 51 Mercer Street, New

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

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

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

Numerische Mathematik

Numerische Mathematik Numer. Math. (1999) 83: 231 257 Numerische Mathematik c Springer-Verlag 1999 Eigenanalysis of some preconditioned Helmholtz problems Howard C. Elman, Dianne P. O Leary Computer Science Department and Institute

More information

The mortar element method for quasilinear elliptic boundary value problems

The mortar element method for quasilinear elliptic boundary value problems The mortar element method for quasilinear elliptic boundary value problems Leszek Marcinkowski 1 Abstract We consider a discretization of quasilinear elliptic boundary value problems by the mortar version

More information

Nested Krylov methods for shifted linear systems

Nested Krylov methods for shifted linear systems Nested Krylov methods for shifted linear systems M. Baumann, and M. B. van Gizen Email: M.M.Baumann@tudelft.nl Delft Institute of Applied Mathematics Delft University of Technology Delft, The Netherlands

More information

Master Thesis Literature Study Presentation

Master Thesis Literature Study Presentation Master Thesis Literature Study Presentation Delft University of Technology The Faculty of Electrical Engineering, Mathematics and Computer Science January 29, 2010 Plaxis Introduction Plaxis Finite Element

More information

On the performance of the Algebraic Optimized Schwarz Methods with applications

On the performance of the Algebraic Optimized Schwarz Methods with applications On the performance of the Algebraic Optimized Schwarz Methods with applications Report 12-1-18 Department of Mathematics Temple University October 212 This report is available at http://www.math.temple.edu/~szyld

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

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

CONVERGENCE ANALYSIS OF A BALANCING DOMAIN DECOMPOSITION METHOD FOR SOLVING A CLASS OF INDEFINITE LINEAR SYSTEMS

CONVERGENCE ANALYSIS OF A BALANCING DOMAIN DECOMPOSITION METHOD FOR SOLVING A CLASS OF INDEFINITE LINEAR SYSTEMS CONVERGENCE ANALYSIS OF A BALANCING DOMAIN DECOMPOSITION METHOD FOR SOLVING A CLASS OF INDEFINITE LINEAR SYSTEMS JING LI AND XUEMIN TU Abstract A variant of balancing domain decomposition method by constraints

More information

Lecture 8: Fast Linear Solvers (Part 7)

Lecture 8: Fast Linear Solvers (Part 7) Lecture 8: Fast Linear Solvers (Part 7) 1 Modified Gram-Schmidt Process with Reorthogonalization Test Reorthogonalization If Av k 2 + δ v k+1 2 = Av k 2 to working precision. δ = 10 3 2 Householder Arnoldi

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 Hybrid Multigrid-Schwarz algorithms Sébastien Loisel, Reinhard Nabben, and Daniel B. Szyld Research Report August 2007

On Hybrid Multigrid-Schwarz algorithms Sébastien Loisel, Reinhard Nabben, and Daniel B. Szyld Research Report August 2007 On Hybrid Multigrid-Schwarz algorithms Sébastien Loisel, Reinhard Nabben, and Daniel B. Szyld Research Report 07-8-28 August 2007 This report is available in the World Wide Web at http://www.math.temple.edu/~szyld

More information

Lecture 3: Inexact inverse iteration with preconditioning

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

More information

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

ITERATIVE METHODS FOR SPARSE LINEAR SYSTEMS

ITERATIVE METHODS FOR SPARSE LINEAR SYSTEMS ITERATIVE METHODS FOR SPARSE LINEAR SYSTEMS YOUSEF SAAD University of Minnesota PWS PUBLISHING COMPANY I(T)P An International Thomson Publishing Company BOSTON ALBANY BONN CINCINNATI DETROIT LONDON MADRID

More information

Linear and Non-Linear Preconditioning

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

More information

Newton additive and multiplicative Schwarz iterative methods

Newton additive and multiplicative Schwarz iterative methods IMA Journal of Numerical Analysis (2008) 28, 143 161 doi:10.1093/imanum/drm015 Advance Access publication on July 16, 2007 Newton additive and multiplicative Schwarz iterative methods JOSEP ARNAL, VIOLETA

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

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

A SHORT NOTE COMPARING MULTIGRID AND DOMAIN DECOMPOSITION FOR PROTEIN MODELING EQUATIONS

A SHORT NOTE COMPARING MULTIGRID AND DOMAIN DECOMPOSITION FOR PROTEIN MODELING EQUATIONS A SHORT NOTE COMPARING MULTIGRID AND DOMAIN DECOMPOSITION FOR PROTEIN MODELING EQUATIONS MICHAEL HOLST AND FAISAL SAIED Abstract. We consider multigrid and domain decomposition methods for the numerical

More information

A Balancing Algorithm for Mortar Methods

A Balancing Algorithm for Mortar Methods A Balancing Algorithm for Mortar Methods Dan Stefanica Baruch College, City University of New York, NY, USA. Dan_Stefanica@baruch.cuny.edu Summary. The balancing methods are hybrid nonoverlapping Schwarz

More information

Lecture 17 Methods for System of Linear Equations: Part 2. Songting Luo. Department of Mathematics Iowa State University

Lecture 17 Methods for System of Linear Equations: Part 2. Songting Luo. Department of Mathematics Iowa State University Lecture 17 Methods for System of Linear Equations: Part 2 Songting Luo Department of Mathematics Iowa State University MATH 481 Numerical Methods for Differential Equations Songting Luo ( Department of

More information

Contents. Preface... xi. Introduction...

Contents. Preface... xi. Introduction... Contents Preface... xi Introduction... xv Chapter 1. Computer Architectures... 1 1.1. Different types of parallelism... 1 1.1.1. Overlap, concurrency and parallelism... 1 1.1.2. Temporal and spatial parallelism

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

Space-time Finite Element Methods for Parabolic Evolution Problems

Space-time Finite Element Methods for Parabolic Evolution Problems Space-time Finite Element Methods for Parabolic Evolution Problems with Variable Coefficients Ulrich Langer, Martin Neumüller, Andreas Schafelner Johannes Kepler University, Linz Doctoral Program Computational

More information

An Iterative Substructuring Method for Mortar Nonconforming Discretization of a Fourth-Order Elliptic Problem in two dimensions

An Iterative Substructuring Method for Mortar Nonconforming Discretization of a Fourth-Order Elliptic Problem in two dimensions An Iterative Substructuring Method for Mortar Nonconforming Discretization of a Fourth-Order Elliptic Problem in two dimensions Leszek Marcinkowski Department of Mathematics, Warsaw University, Banacha

More information

ON ORTHOGONAL REDUCTION TO HESSENBERG FORM WITH SMALL BANDWIDTH

ON ORTHOGONAL REDUCTION TO HESSENBERG FORM WITH SMALL BANDWIDTH ON ORTHOGONAL REDUCTION TO HESSENBERG FORM WITH SMALL BANDWIDTH V. FABER, J. LIESEN, AND P. TICHÝ Abstract. Numerous algorithms in numerical linear algebra are based on the reduction of a given matrix

More information

Preconditioning for Nonsymmetry and Time-dependence

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

More information

Linear and Non-Linear Preconditioning

Linear and Non-Linear Preconditioning and Non- martin.gander@unige.ch University of Geneva June 2015 Invents an Iterative Method in a Letter (1823), in a letter to Gerling: in order to compute a least squares solution based on angle measurements

More information

Efficient domain decomposition methods for the time-harmonic Maxwell equations

Efficient domain decomposition methods for the time-harmonic Maxwell equations Efficient domain decomposition methods for the time-harmonic Maxwell equations Marcella Bonazzoli 1, Victorita Dolean 2, Ivan G. Graham 3, Euan A. Spence 3, Pierre-Henri Tournier 4 1 Inria Saclay (Defi

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

INSTITUTE OF MATHEMATICS THE CZECH ACADEMY OF SCIENCES. A virtual overlapping Schwarz method for scalar elliptic problems in two dimensions

INSTITUTE OF MATHEMATICS THE CZECH ACADEMY OF SCIENCES. A virtual overlapping Schwarz method for scalar elliptic problems in two dimensions INSTITUTE OF MATHEMATICS THE CZECH ACADEMY OF SCIENCES A virtual overlapping Schwarz method for scalar elliptic problems in two dimensions Juan Gabriel Calvo Preprint No. 25-2017 PRAHA 2017 A VIRTUAL

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

BLOCK ILU PRECONDITIONED ITERATIVE METHODS FOR REDUCED LINEAR SYSTEMS

BLOCK ILU PRECONDITIONED ITERATIVE METHODS FOR REDUCED LINEAR SYSTEMS CANADIAN APPLIED MATHEMATICS QUARTERLY Volume 12, Number 3, Fall 2004 BLOCK ILU PRECONDITIONED ITERATIVE METHODS FOR REDUCED LINEAR SYSTEMS N GUESSOUS AND O SOUHAR ABSTRACT This paper deals with the iterative

More information

4.8 Arnoldi Iteration, Krylov Subspaces and GMRES

4.8 Arnoldi Iteration, Krylov Subspaces and GMRES 48 Arnoldi Iteration, Krylov Subspaces and GMRES We start with the problem of using a similarity transformation to convert an n n matrix A to upper Hessenberg form H, ie, A = QHQ, (30) with an appropriate

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

A Fast Fourier transform based direct solver for the Helmholtz problem. AANMPDE 2017 Palaiochora, Crete, Oct 2, 2017

A Fast Fourier transform based direct solver for the Helmholtz problem. AANMPDE 2017 Palaiochora, Crete, Oct 2, 2017 A Fast Fourier transform based direct solver for the Helmholtz problem Jari Toivanen Monika Wolfmayr AANMPDE 2017 Palaiochora, Crete, Oct 2, 2017 Content 1 Model problem 2 Discretization 3 Fast solver

More information

A FETI-DP Method for Mortar Finite Element Discretization of a Fourth Order Problem

A FETI-DP Method for Mortar Finite Element Discretization of a Fourth Order Problem A FETI-DP Method for Mortar Finite Element Discretization of a Fourth Order Problem Leszek Marcinkowski 1 and Nina Dokeva 2 1 Department of Mathematics, Warsaw University, Banacha 2, 02 097 Warszawa, Poland,

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University Nonconformity and the Consistency Error First Strang Lemma Abstract Error Estimate

More information

Convergence analysis of a balancing domain decomposition method for solving a class of indefinite linear systems

Convergence analysis of a balancing domain decomposition method for solving a class of indefinite linear systems NUMERICAL LINEAR ALGEBRA WITH APPLICATIONS Numer. Linear Algebra Appl. 2000; 00:1 6 [Version: 2002/09/18 v1.02] Convergence analysis of a balancing domain decomposition method for solving a class of indefinite

More information

Multigrid and Domain Decomposition Methods for Electrostatics Problems

Multigrid and Domain Decomposition Methods for Electrostatics Problems Multigrid and Domain Decomposition Methods for Electrostatics Problems Michael Holst and Faisal Saied Abstract. We consider multigrid and domain decomposition methods for the numerical solution of electrostatics

More information

A PRECONDITIONED GMRES METHOD FOR NONSYMMETRIC OR INDEFINITE PROBLEMS

A PRECONDITIONED GMRES METHOD FOR NONSYMMETRIC OR INDEFINITE PROBLEMS MATHEMATICS OF COMPUTATION VOLUME 59, NUMBER 200 OCTOBER 1992, PAGES 311-319 A PRECONDITIONED GMRES METHOD FOR NONSYMMETRIC OR INDEFINITE PROBLEMS JINCHAO XU AND XIAO-CHUAN CAI Abstract. A preconditioning

More information

Deflated Krylov Iterations in Domain Decomposition Methods

Deflated Krylov Iterations in Domain Decomposition Methods 305 Deflated Krylov Iterations in Domain Decomposition Methods Y.L.Gurieva 1, V.P.Ilin 1,2, and D.V.Perevozkin 1 1 Introduction The goal of this research is an investigation of some advanced versions of

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra)

AMS526: Numerical Analysis I (Numerical Linear Algebra) AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 23: GMRES and Other Krylov Subspace Methods Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Numerical Analysis I 1 / 9 Minimizing Residual CG

More information

PDEs, part 1: Introduction and elliptic PDEs

PDEs, part 1: Introduction and elliptic PDEs PDEs, part 1: Introduction and elliptic PDEs Anna-Karin Tornberg Mathematical Models, Analysis and Simulation Fall semester, 2013 Partial di erential equations The solution depends on several variables,

More information

Block-Structured Adaptive Mesh Refinement

Block-Structured Adaptive Mesh Refinement Block-Structured Adaptive Mesh Refinement Lecture 2 Incompressible Navier-Stokes Equations Fractional Step Scheme 1-D AMR for classical PDE s hyperbolic elliptic parabolic Accuracy considerations Bell

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

INTRODUCTION TO MULTIGRID METHODS

INTRODUCTION TO MULTIGRID METHODS INTRODUCTION TO MULTIGRID METHODS LONG CHEN 1. ALGEBRAIC EQUATION OF TWO POINT BOUNDARY VALUE PROBLEM We consider the discretization of Poisson equation in one dimension: (1) u = f, x (0, 1) u(0) = u(1)

More information

Inexact inverse iteration with preconditioning

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

More information