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

Size: px
Start display at page:

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

Transcription

1 A Jacobi Davidson Method with a Multigrid Solver for the Hermitian Wilson-Dirac Operator Artur Strebel Bergische Universität Wuppertal August 3, 2016

2 Joint Work This project is joint work with: Gunnar Bali, Sarah Collins, Andreas Frommer, Karsten Kahl, Matthias Rottmann, Benjamin Müller +, Jakob Simeth : Universität Regensburg : Bergische Universität Wuppertal + : Johannes Gutenberg-Universität Mainz A. Strebel et al., Multigrid Solver for the Jacobi Davidson Method 1/21

3 Outline AMG for Lattice QCD Jacobi-Davidson + AMG Numerical Results Summary & Outlook A. Strebel et al., Multigrid Solver for the Jacobi Davidson Method 2/21

4 Lattice QCD: The Wilson Discretization FD Discretization: N 3 s N t regular lattice L (parallelized by distributing sub-blocks) nearest neighbor coupling 12 variables per site and four coupling matrices periodic boundary conditions γ 5 -symmetry: γ 5 D = (γ 5 D) (γ 5 := γ 1 γ 2 γ 3 γ 4, γ 2 5 = I) imaginary axis real axis spec(d) spec(d) is in the right half plane and symmetric to the real axis A. Strebel et al., Multigrid Solver for the Jacobi Davidson Method 3/21

5 Lattice QCD: The Wilson Discretization FD Discretization: N 3 s N t regular lattice L (parallelized by distributing sub-blocks) nearest neighbor coupling 12 variables per site and four coupling matrices periodic boundary conditions γ 5 -symmetry: γ 5 D = (γ 5 D) (γ 5 := γ 1 γ 2 γ 3 γ 4, γ 2 5 = I) eigenvalue λi index i spec(γ 5 D) spec(γ 5 D) is real and maximally indefinite, we denote Q := γ 5 D A. Strebel et al., Multigrid Solver for the Jacobi Davidson Method 3/21

6 Lattice QCD: Tasks Application: calculating physical observables oftentimes requires tr(q 1 ) tr(q 1 ) = λ 1 i compute small eigenvectors exactly treat remainder of spectrum with stochastic algorithm Challenges: todays matrix sizes: and larger (shifted) linear systems with either D or Q to be solved small EVs of Q (= singular vectors of D) highly desired Approaches: multigrid approaches for inverting D and Q Jacobi-Davidson method + multigrid approach for Q cheap eigensolver A. Strebel et al., Multigrid Solver for the Jacobi Davidson Method 4/21

