AMG for a Peta-scale Navier Stokes Code

Size: px
Start display at page:

Download "AMG for a Peta-scale Navier Stokes Code"

Transcription

1 AMG for a Peta-scale Navier Stokes Code James Lottes Argonne National Laboratory October 18, 2007

2 The Challenge Develop an AMG iterative method to solve Poisson 2 u = f discretized on highly irregular (stretched, deformed, curved) trilinear FEs. System Ax = b needs solving many many times (for different b s), allowing a very high constant for set-up time. Scalability requirements start at P > 32,000 as a good solution is in place below this level.

3 Outline Notation for iterative solvers and multigrid (3 slides) Analysis of two-level multigrid, illustrated on model problem AMG iteration design

4 Iterative Solvers Linear system to solve is Ax = b. Iteration defined through preconditioner B by x k = x k 1 + B(b Ax k 1 ) = (I BA)x k 1 + Bb. Error e k x x k behaves as e k = Ee k 1 = E k e 0, E I BA. Convergence characterized by ρ(e), and E A ρ(e).

5 Multigrid Iteration Multigrid iteration defined by E mg = I B mg A = (I PB c P t A)(I BA), where B c is a multigrid preconditioner for the coarse operator A c P t AP, defined in terms of the n n c prolongator P, and B is the smoother.

6 C-F Point Algebraic Multigrid Assume n c coarse variables are a subset of the n variables, so that the prolongation matrix takes the form [ ] W P I for some n f n c W, with n f + n c = n. Let A have the corresponding block form [ ] Aff A A = fc, and also let A cf A cc R f [ I O ], R c [ O I ].

7 Model Problem Poisson, bilinear FEs, Neumann BCs Mesh is 2-D slice from an application mesh A is SPD (but not an M-matrix) except A1 = 0

8 C-F Points Figure: C-pts in red, F-pts in blue

9 Prolongation The energy-minimizing prolongation of Wan, Chan, and Smith [8, 9] Find P, given its sparsity pattern, and with R c P = I, that minimizes tr(p T AP) subject to P1 nc = 1 n.

10 Smoothers Damped Jacobi insufficient, Gauss-Seidel not parallel Adams, Brezina, Hu, and Tuminaro [1] recommend Chebyshev polynomial smoothers over Gauss-Seidel Sparse Approximate Inverse: Tang & Wan [6] Find B with a given sparsity pattern that minimizes I BA F SAI-0: Diagonal B A ii B ii = n k=1 A (compare to Jacobi: B ii = ω ) ika ik A ii SAI-1: Sparsity pattern of A used for M Simple to compute, and parameter-free

11 Chebyshev Polynomial Smoothing Chebyshev semi-iterative method to accelerate I BA B 1 = a 1 B, B 2 = a 1 B + a 2 BAB, λ(i B 1 A) = 1 a 1 λ(ba) λ(i B 2 A) = 1 a 1 λ(ba) a 2 λ 2 (BA) Choose coefficients using Chebyshev polynomials to damp error modes λ [λ min, λ max (BA)] λ min open parameter B: Jacobi, Diagonal SAI

12 Smoother Error Propagation Spectra Gauss Seidel Damped Jacobi Diagonal SAI SAI, A s stencil Diagonal SAI, 1st Chebyshev Improvement Figure: λ i (I BA) vs. i

13 Two-grid Error Propagation Spectra Gauss Seidel Damped Jacobi Diagonal SAI SAI, A s stencil Diagonal SAI, 1st Chebyshev Improvement Figure: λ i [(I P(P t AP) 1 P t A)(I BA)] vs. i

14 Change of Basis Given invertible T, defining a change of basis by, x = T ˆx, Transformed system is ˆx = T t b,  T t AT. Transformed iteration given by ˆB T 1 BT t, ˆP T 1 P, Ê mg (I ˆPB ˆPt c Â)(I ˆBÂ) = T 1 E mg T. Equivalent in that λ(êmg) = λ(e mg ), Êmg  = E mg A.

15 On the C-F Point Assumption Analysis of a C-F point AMG method can apply to other, more general AMG methods, so long as one can find a T such that [ ] ˆP = T 1 W P =. I This T is related to the R and S of Falgout and Vassilevski s On generalizing the AMG framework [4] through [ ] T 1 S t =. R

16 Hierarchical Basis Two-level hierarchical basis [ ] I W T = [ R I f t P ], T 1 = Chosen so that ˆP = R t c [ ] I W I Transforms A into [ A Â = ff W t A ff + A cf ] A ff W + A fc A c

17 Discrete Fundamental Solutions The transformed A, [ A Â = ff W t A ff + A cf A ff W + A fc A c ], is block-diagonal when the coarse basis functions are the discrete fundamental solutions W = A 1 ff A fc. But W is not sparse, hence not a viable choice. Introduce F W W.

18 Introducing F In terms of F, and where [ ] Aff A Â = ff F F t, A ff A c A c = S c + F t A ff F, S c A cc A cf A 1 ff A fc is the Schur complement of A ff in both A and Â. Note v 2 A c = v 2 S c + F v 2 A ff.

19 Exact Compatible Relaxation Theorem When B c = A 1 c, non-zero eigenvalues of E mg are also eigenvalues of I ˆB ff S f, where ˆB ff = [ I W ] B [ I W ] t, is the ff -block of the transformed smoother, and S f = A ff A ff FA 1 c F t A ff is the Schur complement of A c in Â.

