a jacobi--davidson algorithm for large eigenvalue problems...

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

Upload: phamngoc

Post on 14-Aug-2019

213 views

Category:

Documents


0 download

TRANSCRIPT

Page 1: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

A Jacobi–Davidson Algorithm for Large EigenvalueProblems from Opto-Electronics

Peter Arbenz1 Urban Weber1

Ratko Veprek2 Bernd Witzigmann2

1Institute of Computational Science, ETH Zurich,

2Integrated Systems Laboratory, ETH Zurich

Work in progress

RANMEP, Hsinchu, Taiwan, January 4–8, 2008.

RANMEP, Hsinchu, Taiwan, January 4–8, 2008 1/30

Page 2: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

Introduction I

In solid state physics, the (electronic) band structure of a soliddescribes ranges of energy that an electron can assume.

Electrons of single free-standingatom occupy atomic orbitals, thatform discrete set of energy levels.When a large number of atoms arebrought together to form a solid,the number of orbitals becomes ex-ceedingly large, and the difference inenergy between them becomes verysmall. Bands of energy levels areform rather than discrete energy lev-els. Intervals that contain no orbitalsare called band gaps.

From wikipedia.org

RANMEP, Hsinchu, Taiwan, January 4–8, 2008 2/30

Page 3: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

Introduction II

Any solid has a large number of bands, in theory, ∞ many.However, all but a few lie at energies so high that any electronthat reaches those energies escapes from the solid. Thesebands are usually disregarded.

RANMEP, Hsinchu, Taiwan, January 4–8, 2008 3/30

Page 4: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

Introduction III

The uppermost occupied band is called valence band byanalogy to the valence electrons of individual atoms. Thelowermost unoccupied band is called the conduction bandbecause only when electrons are excited to the conductionband can current flow in these materials.

RANMEP, Hsinchu, Taiwan, January 4–8, 2008 4/30

Page 5: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

Introduction IV

A numerical evaluation of the band structure takes intoaccount the periodic nature of a crystal lattice.The Schrodinger equation for a single particle in a cristallattice is given by

(− ~2

2m0∇2 + V (r))Ψ(r) = EΨ(r) (1)

where the potential V exhibits the cristal periodicities:V (r) = V (r + R) for all lattice vectors R.Solutions of (1) are Bloch functions:

Ψnk(r) = e ik·runk(r). (2)

where unk(r) is lattice-periodic.

RANMEP, Hsinchu, Taiwan, January 4–8, 2008 5/30

Page 6: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

Introduction V

Here, k is called the wave vector, and is related to thedirection of motion of the electron in the crystal, and n is theband index, which simply numbers the energy bands. Thewave vector k takes on values within the Brillouin zonecorresponding to the crystal lattice.Plugging (2) into (1) yields

~2

2m0

(−∇2 + 2ik · ∇+ |k|2 + V (r)

)unk(r) = En(k)unk(r)

(3)For each of the possible k there are infinitely manyn = 1, 2, . . ..

RANMEP, Hsinchu, Taiwan, January 4–8, 2008 6/30

Page 7: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

Introduction VI

There are a number of possible ways to compute the spectralbands.

1 Solve (3) for k = k0 = 0 and determine the rest of theeigenvalues by perturbation theory. (Effective mass m∗)

2 Solve (3) in a subspace spanned by a small number ofeigenfunctions (zone-centered Bloch functions) un0 (Kane,1957).

3 In the k·p method the two methods are somehow combined bywriting

Φ(r) =m∑

i=1

gi (r)ui0(r). (4)

Here, the so-called envelope gi replaces the plane wave e ik·r

in (2) (Luttinger-Kohn, 1955; Lowdin, 1951).

We go for the k·p method for its superior accuracy.

RANMEP, Hsinchu, Taiwan, January 4–8, 2008 7/30

Page 8: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

Introduction VII

We finally arrive at an eigenvalue problem for the envelopes: ∑i ,j=1,2,3

H(2)ij (r)∂i∂j + H

(1)i (r)∂i + H(0)(r) + U(r)

g(r) = Eg(r)

(5)Here, the perturbation U(r) takes into account an impuritypotential of the material or quantum dot, etc.Note, that g is a m-vector (field).

For the numerical computation g is represented by piecewise(linear) finite elements.