7 Adaptive Algebraic Multigrid Approach for D (non-hermitian) Two-grid error propagator for ν steps of post-smoothing E (ν) 2g = (I MD)ν } {{ } smoother (I P Dc 1 P D), D }{{} c := P DP }{{} coarse grid correction coarse operator low accuracy for Dc 1 and M is sufficient introduce recursive construction for D c multigrid To Do: Define interpolation P and smoother M DD-αAMG [ArXiv: , ] M: Schwarz Alternating Procedure (SAP) [Lüscher 2003] P : Aggregation based Interpolation [Brannick, Clark et al. 2010] A. Strebel et al., Multigrid Solver for the Jacobi Davidson Method 5/21

8 Aggregation Based Interpolation Construction define aggregates: domain decomposition A 1,..., A s A 1 A 3 A 2 A 4 P R = P calculate test vectors w 1,..., w N decompose test vectors over aggregates A 1,..., A s A 1 A 1 (w 1,..., w N ) = = A 2 P = A 2 A s A s A. Strebel et al., Multigrid Solver for the Jacobi Davidson Method 6/21

9 Adaptive Algebraic Multigrid Approach for Q = γ 5 D Construct P such that P γ 5 = γ 5 P Replacing D Q = γ 5 D we obtain the two-grid error propagator Ẽ (ν) 2g = (I MQ)ν }{{} requires new smoother (I P Q 1 c P Q), Q }{{} c := P QP }{{} new coarse operator =I P Dc 1 P D P is valid for D and Q P preserves Q c = Q c recursive application possible SAP smoother does not work anymore Choice: Replace M by GMRES A. Strebel et al., Multigrid Solver for the Jacobi Davidson Method 7/21

10 γ 5 -Preconditioning AMG for Q in practice a factor of 2 slower than DD-αAMG can be remedied by γ 5 -preconditioning : (Q σi)ϕ = ψ γ 5 (Q σi)ϕ = γ 5 ψ (D σγ 5 )ϕ = γ 5 ψ error propagator of smoother now reads: Ẽ (ν) S = (I M(D σγ 5)) ν enables to compute (Q σ) 1 with AMG efficiently and thus to compute small eigenvectors of Q A. Strebel et al., Multigrid Solver for the Jacobi Davidson Method 8/21

11 AMG for D in Practice: Scaling with the Bare Quark Mass Configuration: , 128 cores time to solution (in seconds) m crit m u m ud m d 0.05 m 0 two-level DD-αAMG three-level DD-αAMG four-level DD-αAMG mp oe BiCGStab lighter quark mass m 0 more ill-conditioned system AMG less sensitive to condition number than Krylov subspace methods A. Strebel et al., Multigrid Solver for the Jacobi Davidson Method 9/21

12 AMG for Lattice QCD Jacobi-Davidson + AMG Numerical Results Summary & Outlook A. Strebel et al., Multigrid Solver for the Jacobi Davidson Method 10/21

13 An Introduction to Eigensolver Methods Applying a matrix A to an arbitrary vector v multiple times converges to largest eigenvector Power method If λ is an eigenvalue of A, then (λ σ) 1 is an eigenvalue of (A σi) 1 Inverse iteration Now we can compute any eigenpair we want Given a normalized vector v the Rayleigh Quotient is defined as r(x) = v Av r(x) is the best-approximation to an eigenvalue of v Rayleigh quotient iteration (cubic convergence for hermitian matrices) A. Strebel et al., Multigrid Solver for the Jacobi Davidson Method 11/21

14 An Introduction to the Jacobi-Davidson Method The Jacobi-Davidson method combines two ideas Davidson: Impose Galerkin Condition AV s θs V on eigenvalue problem to some subspace V = {v 1, v 2,..., v n }, which leads to V AV s θs = 0 If (θ i, s i ) is a solution of this equation then (θ i, u i = V s i ) is called a Ritz pair w.r.t. the subspace V (θ i, u i ) approximates eigenpairs How to construct V? Jacobi: Given an eigenvector approximation u i, choose an orthogonal correction t u i such that A(u i + t) = λ(u i + t) We find that t fulfills the equation (I u i u i )(A λi)(i u iu i )t = (A θ ii)u i := r λ unknown replace by θ i A. Strebel et al., Multigrid Solver for the Jacobi Davidson Method 12/21

15 An Introduction to the Jacobi-Davidson Method The Jacobi-Davidson method combines two ideas Davidson: Impose Galerkin Condition AV s θs V on eigenvalue problem to some subspace V = {v 1, v 2,..., v n }, which leads to V AV s θs = 0 If (θ i, s i ) is a solution of this equation then (θ i, u i = V s i ) is called a Ritz pair w.r.t. the subspace V (θ i, u i ) approximates eigenpairs How to construct V? Jacobi: Given an eigenvector approximation u i, choose an orthogonal correction t u i such that A(u i + t) = λ(u i + t) We find that t fulfills the equation (I u i u i )(A θ ii)(i u i u i )t = (A θ ii)u i =: r Solve inexactly for t and add result to V A. Strebel et al., Multigrid Solver for the Jacobi Davidson Method 12/21

16 The Jacobi-Davidson Method Algorithm 1: Jacobi-Davidson (basic) input: initial guess t, desired accuracy ε output: eigenpair (λ, x) 1 for all m = 1, 2,... do 2 t = t V V t, v m = t/ t 2 3 M = V AV 4 compute smallest eigenpair (θ, s) of M 5 u = V s 6 r = Au θu 7 if r 2 ε then 8 λ = θ, x = u 9 solve (approximately) for t u in (I uu )(A θi)(i uu )t = r A. Strebel et al., Multigrid Solver for the Jacobi Davidson Method 13/21

17 The Jacobi-Davidson Method with AMG Algorithm 2: Jacobi-Davidson + AMG input: no. of eigenvalues n, subspace size l, initial guess [v 0, v 1,..., v k, t], desired accuracy ε output: set of n eigenpairs (Λ, X) 1 for all m = k + 1, k + 2,... do 2 t = t V V t, v m = t/ t 2 3 compute all (θ i, s i ) with (AV ) (AV )s i = θ i (AV ) V s i 4 find smallest θ i / Λ 5 u = V s i, r = Au θ i u 6 if r 2 ε then 7 Λ = [Λ, θ i ], X = [X, u] 8 if m l + n conv then 9 jd restart 10 find smallest θ i / Λ 11 rebuild interpolation 12 solve (approximately) (A θ i I)t = r A. Strebel et al., Multigrid Solver for the Jacobi Davidson Method 14/21

18 Restarting Goal: Limit the amount of work (and memory) per iteration control dimension of search space V Algorithm 3: jd restart input: look ahead m, number of converged eigenpairs n conv, search space V output: new search space V and Ritz pairs (θ i, s i ) 1 [, π] = sort( Θ, ascending) 2 for all i = 1,... m + n conv do 3 V i = V s π(i) 4 V = V (1 : m + n conv ) 5 orthogonalize V 6 compute all (θ i, s i ) with (AV ) (AV )s i = (AV ) V s i look ahead m preserves search space information in spirit of thick restarting subspace size is bound by n + l A. Strebel et al., Multigrid Solver for the Jacobi Davidson Method 15/21

19 Interaction between Jacobi-Davidson and AMG Rebuilding the interpolation JD computed all eigenvectors up to some point σ AMG needs small eigenvectors of (A σi) for interpolation P Idea: Use converged vectors to improve P dynamically: current EV (to be computed) k fix smallest EVs k flex EVs Build interpolation P with: k fix smallest eigenvectors current eigenvector approximation u k flex converged eigenvectors closest to u A. Strebel et al., Multigrid Solver for the Jacobi Davidson Method 16/21

20 Interaction between Jacobi-Davidson and AMG Rebuilding the interpolation JD computed all eigenvectors up to some point σ AMG needs small eigenvectors of (A σi) for interpolation P Idea: Use converged vectors to improve P dynamically: current EV (to be computed) k flex EVs k fix smallest EVs Build interpolation P with: k fix smallest eigenvectors current eigenvector approximation u k flex converged eigenvectors closest to u A. Strebel et al., Multigrid Solver for the Jacobi Davidson Method 16/21

21 AMG for Lattice QCD Jacobi-Davidson + AMG Numerical Results Summary & Outlook A. Strebel et al., Multigrid Solver for the Jacobi Davidson Method 17/21

22 Comparison with PARPACK: Scaling with the Number of Eigenvectors N 10 5 PARPACK JD + AMG core-h number of eigenvectors N lattice ( unknowns) 648 cores on JURECA PARPACK: Krylov subspace dimension 4N JD: k fix = 8, k flex = 16, search space dimension 150 orthogonalization cost n conv A. Strebel et al., Multigrid Solver for the Jacobi Davidson Method 18/21

23 Effectiveness of AMG Solves solve time per EV (in seconds) FGMRES + AMG FGMRESR (after 50 EVs) eigenvector number coarse grid correction switched off after 50 converged eigenvectors clear loss in solve time for first 400 eigenvectors afterwards coarse grid effectiveness deteriorates better interpolation strategy? hybrid approach? different preconditioner at some point? A. Strebel et al., Multigrid Solver for the Jacobi Davidson Method 19/21

24 AMG for Lattice QCD Jacobi-Davidson + AMG Numerical Results Summary & Outlook A. Strebel et al., Multigrid Solver for the Jacobi Davidson Method 20/21

25 Summary & Outlook Summary Jacobi-Davidson type algorithm with multigrid support good scaling with number of eigenvalues scalability mostly depends on solver performance speed up can be orders of magnitudes Improve Eigensolver explore possible benefits of AMG with more levels study orthogonal projections for solves find optimal restarting strategy improve interaction between JD and interpolation explore scaling behavior with lattice size (former approach scaled better than PARPACK) compare with other eigensolver approaches (e.g. FEAST) A. Strebel et al., Multigrid Solver for the Jacobi Davidson Method 21/21

26 Acknowledgments All results computed on JUROPA at Jülich Supercomputing Centre (JSC) Funded by Deutsche Forschungsgemeinschaft (DFG), Transregional Collaborative Research Centre 55 (SFB TR 55) All configurations provided by BMW-c, QCDSF & CLS

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

A Comparison of Adaptive Algebraic Multigrid and Lüscher s Inexact Deflation

A Comparison of Adaptive Algebraic Multigrid and Lüscher s Inexact Deflation A Comparison of Adaptive Algebraic Multigrid and Lüscher s Inexact Deflation Andreas Frommer, Karsten Kahl, Stefan Krieg, Björn Leder and Matthias Rottmann Bergische Universität Wuppertal April 11, 2013

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

DDalphaAMG for Twisted Mass Fermions

DDalphaAMG for Twisted Mass Fermions DDalphaAMG for Twisted Mass Fermions, a, b, Constantia Alexandrou a,c, Jacob Finkenrath c, Andreas Frommer b, Karsten Kahl b and Matthias Rottmann b a Department of Physics, University of Cyprus, PO Box

More information

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

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

More information

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

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

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

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

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

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

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

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

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

arxiv: v1 [hep-lat] 19 Jul 2009

arxiv: v1 [hep-lat] 19 Jul 2009 arxiv:0907.3261v1 [hep-lat] 19 Jul 2009 Application of preconditioned block BiCGGR to the Wilson-Dirac equation with multiple right-hand sides in lattice QCD Abstract H. Tadano a,b, Y. Kuramashi c,b, T.

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

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

Model order reduction of large-scale dynamical systems with Jacobi-Davidson style eigensolvers

Model order reduction of large-scale dynamical systems with Jacobi-Davidson style eigensolvers MAX PLANCK INSTITUTE International Conference on Communications, Computing and Control Applications March 3-5, 2011, Hammamet, Tunisia. Model order reduction of large-scale dynamical systems with Jacobi-Davidson

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

arxiv: v1 [hep-lat] 2 May 2012

arxiv: v1 [hep-lat] 2 May 2012 A CG Method for Multiple Right Hand Sides and Multiple Shifts in Lattice QCD Calculations arxiv:1205.0359v1 [hep-lat] 2 May 2012 Fachbereich C, Mathematik und Naturwissenschaften, Bergische Universität

More information

A mathematicians way into STRONGnet

A mathematicians way into STRONGnet A mathematicians way into STRONGnet Nemanja Bozovic Bergische Universität Wuppertal bozovic@math.uni-wuppertal.de 03-10-2011 My work is funded by STRONGnet Career so far Nemanja Božović, born on 16.11.1984,

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

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

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

More information

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

A Jacobi-Davidson method for solving complex symmetric eigenvalue problems Arbenz, P.; Hochstenbach, M.E.

A Jacobi-Davidson method for solving complex symmetric eigenvalue problems Arbenz, P.; Hochstenbach, M.E. A Jacobi-Davidson method for solving complex symmetric eigenvalue problems Arbenz, P.; Hochstenbach, M.E. Published in: SIAM Journal on Scientific Computing DOI: 10.1137/S1064827502410992 Published: 01/01/2004

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

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

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

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

A Jacobi Davidson Algorithm for Large Eigenvalue Problems from Opto-Electronics RANMEP, Hsinchu, Taiwan, January 4 8, 2008 1/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

More information

Davidson Method CHAPTER 3 : JACOBI DAVIDSON METHOD

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

More information

Adaptive Algebraic Multigrid for Lattice QCD Computations

Adaptive Algebraic Multigrid for Lattice QCD Computations Adaptive Algebraic Multigrid for Lattice QCD Computations Dissertation zur Erlangung des akademischen Grades eines Doktor der Naturwissenschaften (Dr. rer. nat.) dem Fachbereich C - Mathematik und Naturwissenschaften

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

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

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

Polynomial Jacobi Davidson Method for Large/Sparse Eigenvalue Problems

Polynomial Jacobi Davidson Method for Large/Sparse Eigenvalue Problems Polynomial Jacobi Davidson Method for Large/Sparse Eigenvalue Problems Tsung-Ming Huang Department of Mathematics National Taiwan Normal University, Taiwan April 28, 2011 T.M. Huang (Taiwan Normal Univ.)

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

Deflation for inversion with multiple right-hand sides in QCD

Deflation for inversion with multiple right-hand sides in QCD Deflation for inversion with multiple right-hand sides in QCD A Stathopoulos 1, A M Abdel-Rehim 1 and K Orginos 2 1 Department of Computer Science, College of William and Mary, Williamsburg, VA 23187 2

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

ABSTRACT OF DISSERTATION. Ping Zhang

ABSTRACT OF DISSERTATION. Ping Zhang ABSTRACT OF DISSERTATION Ping Zhang The Graduate School University of Kentucky 2009 Iterative Methods for Computing Eigenvalues and Exponentials of Large Matrices ABSTRACT OF DISSERTATION A dissertation

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

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

EIGENVALUE PROBLEMS. Background on eigenvalues/ eigenvectors / decompositions. Perturbation analysis, condition numbers..

EIGENVALUE PROBLEMS. Background on eigenvalues/ eigenvectors / decompositions. Perturbation analysis, condition numbers.. EIGENVALUE PROBLEMS Background on eigenvalues/ eigenvectors / decompositions Perturbation analysis, condition numbers.. Power method The QR algorithm Practical QR algorithms: use of Hessenberg form and

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

Efficient implementation of the overlap operator on multi-gpus

Efficient implementation of the overlap operator on multi-gpus Efficient implementation of the overlap operator on multi-gpus Andrei Alexandru Mike Lujan, Craig Pelissier, Ben Gamari, Frank Lee SAAHPC 2011 - University of Tennessee Outline Motivation Overlap operator

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

Algebraic Multi-Grid solver for lattice QCD on Exascale hardware: Intel Xeon Phi

Algebraic Multi-Grid solver for lattice QCD on Exascale hardware: Intel Xeon Phi Available online at www.prace-ri.eu Partnership for Advanced Computing in Europe Algebraic Multi-Grid solver for lattice QCD on Exascale hardware: Intel Xeon Phi A. Abdel-Rehim aa, G. Koutsou a, C. Urbach

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

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

Jacobi-Davidson Algorithm for Locating Resonances in a Few-Body Tunneling System

Jacobi-Davidson Algorithm for Locating Resonances in a Few-Body Tunneling System Jacobi-Davidson Algorithm for Locating Resonances in a Few-Body Tunneling System Bachelor Thesis in Physics and Engineering Physics Gustav Hjelmare Jonathan Larsson David Lidberg Sebastian Östnell Department

More information

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

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

More information

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

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

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

THEORETICAL AND NUMERICAL COMPARISON OF PROJECTION METHODS DERIVED FROM DEFLATION, DOMAIN DECOMPOSITION AND MULTIGRID METHODS

THEORETICAL AND NUMERICAL COMPARISON OF PROJECTION METHODS DERIVED FROM DEFLATION, DOMAIN DECOMPOSITION AND MULTIGRID METHODS THEORETICAL AND NUMERICAL COMPARISON OF PROJECTION METHODS DERIVED FROM DEFLATION, DOMAIN DECOMPOSITION AND MULTIGRID METHODS J.M. TANG, R. NABBEN, C. VUIK, AND Y.A. ERLANGGA Abstract. For various applications,

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

1. Introduction. In this paper we consider the large and sparse eigenvalue problem. Ax = λx (1.1) T (λ)x = 0 (1.2)

1. Introduction. In this paper we consider the large and sparse eigenvalue problem. Ax = λx (1.1) T (λ)x = 0 (1.2) A NEW JUSTIFICATION OF THE JACOBI DAVIDSON METHOD FOR LARGE EIGENPROBLEMS HEINRICH VOSS Abstract. The Jacobi Davidson method is known to converge at least quadratically if the correction equation is solved

More information

HARMONIC RAYLEIGH RITZ EXTRACTION FOR THE MULTIPARAMETER EIGENVALUE PROBLEM

HARMONIC RAYLEIGH RITZ EXTRACTION FOR THE MULTIPARAMETER EIGENVALUE PROBLEM HARMONIC RAYLEIGH RITZ EXTRACTION FOR THE MULTIPARAMETER EIGENVALUE PROBLEM MICHIEL E. HOCHSTENBACH AND BOR PLESTENJAK Abstract. We study harmonic and refined extraction methods for the multiparameter

More information

Lattice Quantum Chromodynamics on the MIC architectures

Lattice Quantum Chromodynamics on the MIC architectures Lattice Quantum Chromodynamics on the MIC architectures Piotr Korcyl Universität Regensburg Intel MIC Programming Workshop @ LRZ 28 June 2017 Piotr Korcyl Lattice Quantum Chromodynamics on the MIC 1/ 25

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

1. Introduction. In this paper we consider variants of the Jacobi Davidson (JD) algorithm [27] for computing a few eigenpairs of

1. Introduction. In this paper we consider variants of the Jacobi Davidson (JD) algorithm [27] for computing a few eigenpairs of SIAM J. SCI. COMPUT. Vol. 25, No. 5, pp. 1655 1673 c 2004 Society for Industrial and Applied Mathematics A JACOBI DAVIDSON METHOD FOR SOLVING COMPLEX SYMMETRIC EIGENVALUE PROBLEMS PETER ARBENZ AND MICHIEL

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

Comparing iterative methods to compute the overlap Dirac operator at nonzero chemical potential

Comparing iterative methods to compute the overlap Dirac operator at nonzero chemical potential Comparing iterative methods to compute the overlap Dirac operator at nonzero chemical potential, Tobias Breu, and Tilo Wettig Institute for Theoretical Physics, University of Regensburg, 93040 Regensburg,

More information

Alternative correction equations in the Jacobi-Davidson method. Mathematical Institute. Menno Genseberger and Gerard L. G.

Alternative correction equations in the Jacobi-Davidson method. Mathematical Institute. Menno Genseberger and Gerard L. G. Universiteit-Utrecht * Mathematical Institute Alternative correction equations in the Jacobi-Davidson method by Menno Genseberger and Gerard L. G. Sleijpen Preprint No. 173 June 1998, revised: March 1999

More information

Inexact Inverse Iteration for Symmetric Matrices

Inexact Inverse Iteration for Symmetric Matrices Inexact Inverse Iteration for Symmetric Matrices Jörg Berns-Müller Ivan G. Graham Alastair Spence Abstract In this paper we analyse inexact inverse iteration for the real symmetric eigenvalue problem Av

More information

DELFT UNIVERSITY OF TECHNOLOGY

DELFT UNIVERSITY OF TECHNOLOGY DELFT UNIVERSITY OF TECHNOLOGY REPORT -09 Computational and Sensitivity Aspects of Eigenvalue-Based Methods for the Large-Scale Trust-Region Subproblem Marielba Rojas, Bjørn H. Fotland, and Trond Steihaug

More information

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems P.-O. Persson and J. Peraire Massachusetts Institute of Technology 2006 AIAA Aerospace Sciences Meeting, Reno, Nevada January 9,

More information

Data Analysis and Manifold Learning Lecture 2: Properties of Symmetric Matrices and Examples

Data Analysis and Manifold Learning Lecture 2: Properties of Symmetric Matrices and Examples Data Analysis and Manifold Learning Lecture 2: Properties of Symmetric Matrices and Examples Radu Horaud INRIA Grenoble Rhone-Alpes, France Radu.Horaud@inrialpes.fr http://perception.inrialpes.fr/ Outline

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra)

