and applications in quantum mechanical simulations zhaojun ...the expected value of a physical...

29
Multi-Length Scale Matrix Computations and Applications in Quantum Mechanical Simulations Zhaojun Bai http://www.cs.ucdavis.edu/bai joint work with Wenbin Chen, Roger Lee, Richard Scalettar, Ichitaro Yamazaki Workshop on Future Directions in Tensor-Based Computation and Modeling NSF, Arlington, Feb. 20-21, 2009

Upload: others

Post on 05-Aug-2020

3 views

Category:

Documents


0 download

TRANSCRIPT

Page 1: and Applications in Quantum Mechanical Simulations Zhaojun ...The expected value of a physical observable E, such as density-density correlation, spin-spin correlation, the magnetic

Multi-Length Scale Matrix Computations

and Applications in Quantum Mechanical Simulations

Zhaojun Baihttp://www.cs.ucdavis.edu/∼bai

joint work with

Wenbin Chen, Roger Lee, Richard Scalettar, Ichitaro Yamazaki

Workshop on Future Directions in Tensor-Based Computation and ModelingNSF, Arlington, Feb. 20-21, 2009

Page 2: and Applications in Quantum Mechanical Simulations Zhaojun ...The expected value of a physical observable E, such as density-density correlation, spin-spin correlation, the magnetic

Computational Material Science

Simulation and understanding properties of solid-state materials: magnetism,metal-insulator transition, high temperature superconductivity, ...

Conductance map of an electroniccrystal state ... at the atomic scale.[T. Hanaguri et al, Nature 430, 1001(2004)]

Page 3: and Applications in Quantum Mechanical Simulations Zhaojun ...The expected value of a physical observable E, such as density-density correlation, spin-spin correlation, the magnetic

Outline of this talk

1. Hubbard model and quantum Monte Carlo simulation

2. QUEST: QUantum Electron Simulation Toolbox

3. Multi-length scale matrix computations – “tensor-based?”

• Multi-length scale matrix analysis

• Communication-avoiding stable matrix inversion

• Self-adapting direct linear solvers

• Robust preconditioned iterative solvers

4. Concluding remarks

Supported by NSF and DOE SciDAC

Page 4: and Applications in Quantum Mechanical Simulations Zhaojun ...The expected value of a physical observable E, such as density-density correlation, spin-spin correlation, the magnetic

Many body simulation on multi-layer lattice

Hubbard model and quantum Monte Carlo simulation

Page 5: and Applications in Quantum Mechanical Simulations Zhaojun ...The expected value of a physical observable E, such as density-density correlation, spin-spin correlation, the magnetic

Hubbard Hamiltonian – 4N

H = HK +Hμ +HV

= −t∑〈i,j〉,σ

(c†iσcjσ + c†jσciσ) + μ∑

i

(ni↑ + ni↓) + U∑

i

(ni↑ − 1

2)(ni↓ − 1

2)

• 〈i, j〉: a pair of nearest-neighbor spatial sites

• σ =↑, ↓: spin direction of electrons

• c†iσ (ciσ) creates (destroys) an electron of spin σ on site i

• t: hopping parameter⇐ kinetic energy

• U : local repulsion between electrons⇐ potential energy

• μ: controls the electron density⇐ chemical potential energy

Related quantum many body models:

• Ising model for phase transition

• Anderson model of localization for electron transport

Hubbard model and quantum Monte Carlo simulation

Page 6: and Applications in Quantum Mechanical Simulations Zhaojun ...The expected value of a physical observable E, such as density-density correlation, spin-spin correlation, the magnetic

Physical observable E

The expected value of a physical observable E , such as density-densitycorrelation, spin-spin correlation, the magnetic susceptibility, is given by

〈E〉 = Tr (EP) ,

where P is the probability (Boltzmann) distribution

P =1

Z e−βH

and

β ∝ 1

T=

1

Temperature

Z = Tr(e−βH) = the partition function

Hubbard model and quantum Monte Carlo simulation

Page 7: and Applications in Quantum Mechanical Simulations Zhaojun ...The expected value of a physical observable E, such as density-density correlation, spin-spin correlation, the magnetic

Computational approximations of Boltzmann distribution P

P =1

Z e−βH “path integral”−→