20 Two-grid Error Propagation Spectra Gauss Seidel Damped Jacobi Diagonal SAI SAI, A s stencil Diagonal SAI, 1st Chebyshev Improvement Figure: λ i [(I P(P t AP) 1 P t A)(I BA)] vs. i

21 Exact Compatible Relaxation Spectra 1.2 Gauss Seidel Damped Jacobi Diagonal SAI SAI, A s stencil Diagonal SAI, 1st Chebyshev Improvement Figure: λ i (I ˆB ff S f ) vs. i

22 Equivalent F-relaxation Corollary With an exact coarse grid correction, the spectrum of E mg is left unchanged when the smoother B is replaced by the F-relaxation B F-r = R t f ˆB ff R f, where again, ˆB ff = [ I W ] B [ I W ] t.

23 Coarse- and Smoother-space Energies Coarse-space operator A c = S c + F t A ff F. Smoother-space operator S f = A ff A ff FA 1 c F t A ff. Coarse-space and smoother-space energies v 2 A c = v 2 S c + F v 2 A ff, w 2 S f = w 2 A ff F t A ff w 2, Ac 1 are minimal and maximal for any vectors when F = O. S f is close to A ff when F is small.

24 Exact Compatible Relaxation Spectra 1.2 Gauss Seidel Damped Jacobi Diagonal SAI SAI, A s stencil Diagonal SAI, 1st Chebyshev Improvement Figure: λ i (I ˆB ff S f ) vs. i

25 Inexact Compatible Relaxation Spectra 1.2 Gauss Seidel Damped Jacobi Diagonal SAI SAI, A s stencil Diagonal SAI, 1st Chebyshev Improvement Figure: λ i (I ˆB ff A ff ) vs. i

26 Measuring F Define γ as an energy norm of F, F v Aff γ sup. v 0 v Ac This quantity appears in, e.g., Falgout, Vassilevski, and Zikatanov [5] in the form γ 2 v 2 A = sup c v 2 S c v 0 v 2 < 1 A c as the square of the cosine of the abstract angle between the hierarchical component subspaces.

27 How Closely A ff Approximates S f Lemma The eigenvalues of A 1 ff S f are real and bounded by 0 < 1 γ 2 λ(a 1 ff S f ) 1.

28 A ff vs. S f : 1 γ 2 λ(a 1 ff S f ) Figure: λ i (A 1 ff S f ) vs. i

29 An Inexact Compatible Relaxation Iteration Theorem If ˆB ff is symmetric and ρ(i ˆB ff A ff ) ρ f < 1, then ρ(e mg ) = ρ(i ˆB ff S f ) ρ f + γ 2 (1 ρ f ).

30 Symmetric Cycle Corollary Define the symmetrized smoother as and its transformed ff -block as If σ is given such that then B s B + B t BAB t, ˆB ff,s [ I W ] B s [ I W ] t. ρ(i ˆB ff,s A ff ) σ 2 < 1, E mg 2 A = ρ[(i Bt A)Q(I BA)] σ 2 + γ 2 (1 σ 2 ).

31 Symmetric Cycle with F-relaxation Corollary If the smoother is an F-relaxation, and σ is given such that then, again, B = R t f ˆB ff R f, I ˆB ff A ff Aff σ < 1, E mg 2 A = ρ[(i Bt A)Q(I BA)] σ 2 + γ 2 (1 σ 2 ). Equivalent to first half of Theorem 4.2 in Falgout, Vassilevski, and Zikatanov s On two-grid convergence estimates [5].

32 AMG Iteration Design Central goal: make γ small Coarsening heursistic: make the columns of A 1 ff decay quickly Prolongation: choose sparsity by cutting off A 1 ff A fc according to some tolerance Smoother: simple F-relaxation of A ff

33 Designer F-relaxations, Compatible Relaxation Prediction 1.2 Diagonal SAI Diagonal SAI, 1st Chebyshev Improvement Damped Diagonal SAI of A ff Damped SAI of A ff with A ff sparsity Diagonal SAI of A ff, 1st Chebyshev Improvement Figure: λ i (I ˆB ff A ff ) vs. i

34 Designer F-relaxations, Two-level Performance Diagonal SAI Diagonal SAI, 1st Chebyshev Improvement Damped Diagonal SAI of A ff Damped SAI of A ff with A ff sparsity Diagonal SAI of A ff, 1st Chebyshev Improvement A ff Figure: λ i (I ˆB ff S f ) vs. i

35 M. Adams, M. Brezina, J. Hu, and R. Tuminaro. Parallel multigrid smoothing: polynomial versus Gauss-Seidel. Journal of Computational Physics, 188(2): , J. Brannick and L. Zikatanov. Domain Decomposition Methods in Science and Engineering XVI, volume 55 of Lecture Notes in Computational Science and Engineering, chapter Algebraic multigrid methods based on compatible relaxation and energy minimization, pages Springer Berlin Heidelberg, O. Bröker and M. J. Grote. Sparse approximate inverse smoothers for geometric and algebraic multigrid. Applied Numerical Mathematics, 41(1):61 80, R. D. Falgout and P. S. Vassilevski. On generalizing the algebraic multigrid framework. SIAM Journal on Numerical Analysis, 42(4): , 2004.

