A Jacobi Davidson Algorithm for Large Eigenvalue Problems from Opto-Electronics

Size: px
Start display at page:

Download "A Jacobi Davidson Algorithm for Large Eigenvalue Problems from Opto-Electronics"

Transcription

1 RANMEP, Hsinchu, Taiwan, January 4 8, /30 A Jacobi Davidson Algorithm for Large Eigenvalue Problems from Opto-Electronics Peter Arbenz 1 Urban Weber 1 Ratko Veprek 2 Bernd Witzigmann 2 1 Institute of Computational Science, ETH Zurich, 2 Integrated Systems Laboratory, ETH Zurich Work in progress RANMEP, Hsinchu, Taiwan, January 4 8, 2008.

2 RANMEP, Hsinchu, Taiwan, January 4 8, /30 Introduction I In solid state physics, the (electronic) band structure of a solid describes ranges of energy that an electron can assume. Electrons of single free-standing atom occupy atomic orbitals, that form discrete set of energy levels. When a large number of atoms are brought together to form a solid, the number of orbitals becomes exceedingly large, and the difference in energy between them becomes very small. Bands of energy levels are form rather than discrete energy levels. Intervals that contain no orbitals are called band gaps. From wikipedia.org

3 RANMEP, Hsinchu, Taiwan, January 4 8, /30 Introduction II Any solid has a large number of bands, in theory, many. However, all but a few lie at energies so high that any electron that reaches those energies escapes from the solid. These bands are usually disregarded.

4 RANMEP, Hsinchu, Taiwan, January 4 8, /30 Introduction III The uppermost occupied band is called valence band by analogy to the valence electrons of individual atoms. The lowermost unoccupied band is called the conduction band because only when electrons are excited to the conduction band can current flow in these materials.

5 RANMEP, Hsinchu, Taiwan, January 4 8, /30 Introduction IV A numerical evaluation of the band structure takes into account the periodic nature of a crystal lattice. The Schrödinger equation for a single particle in a cristal lattice is given by ( 2 2m V (r))ψ(r) = EΨ(r) (1) where the potential V exhibits the cristal periodicities: V (r) = V (r + R) for all lattice vectors R. Solutions of (1) are Bloch functions: where u nk (r) is lattice-periodic. Ψ nk (r) = e ik r u nk (r). (2)

6 RANMEP, Hsinchu, Taiwan, January 4 8, /30 Introduction V Here, k is called the wave vector, and is related to the direction of motion of the electron in the crystal, and n is the band index, which simply numbers the energy bands. The wave vector k takes on values within the Brillouin zone corresponding to the crystal lattice. Plugging (2) into (1) yields 2 2m 0 ( 2 + 2ik + k 2 + V (r) ) u nk (r) = E n (k)u nk (r) For each of the possible k there are infinitely many n = 1, 2,.... (3)

7 RANMEP, Hsinchu, Taiwan, January 4 8, /30 Introduction VI There are a number of possible ways to compute the spectral bands. 1 Solve (3) for k = k 0 = 0 and determine the rest of the eigenvalues by perturbation theory. (Effective mass m ) 2 Solve (3) in a subspace spanned by a small number of eigenfunctions (zone-centered Bloch functions) u n0 (Kane, 1957). 3 In the k p method the two methods are somehow combined by writing m Φ(r) = g i (r)u i0 (r). (4) i=1 Here, the so-called envelope g i replaces the plane wave e ik r in (2) (Luttinger-Kohn, 1955; Löwdin, 1951). We go for the k p method for its superior accuracy.

8 RANMEP, Hsinchu, Taiwan, January 4 8, /30 Introduction VII We finally arrive at an eigenvalue problem for the envelopes: H (2) ij (r) i j + H (1) i (r) i + H (0) (r) + U(r) g(r) = Eg(r) i,j=1,2,3 (5) Here, the perturbation U(r) takes into account an impurity potential of the material or quantum dot, etc. Note, that g is a m-vector (field). For the numerical computation g is represented by piecewise (linear) finite elements.

9 RANMEP, Hsinchu, Taiwan, January 4 8, /30 Quantum dot Probability density of an excited state in a valence band in a pyramidal quantum dot.