AMS526: Numerical Analysis I (Numerical Linear Algebra) AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 16: Rayleigh Quotient Iteration Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Numerical Analysis I 1 / 10 Solving Eigenvalue Problems All

More information

Reduction of nonlinear eigenproblems with JD

Reduction of nonlinear eigenproblems with JD Reduction of nonlinear eigenproblems with JD Henk van der Vorst H.A.vanderVorst@math.uu.nl Mathematical Institute Utrecht University July 13, 2005, SIAM Annual New Orleans p.1/16 Outline Polynomial Eigenproblems

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

On the Modification of an Eigenvalue Problem that Preserves an Eigenspace

On the Modification of an Eigenvalue Problem that Preserves an Eigenspace Purdue University Purdue e-pubs Department of Computer Science Technical Reports Department of Computer Science 2009 On the Modification of an Eigenvalue Problem that Preserves an Eigenspace Maxim Maumov

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

Solving the Stochastic Steady-State Diffusion Problem Using Multigrid

Solving the Stochastic Steady-State Diffusion Problem Using Multigrid Solving the Stochastic Steady-State Diffusion Problem Using Multigrid Tengfei Su Applied Mathematics and Scientific Computing Advisor: Howard Elman Department of Computer Science Sept. 29, 2015 Tengfei

More information