36 R. D. Falgout, P. S. Vassilevski, and L. T. Zikatanov. On two-grid convergence estimates. Numerical Linear Algebra with Applications, 12(5 6): , W.-P. Tang and W. L. Wan. Sparse approximate inverse smoother for multigrid. SIAM Journal on Matrix Analysis and Applications, 21(4): , H. M. Tufo and P. F. Fischer. Fast parallel direct solvers for coarse grid problems. J. Par. & Dist. Comput., 61: , W. L. Wan, T. F. Chan, and B. Smith. An energy-minimizing interpolation for robust multigrid methods. SIAM Journal on Scientific Computing, 21(4): , J. Xu and L. Zikatanov.

37 On an energy minimizing basis for algebraic multigrid methods. Computing and Visualization in Science, 7(3 4): , 2004.

38 Two-level Analysis Assume the coarse grid correction is exact, The coarse grid correction is a projection. ˆQ I B c A 1 c. Q I PA 1 c P t A, 1 ˆPA c ˆP t  = I RcA t 1 c R c Â, The error propagation matrix spectrum is λ(e mg ) = λ[ ˆQ(I ˆBÂ)] = λ[(i ˆBÂ) ˆQ].

39 Proof of First Theorem One may calculate [ ˆQ = Â ˆQ = I O A 1 c F t A ff O [ Aff A ff FA 1 c F t ] A ff O [ ] ˆBff ˆBfc ˆB, ˆB cf ˆBcc ], [ Sf [ (I ˆBÂ) ˆQ I = ˆB ] ff S f O A 1 c F t A ff ˆB cf S f O S f is the Schur complement of A c in Â. O ],

40 More on γ One may alternatively define F v Aff β sup = Rf t v 0 v FR c A. Sc The two quantities are related through γ 2 = sup v 0 F v 2 A ff v 2 S c + F v 2 A ff F v 2 A = sup ff / v 2 S c v F v 2 A ff / v 2 = β2 S c 1 + β 2.

41 How Closely A ff Approximates S f Lemma The eigenvalues of A 1 ff S f are real and bounded by 0 < 1 γ 2 λ(a 1 ff S f ) 1. Proof. A 1 ff S f = I FA 1 c F t A ff. λ(a 1 ff S f ) = 1 λ(fa 1 c F t A ff ) = 1 [{0} λ(a 1 c F t A ff F )]. F v 2 A 0 inf ff v 0 v 2 A c λ(a 1 c F t F v 2 A A ff F ) sup ff v 0 v 2 = γ 2. A c

New Multigrid Solver Advances in TOPS

New Multigrid Solver Advances in TOPS New Multigrid Solver Advances in TOPS R D Falgout 1, J Brannick 2, M Brezina 2, T Manteuffel 2 and S McCormick 2 1 Center for Applied Scientific Computing, Lawrence Livermore National Laboratory, P.O.

More information

Adaptive algebraic multigrid methods in lattice computations

Adaptive algebraic multigrid methods in lattice computations Adaptive algebraic multigrid methods in lattice computations Karsten Kahl Bergische Universität Wuppertal January 8, 2009 Acknowledgements Matthias Bolten, University of Wuppertal Achi Brandt, Weizmann

More information

Spectral element agglomerate AMGe

Spectral element agglomerate AMGe Spectral element agglomerate AMGe T. Chartier 1, R. Falgout 2, V. E. Henson 2, J. E. Jones 4, T. A. Manteuffel 3, S. F. McCormick 3, J. W. Ruge 3, and P. S. Vassilevski 2 1 Department of Mathematics, Davidson

More information

Solving PDEs with Multigrid Methods p.1

Solving PDEs with Multigrid Methods p.1 Solving PDEs with Multigrid Methods Scott MacLachlan maclachl@colorado.edu Department of Applied Mathematics, University of Colorado at Boulder Solving PDEs with Multigrid Methods p.1 Support and Collaboration

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra)

AMS526: Numerical Analysis I (Numerical Linear Algebra) AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 24: Preconditioning and Multigrid Solver Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Numerical Analysis I 1 / 5 Preconditioning Motivation:

More information

A greedy strategy for coarse-grid selection

A greedy strategy for coarse-grid selection A greedy strategy for coarse-grid selection S. MacLachlan Yousef Saad August 3, 2006 Abstract Efficient solution of the very large linear systems that arise in numerical modelling of real-world applications

More information

Aggregation-based algebraic multigrid

Aggregation-based algebraic multigrid Aggregation-based algebraic multigrid from theory to fast solvers Yvan Notay Université Libre de Bruxelles Service de Métrologie Nucléaire CEMRACS, Marseille, July 18, 2012 Supported by the Belgian FNRS

More information

Using an Auction Algorithm in AMG based on Maximum Weighted Matching in Matrix Graphs

Using an Auction Algorithm in AMG based on Maximum Weighted Matching in Matrix Graphs Using an Auction Algorithm in AMG based on Maximum Weighted Matching in Matrix Graphs Pasqua D Ambra Institute for Applied Computing (IAC) National Research Council of Italy (CNR) pasqua.dambra@cnr.it

More information

Adaptive Multigrid for QCD. Lattice University of Regensburg