RANMEP, Hsinchu, Taiwan, January 4–8, 2008 8/30

Page 9: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

Quantum dot

Probability density of an excited state in a valence band in apyramidal quantum dot.

RANMEP, Hsinchu, Taiwan, January 4–8, 2008 9/30

Page 10: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

The linear algebra problem

We end up with the generalized complex Hermitian eigenvalueproblem

Ax = λMx. (6)

whereA∗ = A ∈ Cn×n, MT = M ∈ Rn×n,

Depending on the bands included, A is either definite or indefinite.The latter holds if valence and conduction band are taken intoaccount.

Just a small number (k = 1− 8) of bands are used. Matrices havek × k blocks.

Only a few of the eigenvalues closest to 0 of (6) are desired.

RANMEP, Hsinchu, Taiwan, January 4–8, 2008 10/30

Page 11: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

Transformation complex Hermitian → real symmetric I

For A = Ar + i Ai ∈ Cn×m, Ar ,Ai ∈ Rn×m, define the mapping(Day & Heroux, 2001)

ϕ : Cm×n −→ R2m×2n : A 7−→ ϕ(A) :=

(Ar −Ai

Ai Ar

)(7)

that transforms a complex m × n matrix into a real 2m × 2nmatrix. If operations are allowed, then

ϕ(AB) = ϕ(A)ϕ(B). (8)

Many codes for solving eigenvalue problems, in particular forlarge sparse eigenvalue problems, are available only in realarithmetic.

Very often the sparsity structures of real and imaginary partsof the underlying matrices differ considerably.

RANMEP, Hsinchu, Taiwan, January 4–8, 2008 11/30

Page 12: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

Transformation complex Hermitian → real symmetric II

We can rewrite the complex eigenvalue problem

Ax = xλ (9)

in the real form

ϕ(Ax) = ϕ(A)ϕ(x) = ϕ(xλ) = ϕ(x)ϕ(λ). (10)

or, (Ar −Ai

Ai Ar

) (xr −xi

xi xr

)=

(xr −xi

xi xr

) (λr −λi

λi λr

).

(11)So, a complex eigenvalue of A becomes a pair of complexconjugate eigenvalues of ϕ(A).

A Hermitian =⇒ λi = 0.

RANMEP, Hsinchu, Taiwan, January 4–8, 2008 12/30

Page 13: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

Transformation complex Hermitian → real symmetric III

Special cases:

ϕ(x∗)ϕ(x) = ϕ(‖x‖2) ⇐⇒(

xTr xT

i

−xTi xT

r

) (xr −xi

xi xr

)= ‖x‖2

(1 00 1

)

Enforcing x∗y = 0 thus means that

(yr

yi

)is made orthogonal

to both

(xi

xr

)and

(xr

−xi

). The companion vector

(−yi

yr

)will then automatically be orthogonal to these two vectors.

Computation is done with just one vector.

RANMEP, Hsinchu, Taiwan, January 4–8, 2008 13/30

Page 14: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

Computing only a few eigenpairs

Case 1. A is positive definite. Compute eigenvalues one by onestarting with the smallest.

Case 2: A is indefinite. (M is always spd.)

Use approaches employing harmonic Ritz values/vectors.Preconditioner?Generate two new positive definite eigenvalue problems

(A− σiM)M−1(A− σiM)x = λMx, i = 1, 2. (12)

where σ1 is close to the smallest positive eigenvalue of (A,M)and σ2 is close to the smallest negative eigenvalue of (A,M)(Vomel, 2007; Shi Shu, 2006).Compute eigenvalues of (12) with shift σ1 one by one startingwith the smallest.Compute eigenvalues of (12) with shift σ2 one by one startingwith the smallest.Preconditioner? AMG preconditioner?

RANMEP, Hsinchu, Taiwan, January 4–8, 2008 14/30

Page 15: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

Symmetric Jacobi–Davidson (JDSYM)

(Sleijpen/van der Vorst, 1996; Geus, 2003)

Let Vk = span{v1, . . . , vk}, vTk Mvj = δkj , be the actual

search space (not a Krylov space).

Rayleigh–Ritz–Galerkin procedure: Extract Ritz pair (λ, q) inVk with λ closest to some target value τ .

Convergence: If ‖rk‖M−1 ≡ ‖(A− λM) q‖M−1 < ε‖q‖M thenwe have found an eigenpair

