Large-scale eigenvalue computations with SLEPc

Size: px
Start display at page:

Download "Large-scale eigenvalue computations with SLEPc"

Transcription

1 Large-scale eigenvalue computations with SLEPc Jose E. Roman Universitat Politècnica de València, Spain Joint work with: A. Tomás, E. Romero, E. Ramos RES Scientific Seminar on Parallel Simulations on the Network 30 November, 2010 Grid y Computación de Altas Prestaciones

2 Outline 1 Eigenvalue Problems 2 Numerical Libraries The SLEPc Project Basic Usage Parallel Performance 3 4

3 Eigenvalue Problems

4 Eigenproblems Large-scale eigenvalue problems are among the most demanding calculations in scientific computing Example application areas: Dynamic structural analysis (e.g., civil engineering) Stability analysis (e.g., control engineering) Eigenfunction determination (e.g., electromagnetics) Bifurcation analysis (e.g., fluid dynamics) Information retrieval (e.g., latent semantic indexing)

5 Example 1: Structural Analysis Smallest eigenfrequencies of a real symmetric problem Kx = λm x

6 Example 2: FE in Schrödinger Equation λ = 1 λ = 2 λ = 3 Eigenstates of simple harmonic oscillator, (A ε n B) ψ n = 0

7 Example 3: Neutron Difusion Modal analysis of nuclear reactor cores Objectives: Improve safety Reduce operation costs Lambda Modes Equation Lφ = 1 λ Mφ Target: modes associated to largest λ Criticality (eigenvalues) Prediction of instabilities and transient analysis (eigenvectors) e

8 Example 3: Neutron Difusion - Algebraic Eigenproblem Discretized eigenproblem (two energy groups): [ L11 0 L 21 L 22 ] [ ψ1 ψ 2 ] = 1 λ [ M11 M ] [ ] ψ1 ψ 2

9 Example 3: Neutron Difusion - Algebraic Eigenproblem Discretized eigenproblem (two energy groups): [ L11 0 L 21 L 22 ] [ ψ1 ψ 2 ] = 1 λ [ M11 M ] [ ψ1 ψ 2 ] Can be formulated as Gψ 1 = λψ 1, G = L 1 11 (M 11 + M 12 L 1 22 L 21) Matrix should not be computed explicitly In some applications, many successive problems are solved Other modes may be of interest [Verdú, Ginestar, R., Vidal, 2010]

10 Example 4: Computational Electromagnetics Analysis of resonant cavities Source-free wave equations (ˆµ 1 r E) κ 2 0ˆε re =0 (ˆε 1 r H) κ 2 0ˆµ rh =0 FEM discretization leads to Ax = κ 2 0 Bx Target: smallest nonzero eigenfrequencies (large nullspace) λ 1, λ 2,..., λ }{{ k, λ } k+1, λ k+2,..., λ }{{} n =0 Target Eigenfunctions associated to 0 are irrotational electric fields, E = Φ. This allows the computation of a basis of N (A) Constrained Eigenvalue Problem Ax = κ 2 0 Bx } C T Bx = 0

11 Example 5: Damped Track System Underground tracks laid on concrete To prevent vibrations, sleepers are laid on elastic, vibration-damping matting Quadratic eigenvalue problem (QEP): (λ 2 M + λc + K)x = 0

12 Many Flavours of Eigenvalue Problems Various problem characteristics Real/complex, Hermitian/non-Hermitian Need to support complex in real arithmetic Many formulations Standard, generalized, quadratic, non-linear, SVD Special cases: implicit matrix, block-structured problems, constrained problems, structured spectrum Wanted solutions Usually only a few eigenpairs, but may be many Any part of the spectrum (exterior, interior), intervals Robustness and usability Singular B and other special cases, high multiplicity Interoperability (linear solvers, FE), flexibility

13 Eigenvalue Problems Consider the following eigenvalue problems Standard Eigenproblem Ax = λx Generalized Eigenproblem Ax = λbx where λ is a (complex) scalar: eigenvalue x is a (complex) vector: eigenvector Matrices A and B can be real or complex Matrices A and B can be symmetric (Hermitian) or not Typically, B is symmetric positive (semi-) definite

14 Solution of the Eigenvalue Problem There are n eigenvalues (counted with their multiplicities) Partial eigensolution: nev solutions λ 0, λ 1,..., λ nev 1 C x 0, x 1,..., x nev 1 C n nev = number of eigenvalues / eigenvectors (eigenpairs)

15 Solution of the Eigenvalue Problem There are n eigenvalues (counted with their multiplicities) Partial eigensolution: nev solutions λ 0, λ 1,..., λ nev 1 C x 0, x 1,..., x nev 1 C n nev = number of eigenvalues / eigenvectors (eigenpairs) Different requirements: Compute a few of the dominant eigenvalues (largest magnitude) Compute a few λ i s with smallest or largest real parts Compute all λ i s in a certain region of the complex plane

16 Spectral Transformation A general technique that can be used in many methods Ax = λx = T x = θx