Adaptive Multigrid for QCD. Lattice University of Regensburg Lattice 2007 University of Regensburg Michael Clark Boston University with J. Brannick, R. Brower, J. Osborn and C. Rebbi -1- Lattice 2007, University of Regensburg Talk Outline Introduction to Multigrid

More information

Bootstrap AMG. Kailai Xu. July 12, Stanford University

Bootstrap AMG. Kailai Xu. July 12, Stanford University Bootstrap AMG Kailai Xu Stanford University July 12, 2017 AMG Components A general AMG algorithm consists of the following components. A hierarchy of levels. A smoother. A prolongation. A restriction.

More information

Multigrid Methods and their application in CFD

Multigrid Methods and their application in CFD Multigrid Methods and their application in CFD Michael Wurst TU München 16.06.2009 1 Multigrid Methods Definition Multigrid (MG) methods in numerical analysis are a group of algorithms for solving differential

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

1. Fast Iterative Solvers of SLE

1. Fast Iterative Solvers of SLE 1. Fast Iterative Solvers of crucial drawback of solvers discussed so far: they become slower if we discretize more accurate! now: look for possible remedies relaxation: explicit application of the multigrid

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

An efficient multigrid solver based on aggregation

An efficient multigrid solver based on aggregation An efficient multigrid solver based on aggregation Yvan Notay Université Libre de Bruxelles Service de Métrologie Nucléaire Graz, July 4, 2012 Co-worker: Artem Napov Supported by the Belgian FNRS http://homepages.ulb.ac.be/

More information

University of Illinois at Urbana-Champaign. Multigrid (MG) methods are used to approximate solutions to elliptic partial differential

University of Illinois at Urbana-Champaign. Multigrid (MG) methods are used to approximate solutions to elliptic partial differential Title: Multigrid Methods Name: Luke Olson 1 Affil./Addr.: Department of Computer Science University of Illinois at Urbana-Champaign Urbana, IL 61801 email: lukeo@illinois.edu url: http://www.cs.uiuc.edu/homes/lukeo/

More information

CLASSICAL ITERATIVE METHODS

CLASSICAL ITERATIVE METHODS CLASSICAL ITERATIVE METHODS LONG CHEN In this notes we discuss classic iterative methods on solving the linear operator equation (1) Au = f, posed on a finite dimensional Hilbert space V = R N equipped

More information

Constrained Minimization and Multigrid

Constrained Minimization and Multigrid Constrained Minimization and Multigrid C. Gräser (FU Berlin), R. Kornhuber (FU Berlin), and O. Sander (FU Berlin) Workshop on PDE Constrained Optimization Hamburg, March 27-29, 2008 Matheon Outline Successive

More information

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

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

More information

Robust solution of Poisson-like problems with aggregation-based AMG

Robust solution of Poisson-like problems with aggregation-based AMG Robust solution of Poisson-like problems with aggregation-based AMG Yvan Notay Université Libre de Bruxelles Service de Métrologie Nucléaire Paris, January 26, 215 Supported by the Belgian FNRS http://homepages.ulb.ac.be/

More information

Aspects of Multigrid

Aspects of Multigrid Aspects of Multigrid Kees Oosterlee 1,2 1 Delft University of Technology, Delft. 2 CWI, Center for Mathematics and Computer Science, Amsterdam, SIAM Chapter Workshop Day, May 30th 2018 C.W.Oosterlee (CWI)

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

Indefinite and physics-based preconditioning

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

More information

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

ADAPTIVE ALGEBRAIC MULTIGRID

ADAPTIVE ALGEBRAIC MULTIGRID ADAPTIVE ALGEBRAIC MULTIGRID M. BREZINA, R. FALGOUT, S. MACLACHLAN, T. MANTEUFFEL, S. MCCORMICK, AND J. RUGE Abstract. Efficient numerical simulation of physical processes is constrained by our ability

More information

hypre MG for LQFT Chris Schroeder LLNL - Physics Division