10 RANMEP, Hsinchu, Taiwan, January 4 8, /30 The linear algebra problem We end up with the generalized complex Hermitian eigenvalue problem Ax = λmx. (6) where A = A C n n, M T = M R n n, Depending on the bands included, A is either definite or indefinite. The latter holds if valence and conduction band are taken into account. Just a small number (k = 1 8) of bands are used. Matrices have k k blocks. Only a few of the eigenvalues closest to 0 of (6) are desired.

11 RANMEP, Hsinchu, Taiwan, January 4 8, /30 Transformation complex Hermitian real symmetric I For A = A r + i A i C n m, A r, A i R n m, define the mapping (Day & Heroux, 2001) ( ) ϕ : C m n R 2m 2n Ar A : A ϕ(a) := i A i A r (7) that transforms a complex m n matrix into a real 2m 2n matrix. If operations are allowed, then ϕ(ab) = ϕ(a)ϕ(b). (8) Many codes for solving eigenvalue problems, in particular for large sparse eigenvalue problems, are available only in real arithmetic. Very often the sparsity structures of real and imaginary parts of the underlying matrices differ considerably.

12 RANMEP, Hsinchu, Taiwan, January 4 8, /30 Transformation complex Hermitian real symmetric II We can rewrite the complex eigenvalue problem Ax = xλ (9) in the real form ϕ(ax) = ϕ(a)ϕ(x) = ϕ(xλ) = ϕ(x)ϕ(λ). (10) or, ( Ar A i A i A r ) ( ) ( ) ( xr x i xr x = i λr λ i x i x r So, a complex eigenvalue of A becomes a pair of complex conjugate eigenvalues of ϕ(a). A Hermitian = λ i = 0. x i x r λ i λ r ). (11)

13 RANMEP, Hsinchu, Taiwan, January 4 8, /30 Transformation complex Hermitian real symmetric III Special cases: ϕ(x )ϕ(x) = ϕ( x 2 ) ( x T r x T i x T i x T r ) ( ) xr x i x i x r ( ) = x ( ) Enforcing x yr y = 0 thus means that is made orthogonal y ( ) ( ) i ( ) xi xr yi to both and. The companion vector x r x i y r will then automatically be orthogonal to these two vectors. Computation is done with just one vector.

14 RANMEP, Hsinchu, Taiwan, January 4 8, /30 Computing only a few eigenpairs Case 1. A is positive definite. Compute eigenvalues one by one starting with the smallest. Case 2: A is indefinite. (M is always spd.) Use approaches employing harmonic Ritz values/vectors. Preconditioner? Generate two new positive definite eigenvalue problems (A σ i M)M 1 (A σ i M)x = λmx, i = 1, 2. (12) where σ 1 is close to the smallest positive eigenvalue of (A, M) and σ 2 is close to the smallest negative eigenvalue of (A, M) (Vömel, 2007; Shi Shu, 2006). Compute eigenvalues of (12) with shift σ 1 one by one starting with the smallest. Compute eigenvalues of (12) with shift σ 2 one by one starting with the smallest. Preconditioner? AMG preconditioner?

15 RANMEP, Hsinchu, Taiwan, January 4 8, /30 Symmetric Jacobi Davidson (JDSYM) (Sleijpen/van der Vorst, 1996; Geus, 2003) Let V k = span{v 1,..., v k }, v T k Mv j = δ kj, be the actual search space (not a Krylov space). Rayleigh Ritz Galerkin procedure: Extract Ritz pair ( λ, q) in V k with λ closest to some target value τ. Convergence: If r k M 1 (A λm) q M 1 < ε q M then we have found an eigenpair Solve correction equation for t k M q, (I M q q T )(A η k M)(I q q T M)t k = r k, q T Mt k = 0. (13) M-orthonormalize t k to V k to obtain v k+1 Expand search space: V k+1 = span{v 1,..., v k+1 }.

16 RANMEP, Hsinchu, Taiwan, January 4 8, /30 Remarks on JDSYM In exact arithmetic, one-vector JD is Rayleigh quotient iteration. Eigenvalue approximations converge cubically. Shift η k in (13) is set to target value τ initially ( inverse iteration) and to the Rayleigh quotient ρ( q) close to convergence. Keep subspace size bounded: If k = j max reduce size of the search space to j min. Use j min best Ritz vectors in V jmax to define V jmin. The correction equation is solved only approximatively. We use a Krylov space method: QMRS (admits indefinite preconditioner) (Freund, 1992). Eigenvectors corresponding to higher eigenvalues are computed in the orthogonal complement of previously computed eigenvectors.