17 Spectral Transformation A general technique that can be used in many methods Ax = λx = T x = θx In the transformed problem Eigenvalues are remapped, eigenvectors are not altered Convergence is usually improved (better separation)

18 Spectral Transformation A general technique that can be used in many methods Ax = λx = T x = θx In the transformed problem Eigenvalues are remapped, eigenvectors are not altered Convergence is usually improved (better separation) Shift-and-invert T SI = (A σi) 1 Cayley T C = (A σi) 1 (A + τi) Can be used to compute interior eigenvalues T not computed explicitly, linear solves instead Cheaper alternative: preconditioned eigensolvers (J-D)

19 What Users Need Abstraction of mathematical objects: vectors and matrices Efficient linear solvers and preconditioners Easy programming interface Run-time flexibility, full control over the solution process Parallel computing, mostly transparent to the user State-of-the-art eigensolvers Spectral transformations

20 What Users Need Provided by PETSc Abstraction of mathematical objects: vectors and matrices Efficient linear solvers and preconditioners Easy programming interface Run-time flexibility, full control over the solution process Parallel computing, mostly transparent to the user Provided by SLEPc State-of-the-art eigensolvers Spectral transformations

21

22 Large Scientific Codes: Common Programming Practice Algorithmic Implementations Application Data Layout Control I/O Tuned and machine dependent modules

23 Large Scientific Codes: Common Programming Practice Changes in algorithms sometimes lead to several years advancement in computations. Needs flexibility! Algorithmic Implementations Application Data Layout Control I/O Tuned and machine dependent modules

24 Large Scientific Codes: Common Programming Practice Changes in algorithms sometimes lead to several years advancement in computations. Needs flexibility! Its performance is influenced by system parameters and in steps in the algorithm. Critical points: portability and scalability. Algorithmic Implementations Application Data Layout Control Tuned and machine dependent modules I/O

25 Large Scientific Codes: Common Programming Practice Changes in algorithms sometimes lead to several years advancement in computations. Needs flexibility! Its performance is influenced by system parameters and in steps in the algorithm. Critical points: portability and scalability. Algorithmic Implementations Application Data Layout Control Tuned and machine dependent modules I/O New architecture requires extensive tuning, may even require new programming paradigms. This is difficult to maintain and not very portable.

26 Large Scientific Codes: An Alternative Approach User s Application Code (Main Control) Application Data Layout Algorithmic Implementations I/O Tuned and machine dependent modules

27 Large Scientific Codes: An Alternative Approach User s Application Code (Main Control) Compilers + Expert Drivers + Support AVAILABLE Application Data Layout LIBRARIES AVAILABLE Algorithmic Implementations LIBRARIES AVAILABLE I/O LIBRARIES Tuned and machine dependent modules

28 Large Scientific Codes: An Alternative Approach User s Application Code (Main Control) Compilers + Expert Drivers + Support AVAILABLE Application Data Layout LIBRARIES AVAILABLE Algorithmic Implementations LIBRARIES AVAILABLE I/O LIBRARIES Tuned and machine dependent modules Goal: minimize the time to solution (prototype and production); maximize software life and resource utilization

29 HPC Software Stack APPLICATIONS GENERAL PURPOSE TOOLS PLATFORM SUPPORT TOOLS & UTILITIES HARDWARE

30 HPC Software Stack APPLICATIONS GENERAL PURPOSE TOOLS PETSc, SLEPc, MUMPS, SuperLU, FFTW, SUNDIALS, Trilinos, Hypre, ScaLAPACK,... PLATFORM SUPPORT TOOLS & UTILITIES HARDWARE

31 Requirements of Sustainable Software 1. Robust Maintained across platforms, compiler independent, precision independent, error handling, checkpointing 2. Scalable (accross large petascale systems) 3. Extensible (new algorithms, new techniques) 4. Interoperable (frameworks, PSE s, tool-to-tool, components) 5. User friendly interfaces, well documented 6. Periodic tests and evaluations (versions of tools, OS, compiler) 7. Portability and fast adaptability 8. Long-term support 9. Training (hands-on examples) 10. Community support (developers, user groups, mailing lists)

32 PETSc: Portable, Extensible Toolkit for Scientific Computation Software for the scalable (parallel) solution of algebraic systems arising from partial differential equation (PDE) simulations Developed at Argonne National Lab since 1991 Usable from C, C++, Fortran77/90 Focus on abstraction, portability, interoperability Extensive documentation and examples Freely available and supported through Current version: 3.1 (released March 2010)

33 SLEPc: Scalable Library for Eigenvalue Problem Computations A general library for solving large-scale sparse eigenproblems on parallel computers For standard and generalized eigenproblems For real and complex arithmetic For Hermitian or non-hermitian problems Also support for SVD and QEP Ax = λx Ax = λbx Av i = σ i u i (λ 2 M+λC+K)x = 0 Current version: 3.1 (released Aug 2010)

34 The SLEPc Project Project started around releases since 2002 More than 5,300 downloads (average 100+ downloads per month) SLEPc downloads in the last 22 months downloads average Currently funded by MICINN