⎧⎪⎨⎪⎩P (h) = 1

Zhdet[M+(h)]det[M−(h)]

P (x, p, Φσ) = 1ZH

e−H(x,p,Φσ)

[Feynman’65, ....]

• Determinant QMCh ∼ P (h)

• Hybird QMC (=molecular dynamics + mc)

(x; p, Φσ) ∼ P (x; p, Φσ)

[Blankenbecler/Scalapino/Sugar’81, Hirsch’85, ....]

[Scalettar/Scalapino/Sugar/Toussaint’87, ....]

Hubbard model and quantum Monte Carlo simulation

Page 8: and Applications in Quantum Mechanical Simulations Zhaojun ...The expected value of a physical observable E, such as density-density correlation, spin-spin correlation, the magnetic

QUEST: QUantum Electron Simulation Toolbox

• Fortran 90 package for determinant (and hybrid) Monte Carlo simulations

• Integration and revision of several “legacy” codes developed in the past twodecades

• Modulized structures and configurations

variations of Hamiltonian

different lattice geometry and multi-layer

many physical measurements

• Stable and efficient multi-length scale matrix computation kernels

• Partially parallelized (MPI, OpenMP)

QUEST

Page 9: and Applications in Quantum Mechanical Simulations Zhaojun ...The expected value of a physical observable E, such as density-density correlation, spin-spin correlation, the magnetic

QUEST⇒ “Right” Physics and “Record-breaking” lattice sizes

-0.15

-0.1

-0.05

0

0.05

0.1

(0,0) (10,0) (10,10) (0,0)

c(lx

,ly

)

(0,0) (10,0)

(10,10)

β = 32β = 20β = 12

-0.2

-0.15

-0.1

-0.05

0

0.05

0.1

(0,0) (L/2,0) (L/2, L/2) (0,0)c(

lx,l

y)

(0,0) (L/2,0)

(L/2, L/2)

24 x 2420 x 2016 x 1612 x 128 x 8

magnetism forms as T is lowered large lattice sizes lead to converge

Page 10: and Applications in Quantum Mechanical Simulations Zhaojun ...The expected value of a physical observable E, such as density-density correlation, spin-spin correlation, the magnetic

Matrix kernel

• Multi-length scale matrices

DQMC:

Mσ(h) = I + BDLBDL−1 · · ·BD1

HQMC:

Mσ(x) = INL − (IN ⊗B)D[L](P ⊗ IN)

• B = etΔτK

D� = eσV�(x�)

• D[L] = diag(D1, D2, . . . , DL)

V�(x�) = diag(x1, x2, . . . , xL)

• K is defined based on lattice structure:

K = Kx ⊕Ky for 2-D rectangle

Multi-length scale matrices

Page 11: and Applications in Quantum Mechanical Simulations Zhaojun ...The expected value of a physical observable E, such as density-density correlation, spin-spin correlation, the magnetic

Multi-length scaling

• Length-scales: N , L

– N : spatial lattice size,

– L: the number of imaginary-time slices,

• Energy scales: t, U , β

– t: hopping of electrons between atoms and layers (kinetic energy),

– U : strength of the interactions between the electrons (potential energy),

– β: inverse temperature,

• Length and energy scale connection: Δτ = βL

In more complex situations other energy scales also enter, such as the frequencyof ionic vibrations (phonons) and the strength of the coupling of electrons tothose vibrations

Multi-length scale matrices

Page 12: and Applications in Quantum Mechanical Simulations Zhaojun ...The expected value of a physical observable E, such as density-density correlation, spin-spin correlation, the magnetic

QMC simulation kernels

Matrix computation problems

det[Mσ(h′)]det[Mσ(h)]

, (MTσ (x)Mσ(x))−1Φσ, Gσ(h) = M−1

σ (h) . . .

1. High order, say

Nx ×Ny × L = 64× 64× 160

= 655, 360

2. Wide range of eigenvalue dis-tributions λ(M) and conditionnumbers κ(M)

3. Metropolis Monte-Carlo,O(104) solutions required

A typical MD trajectory:

−1.5 −1 −0.5 0 0.5 1 1.50

0.5

1

1.5

2

2.5

3

3.5

4

4.5

P

X

h11