Solve correction equation for tk ⊥M q,

(I −MqqT )(A− ηkM)(I − qqTM)tk =−rk , qTMtk = 0.(13)

M-orthonormalize tk to Vk to obtain vk+1

Expand search space: Vk+1 = span{v1, . . . , vk+1}.

RANMEP, Hsinchu, Taiwan, January 4–8, 2008 15/30

Page 16: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

Remarks on JDSYM

In exact arithmetic, ‘one-vector JD’ is Rayleigh quotientiteration. Eigenvalue approximations converge cubically.

Shift ηk in (13) is set to target value τ initially (∼ inverseiteration) and to the Rayleigh quotient ρ(q) close toconvergence.

Keep subspace size bounded: If k = jmax reduce size of thesearch space to jmin. Use jmin ‘best’ Ritz vectors in Vjmax todefine Vjmin

.

The correction equation is solved only approximatively. Weuse a Krylov space method: QMRS (admits indefinitepreconditioner) (Freund, 1992).

Eigenvectors corresponding to higher eigenvalues arecomputed in the orthogonal complement of previouslycomputed eigenvectors.

RANMEP, Hsinchu, Taiwan, January 4–8, 2008 16/30

Page 17: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

Preconditioning the correction equation

The correction equation is given by

(I −MqqT )(A− ηkM)(I − qqTM)tk = −rk , qTMtk = 0.

Preconditioning means solving with a system of the form

(I −MqqT )K (I − qqTM)c = b, qTMc = 0. (14)

where K is a preconditioner for A− ρkM.

As we are looking for just a few of the smallest eigenvalues we takeK ≈ A− σM where σ is close to the desired eigenvalues. Usually,σ = τ .

We use the same aggregation-based AMG preconditioner K for allcorrection equations (Vanek, Brezina, Mandel, 1996)(Remember we only compute a few eigenpairs.)

RANMEP, Hsinchu, Taiwan, January 4–8, 2008 17/30

Page 18: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

Setup procedure for an abstract multigrid solver

1: Define the number of levels, L2: for level ` = 0, . . . , L− 1 do3: if ` < L− 1 then4: Define prolongator P`;5: Define restriction R` = PT

` ;6: K`+1 = R`K`P`;7: Define smoother S`;8: else9: Prepare for solving with K`;

10: end if11: end for

RANMEP, Hsinchu, Taiwan, January 4–8, 2008 18/30

Page 19: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

Smoothed aggregation (SA) AMG preconditioner I

1 Build adjacency graph G0 of K0 = K .(Take m ×m block structure into account.)

2 Group graph vertices into contiguous subsets, calledaggregates. Each aggregate represents a coarser grid vertex.

Typical aggregates: 3× 3× 3 nodes (of the graph) up to5× 5× 5 nodes (if aggressive coarsening is used)(Par)METISNote: The matrices K1,K2, . . . need much less memory spacethan K0!Typical operator complexity for SA: 1.4 (!!!)

RANMEP, Hsinchu, Taiwan, January 4–8, 2008 19/30

Page 20: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

Smoothed aggregation (SA) AMG preconditioner II

3 Define a grid transfer operator:

Low-energy modes (near-kernel) are ‘chopped’ according toaggregation

B` =

B(`)1...

B(`)n`+1

B(`)j = rows of B` corresponding

to grid points assigned to j th ag-gregate.

Let B(`)j = Q

(`)j R

(`)j be QR factorization of B

(`)j then

B` = P`B`+1, PT` P` = I ,

with

P` = diag(Q(`)1 , . . . ,Q(`)

n`+1) and B`+1 =

R(`)1...