35 PETSc/SLEPc Numerical Components Nonlinear Systems Line Search Trust Region Other PETSc Euler Time Steppers Backward Euler Pseudo Time Step Other Krylov Subspace Methods GMRES CG CGS Bi-CGStab TFQMR Richardson Chebychev Other Additive Schwarz Block Jacobi Preconditioners Jacobi ILU ICC LU Other Matrices Compressed Sparse Row Block Compressed Sparse Row Block Diagonal Dense Other Vectors Index Sets Indices Block Indices Stride Other

36 PETSc/SLEPc Numerical Components PETSc SLEPc Nonlinear Systems Line Search Trust Region Other Euler Time Steppers Backward Euler Pseudo Time Step Other SVD Solvers Cross Cyclic Thick R. Lanczos Product Matrix Lanczos Quadratic Linearization Q-Arnoldi Krylov Subspace Methods GMRES CG CGS Bi-CGStab TFQMR Richardson Chebychev Other Eigensolvers Krylov-Schur Arnoldi Lanczos GD JD Other Preconditioners Spectral Transformation Additive Schwarz Block Jacobi Jacobi ILU ICC LU Other Shift Shift-and-invert Cayley Fold Preconditioner Matrices Compressed Sparse Row Block Compressed Sparse Row Block Diagonal Dense Other Vectors Index Sets Indices Block Indices Stride Other

37 EPS: Simple Example Program EPS eps; /* eigensolver context */ Mat A, B; /* matrices of Ax=kBx */ Vec xr, xi; /* eigenvector, x */ PetscScalar kr, ki; /* eigenvalue, k */ EPSCreate(PETSC_COMM_WORLD, &eps); EPSSetOperators(eps, A, B); EPSSetProblemType(eps, EPS_GNHEP); EPSSetFromOptions(eps); EPSSolve(eps); EPSGetConverged(eps, &nconv); for (i=0; i<nconv; i++) { EPSGetEigenpair(eps, i, &kr, &ki, xr, xi); } EPSDestroy(eps);

38 EPS: Run-Time Examples $ program -eps_type krylovschur -eps_nev 6 -eps_ncv 24 $ program -eps_type gd -eps_smallest_real -eps_max_it 2000 $ program -eps_type jd -eps_jd_blocksize 2 -eps_tol 1e-8 $ program -eps_target 2.1 -eps_harmonic $ program -eps_target 2.1 -st_type sinvert -st_ksp_type gmres -st_ksp_rtol 1e-8 -st_pc_type sor -st_pc_sor_omega 1.3 $ program -eps_view -eps_monitor -log_summary

39 Computers from RES IBM BladeCenter clusters with Myrinet interconnect 256 JS20 nodes Two 64-bit PowerPC 2.2 GHz processors We have used three nodes: MareNostrum (Barcelona) CaesarAugusta (Zaragoza) Tirant (Valencia)

40 Parallel Performance in MareNostrum Speed-up Matrix PRE2 S p = T s T p University of Florida Dimension 659,033 5,834,044 nonzeros 10 eigenvalues with 30 basis vectors 1 processor per node Speed-up Ideal ARPACK SLEPc Nodes

41

42 Molecular Clusters Goal: Analysis of high-nuclearity spin clusters Collaboration with a group in ICMOL-U. Valencia Parallel version of MAGPACK using SLEPc

43 Molecular Clusters Goal: Analysis of high-nuclearity spin clusters Collaboration with a group in ICMOL-U. Valencia Parallel version of MAGPACK using SLEPc Features: Irreducible Tensor Operators (ITO) technique All kind of anisotropic and isotropic spin interactions Bulk magnetic properties (magnetic susceptibility and magnetization) Spectroscopic properties (inelastic neutron scattering spectra) Validation [Ramos, R., Cardona-Serra, Clemente-Juan, 2010]

44 Molecular Clusters - Isotropic Analysis Study: 8 manganese ring with antiferromagnetic coupling (n=135,954) Isotropic analysis: no mixing between different spins The matrix has a block diagonal structure (one block per spin) Can diagonalize each spin matrix separately Computing 1000 eigenpairs takes 12 hours on 1 processor

45 Molecular Clusters - Anisotropic Analysis Chain of Ni atoms with antiferromagnetic interaction

46 Molecular Clusters - Anisotropic Analysis Chain of Ni atoms with antiferromagnetic interaction We use closed rings to simulate infinite chains Study: magnetic susceptibility in a ring of 10 centers of Nickel(II) ions (n=59,049)

47 Molecular Clusters - Anisotropic Analysis (Results) Performance analysis: solve the Nickel ring with 600 eigenvalues Breakdown of execution time (in seconds) Step Time Percentage Generation of energy matrix % First diagonalization % Generation of Zeeman matrices % Thermodynamic properties % (6 diagonalizations and 4 matrix AXPYs) TOTAL % *Results in CaesarAugusta with 8 nodes (16 procs) Matrix-vector multiplication accounts for 67 % of diagonalization Different matrix storage formats: symmetric, implicit A + γb