17 RANMEP, Hsinchu, Taiwan, January 4 8, /30 Preconditioning the correction equation The correction equation is given by (I M q q T )(A η k M)(I q q T M)t k = r k, q T Mt k = 0. Preconditioning means solving with a system of the form (I M q q T )K(I q q T M)c = b, q T Mc = 0. (14) where K is a preconditioner for A ρ k M. As we are looking for just a few of the smallest eigenvalues we take K A σm where σ is close to the desired eigenvalues. Usually, σ = τ. We use the same aggregation-based AMG preconditioner K for all correction equations (Vaněk, Brezina, Mandel, 1996) (Remember we only compute a few eigenpairs.)

18 RANMEP, Hsinchu, Taiwan, January 4 8, /30 Setup procedure for an abstract multigrid solver 1: Define the number of levels, L 2: for level l = 0,..., L 1 do 3: if l < L 1 then 4: Define prolongator P l ; 5: Define restriction R l = Pl T ; 6: K l+1 = R l K l P l ; 7: Define smoother S l ; 8: else 9: Prepare for solving with K l ; 10: end if 11: end for

19 RANMEP, Hsinchu, Taiwan, January 4 8, /30 Smoothed aggregation (SA) AMG preconditioner I 1 Build adjacency graph G 0 of K 0 = K. (Take m m block structure into account.) 2 Group graph vertices into contiguous subsets, called aggregates. Each aggregate represents a coarser grid vertex. Typical aggregates: nodes (of the graph) up to nodes (if aggressive coarsening is used) (Par)METIS Note: The matrices K 1, K 2,... need much less memory space than K 0! Typical operator complexity for SA: 1.4 (!!!)

20 Smoothed aggregation (SA) AMG preconditioner II 3 Define a grid transfer operator: Low-energy modes (near-kernel) are chopped according to aggregation B l = Let B (l) j B (l) 1.. B (l) n l+1 = rows of B l corresponding to grid points assigned to j th aggregate. B (l) j = Q (l) j R (l) j be QR factorization of B (l) j then B l = P l B l+1, PT l Pl = I, with P l = diag(q (l) 1,..., Q(l) n l+1 ) and B l+1 = R (l) 1.. R (l) n l+1 Columns of B l+1 span the near kernel of K l+1. Notice: matrices K l are not used in constructing tentative prolongators P l, near kernels B l, and graphs G l. RANMEP, Hsinchu, Taiwan, January 4 8, /30.

21 RANMEP, Hsinchu, Taiwan, January 4 8, /30 Smoothed aggregation (SA) AMG preconditioner III 4 For elliptic problems, it is advisable to perform an additional step, to obtain smoothed aggregation (SA). P l = (I l ω l D 1 l K l ) P l, ω l = smoothed prolongator 4/3 λ max (D 1 l K l ), In non-smoothed aggregation: P l = P l 5 Smoother S l : polynomial smoother Choose a Chebyshev polynomial that is small on the upper part of the spectrum of K l (Adams, Brezina, Hu, Tuminaro, 2003). Parallelizes perfectly, quality independent of processor number.

22 RANMEP, Hsinchu, Taiwan, January 4 8, /30 Matrix-free multigrid Our approach: pcg which almost smoothed aggregation AMG preconditioning We set K = K 0 = A σm in the positive definite case and K = (A σm)m 1 lumped (A σm) in the indefinite case. (We apply K 0.) We lump because M 1 is dense. G 0 is the graph corresponding to (A σm)m 1 lumped (A σm). P 0 is not smoothed, i.e. P 0 = P 0. K 1 = P T 0 K 0P 0 is formed explicitely. All graphs, including G 0, are constructed.

23 RANMEP, Hsinchu, Taiwan, January 4 8, /30 The Software Environment: Trilinos The Trilinos Project is an effort to develop parallel solver algorithms and libraries within an object-oriented software framework for the solution of large-scale, complex multi-physics engineering and scientific applications. See Provides means to distribute (multi)vectors and (sparse) matrices (Epetra and EpetraExt packages). Provides solvers that work on these distributed data. Here we use iterative solvers and preconditioners (packages AztecOO/IFPACK), smoothed aggregation multilevel AMG preconditioner (ML), direct solver wrappers (Amesos) and data distribution for parallelization (Zoltan/ParMETIS). Quality of documentation depends on package.