A JACOBI DAVIDSON METHOD FOR SOLVING COMPLEX-SYMMETRIC EIGENVALUE PROBLEMS

A JACOBI DAVIDSON METHOD FOR SOLVING COMPLEX-SYMMETRIC EIGENVALUE PROBLEMS A JACOBI DAVIDSON METHOD FOR SOLVING COMPLEX-SYMMETRIC EIGENVALUE PROBLEMS PETER ARBENZ AND MICHIEL E. HOCHSTENBACH Abstract. We discuss variants of the Jacobi Davidson method for solving the generalized

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

Case Study: Quantum Chromodynamics

Case Study: Quantum Chromodynamics Case Study: Quantum Chromodynamics Michael Clark Harvard University with R. Babich, K. Barros, R. Brower, J. Chen and C. Rebbi Outline Primer to QCD QCD on a GPU Mixed Precision Solvers Multigrid solver

More information

A Residual Inverse Power Method

A Residual Inverse Power Method University of Maryland Institute for Advanced Computer Studies Department of Computer Science College Park TR 2007 09 TR 4854 A Residual Inverse Power Method G. W. Stewart February 2007 ABSTRACT The inverse

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

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

MICHIEL E. HOCHSTENBACH

MICHIEL E. HOCHSTENBACH VARIATIONS ON HARMONIC RAYLEIGH RITZ FOR STANDARD AND GENERALIZED EIGENPROBLEMS MICHIEL E. HOCHSTENBACH Abstract. We present several variations on the harmonic Rayleigh Ritz method. First, we introduce

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

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