48 Molecular Clusters - Anisotropic Analysis (Results) 64 Ideal aijfull aijhalf sbaij 64 Ideal aijhalf sbaij sbaijshell sbaijreuse Speedup 32 Speedup Nodes Nodes

49 Molecular Clusters - Real Use Case: Fe8 Study: octanuclear iron, Fe8 (n=1,679,616) Classical example of single molecule magnet, with interesting properties Magnetic moment relaxation at low temperatures Strong axial anisotropy No one has been able to simulate this molecule

50 Molecular Clusters - Real Use Case: Fe8 Computing 200 lowest energy levels took 7 days on 64 processors (Tirant) Results match experimental observation Fundamental state of S=10 Two energy wells At temperatures below 0.36K only states S=10 and S=9 are populated

51

52 Plasma Physics Plasma turbulence in a tokamak determines its energy confinement Simulation based on the nonlinear gyrokinetic equations GENE parallel code, scalable to 1000 s of processors Two main goals: a deeper understanding of fundamental physics issues and direct comparisons with experiments

53 Turbulent Fluctuations Behaves more like 2D fluid turbulence due to strong background magnetic field

54 Turbulent Fluctuations (Cross Section) Inboard side streamer formation Outboard side streamer formation gradients fluctuations transport

55 The Plasma Turbulence Problem is Really 5D Dilute and/or hot plasmas are almost collisionless (3D) fluid theory not applicable, must use a (reduced) kinetic description! Vlasov-Maxwell Equations [ t + v x + q m Removing the fast gyromotion (E + v c B ) [Frieman, Chen, Lee, Hahm et al., 1980s] Charged rings as quasiparticles; gyrocenter coordinates ] f(x, v, t) = 0 v Nonlinear integro-differential equations in 5 dimensions...

56 The Nonlinear Gyrokinetic Equations f = f(x, v, µ; t) Advection/Conservation Equation f t + Ẋ f X + v f = 0 v X = gyrocenter position v = parallel velocity µ = magnetic moment Ẋ = v b + B B ( v B B 1 + v ) v c B 2 Ē1 B + µ mω b (B + B 1 ) + v2 Ω ( b) v = Ẋ mv (eē1 µ (B + B 1 ) ) and appropriate field equations

57 GENE: Numerical Solution Initial value solver Method of lines: space/velocity discretized first 6-step, 4th-order explicit Runge-Kutta for time integration An explicit time scheme is not globally stable the timestep must be kept below an upper limit To maximize efficiency, the largest possible timestep should be used The optimal timestep can be estimated from the eigenspectrum of the linearized equation This estimate should be very accurate

58 Plasma Physics - Use of SLEPc Knowledge of the spectrum of the linearized equation Ax = λx Complex, non-hermitian eigenproblem The matrix is not built explicitly Sizes ranging from a few millions to a billion Uses: 1. Largest magnitude eigenvalue to estimate optimal timestep 2. Track sub-dominant instabilities (rightmost eigenvalues) [R., Kammerer, Merz, Jenko, 2010]! "

59 Sub-dominant Modes Usually, turbulence codes address the initial value problem linear calculations only allow to determine the fastest growing eigenmode GENE can also be run as a linear eigenvalue solver, accessing also sub-dominant instabilities which can affect the turbulence properties ω γ R/L n = 4.4 R/L n = R/L T,e R/L T,e Challenging from numerical point of view solved with SLEPc

60 Plasma Physics - Performance Results Test case 1: tokamak model with a realistic species configuration (deuterium, tritium, helium and electrons)

61 Plasma Physics - Performance Results Test case 1: tokamak model with a realistic species configuration (deuterium, tritium, helium and electrons) Test case 2: stellarator device with realistic geometry (W7-X)

62 Plasma Physics - Strong Scaling Speedup on Tirant (matrix size is 442,368 in both cases) KS JD ideal Test case KS JD ideal Test case speedup 150 speedup processors processors KS=Krylov-Schur, JD=Jacobi-Davidson

63 Plasma Physics - Weak Scaling On 1 processor JD is about 4 times faster than KS for this problem Both methods scale well The plot shows weak scaling results, with increasing problem size (largest size is 884,736) time KS JD processors

64 Wrap Up SLEPc highlights: Growing list of eigensolvers (also QEP and SVD solvers) Seamlessly integrated spectral transformation Easy programming with PETSc s object-oriented style Data-structure neutral implementation Run-time flexibility Portability to a wide range of parallel platforms Usable from code written in C, C++, Fortran, Python Extensive documentation

65 More Information Homepage: Contact

SLEPc: overview, applications and some implementation details

SLEPc: overview, applications and some implementation details SLEPc: overview, applications and some implementation details Jose E. Roman Universidad Politécnica de Valencia, Spain ETH Zürich - May, 2010 Arnoldi Method Computes a basis V m of K m (A, v 1 ) and H

More information

SLEPc: Scalable Library for Eigenvalue Problem Computations