hypre MG for LQFT Chris Schroeder LLNL - Physics Division hypre MG for LQFT Chris Schroeder LLNL - Physics Division This work performed under the auspices of the U.S. Department of Energy by under Contract DE-??? Contributors hypre Team! Rob Falgout (project

More information

A Generalized Eigensolver Based on Smoothed Aggregation (GES-SA) for Initializing Smoothed Aggregation Multigrid (SA)

A Generalized Eigensolver Based on Smoothed Aggregation (GES-SA) for Initializing Smoothed Aggregation Multigrid (SA) NUMERICAL LINEAR ALGEBRA WITH APPLICATIONS Numer. Linear Algebra Appl. 2007; 07: 6 [Version: 2002/09/8 v.02] A Generalized Eigensolver Based on Smoothed Aggregation (GES-SA) for Initializing Smoothed Aggregation

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

6. Iterative Methods for Linear Systems. The stepwise approach to the solution...

6. Iterative Methods for Linear Systems. The stepwise approach to the solution... 6 Iterative Methods for Linear Systems The stepwise approach to the solution Miriam Mehl: 6 Iterative Methods for Linear Systems The stepwise approach to the solution, January 18, 2013 1 61 Large Sparse

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

Boundary Value Problems - Solving 3-D Finite-Difference problems Jacob White

Boundary Value Problems - Solving 3-D Finite-Difference problems Jacob White Introduction to Simulation - Lecture 2 Boundary Value Problems - Solving 3-D Finite-Difference problems Jacob White Thanks to Deepak Ramaswamy, Michal Rewienski, and Karen Veroy Outline Reminder about

More information

The Removal of Critical Slowing Down. Lattice College of William and Mary

The Removal of Critical Slowing Down. Lattice College of William and Mary The Removal of Critical Slowing Down Lattice 2008 College of William and Mary Michael Clark Boston University James Brannick, Rich Brower, Tom Manteuffel, Steve McCormick, James Osborn, Claudio Rebbi 1

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

Geometric Multigrid Methods

Geometric Multigrid Methods Geometric Multigrid Methods Susanne C. Brenner Department of Mathematics and Center for Computation & Technology Louisiana State University IMA Tutorial: Fast Solution Techniques November 28, 2010 Ideas

More information

PALADINS: Scalable Time-Adaptive Algebraic Splitting and Preconditioners for the Navier-Stokes Equations

PALADINS: Scalable Time-Adaptive Algebraic Splitting and Preconditioners for the Navier-Stokes Equations 2013 SIAM Conference On Computational Science and Engineering Boston, 27 th February 2013 PALADINS: Scalable Time-Adaptive Algebraic Splitting and Preconditioners for the Navier-Stokes Equations U. Villa,

More information

On the choice of abstract projection vectors for second level preconditioners

On the choice of abstract projection vectors for second level preconditioners On the choice of abstract projection vectors for second level preconditioners C. Vuik 1, J.M. Tang 1, and R. Nabben 2 1 Delft University of Technology 2 Technische Universität Berlin Institut für Mathematik

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

DELFT UNIVERSITY OF TECHNOLOGY

DELFT UNIVERSITY OF TECHNOLOGY DELFT UNIVERSITY OF TECHNOLOGY REPORT 12-10 Fast linear solver for pressure computation in layered domains P. van Slingerland and C. Vuik ISSN 1389-6520 Reports of the Department of Applied Mathematical

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

Kasetsart University Workshop. Multigrid methods: An introduction

Kasetsart University Workshop. Multigrid methods: An introduction Kasetsart University Workshop Multigrid methods: An introduction Dr. Anand Pardhanani Mathematics Department Earlham College Richmond, Indiana USA pardhan@earlham.edu A copy of these slides is available

More information

OPERATOR-BASED INTERPOLATION FOR BOOTSTRAP ALGEBRAIC MULTIGRID

OPERATOR-BASED INTERPOLATION FOR BOOTSTRAP ALGEBRAIC MULTIGRID OPERATOR-BASED INTERPOLATION FOR BOOTSTRAP ALGEBRAIC MULTIGRID T. MANTEUFFEL, S. MCCORMICK, M. PARK, AND J. RUGE Abstract. Bootstrap Algebraic Multigrid (BAMG) is a multigrid-based solver for matrix equations

More information

Universal Scalable Robust Solvers from Computational Information Games and fast eigenspace adapted Multiresolution Analysis.

Universal Scalable Robust Solvers from Computational Information Games and fast eigenspace adapted Multiresolution Analysis. Universal Scalable Robust Solvers from Computational Information Games and fast eigenspace adapted Multiresolution Analysis Houman Owhadi Joint work with Clint Scovel IPAM Apr 3, 2017 DARPA EQUiPS / AFOSR

More information

A New Multilevel Smoothing Method for Wavelet-Based Algebraic Multigrid Poisson Problem Solver

A New Multilevel Smoothing Method for Wavelet-Based Algebraic Multigrid Poisson Problem Solver Journal of Microwaves, Optoelectronics and Electromagnetic Applications, Vol. 10, No.2, December 2011 379 A New Multilevel Smoothing Method for Wavelet-Based Algebraic Multigrid Poisson Problem Solver

More information

An Algebraic Multigrid Method Based on Matching 2 in Graphs 3 UNCORRECTED PROOF

An Algebraic Multigrid Method Based on Matching 2 in Graphs 3 UNCORRECTED PROOF 1 An Algebraic Multigrid Method Based on Matching 2 in Graphs 3 James Brannic 1, Yao Chen 1, Johannes Kraus 2, and Ludmil Ziatanov 1 4 1 Department of Mathematics, The Pennsylvania State University, PA

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

ANALYSIS OF AUGMENTED LAGRANGIAN-BASED PRECONDITIONERS FOR THE STEADY INCOMPRESSIBLE NAVIER-STOKES EQUATIONS

ANALYSIS OF AUGMENTED LAGRANGIAN-BASED PRECONDITIONERS FOR THE STEADY INCOMPRESSIBLE NAVIER-STOKES EQUATIONS ANALYSIS OF AUGMENTED LAGRANGIAN-BASED PRECONDITIONERS FOR THE STEADY INCOMPRESSIBLE NAVIER-STOKES EQUATIONS MICHELE BENZI AND ZHEN WANG Abstract. We analyze a class of modified augmented Lagrangian-based

More information

FEM and Sparse Linear System Solving

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

More information

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 9

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 9 Spring 2015 Lecture 9 REVIEW Lecture 8: Direct Methods for solving (linear) algebraic equations Gauss Elimination LU decomposition/factorization Error Analysis for Linear Systems and Condition Numbers

More information

A decade of fast and robust Helmholtz solvers

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

More information

An Introduction of Multigrid Methods for Large-Scale Computation

An Introduction of Multigrid Methods for Large-Scale Computation An Introduction of Multigrid Methods for Large-Scale Computation Chin-Tien Wu National Center for Theoretical Sciences National Tsing-Hua University 01/4/005 How Large the Real Simulations Are? Large-scale

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra for Computational and Data Sciences)