h11

→ h11’ :

400*M−1

MD step: 0.01

h11’

Multi-length scale matrix computations

Page 13: and Applications in Quantum Mechanical Simulations Zhaojun ...The expected value of a physical observable E, such as density-density correlation, spin-spin correlation, the magnetic

Hubbard matrix eigenvalue distribution λ(M)

λ(M) = 1− λ(BL · · ·B2B1)1Lei

(2�+1)πL , 0 ≤ � ≤ L− 1

[Frobenius ’12, Romanovsky ’43, Varga ’62]

−1 −0.5 0 0.5 1 1.5 2 2.5 3−2

−1.5

−1

−0.5

0

0.5

1

1.5

2

Multi-length scale matrix analysis

Page 14: and Applications in Quantum Mechanical Simulations Zhaojun ...The expected value of a physical observable E, such as density-density correlation, spin-spin correlation, the magnetic

Hubbard matrix eigenvalue distribution λ(M)

λ(M) = 1− λ(BL · · ·B2B1)1Lei

(2�+1)πL , 0 ≤ � ≤ L− 1

[Frobenius ’12, Romanovsky ’43, Varga ’62]

−1 −0.5 0 0.5 1 1.5 2 2.5 3−2

−1.5

−1

−0.5

0

0.5

1

1.5

2N=16N=256

Multi-length scale matrix analysis

Page 15: and Applications in Quantum Mechanical Simulations Zhaojun ...The expected value of a physical observable E, such as density-density correlation, spin-spin correlation, the magnetic

Hubbard matrix eigenvalue distribution λ(M)

λ(M) = 1− λ(BL · · ·B2B1)1Lei

(2�+1)πL , 0 ≤ � ≤ L− 1

[Frobenius ’12, Romanovsky ’43, Varga ’62]

−1 −0.5 0 0.5 1 1.5 2 2.5 3−2

−1.5

−1

−0.5

0

0.5

1

1.5

2p=8p=64

Multi-length scale matrix analysis

Page 16: and Applications in Quantum Mechanical Simulations Zhaojun ...The expected value of a physical observable E, such as density-density correlation, spin-spin correlation, the magnetic

Hubbard matrix eigenvalue distribution λ(M)

λ(M) = 1− λ(BL · · ·B2B1)1Lei

(2�+1)πL , 0 ≤ � ≤ L− 1

[Frobenius ’12, Romanovsky ’43, Varga ’62]

−1.5 −1 −0.5 0 0.5 1 1.5 2 2.5 3 3.5−2.5

−2

−1.5

−1

−0.5

0

0.5

1

1.5

2

2.5U=0U=6

Multi-length scale matrix analysis

Page 17: and Applications in Quantum Mechanical Simulations Zhaojun ...The expected value of a physical observable E, such as density-density correlation, spin-spin correlation, the magnetic

Hubbard matrix eigenvalue distribution λ(M)

λ(M) = 1− λ(BL · · ·B2B1)1Lei

(2�+1)πL , 0 ≤ � ≤ L− 1

[Frobenius ’12, Romanovsky ’43, Varga ’62]

−1 −0.5 0 0.5 1 1.5 2 2.5 3−2

−1.5

−1

−0.5

0

0.5

1

1.5

2p=8,t=1p=64,t=8

Multi-length scale matrix analysis

Page 18: and Applications in Quantum Mechanical Simulations Zhaojun ...The expected value of a physical observable E, such as density-density correlation, spin-spin correlation, the magnetic

Communication-avoiding stable matrix inversion

• Green’s function

G = M−1 = (I + BLBL−1 · · ·B1)−1

• Singular values of BLBL−1 · · ·B1 could spread out from 1030 to 10−30

• A number of methods have been studied to calculate the matrix product inour community, Heath/Laub/Paige/Ward, Bojanczyk/Nagy/Plemmnons, van Dooren,

Kagstrom, ...

• Graded (stratified) decomposition

BLBL−1 · · ·B1 = UDT = U

⎡⎢⎢⎣x

xx

x

⎤⎥⎥⎦T

using QR with pivoting, and proper ordering of multiplications [Loh etal’92], or Jacobi rotations [Stewart’94].

• G = M−1 = (I + UDT )−1 = T−1(UTT−1 + D)−1UT