24 RANMEP, Hsinchu, Taiwan, January 4 8, /30 Parallel mesh reading Implementation: HDF5 format/library Allows for parallel I/O Mesh file content A list of tetrahedra (4 vertices) Mesh reading scales with number of processors Binary file format allows for efficient I/O A list of vertex coordinates (x, y, z) A list of surface triangles (3 vertices)

25 RANMEP, Hsinchu, Taiwan, January 4 8, /30 Timings for a small quantum wire problem (4 4, spd) Problem size n = 49860, 2*n = Number of nonzeros in the graph = Some JDSYM parameters itmax=1000 linitmax=50 kmax=8 jmin=8 jmax=16 tau=0.0e+00 jdtol=1.0e-08 eps tr=1.0e-02 toldecay=1.5e+00 sigma=0.0e+00 linsolver=qmrs blksize=1

26 RANMEP, Hsinchu, Taiwan, January 4 8, /30 Convergence history of a typical JD run

27 RANMEP, Hsinchu, Taiwan, January 4 8, /30 Performance with spd problems E(p) = t(1) p t(p) 2DBigWire p t [sec] E(p) t(prec) n out n avg inner

28 Performance with indefinite problems Isoprobability surface at probability density of of an elevated electron state of a pyramidal Indium-Arsenide (InAs) quantum dot calculated using k p 8 8. RANMEP, Hsinchu, Taiwan, January 4 8, /30

29 RANMEP, Hsinchu, Taiwan, January 4 8, /30 Conclusions JD solves the spd eigenvalue very efficiently (with the right number of processors) The SA multilevel preconditioner is unbeatable (memory consumption, scalability), if it is applicable. Uncertainties with respect to success with the indefinite system does preconditioner work? near null space right? stopping criterion? how is the accuracy affected by squaring of the matrix?

30 RANMEP, Hsinchu, Taiwan, January 4 8, /30 The End

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

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

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

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

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

More information

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

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

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

An Algebraic Multigrid Method for Eigenvalue Problems

An Algebraic Multigrid Method for Eigenvalue Problems An Algebraic Multigrid Method for Eigenvalue Problems arxiv:1503.08462v1 [math.na] 29 Mar 2015 Xiaole Han, Yunhui He, Hehu Xie and Chunguang You Abstract An algebraic multigrid method is proposed to solve

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

A Jacobi Davidson Method with a Multigrid Solver for the Hermitian Wilson-Dirac Operator

A Jacobi Davidson Method with a Multigrid Solver for the Hermitian Wilson-Dirac Operator A Jacobi Davidson Method with a Multigrid Solver for the Hermitian Wilson-Dirac Operator Artur Strebel Bergische Universität Wuppertal August 3, 2016 Joint Work This project is joint work with: Gunnar

More information

APPLIED NUMERICAL LINEAR ALGEBRA

APPLIED NUMERICAL LINEAR ALGEBRA APPLIED NUMERICAL LINEAR ALGEBRA James W. Demmel University of California Berkeley, California Society for Industrial and Applied Mathematics Philadelphia Contents Preface 1 Introduction 1 1.1 Basic Notation

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

Linear Solvers. Andrew Hazel

Linear Solvers. Andrew Hazel Linear Solvers Andrew Hazel Introduction Thus far we have talked about the formulation and discretisation of physical problems...... and stopped when we got to a discrete linear system of equations. Introduction

More information

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

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

Solving Ax = b, an overview. Program

Solving Ax = b, an overview. Program Numerical Linear Algebra Improving iterative solvers: preconditioning, deflation, numerical software and parallelisation Gerard Sleijpen and Martin van Gijzen November 29, 27 Solving Ax = b, an overview

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

Computers and Mathematics with Applications

Computers and Mathematics with Applications Computers and Mathematics with Applications 68 (2014) 1151 1160 Contents lists available at ScienceDirect Computers and Mathematics with Applications journal homepage: www.elsevier.com/locate/camwa A GPU

More information

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

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

More information

AMG for a Peta-scale Navier Stokes Code

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

More information

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

LARGE SPARSE EIGENVALUE PROBLEMS

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

More information

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

SOLVING MESH EIGENPROBLEMS WITH MULTIGRID EFFICIENCY