AMS526: Numerical Analysis I (Numerical Linear Algebra for Computational and Data Sciences) AMS526: Numerical Analysis I (Numerical Linear Algebra for Computational and Data Sciences) Lecture 19: Computing the SVD; Sparse Linear Systems Xiangmin Jiao Stony Brook University Xiangmin Jiao Numerical

More information

ALGEBRAIC MULTILEVEL METHODS FOR GRAPH LAPLACIANS

ALGEBRAIC MULTILEVEL METHODS FOR GRAPH LAPLACIANS The Pennsylvania State University The Graduate School Department of Mathematics ALGEBRAIC MULTILEVEL METHODS FOR GRAPH LAPLACIANS A Dissertation in Mathematics by Yao Chen Submitted in Partial Fulfillment

More information

Computational Information Games A minitutorial Part II Houman Owhadi ICERM June 5, 2017

Computational Information Games A minitutorial Part II Houman Owhadi ICERM June 5, 2017 Computational Information Games A minitutorial Part II Houman Owhadi ICERM June 5, 2017 DARPA EQUiPS / AFOSR award no FA9550-16-1-0054 (Computational Information Games) Question Can we design a linear

More information

Efficient smoothers for all-at-once multigrid methods for Poisson and Stokes control problems

Efficient smoothers for all-at-once multigrid methods for Poisson and Stokes control problems Efficient smoothers for all-at-once multigrid methods for Poisson and Stoes control problems Stefan Taacs stefan.taacs@numa.uni-linz.ac.at, WWW home page: http://www.numa.uni-linz.ac.at/~stefant/j3362/

More information

Solving Large Nonlinear Sparse Systems

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

More information

Newton s Method and Efficient, Robust Variants

Newton s Method and Efficient, Robust Variants Newton s Method and Efficient, Robust Variants Philipp Birken University of Kassel (SFB/TRR 30) Soon: University of Lund October 7th 2013 Efficient solution of large systems of non-linear PDEs in science

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

Fast Iterative Solution of Saddle Point Problems