R(`)n`+1

.

Columns of B`+1 span the near kernel of K`+1.Notice: matrices K` are not used in constructing tentativeprolongators P`, near kernels B`, and graphs G`.

RANMEP, Hsinchu, Taiwan, January 4–8, 2008 20/30

Page 21: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

Smoothed aggregation (SA) AMG preconditioner III

4 For elliptic problems, it is advisable to perform an additionalstep, to obtain smoothed aggregation (SA).

P` = (I` − ω` D−1` K`) P`, ω` =

4/3

λmax(D−1` K`)

,

smoothed prolongator

In non-smoothed aggregation: P` = P`

5 Smoother S`: polynomial smoother

Choose a Chebyshev polynomial that is small on the upper partof the spectrum of K` (Adams, Brezina, Hu, Tuminaro, 2003).Parallelizes perfectly, quality independent of processor number.

RANMEP, Hsinchu, Taiwan, January 4–8, 2008 21/30

Page 22: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

‘Matrix-free’ multigrid

Our approach: pcg which “almost” smoothed aggregationAMG preconditioning

We set K = K0 = A− σM in the positive definite case andK = (A− σM)M−1

lumped(A− σM) in the indefinite case. (Weapply K0.)

We lump because M−1 is dense. G0 is the graphcorresponding to (A− σM)M−1

lumped(A− σM).

P0 is not smoothed, i.e. P0 = P0.

K1 = PT0 K0P0 is formed explicitely.

All graphs, including G0, are constructed.

RANMEP, Hsinchu, Taiwan, January 4–8, 2008 22/30

Page 23: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

The Software Environment: Trilinos

The Trilinos Project is an effort to develop parallel solveralgorithms and libraries within an object-oriented softwareframework for the solution of large-scale, complexmulti-physics engineering and scientific applications.

See http://software.sandia.gov/trilinos/

Provides means to distribute (multi)vectors and (sparse)matrices (Epetra and EpetraExt packages).

Provides solvers that work on these distributed data. Here weuse iterative solvers and preconditioners (packagesAztecOO/IFPACK), smoothed aggregation multilevel AMGpreconditioner (ML), direct solver wrappers (Amesos) anddata distribution for parallelization (Zoltan/ParMETIS).

Quality of documentation depends on package.

RANMEP, Hsinchu, Taiwan, January 4–8, 2008 23/30

Page 24: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

Parallel mesh reading

Mesh file content

A list of tetrahedra(4 vertices)

A list of vertex coordinates(x , y , z)

A list of surface triangles(3 vertices)

Implementation: HDF5 format/library

Allows for parallel I/O

Mesh reading scales with number of processors

Binary file format allows for efficient I/O

RANMEP, Hsinchu, Taiwan, January 4–8, 2008 24/30

Page 25: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

Timings for a small quantum wire problem (4× 4, spd)

Problem sizen = 49860, 2*n = 99720Number of nonzeros in the graph = 1259826

Some JDSYM parametersitmax=1000 linitmax=50 kmax=8 jmin=8 jmax=16tau=0.0e+00 jdtol=1.0e-08 eps tr=1.0e-02toldecay=1.5e+00 sigma=0.0e+00linsolver=qmrs blksize=1

RANMEP, Hsinchu, Taiwan, January 4–8, 2008 25/30

Page 26: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

Convergence history of a typical JD run

RANMEP, Hsinchu, Taiwan, January 4–8, 2008 26/30

Page 27: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

Performance with spd problems

2DBigWire

p t [sec] E (p) t(Prec) nout navginner

1 400 1.00 243 59 15.62 181 1.10 147 56 15.84 140 0.71 115 56 15.78 215 0.23 178 61 17.1

E (p) =t(1)

p t(p)

RANMEP, Hsinchu, Taiwan, January 4–8, 2008 27/30

Page 28: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

Performance with indefinite problems

Isoprobability surface at probability density of 0.006 of an elevated

electron state of a pyramidal Indium-Arsenide (InAs) quantum dot

calculated using k·p 8× 8.RANMEP, Hsinchu, Taiwan, January 4–8, 2008 28/30

Page 29: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

Conclusions

JD solves the spd eigenvalue very efficiently (with the rightnumber of processors)

The SA multilevel preconditioner is unbeatable (memoryconsumption, scalability), if it is applicable.

Uncertainties with respect to success with the indefinitesystem

does preconditioner work?near null space right?stopping criterion?how is the accuracy affected by squaring of the matrix?

RANMEP, Hsinchu, Taiwan, January 4–8, 2008 29/30

Page 30: A Jacobi--Davidson Algorithm for Large Eigenvalue Problems ...math.cts.nthu.edu.tw/Mathematics/RANMEP Slides/Peter Arbenz.pdf · Introduction C → R Eigensolver Preconditioning Experimental

Introduction C → R Eigensolver Preconditioning Experimental Results Conclusions

The End

RANMEP, Hsinchu, Taiwan, January 4–8, 2008 30/30