SOLVING MESH EIGENPROBLEMS WITH MULTIGRID EFFICIENCY SOLVING MESH EIGENPROBLEMS WITH MULTIGRID EFFICIENCY KLAUS NEYMEYR ABSTRACT. Multigrid techniques can successfully be applied to mesh eigenvalue problems for elliptic differential operators. They allow

More information

Iterative methods for Linear System

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

More information

Is there life after the Lanczos method? What is LOBPCG?

Is there life after the Lanczos method? What is LOBPCG? 1 Is there life after the Lanczos method? What is LOBPCG? Andrew V. Knyazev Department of Mathematics and Center for Computational Mathematics University of Colorado at Denver SIAM ALA Meeting, July 17,

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

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

Eigenvalue Problems CHAPTER 1 : PRELIMINARIES

Eigenvalue Problems CHAPTER 1 : PRELIMINARIES Eigenvalue Problems CHAPTER 1 : PRELIMINARIES Heinrich Voss voss@tu-harburg.de Hamburg University of Technology Institute of Mathematics TUHH Heinrich Voss Preliminaries Eigenvalue problems 2012 1 / 14

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

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

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

Lecture 10 Preconditioning, Software, Parallelisation

Lecture 10 Preconditioning, Software, Parallelisation March 26, 2018 Lecture 10 Preconditioning, Software, Parallelisation A Incorporating a preconditioner We are interested in solving Ax = b (10.1) for x. Here, A is an n n non-singular matrix and b is a

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

Conjugate Gradient Method

Conjugate Gradient Method Conjugate Gradient Method direct and indirect methods positive definite linear systems Krylov sequence spectral analysis of Krylov sequence preconditioning Prof. S. Boyd, EE364b, Stanford University Three

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

Preconditioned Eigensolver LOBPCG in hypre and PETSc

Preconditioned Eigensolver LOBPCG in hypre and PETSc Preconditioned Eigensolver LOBPCG in hypre and PETSc Ilya Lashuk, Merico Argentati, Evgueni Ovtchinnikov, and Andrew Knyazev Department of Mathematics, University of Colorado at Denver, P.O. Box 173364,

More information

Preconditioned Eigenvalue Solvers for electronic structure calculations. Andrew V. Knyazev. Householder Symposium XVI May 26, 2005

Preconditioned Eigenvalue Solvers for electronic structure calculations. Andrew V. Knyazev. Householder Symposium XVI May 26, 2005 1 Preconditioned Eigenvalue Solvers for electronic structure calculations Andrew V. Knyazev Department of Mathematics and Center for Computational Mathematics University of Colorado at Denver Householder

More information

Multilevel Methods for Eigenspace Computations in Structural Dynamics

Multilevel Methods for Eigenspace Computations in Structural Dynamics Multilevel Methods for Eigenspace Computations in Structural Dynamics Ulrich Hetmaniuk & Rich Lehoucq Sandia National Laboratories, Computational Math and Algorithms, Albuquerque, NM Joint work with Peter

More information

Conjugate-Gradient Eigenvalue Solvers in Computing Electronic Properties of Nanostructure Architectures

Conjugate-Gradient Eigenvalue Solvers in Computing Electronic Properties of Nanostructure Architectures Conjugate-Gradient Eigenvalue Solvers in Computing Electronic Properties of Nanostructure Architectures Stanimire Tomov 1, Julien Langou 1, Andrew Canning 2, Lin-Wang Wang 2, and Jack Dongarra 1 1 Innovative

More information

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

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

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 23: GMRES and Other Krylov Subspace Methods; Preconditioning

AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 23: GMRES and Other Krylov Subspace Methods; Preconditioning AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 23: GMRES and Other Krylov Subspace Methods; Preconditioning Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Numerical Analysis I 1 / 18 Outline

More information

A 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

Jae Heon Yun and Yu Du Han

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

More information

Krylov subspace projection methods

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

More information

Iterative Methods for Solving A x = b

Iterative Methods for Solving A x = b Iterative Methods for Solving A x = b A good (free) online source for iterative methods for solving A x = b is given in the description of a set of iterative solvers called templates found at netlib: http

More information

Numerical Methods I Non-Square and Sparse Linear Systems