Fast Iterative Solution of Saddle Point Problems Michele Benzi Department of Mathematics and Computer Science Emory University Atlanta, GA Acknowledgments NSF (Computational Mathematics) Maxim Olshanskii (Mech-Math, Moscow State U.) Zhen Wang (PhD student,

More information

c 2011 Society for Industrial and Applied Mathematics

c 2011 Society for Industrial and Applied Mathematics SIAM J. SCI. COMPUT. Vol. 33, No. 5, pp. 2761 2784 c 2011 Society for Industrial and Applied Mathematics ANALYSIS OF AUGMENTED LAGRANGIAN-BASED PRECONDITIONERS FOR THE STEADY INCOMPRESSIBLE NAVIER STOKES

More information

Algebraic Multigrid Methods for the Oseen Problem

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

More information

INTERGRID OPERATORS FOR THE CELL CENTERED FINITE DIFFERENCE MULTIGRID ALGORITHM ON RECTANGULAR GRIDS. 1. Introduction

INTERGRID OPERATORS FOR THE CELL CENTERED FINITE DIFFERENCE MULTIGRID ALGORITHM ON RECTANGULAR GRIDS. 1. Introduction Trends in Mathematics Information Center for Mathematical Sciences Volume 9 Number 2 December 2006 Pages 0 INTERGRID OPERATORS FOR THE CELL CENTERED FINITE DIFFERENCE MULTIGRID ALGORITHM ON RECTANGULAR

More information

Robust multigrid methods for nonsmooth coecient elliptic linear systems

Robust multigrid methods for nonsmooth coecient elliptic linear systems Journal of Computational and Applied Mathematics 123 (2000) 323 352 www.elsevier.nl/locate/cam Robust multigrid methods for nonsmooth coecient elliptic linear systems Tony F. Chan a; ; 1, W.L. Wan b; 2

More information

Math Introduction to Numerical Analysis - Class Notes. Fernando Guevara Vasquez. Version Date: January 17, 2012.

Math Introduction to Numerical Analysis - Class Notes. Fernando Guevara Vasquez. Version Date: January 17, 2012. Math 5620 - Introduction to Numerical Analysis - Class Notes Fernando Guevara Vasquez Version 1990. Date: January 17, 2012. 3 Contents 1. Disclaimer 4 Chapter 1. Iterative methods for solving linear systems

More information

A NEW EFFECTIVE PRECONDITIONED METHOD FOR L-MATRICES

A NEW EFFECTIVE PRECONDITIONED METHOD FOR L-MATRICES Journal of Mathematical Sciences: Advances and Applications Volume, Number 2, 2008, Pages 3-322 A NEW EFFECTIVE PRECONDITIONED METHOD FOR L-MATRICES Department of Mathematics Taiyuan Normal University

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

ANALYSIS AND COMPARISON OF GEOMETRIC AND ALGEBRAIC MULTIGRID FOR CONVECTION-DIFFUSION EQUATIONS

ANALYSIS AND COMPARISON OF GEOMETRIC AND ALGEBRAIC MULTIGRID FOR CONVECTION-DIFFUSION EQUATIONS ANALYSIS AND COMPARISON OF GEOMETRIC AND ALGEBRAIC MULTIGRID FOR CONVECTION-DIFFUSION EQUATIONS CHIN-TIEN WU AND HOWARD C. ELMAN Abstract. The discrete convection-diffusion equations obtained from streamline

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

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

C. Vuik 1 R. Nabben 2 J.M. Tang 1

C. Vuik 1 R. Nabben 2 J.M. Tang 1 Deflation acceleration of block ILU preconditioned Krylov methods C. Vuik 1 R. Nabben 2 J.M. Tang 1 1 Delft University of Technology J.M. Burgerscentrum 2 Technical University Berlin Institut für Mathematik

More information

Multigrid Methods for Linear Systems with Stochastic Entries Arising in Lattice QCD. Andreas Frommer

Multigrid Methods for Linear Systems with Stochastic Entries Arising in Lattice QCD. Andreas Frommer Methods for Linear Systems with Stochastic Entries Arising in Lattice QCD Andreas Frommer Collaborators The Dirac operator James Brannick, Penn State University Björn Leder, Humboldt Universität Berlin

More information

PRECONDITIONING OF DISCONTINUOUS GALERKIN METHODS FOR SECOND ORDER ELLIPTIC PROBLEMS. A Dissertation VESELIN ASENOV DOBREV

PRECONDITIONING OF DISCONTINUOUS GALERKIN METHODS FOR SECOND ORDER ELLIPTIC PROBLEMS. A Dissertation VESELIN ASENOV DOBREV PRECONDITIONING OF DISCONTINUOUS GALERKIN METHODS FOR SECOND ORDER ELLIPTIC PROBLEMS A Dissertation by VESELIN ASENOV DOBREV Submitted to the Office of Graduate Studies of Texas A&M University in partial

More information

Preconditioners for the incompressible Navier Stokes equations

Preconditioners for the incompressible Navier Stokes equations Preconditioners for the incompressible Navier Stokes equations C. Vuik M. ur Rehman A. Segal Delft Institute of Applied Mathematics, TU Delft, The Netherlands SIAM Conference on Computational Science and

More information

Fast solvers for steady incompressible flow

Fast solvers for steady incompressible flow ICFD 25 p.1/21 Fast solvers for steady incompressible flow Andy Wathen Oxford University wathen@comlab.ox.ac.uk http://web.comlab.ox.ac.uk/~wathen/ Joint work with: Howard Elman (University of Maryland,

More information

AN AGGREGATION MULTILEVEL METHOD USING SMOOTH ERROR VECTORS

AN AGGREGATION MULTILEVEL METHOD USING SMOOTH ERROR VECTORS AN AGGREGATION MULTILEVEL METHOD USING SMOOTH ERROR VECTORS EDMOND CHOW Abstract. Many algebraic multilevel methods for solving linear systems assume that the slowto-converge, or algebraically smooth error

More information

Elliptic Problems / Multigrid. PHY 604: Computational Methods for Physics and Astrophysics II

Elliptic Problems / Multigrid. PHY 604: Computational Methods for Physics and Astrophysics II Elliptic Problems / Multigrid Summary of Hyperbolic PDEs We looked at a simple linear and a nonlinear scalar hyperbolic PDE There is a speed associated with the change of the solution Explicit methods

More information

Operator Dependent Interpolation. A. Krechel. K. Stuben. German National Research Center for Information Technology (GMD)

Operator Dependent Interpolation. A. Krechel. K. Stuben. German National Research Center for Information Technology (GMD) Operator Dependent Interpolation in Algebraic Multigrid A. Krechel K. Stuben German National Research Center for Information Technology (GMD) Institute for Algorithms and Scientic Computing (SCAI) Schloss

More information

On deflation and singular symmetric positive semi-definite matrices

On deflation and singular symmetric positive semi-definite matrices Journal of Computational and Applied Mathematics 206 (2007) 603 614 www.elsevier.com/locate/cam On deflation and singular symmetric positive semi-definite matrices J.M. Tang, C. Vuik Faculty of Electrical

More information

A Novel Aggregation Method based on Graph Matching for Algebraic MultiGrid Preconditioning of Sparse Linear Systems

A Novel Aggregation Method based on Graph Matching for Algebraic MultiGrid Preconditioning of Sparse Linear Systems A Novel Aggregation Method based on Graph Matching for Algebraic MultiGrid Preconditioning of Sparse Linear Systems Pasqua D Ambra, Alfredo Buttari, Daniela Di Serafino, Salvatore Filippone, Simone Gentile,

More information

K.S. Kang. The multigrid method for an elliptic problem on a rectangular domain with an internal conductiong structure and an inner empty space

K.S. Kang. The multigrid method for an elliptic problem on a rectangular domain with an internal conductiong structure and an inner empty space K.S. Kang The multigrid method for an elliptic problem on a rectangular domain with an internal conductiong structure and an inner empty space IPP 5/128 September, 2011 The multigrid method for an elliptic

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

Motivation: Sparse matrices and numerical PDE's

Motivation: Sparse matrices and numerical PDE's Lecture 20: Numerical Linear Algebra #4 Iterative methods and Eigenproblems Outline 1) Motivation: beyond LU for Ax=b A little PDE's and sparse matrices A) Temperature Equation B) Poisson Equation 2) Splitting