SLEPc: Scalable Library for Eigenvalue Problem Computations SLEPc: Scalable Library for Eigenvalue Problem Computations Jose E. Roman High Performance Networking and Computing Group (GRyCAP) Universidad Politécnica de Valencia, Spain August, 2005 Tutorial Outline

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

Preliminary Results of GRAPES Helmholtz solver using GCR and PETSc tools

Preliminary Results of GRAPES Helmholtz solver using GCR and PETSc tools Preliminary Results of GRAPES Helmholtz solver using GCR and PETSc tools Xiangjun Wu (1),Lilun Zhang (2),Junqiang Song (2) and Dehui Chen (1) (1) Center for Numerical Weather Prediction, CMA (2) School

More information

A Parallel Implementation of the Trace Minimization Eigensolver

A Parallel Implementation of the Trace Minimization Eigensolver A Parallel Implementation of the Trace Minimization Eigensolver Eloy Romero and Jose E. Roman Instituto ITACA, Universidad Politécnica de Valencia, Camino de Vera, s/n, 4622 Valencia, Spain. Tel. +34-963877356,

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

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

Optimized analysis of isotropic high-nuclearity spin clusters with GPU acceleration

Optimized analysis of isotropic high-nuclearity spin clusters with GPU acceleration Optimized analysis of isotropic high-nuclearity spin clusters with GPU acceleration A. Lamas Daviña, E. Ramos, J. E. Roman D. Sistemes Informàtics i Computació, Universitat Politècnica de València, Camí

More information

Eigenvalue Problems Computation and Applications

Eigenvalue Problems Computation and Applications Eigenvalue ProblemsComputation and Applications p. 1/36 Eigenvalue Problems Computation and Applications Che-Rung Lee cherung@gmail.com National Tsing Hua University Eigenvalue ProblemsComputation and

More information

Progress in Parallel Implicit Methods For Tokamak Edge Plasma Modeling

Progress in Parallel Implicit Methods For Tokamak Edge Plasma Modeling Progress in Parallel Implicit Methods For Tokamak Edge Plasma Modeling Michael McCourt 1,2,Lois Curfman McInnes 1 Hong Zhang 1,Ben Dudson 3,Sean Farley 1,4 Tom Rognlien 5, Maxim Umansky 5 Argonne National

More information

Frank Jenko. Session on Plasma Physics: Petascale Computations of Turbulence in Laboratory and Astrophysical Plasmas

Frank Jenko.   Session on Plasma Physics: Petascale Computations of Turbulence in Laboratory and Astrophysical Plasmas Frank Jenko www.ipp.mpg.de/~fsj Session on Plasma Physics: Petascale Computations of Turbulence in Laboratory and Astrophysical Plasmas Max-Planck-Institut für Plasmaphysik, Germany 3 rd EU-US HPC Summer

More information

Integration of PETSc for Nonlinear Solves

Integration of PETSc for Nonlinear Solves Integration of PETSc for Nonlinear Solves Ben Jamroz, Travis Austin, Srinath Vadlamani, Scott Kruger Tech-X Corporation jamroz@txcorp.com http://www.txcorp.com NIMROD Meeting: Aug 10, 2010 Boulder, CO

More information

Lecture 11: CMSC 878R/AMSC698R. Iterative Methods An introduction. Outline. Inverse, LU decomposition, Cholesky, SVD, etc.

Lecture 11: CMSC 878R/AMSC698R. Iterative Methods An introduction. Outline. Inverse, LU decomposition, Cholesky, SVD, etc. Lecture 11: CMSC 878R/AMSC698R Iterative Methods An introduction Outline Direct Solution of Linear Systems Inverse, LU decomposition, Cholesky, SVD, etc. Iterative methods for linear systems Why? Matrix

More information

Gyrokinetics an efficient framework for studying turbulence and reconnection in magnetized plasmas

Gyrokinetics an efficient framework for studying turbulence and reconnection in magnetized plasmas Frank Jenko Gyrokinetics an efficient framework for studying turbulence and reconnection in magnetized plasmas Max-Planck-Institut für Plasmaphysik, Garching Workshop on Vlasov-Maxwell Kinetics WPI, Vienna,

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

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

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

ELSI: A Unified Software Interface for Kohn-Sham Electronic Structure Solvers

ELSI: A Unified Software Interface for Kohn-Sham Electronic Structure Solvers ELSI: A Unified Software Interface for Kohn-Sham Electronic Structure Solvers Victor Yu and the ELSI team Department of Mechanical Engineering & Materials Science Duke University Kohn-Sham Density-Functional

More information

Lecture 8: Fast Linear Solvers (Part 7)

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

More information

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

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

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

Parallel Eigensolver Performance on High Performance Computers

Parallel Eigensolver Performance on High Performance Computers Parallel Eigensolver Performance on High Performance Computers Andrew Sunderland Advanced Research Computing Group STFC Daresbury Laboratory CUG 2008 Helsinki 1 Summary (Briefly) Introduce parallel diagonalization

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

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