Low Rank Approximation Lecture 7. Daniel Kressner Chair for Numerical Algorithms and HPC Institute of Mathematics, EPFL

Low Rank Approximation Lecture 7. Daniel Kressner Chair for Numerical Algorithms and HPC Institute of Mathematics, EPFL Low Rank Approximation Lecture 7 Daniel Kressner Chair for Numerical Algorithms and HPC Institute of Mathematics, EPFL daniel.kressner@epfl.ch 1 Alternating least-squares / linear scheme General setting:

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

Inexact inverse iteration for symmetric matrices

Inexact inverse iteration for symmetric matrices Linear Algebra and its Applications 46 (2006) 389 43 www.elsevier.com/locate/laa Inexact inverse iteration for symmetric matrices Jörg Berns-Müller a, Ivan G. Graham b, Alastair Spence b, a Fachbereich

More information

Iterative Helmholtz Solvers

Iterative Helmholtz Solvers Iterative Helmholtz Solvers Scalability of deflation-based Helmholtz solvers Delft University of Technology Vandana Dwarka March 28th, 2018 Vandana Dwarka (TU Delft) 15th Copper Mountain Conference 2018

More information

PoS(LATTICE 2008)114. Investigation of the η -η c -mixing with improved stochastic estimators

PoS(LATTICE 2008)114. Investigation of the η -η c -mixing with improved stochastic estimators Investigation of the η -η c -mixing with improved stochastic estimators and Gunnar S. Bali Institut für Theoretische Physik, Universität Regensburg, 934 Regensburg, Germany E-mail: christian.ehmann@physik.uni-regensburg.de,