More information

Efficient Solvers for Stochastic Finite Element Saddle Point Problems

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

More information

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

Algebraic multigrid for moderate order finite elements

Algebraic multigrid for moderate order finite elements Algebraic multigrid for moderate order finite elements Artem Napov and Yvan Notay Service de Métrologie Nucléaire Université Libre de Bruxelles (C.P. 165/84) 50, Av. F.D. Roosevelt, B-1050 Brussels, Belgium.

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

Algebraic Multigrid Preconditioners for Computing Stationary Distributions of Markov Processes

Algebraic Multigrid Preconditioners for Computing Stationary Distributions of Markov Processes Algebraic Multigrid Preconditioners for Computing Stationary Distributions of Markov Processes Elena Virnik, TU BERLIN Algebraic Multigrid Preconditioners for Computing Stationary Distributions of Markov

More information

Geometric Multigrid Methods for the Helmholtz equations

Geometric Multigrid Methods for the Helmholtz equations Geometric Multigrid Methods for the Helmholtz equations Ira Livshits Ball State University RICAM, Linz, 4, 6 November 20 Ira Livshits (BSU) - November 20, Linz / 83 Multigrid Methods Aim: To understand

More information

Lehrstuhl für Informatik 10 (Systemsimulation)

Lehrstuhl für Informatik 10 (Systemsimulation) FRIEDRICH-ALEXANDER-UNIVERSITÄT ERLANGEN-NÜRNBERG INSTITUT FÜR INFORMATIK (MATHEMATISCHE MASCHINEN UND DATENVERARBEITUNG) Lehrstuhl für Informatik 10 (Systemsimulation) Comparison of two implementations

More information

The Pennsylvania State University The Graduate School THE AUXILIARY SPACE SOLVERS AND THEIR APPLICATIONS. A Dissertation in Mathematics by Lu Wang

The Pennsylvania State University The Graduate School THE AUXILIARY SPACE SOLVERS AND THEIR APPLICATIONS. A Dissertation in Mathematics by Lu Wang The Pennsylvania State University The Graduate School THE AUXILIARY SPACE SOLVERS AND THEIR APPLICATIONS A Dissertation in Mathematics by Lu Wang c 2014 Lu Wang Submitted in Partial Fulfillment of the

More information

Multigrid finite element methods on semi-structured triangular grids

Multigrid finite element methods on semi-structured triangular grids XXI Congreso de Ecuaciones Diferenciales y Aplicaciones XI Congreso de Matemática Aplicada Ciudad Real, -5 septiembre 009 (pp. 8) Multigrid finite element methods on semi-structured triangular grids F.J.

More information

Multigrid Methods for Discretized PDE Problems

Multigrid Methods for Discretized PDE Problems Towards Metods for Discretized PDE Problems Institute for Applied Matematics University of Heidelberg Feb 1-5, 2010 Towards Outline A model problem Solution of very large linear systems Iterative Metods

More information

Comparison of V-cycle Multigrid Method for Cell-centered Finite Difference on Triangular Meshes

Comparison of V-cycle Multigrid Method for Cell-centered Finite Difference on Triangular Meshes Comparison of V-cycle Multigrid Method for Cell-centered Finite Difference on Triangular Meshes Do Y. Kwak, 1 JunS.Lee 1 Department of Mathematics, KAIST, Taejon 305-701, Korea Department of Mathematics,

More information

Preconditioning Techniques Analysis for CG Method

Preconditioning Techniques Analysis for CG Method Preconditioning Techniques Analysis for CG Method Huaguang Song Department of Computer Science University of California, Davis hso@ucdavis.edu Abstract Matrix computation issue for solve linear system

More information

Theoretical Bounds for Algebraic Multigrid Performance: Review and Analysis

Theoretical Bounds for Algebraic Multigrid Performance: Review and Analysis NUMERICL LINER LGEBR WITH PPLICTIONS Numer. Linear lgebra ppl. 2013; 00:1 27 Published online in Wiley InterScience (www.interscience.wiley.com). Theoretical Bounds for lgebraic Multigrid Performance:

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

A Space-Time Multigrid Solver Methodology for the Optimal Control of Time-Dependent Fluid Flow

A Space-Time Multigrid Solver Methodology for the Optimal Control of Time-Dependent Fluid Flow A Space-Time Multigrid Solver Methodology for the Optimal Control of Time-Dependent Fluid Flow Michael Köster, Michael Hinze, Stefan Turek Michael Köster Institute for Applied Mathematics TU Dortmund Trier,

More information

Poisson Equation in 2D

Poisson Equation in 2D A Parallel Strategy Department of Mathematics and Statistics McMaster University March 31, 2010 Outline Introduction 1 Introduction Motivation Discretization Iterative Methods 2 Additive Schwarz Method

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

7.2 Steepest Descent and Preconditioning

7.2 Steepest Descent and Preconditioning 7.2 Steepest Descent and Preconditioning Descent methods are a broad class of iterative methods for finding solutions of the linear system Ax = b for symmetric positive definite matrix A R n n. Consider

More information