Computational Issues in the Continuum Gyrokinetic Code GYRO

Computational Issues in the Continuum Gyrokinetic Code GYRO Computational Issues in the Continuum Gyrokinetic Code GYRO presented by: Eric Bass GSEP SciDAC project at General Atomics CScADS Workshop Snowbird, UT July 19, 2010 About GYRO Purpose: To predict transport

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

Domain Decomposition-based contour integration eigenvalue solvers

Domain Decomposition-based contour integration eigenvalue solvers Domain Decomposition-based contour integration eigenvalue solvers Vassilis Kalantzis joint work with Yousef Saad Computer Science and Engineering Department University of Minnesota - Twin Cities, USA SIAM

More information

Block Iterative Eigensolvers for Sequences of Dense Correlated Eigenvalue Problems

Block Iterative Eigensolvers for Sequences of Dense Correlated Eigenvalue Problems Mitglied der Helmholtz-Gemeinschaft Block Iterative Eigensolvers for Sequences of Dense Correlated Eigenvalue Problems Birkbeck University, London, June the 29th 2012 Edoardo Di Napoli Motivation and Goals

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

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

Co-existence and interference of multiple modes in plasma turbulence: Some recent GENE results

Co-existence and interference of multiple modes in plasma turbulence: Some recent GENE results Co-existence and interference of multiple modes in plasma turbulence: Some recent GENE results Frank Jenko IPP Garching, Germany University of Ulm, Germany Acknowledgements: F. Merz, T. Görler, D. Told,

More information

A parameter tuning technique of a weighted Jacobi-type preconditioner and its application to supernova simulations

A parameter tuning technique of a weighted Jacobi-type preconditioner and its application to supernova simulations A parameter tuning technique of a weighted Jacobi-type preconditioner and its application to supernova simulations Akira IMAKURA Center for Computational Sciences, University of Tsukuba Joint work with

More information

Rational Krylov methods for linear and nonlinear eigenvalue problems

Rational Krylov methods for linear and nonlinear eigenvalue problems Rational Krylov methods for linear and nonlinear eigenvalue problems Mele Giampaolo mele@mail.dm.unipi.it University of Pisa 7 March 2014 Outline Arnoldi (and its variants) for linear eigenproblems Rational

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

Solving Large Nonlinear Sparse Systems

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

More information

FEAST eigenvalue algorithm and solver: review and perspectives

FEAST eigenvalue algorithm and solver: review and perspectives FEAST eigenvalue algorithm and solver: review and perspectives Eric Polizzi Department of Electrical and Computer Engineering University of Masachusetts, Amherst, USA Sparse Days, CERFACS, June 25, 2012

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

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

Automated Multi-Level Substructuring CHAPTER 4 : AMLS METHOD. Condensation. Exact condensation

Automated Multi-Level Substructuring CHAPTER 4 : AMLS METHOD. Condensation. Exact condensation Automated Multi-Level Substructuring CHAPTER 4 : AMLS METHOD Heinrich Voss voss@tu-harburg.de Hamburg University of Technology AMLS was introduced by Bennighof (1998) and was applied to huge problems of

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

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

Enhancing Scalability of Sparse Direct Methods

Enhancing Scalability of Sparse Direct Methods Journal of Physics: Conference Series 78 (007) 0 doi:0.088/7-6596/78//0 Enhancing Scalability of Sparse Direct Methods X.S. Li, J. Demmel, L. Grigori, M. Gu, J. Xia 5, S. Jardin 6, C. Sovinec 7, L.-Q.

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

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

Finding Rightmost Eigenvalues of Large, Sparse, Nonsymmetric Parameterized Eigenvalue Problems

Finding Rightmost Eigenvalues of Large, Sparse, Nonsymmetric Parameterized Eigenvalue Problems Finding Rightmost Eigenvalues of Large, Sparse, Nonsymmetric Parameterized Eigenvalue Problems AMSC 663-664 Final Report Minghao Wu AMSC Program mwu@math.umd.edu Dr. Howard Elman Department of Computer

More information

Recent Progress of Parallel SAMCEF with MUMPS MUMPS User Group Meeting 2013

Recent Progress of Parallel SAMCEF with MUMPS MUMPS User Group Meeting 2013 Recent Progress of Parallel SAMCEF with User Group Meeting 213 Jean-Pierre Delsemme Product Development Manager Summary SAMCEF, a brief history Co-simulation, a good candidate for parallel processing MAAXIMUS,

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

PETSc for Python. Lisandro Dalcin

PETSc for Python.  Lisandro Dalcin PETSc for Python http://petsc4py.googlecode.com Lisandro Dalcin dalcinl@gmail.com Centro Internacional de Métodos Computacionales en Ingeniería Consejo Nacional de Investigaciones Científicas y Técnicas

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

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

A comparison of solvers for quadratic eigenvalue problems from combustion

A comparison of solvers for quadratic eigenvalue problems from combustion INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS [Version: 2002/09/18 v1.01] A comparison of solvers for quadratic eigenvalue problems from combustion C. Sensiau 1, F. Nicoud 2,, M. van Gijzen 3,

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