Numerical Methods I Non-Square and Sparse Linear Systems Numerical Methods I Non-Square and Sparse Linear Systems Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 MATH-GA 2011.003 / CSCI-GA 2945.003, Fall 2014 September 25th, 2014 A. Donev (Courant

More information

A Parallel Scalable PETSc-Based Jacobi-Davidson Polynomial Eigensolver with Application in Quantum Dot Simulation

A Parallel Scalable PETSc-Based Jacobi-Davidson Polynomial Eigensolver with Application in Quantum Dot Simulation A Parallel Scalable PETSc-Based Jacobi-Davidson Polynomial Eigensolver with Application in Quantum Dot Simulation Zih-Hao Wei 1, Feng-Nan Hwang 1, Tsung-Ming Huang 2, and Weichung Wang 3 1 Department of

More information

Alternative correction equations in the Jacobi-Davidson method

Alternative correction equations in the Jacobi-Davidson method Chapter 2 Alternative correction equations in the Jacobi-Davidson method Menno Genseberger and Gerard Sleijpen Abstract The correction equation in the Jacobi-Davidson method is effective in a subspace

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

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

Incomplete Cholesky preconditioners that exploit the low-rank property

Incomplete Cholesky preconditioners that exploit the low-rank property anapov@ulb.ac.be ; http://homepages.ulb.ac.be/ anapov/ 1 / 35 Incomplete Cholesky preconditioners that exploit the low-rank property (theory and practice) Artem Napov Service de Métrologie Nucléaire, Université

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

Iterative projection methods for sparse nonlinear eigenvalue problems

Iterative projection methods for sparse nonlinear eigenvalue problems Iterative projection methods for sparse nonlinear eigenvalue problems Heinrich Voss voss@tu-harburg.de Hamburg University of Technology Institute of Mathematics TUHH Heinrich Voss Iterative projection

More information

CME342 Parallel Methods in Numerical Analysis. Matrix Computation: Iterative Methods II. Sparse Matrix-vector Multiplication.

CME342 Parallel Methods in Numerical Analysis. Matrix Computation: Iterative Methods II. Sparse Matrix-vector Multiplication. CME342 Parallel Methods in Numerical Analysis Matrix Computation: Iterative Methods II Outline: CG & its parallelization. Sparse Matrix-vector Multiplication. 1 Basic iterative methods: Ax = b r = b Ax

More information

Course Notes: Week 1

Course Notes: Week 1 Course Notes: Week 1 Math 270C: Applied Numerical Linear Algebra 1 Lecture 1: Introduction (3/28/11) We will focus on iterative methods for solving linear systems of equations (and some discussion of eigenvalues

More information

The Lanczos and conjugate gradient algorithms

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

More information

Last Time. Social Network Graphs Betweenness. Graph Laplacian. Girvan-Newman Algorithm. Spectral Bisection

Last Time. Social Network Graphs Betweenness. Graph Laplacian. Girvan-Newman Algorithm. Spectral Bisection Eigenvalue Problems Last Time Social Network Graphs Betweenness Girvan-Newman Algorithm Graph Laplacian Spectral Bisection λ 2, w 2 Today Small deviation into eigenvalue problems Formulation Standard eigenvalue

More information

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

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

More information

Solution of eigenvalue problems. Subspace iteration, The symmetric Lanczos algorithm. Harmonic Ritz values, Jacobi-Davidson s method

Solution of eigenvalue problems. Subspace iteration, The symmetric Lanczos algorithm. Harmonic Ritz values, Jacobi-Davidson s method Solution of eigenvalue problems Introduction motivation Projection methods for eigenvalue problems Subspace iteration, The symmetric Lanczos algorithm Nonsymmetric Lanczos procedure; Implicit restarts

More information

State-of-the-art numerical solution of large Hermitian eigenvalue problems. Andreas Stathopoulos

State-of-the-art numerical solution of large Hermitian eigenvalue problems. Andreas Stathopoulos State-of-the-art numerical solution of large Hermitian eigenvalue problems Andreas Stathopoulos Computer Science Department and Computational Sciences Cluster College of William and Mary Acknowledgment:

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

Density-Matrix-Based Algorithms for Solving Eingenvalue Problems

Density-Matrix-Based Algorithms for Solving Eingenvalue Problems University of Massachusetts - Amherst From the SelectedWorks of Eric Polizzi 2009 Density-Matrix-Based Algorithms for Solving Eingenvalue Problems Eric Polizzi, University of Massachusetts - Amherst Available

More information

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

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

More information

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

Iterative methods for symmetric eigenvalue problems

Iterative methods for symmetric eigenvalue problems s Iterative s for symmetric eigenvalue problems, PhD McMaster University School of Computational Engineering and Science February 11, 2008 s 1 The power and its variants Inverse power Rayleigh quotient

More information

Conjugate-Gradient Eigenvalue Solvers in Computing Electronic Properties of Nanostructure Architectures

Conjugate-Gradient Eigenvalue Solvers in Computing Electronic Properties of Nanostructure Architectures Conjugate-Gradient Eigenvalue Solvers in Computing Electronic Properties of Nanostructure Architectures Stanimire Tomov 1, Julien Langou 1, Andrew Canning 2, Lin-Wang Wang 2, and Jack Dongarra 1 1 Innovative

More information

A Jacobi Davidson Method for Nonlinear Eigenproblems

A Jacobi Davidson Method for Nonlinear Eigenproblems A Jacobi Davidson Method for Nonlinear Eigenproblems Heinrich Voss Section of Mathematics, Hamburg University of Technology, D 21071 Hamburg voss @ tu-harburg.de http://www.tu-harburg.de/mat/hp/voss Abstract.

More information

Arnoldi Methods in SLEPc

Arnoldi Methods in SLEPc Scalable Library for Eigenvalue Problem Computations SLEPc Technical Report STR-4 Available at http://slepc.upv.es Arnoldi Methods in SLEPc V. Hernández J. E. Román A. Tomás V. Vidal Last update: October,

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

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

Just solve this: macroscopic Maxwell s equations

Just solve this: macroscopic Maxwell s equations ust solve this: macroscopic Maxwell s equations Faraday: E = B t constitutive equations (here, linear media): Ampere: H = D t + (nonzero frequency) Gauss: D = ρ B = 0 D = ε E B = µ H electric permittivity

More information

Krylov Space Solvers

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

More information

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

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

of dimension n 1 n 2, one defines the matrix determinants

of dimension n 1 n 2, one defines the matrix determinants HARMONIC RAYLEIGH RITZ FOR THE MULTIPARAMETER EIGENVALUE PROBLEM MICHIEL E. HOCHSTENBACH AND BOR PLESTENJAK Abstract. We study harmonic and refined extraction methods for the multiparameter eigenvalue

More information

Lecture Notes for Inf-Mat 3350/4350, Tom Lyche

Lecture Notes for Inf-Mat 3350/4350, Tom Lyche Lecture Notes for Inf-Mat 3350/4350, 2007 Tom Lyche August 5, 2007 2 Contents Preface vii I A Review of Linear Algebra 1 1 Introduction 3 1.1 Notation............................... 3 2 Vectors 5 2.1 Vector

More information

EIGIFP: A MATLAB Program for Solving Large Symmetric Generalized Eigenvalue Problems

EIGIFP: A MATLAB Program for Solving Large Symmetric Generalized Eigenvalue Problems EIGIFP: A MATLAB Program for Solving Large Symmetric Generalized Eigenvalue Problems JAMES H. MONEY and QIANG YE UNIVERSITY OF KENTUCKY eigifp is a MATLAB program for computing a few extreme eigenvalues

More information

A Parallel Implementation of the Davidson Method for Generalized Eigenproblems

A Parallel Implementation of the Davidson Method for Generalized Eigenproblems A Parallel Implementation of the Davidson Method for Generalized Eigenproblems Eloy ROMERO 1 and Jose E. ROMAN Instituto ITACA, Universidad Politécnica de Valencia, Spain Abstract. We present a parallel

More information

Some Geometric and Algebraic Aspects of Domain Decomposition Methods

Some Geometric and Algebraic Aspects of Domain Decomposition Methods Some Geometric and Algebraic Aspects of Domain Decomposition Methods D.S.Butyugin 1, Y.L.Gurieva 1, V.P.Ilin 1,2, and D.V.Perevozkin 1 Abstract Some geometric and algebraic aspects of various domain decomposition

More information

An Introduction to Algebraic Multigrid (AMG) Algorithms Derrick Cerwinsky and Craig C. Douglas 1/84

An Introduction to Algebraic Multigrid (AMG) Algorithms Derrick Cerwinsky and Craig C. Douglas 1/84 An Introduction to Algebraic Multigrid (AMG) Algorithms Derrick Cerwinsky and Craig C. Douglas 1/84 Introduction Almost all numerical methods for solving PDEs will at some point be reduced to solving A

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

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

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

ECS231 Handout Subspace projection methods for Solving Large-Scale Eigenvalue Problems. Part I: Review of basic theory of eigenvalue problems

ECS231 Handout Subspace projection methods for Solving Large-Scale Eigenvalue Problems. Part I: Review of basic theory of eigenvalue problems ECS231 Handout Subspace projection methods for Solving Large-Scale Eigenvalue Problems Part I: Review of basic theory of eigenvalue problems 1. Let A C n n. (a) A scalar λ is an eigenvalue of an n n A

More information

Implementation of a preconditioned eigensolver using Hypre

Implementation of a preconditioned eigensolver using Hypre Implementation of a preconditioned eigensolver using Hypre Andrew V. Knyazev 1, and Merico E. Argentati 1 1 Department of Mathematics, University of Colorado at Denver, USA SUMMARY This paper describes

More information

A Tuned Preconditioner for Inexact Inverse Iteration for Generalised Eigenvalue Problems

A Tuned Preconditioner for Inexact Inverse Iteration for Generalised Eigenvalue Problems A Tuned Preconditioner for for Generalised Eigenvalue Problems Department of Mathematical Sciences University of Bath, United Kingdom IWASEP VI May 22-25, 2006 Pennsylvania State University, University

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra)

AMS526: Numerical Analysis I (Numerical Linear Algebra) AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 19: More on Arnoldi Iteration; Lanczos Iteration Xiangmin Jiao Stony Brook University Xiangmin Jiao Numerical Analysis I 1 / 17 Outline 1

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

Solution of eigenvalue problems. Subspace iteration, The symmetric Lanczos algorithm. Harmonic Ritz values, Jacobi-Davidson s method

Solution of eigenvalue problems. Subspace iteration, The symmetric Lanczos algorithm. Harmonic Ritz values, Jacobi-Davidson s method Solution of eigenvalue problems Introduction motivation Projection methods for eigenvalue problems Subspace iteration, The symmetric Lanczos algorithm Nonsymmetric Lanczos procedure; Implicit restarts

More information

Parallel Discontinuous Galerkin Method

Parallel Discontinuous Galerkin Method Parallel Discontinuous Galerkin Method Yin Ki, NG The Chinese University of Hong Kong Aug 5, 2015 Mentors: Dr. Ohannes Karakashian, Dr. Kwai Wong Overview Project Goal Implement parallelization on Discontinuous

More information

Ma/CS 6b Class 23: Eigenvalues in Regular Graphs

Ma/CS 6b Class 23: Eigenvalues in Regular Graphs Ma/CS 6b Class 3: Eigenvalues in Regular Graphs By Adam Sheffer Recall: The Spectrum of a Graph Consider a graph G = V, E and let A be the adjacency matrix of G. The eigenvalues of G are the eigenvalues

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

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

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

More information

Lecture 17: Iterative Methods and Sparse Linear Algebra

Lecture 17: Iterative Methods and Sparse Linear Algebra Lecture 17: Iterative Methods and Sparse Linear Algebra David Bindel 25 Mar 2014 Logistics HW 3 extended to Wednesday after break HW 4 should come out Monday after break Still need project description

More information

Numerical Methods in Matrix Computations

Numerical Methods in Matrix Computations Ake Bjorck Numerical Methods in Matrix Computations Springer Contents 1 Direct Methods for Linear Systems 1 1.1 Elements of Matrix Theory 1 1.1.1 Matrix Algebra 2 1.1.2 Vector Spaces 6 1.1.3 Submatrices

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

Assignment 1 Math 5341 Linear Algebra Review. Give complete answers to each of the following questions. Show all of your work.

Assignment 1 Math 5341 Linear Algebra Review. Give complete answers to each of the following questions. Show all of your work. Assignment 1 Math 5341 Linear Algebra Review Give complete answers to each of the following questions Show all of your work Note: You might struggle with some of these questions, either because it has

More information

M.A. Botchev. September 5, 2014

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

More information

An efficient multigrid method for graph Laplacian systems II: robust aggregation

An efficient multigrid method for graph Laplacian systems II: robust aggregation An efficient multigrid method for graph Laplacian systems II: robust aggregation Artem Napov and Yvan Notay Service de Métrologie Nucléaire Université Libre de Bruxelles (C.P. 165/84) 50, Av. F.D. Roosevelt,

More information