Communication-avoiding stable matrix inversion

Page 19: and Applications in Quantum Mechanical Simulations Zhaojun ...The expected value of a physical observable E, such as density-density correlation, spin-spin correlation, the magnetic

Communication-avoiding stable matrix inversion

• QR with pivoting is not friendly to multicore computing

BLAS/LAPACK in MKL on Intel Quad 2.4GHzGflops dgemm dgeqrf dgeqp31-core 7.79 6.47 1.472-core 15.68 13.10 2.47

2-way Quad 26.39 21.68 3.22

• We developed an alternative based on a block structure orthogonalfactorization (BSOF) without pivoting

UDT BSOF1-core 4.02 7.682-core 5.06 13.28

2-way Quad 6.22 18.85

Communication-avoiding stable matrix inversion

Page 20: and Applications in Quantum Mechanical Simulations Zhaojun ...The expected value of a physical observable E, such as density-density correlation, spin-spin correlation, the magnetic

Sel-adapting direct linear solvers

• Block cyclic reduction⎡⎢⎢⎢⎢⎣I B1

−B2 I−B3 I

−B4 I−B5 I

⎤⎥⎥⎥⎥⎦⎡⎢⎢⎢⎢⎣

x1

x2

x3

x4

x5

⎤⎥⎥⎥⎥⎦ =

⎡⎢⎢⎢⎢⎣b1

b1

b2

b3

b4

⎤⎥⎥⎥⎥⎦ ,

⇒⎡⎣ I B1

−B3B2 I−B5B4 I

⎤⎦⎡⎣ x1

x3

x5

⎤⎦ =

⎡⎢⎣ b1

b(2)3

b(2)5

⎤⎥⎦ ,

• Factor of 2k–reduction, however, limited k due to numerical instability

[Buzbee/Golub/Nielson’70, ... ]

Self-adapting direct linear solvers

Page 21: and Applications in Quantum Mechanical Simulations Zhaojun ...The expected value of a physical observable E, such as density-density correlation, spin-spin correlation, the magnetic

Sel-adapting direct linear solvers

• Block structured orthogonal factorization (BSOF)

M = (Q1Q2 · · ·QL)R,

i.e. ⎡⎢⎢⎣I B1

−B2 I. . . . . .−BL I

⎤⎥⎥⎦ Qk=⇒

⎡⎢⎢⎢⎢⎣R1 X X

R2 X X. . . . . . X

RL−1 XRL

⎤⎥⎥⎥⎥⎦ .

• Rich substructure of Q1Q2 · · ·QL

exploited for the Green’s function calculations

• Parallelizable [Wright’92,...]

• Stable method, but, high memory cost O(N2L).

Self-adapting direct linear solvers

Page 22: and Applications in Quantum Mechanical Simulations Zhaojun ...The expected value of a physical observable E, such as density-density correlation, spin-spin correlation, the magnetic

Self-adapting direct linear solvers

Block cyclic reduction + BSOF:

1. k-step block reduction:

Mx = b =⇒ M (k)x(k) = b(k)

i.e.,

block L–cyclic system =⇒ block Lk –cyclic system

2. BSOFQT

Lk−1· · ·QT

1 M (k) = R,

and compute x(k)

3. Forward and back substitutions:

xi ←− x(k) −→ xj

Self-adapting direct linear solvers

Page 23: and Applications in Quantum Mechanical Simulations Zhaojun ...The expected value of a physical observable E, such as density-density correlation, spin-spin correlation, the magnetic

Self-adapting direct linear solvers

Factor-k reduction:

• The order of M (k) is reduced by a factor of k.

• However, the condition number of M(k) increases when k increases.

• How to self-adaptively determine the reduction factor k so that thecomputed solutions have the required accuracy?

Self-adapting direct linear solvers

Page 24: and Applications in Quantum Mechanical Simulations Zhaojun ...The expected value of a physical observable E, such as density-density correlation, spin-spin correlation, the magnetic

Self-adapting direct linear solvers

Self-adaptive reduction factor k

Given a desired accuracy‖x� − x̂�‖‖x�‖ ≤ tol,

by an error analysis of x̂� and conditioning estimation of M (k), thereduction factor k is then adaptively determined with respect to thesimulation parameters L(β), U, . . .:

k =

⌊23 ln(tol/ε)

4tΔτ + ν

⌋where ν =

√UΔτ + · · ·

Example: t = 1, Δτ = 1/8, tol = 10−8, ε = 10−16,

U 0 1 2 3 4 5 6Reduction factor k 24 14 12 10 9 9 8

Invited presentation at APS annual meeting 2006Self-adapting direct linear solvers

Page 25: and Applications in Quantum Mechanical Simulations Zhaojun ...The expected value of a physical observable E, such as density-density correlation, spin-spin correlation, the magnetic

Robust preconditioned iterative linear solvers

• Preconditioned conjugate gradient (PCG)

MTMx = b,

• Symmetrical preconditioned linear system

R−T (MTM)R−1 · Rx = R−Tb,

• Earlier work on preconditioning techniques turned out to be of poor quality,and/or the growth of costs (memory and flops) significantlly as N,U, β(L)increasing.

• Is there a linear scaling, O(NL), iterative solver?

Robust preconditioned iterative linear solvers

Page 26: and Applications in Quantum Mechanical Simulations Zhaojun ...The expected value of a physical observable E, such as density-density correlation, spin-spin correlation, the magnetic

Robust preconditioned iterative linear solvers

• Incomplete Cholesky (IC) factorization:

MTM = RTR + E,

where R is an upper triangular matrix and E is the error matrix.

• In QMC simulation, it suffers

– high cost to apply R due to large number of fill-ins,

– or low quality (large number of iterations),

– not robust, pivot break-down due to loss of MTM − E > 0.

Robust preconditioned iterative linear solvers

Page 27: and Applications in Quantum Mechanical Simulations Zhaojun ...The expected value of a physical observable E, such as density-density correlation, spin-spin correlation, the magnetic

Robust preconditioned iterative linear solvers

• Robust Incomplete Cholesky (RIC)⎧⎪⎨⎪⎩MTM = RTR + E

subject to E = RTF + FTR + S,MTM − E > 0,

• Robust, no pivot breakdown

• Quality measured by the residual matrix

I −R−T (MTM)R−1 = FR−1 + R−TF︸ ︷︷ ︸O(‖R−1‖ σ1)

+ R−TSR−1︸ ︷︷ ︸O(‖R−1‖2σ2)

,

• Balance the cost and quality for multi-length scales using proper primaryand secondary drop tolerances σ1 and σ2

• An extended Compressed Sparse Column (CSC) storage format is proposedto accommodate the data access pattern.

• Early work by Ajiz & Jennings, Tismenetsky, Kaporin, Benzi, and Tuma.

• I. Yamazaki’s PhD thesis, 2008

Robust preconditioned iterative linear solvers

Page 28: and Applications in Quantum Mechanical Simulations Zhaojun ...The expected value of a physical observable E, such as density-density correlation, spin-spin correlation, the magnetic

Robust preconditioned iterative linear solvers

Good news: O(NL) for small U Bad news: O(N2L) for large U

64256 576 1024 1600 2304 3136 40960

10

20

30

40

50

60

70

80

Kaporin’s RIC3L

N

CP

U ti

me

(s)

U=0U=1U=2U=3

64256 576 1024 1600 2304 3136 40960

200

400

600

800

1000

1200

1400

1600

1800Kaporin’s RIC3L

N

CP

U ti

me

(s)

U=4U=5U=6

Robust preconditioned iterative linear solvers

Page 29: and Applications in Quantum Mechanical Simulations Zhaojun ...The expected value of a physical observable E, such as density-density correlation, spin-spin correlation, the magnetic

Concluding remarks

1. Synergistic effort on the development of large-scale computationaltechniques for multi-length scale simulations in computational materialscience, where “tensors run rampant!”

2. Emerging opportunities for matrix/tensor research on

• Robust and efficient algorithm design and analysis for multi-length scalematrices/tensors – fully tensor-based?

• Structure exploitation

• Multi-core matrix computing

• Software and toolbox development

[B., Chen, Scalettar and Yamazaki: Lectre notes on numerical methods for quantum Monte

Carlo simulations of the Hubbard model, ∼ 120 pages]

Concluding remarks