Applied Math Algorithms in FACETS

Applied Math Algorithms in FACETS Applied Math Algorithms Speaker: Core: Edge: in FACETS Proto-FSP Review, Sept 1, 2010, PPPL! Lois Curfman McInnes, ANL Alexander Pletzer, Tech-X John Cary, Johan Carlsson, Tech-X: Core solver Srinath Vadlamani,

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra)

AMS526: Numerical Analysis I (Numerical Linear Algebra) AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 21: Sensitivity of Eigenvalues and Eigenvectors; Conjugate Gradient Method Xiangmin Jiao Stony Brook University Xiangmin Jiao Numerical Analysis

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

Iterative Methods for Sparse Linear Systems

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

More information

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

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

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

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

Research Matters. February 25, The Nonlinear Eigenvalue Problem. Nick Higham. Part III. Director of Research School of Mathematics

Research Matters. February 25, The Nonlinear Eigenvalue Problem. Nick Higham. Part III. Director of Research School of Mathematics Research Matters February 25, 2009 The Nonlinear Eigenvalue Problem Nick Higham Part III Director of Research School of Mathematics Françoise Tisseur School of Mathematics The University of Manchester

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

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

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

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

11 th International Computational Accelerator Physics Conference (ICAP) 2012

11 th International Computational Accelerator Physics Conference (ICAP) 2012 Eigenmode Computation For Ferrite-Loaded Cavity Resonators Klaus Klopfer*, Wolfgang Ackermann, Thomas Weiland Institut für Theorie Elektromagnetischer Felder, TU Darmstadt 11 th International Computational

More information

A Robust Preconditioned Iterative Method for the Navier-Stokes Equations with High Reynolds Numbers

A Robust Preconditioned Iterative Method for the Navier-Stokes Equations with High Reynolds Numbers Applied and Computational Mathematics 2017; 6(4): 202-207 http://www.sciencepublishinggroup.com/j/acm doi: 10.11648/j.acm.20170604.18 ISSN: 2328-5605 (Print); ISSN: 2328-5613 (Online) A Robust Preconditioned

More information

Technical Report DSIC-II/24/02. SLEPc Users Manual. Scalable Library for Eigenvalue Problem Computations.

Technical Report DSIC-II/24/02. SLEPc Users Manual. Scalable Library for Eigenvalue Problem Computations. Departamento de Sistemas Informáticos y Computación Technical Report DSIC-II/24/02 SLEPc Users Manual Scalable Library for Eigenvalue Problem Computations http://slepc.upv.es Jose E. Roman Carmen Campos

More information

Efficient Augmented Lagrangian-type Preconditioning for the Oseen Problem using Grad-Div Stabilization

Efficient Augmented Lagrangian-type Preconditioning for the Oseen Problem using Grad-Div Stabilization Efficient Augmented Lagrangian-type Preconditioning for the Oseen Problem using Grad-Div Stabilization Timo Heister, Texas A&M University 2013-02-28 SIAM CSE 2 Setting Stationary, incompressible flow problems

More information

Nonlinear Eigenvalue Problems: An Introduction

Nonlinear Eigenvalue Problems: An Introduction Nonlinear Eigenvalue Problems: An Introduction Cedric Effenberger Seminar for Applied Mathematics ETH Zurich Pro*Doc Workshop Disentis, August 18 21, 2010 Cedric Effenberger (SAM, ETHZ) NLEVPs: An Introduction

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

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

Multilevel low-rank approximation preconditioners Yousef Saad Department of Computer Science and Engineering University of Minnesota

Multilevel low-rank approximation preconditioners Yousef Saad Department of Computer Science and Engineering University of Minnesota Multilevel low-rank approximation preconditioners Yousef Saad Department of Computer Science and Engineering University of Minnesota SIAM CSE Boston - March 1, 2013 First: Joint work with Ruipeng Li Work

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

COURSE DESCRIPTIONS. 1 of 5 8/21/2008 3:15 PM. (S) = Spring and (F) = Fall. All courses are 3 semester hours, unless otherwise noted.

COURSE DESCRIPTIONS. 1 of 5 8/21/2008 3:15 PM. (S) = Spring and (F) = Fall. All courses are 3 semester hours, unless otherwise noted. 1 of 5 8/21/2008 3:15 PM COURSE DESCRIPTIONS (S) = Spring and (F) = Fall All courses are 3 semester hours, unless otherwise noted. INTRODUCTORY COURSES: CAAM 210 (BOTH) INTRODUCTION TO ENGINEERING COMPUTATION

More information

MagmaDNN High-Performance Data Analytics for Manycore GPUs and CPUs

MagmaDNN High-Performance Data Analytics for Manycore GPUs and CPUs MagmaDNN High-Performance Data Analytics for Manycore GPUs and CPUs Lucien Ng The Chinese University of Hong Kong Kwai Wong The Joint Institute for Computational Sciences (JICS), UTK and ORNL Azzam Haidar,

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