More information

A Note on Inverse Iteration

A Note on Inverse Iteration A Note on Inverse Iteration Klaus Neymeyr Universität Rostock, Fachbereich Mathematik, Universitätsplatz 1, 18051 Rostock, Germany; SUMMARY Inverse iteration, if applied to a symmetric positive definite

More information

Progress Report for Year 2. College of William and Mary Algorithms and software

Progress Report for Year 2. College of William and Mary Algorithms and software 2014 Progress Report for Year 2 College of William and Mary Algorithms and software Andreas Stathopoulos (PI) Kostas Orginos (Co-PI) Lingfei Wu (CS Ph.D. student) Jesse Laeuchli (CS Ph.D. student) Arjun

More information

Efficient domain decomposition methods for the time-harmonic Maxwell equations

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

More information

Contour Integral Method for the Simulation of Accelerator Cavities

Contour Integral Method for the Simulation of Accelerator Cavities Contour Integral Method for the Simulation of Accelerator Cavities V. Pham-Xuan, W. Ackermann and H. De Gersem Institut für Theorie Elektromagnetischer Felder DESY meeting (14.11.2017) November 14, 2017

More information

A knowledge-based approach to high-performance computing in ab initio simulations.

A knowledge-based approach to high-performance computing in ab initio simulations. Mitglied der Helmholtz-Gemeinschaft A knowledge-based approach to high-performance computing in ab initio simulations. AICES Advisory Board Meeting. July 14th 2014 Edoardo Di Napoli Academic background