Parallel sparse linear solvers and applications in CFD

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

More information

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

Lecture 18 Classical Iterative Methods

Lecture 18 Classical Iterative Methods Lecture 18 Classical Iterative Methods MIT 18.335J / 6.337J Introduction to Numerical Methods Per-Olof Persson November 14, 2006 1 Iterative Methods for Linear Systems Direct methods for solving Ax = b,

More information

The gyrokinetic turbulence code GENE - Numerics and applications

The gyrokinetic turbulence code GENE - Numerics and applications Contributors: T. Dannert (1), F. Jenko (1),F. Merz (1), D. Told (1), X. Lapillonne (2), S. Brunner (2), and others T. Görler (1) The gyrokinetic turbulence code GENE - Numerics and applications (1) Max-Planck-Institut

More information

Multilevel spectral coarse space methods in FreeFem++ on parallel architectures

Multilevel spectral coarse space methods in FreeFem++ on parallel architectures Multilevel spectral coarse space methods in FreeFem++ on parallel architectures Pierre Jolivet Laboratoire Jacques-Louis Lions Laboratoire Jean Kuntzmann DD 21, Rennes. June 29, 2012 In collaboration with

More information

Index. higher order methods, 52 nonlinear, 36 with variable coefficients, 34 Burgers equation, 234 BVP, see boundary value problems

Index. higher order methods, 52 nonlinear, 36 with variable coefficients, 34 Burgers equation, 234 BVP, see boundary value problems Index A-conjugate directions, 83 A-stability, 171 A( )-stability, 171 absolute error, 243 absolute stability, 149 for systems of equations, 154 absorbing boundary conditions, 228 Adams Bashforth methods,

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

Splitting Iteration Methods for Positive Definite Linear Systems

Splitting Iteration Methods for Positive Definite Linear Systems Splitting Iteration Methods for Positive Definite Linear Systems Zhong-Zhi Bai a State Key Lab. of Sci./Engrg. Computing Inst. of Comput. Math. & Sci./Engrg. Computing Academy of Mathematics and System

More information

Gyrokinetic Transport Driven by Energetic Particle Modes

Gyrokinetic Transport Driven by Energetic Particle Modes Gyrokinetic Transport Driven by Energetic Particle Modes by Eric Bass (General Atomics) Collaborators: Ron Waltz, Ming Chu GSEP Workshop General Atomics August 10, 2009 Outline I. Background Alfvén (TAE/EPM)

More information

Scalable Domain Decomposition Preconditioners For Heterogeneous Elliptic Problems

Scalable Domain Decomposition Preconditioners For Heterogeneous Elliptic Problems Scalable Domain Decomposition Preconditioners For Heterogeneous Elliptic Problems Pierre Jolivet, F. Hecht, F. Nataf, C. Prud homme Laboratoire Jacques-Louis Lions Laboratoire Jean Kuntzmann INRIA Rocquencourt

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

Fast Iterative Solution of Saddle Point Problems

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

More information

Recent advances in approximation using Krylov subspaces. V. Simoncini. Dipartimento di Matematica, Università di Bologna.

Recent advances in approximation using Krylov subspaces. V. Simoncini. Dipartimento di Matematica, Università di Bologna. Recent advances in approximation using Krylov subspaces V. Simoncini Dipartimento di Matematica, Università di Bologna and CIRSA, Ravenna, Italy valeria@dm.unibo.it 1 The framework It is given an operator

More information

Notes on PCG for Sparse Linear Systems

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

More information

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

Customized Sparse Eigenvalue Solutions in Lighthouse

Customized Sparse Eigenvalue Solutions in Lighthouse University of Colorado, Boulder CU Scholar Computer Science Graduate Theses & Dissertations Computer Science Spring 1-1-2014 Customized Sparse Eigenvalue Solutions in Lighthouse Ramya Nair University of

More information

Numerical methods for eigenvalue problems in the description of drift instabilities in the plasma edge

Numerical methods for eigenvalue problems in the description of drift instabilities in the plasma edge Numerical methods for eigenvalue problems in the description of drift instabilities in the plasma edge Dominik Löchel Supervisors: M. Hochbruck and M. Tokar Graduate school Dynamic of hot plasmas Mathematisches

More information

Solving the Inverse Toeplitz Eigenproblem Using ScaLAPACK and MPI *

Solving the Inverse Toeplitz Eigenproblem Using ScaLAPACK and MPI * Solving the Inverse Toeplitz Eigenproblem Using ScaLAPACK and MPI * J.M. Badía and A.M. Vidal Dpto. Informática., Univ Jaume I. 07, Castellón, Spain. badia@inf.uji.es Dpto. Sistemas Informáticos y Computación.

More information

Hierarchical Parallel Solution of Stochastic Systems

Hierarchical Parallel Solution of Stochastic Systems Hierarchical Parallel Solution of Stochastic Systems Second M.I.T. Conference on Computational Fluid and Solid Mechanics Contents: Simple Model of Stochastic Flow Stochastic Galerkin Scheme Resulting Equations

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