More information

Domain decomposition for the Jacobi-Davidson method: practical strategies

Domain decomposition for the Jacobi-Davidson method: practical strategies Chapter 4 Domain decomposition for the Jacobi-Davidson method: practical strategies Abstract The Jacobi-Davidson method is an iterative method for the computation of solutions of large eigenvalue problems.

More information

College of William & Mary Department of Computer Science

College of William & Mary Department of Computer Science Technical Report WM-CS-2009-06 College of William & Mary Department of Computer Science WM-CS-2009-06 Extending the eigcg algorithm to non-symmetric Lanczos for linear systems with multiple right-hand

More information

Domain decomposition in the Jacobi-Davidson method for eigenproblems

Domain decomposition in the Jacobi-Davidson method for eigenproblems Domain decomposition in the Jacobi-Davidson method for eigenproblems Menno Genseberger Domain decomposition in the Jacobi-Davidson method for eigenproblems Domeindecompositie in de Jacobi-Davidson methode

More information

EINDHOVEN UNIVERSITY OF TECHNOLOGY Department of Mathematics and Computer Science. CASA-Report November 2013

EINDHOVEN UNIVERSITY OF TECHNOLOGY Department of Mathematics and Computer Science. CASA-Report November 2013 EINDHOVEN UNIVERSITY OF TECHNOLOGY Department of Mathematics and Computer Science CASA-Report 13-26 November 213 Polynomial optimization and a Jacobi-Davidson type method for commuting matrices by I.W.M.

More information