Introduction to Electronic Structure Calculations with BigDFT

Size: px
Start display at page:

Download "Introduction to Electronic Structure Calculations with BigDFT"

Transcription

1 Multiscale Modelling Methods for Applications in Materials Science CECAM JÜLICH, GERMANY run to Electronic Structure Calculations with Thierry Deutsch, Damien Caliste, Luigi Genovese L_Sim - CEA Grenoble 17 September 2013

2 Objectives of the lesson To know what are the main parameters in a DFT calculation To run a calculation (i.e. the physicist problem) run 1 2 Running Exchange-correlation 3 High-Performance Computing (parallel and GPU) 4 and techniques (very large calculations) Resonant States (Beyond DFT)

3 A basis for nanosciences: the project STREP European project: ( ) Four partners, 15 contributors: CEA-INAC Grenoble, U. Basel, U. Louvain-la-Neuve, U. Kiel run Aim: To develop an ab-initio DFT code based on Daubechies Wavelets, to be integrated in ABINIT, distributed freely (GNU-GPL license) L. Genovese, A. Neelov, S. Goedecker, T. Deutsch, et al., Daubechies wavelets as a basis set for density functional pseudopotential calculations, J. Chem. Phys. 129, (2008)

4 version 1.7: capabilities run Free, surface and periodic boundary conditions Geometry optimizations (with constraints) Born-Oppenheimer Molecular Dynamics Saddle point searches (Nudged-Elastic Band Method) Vibrations External electric fields Unoccupied KS orbitals Collinear and Non-collinear magnetism All functionals of the ABINIT package Hybrid functionals Empirical van der Waals interactions (many flavors) Also available within the ABINIT package

5 Quantum Mechanics Schrödinger equation for N electrons in an external potential V ext (r): run H = 2 2m antisymmetric Ψ(r 1,r 2,...,r N ) = Ψ(r 2,r 1,...,r N ) N i 2 r i + 1 4πε 0 i j 1 r i r j + N i H Ψ(r 1,r 2,...,r N ) = EΨ(r 1,r 2,...,r N ) Ion-electron interactions: V ext (r) = 1 Z α 4πε 0 R α r α V ext (r i )

6 The Hohenberg-Kohn theorem run Schrödinger equation H = N i=1 ( r i + V ext (r i,{r}) ) i j Very difficult to solve for more than two electrons! 1 r i r j The fundamental variable of the problem is however not the wavefunction, but the electronic density ρ(r) = N dr 2 dr N ψ (r,r 2,,r N )ψ(r,r 2,,r N ) Hohenberg-Kohn theorem (1964) The ground state density ρ(r) of a many-electron system uniquely determines (up to a constant) the external potential. The external potential is a functional of ρ: V ext (r) = V ext [ρ](r)

7 The Hohenberg-Kohn theorem run Schrödinger equation H = N i=1 ( r i + V ext (r i,{r}) ) i j Very difficult to solve for more than two electrons! 1 r i r j The fundamental variable of the problem is however not the wavefunction, but the electronic density ρ(r) = N dr 2 dr N ψ (r,r 2,,r N )ψ(r,r 2,,r N ) Hohenberg-Kohn theorem (1964) The ground state density ρ(r) of a many-electron system uniquely determines (up to a constant) the external potential. The external potential is a functional of ρ: V ext (r) = V ext [ρ](r)

8 Density Functional Theory (DFT) Theorem: The total energy of the ground state in an external potential V ext is a functional of the electronic density ρ(r): E [ρ(r)] = F [ρ(r)] + V ext (r)ρ(r)dr r Variational principles: E [ρ 0 (r)] E [ρ(r)] ρ(r) run Kohn-Sham Equation: (approximation) Having a one-electron hamiltonian in a mean field. [ V eff (r) ] ψ i = ε i ψ i occupied ρ(r) = i ψ i (r) 2

9 Density Functional Theory (DFT) Theorem: The total energy of the ground state in an external potential V ext is a functional of the electronic density ρ(r): E [ρ(r)] = F [ρ(r)] + V ext (r)ρ(r)dr r Variational principles: E [ρ 0 (r)] E [ρ(r)] ρ(r) run Kohn-Sham Equation: (approximation) Having a one-electron hamiltonian in a mean field. [ V eff (r) ] ψ i = ε i ψ i occupied ρ(r) = i ψ i (r) 2

10 Kohn-Sham formalism H-K theorem: E is an unknown functional of the density E = E[ρ] Density Functional Theory run Kohn-Sham approach Mapping of an interacting many-electron system into a system with independent particles moving into an effective potential. Find a set of orthonormal orbitals Ψ i (r) that minimizes: E = 1 2 N/2 i=1 N/2 ρ(r) = i=1 Ψ i (r) 2 Ψ i (r)dr + 1 ρ(r)v H (r)dr 2 + E xc [ρ(r)] + V ext (r)ρ(r)dr Ψ i (r)ψ i (r) 2 V H (r) = 4πρ(r)

11 Spirit of Few input files (posinp.xyz, input.dft) run Few input parameters ex. no parameters for parallel calculations Use input files with mandatory parameters Optional input files as input.kpt (for periodic systems) or input.perf (parameters for performance)

12 How to run run Some pre-processing bigdft-tool nprocs [name] Help to find the optimal number of processors for the run that fit into the computer memory. Also useful to check that all input files are without errors. The main run mpirun -np 8 bigdft [name] tee [name].log Number of MPI tasks : 8 OpenMP parallelization : Yes Maximal OpenMP threads per MPI task : 1 Material acceleration : The outputs No #iproc=0 log is output on stdout, so redirect it. generated data are stored in a subdirectory called data[-name].

13 The input files (or not) run posinp.xyz: the atomic coordinates and box definition. psppar.element: pseudo-potentials for each element; input.dft: DFT related parameters; input.geopt: geometrie relaxations and MD; input.kpt: the k-point mesh and band structure path; input.mix: diagonalisation mechanism; input.sic, tddft, occ, perf: other parameters; Only the coordinates are mandatory. All lines of different input files are mandatory and output on log. When is run, all default values are output in files called default.xxx. Naming scheme All input files may be renamed by providing a name argument to the command line i.e. bigdft name.

14 Atomic positions: posinp.xyz or posinp.ascii units reduced, angstroem, bohr or atomic Boundary conditions periodic, surface run 8 reduced periodic Si Si Si Si Si Si Si Si

15 Atomic positions: posinp.xyz or posinp.ascii units reduced, angstroem, bohr or atomic Boundary conditions periodic, surface run 3 angstroem surface O H H

16 Atomic positions: posinp.xyz or posinp.ascii units reduced, angstroem, bohr or atomic Boundary conditions periodic, surface run 5 atomic Si H H H H

17 Atomic coordinate format run uses XYZ format plus additional modifications: physical unit, after the number of atoms on the first line put either bohr or angstroem. boundary conditions, on second line, start with one of freebc, surface X lat 0 Z lat or periodic X lat Y lat Z lat. frozen positions, add a f, fy or fxz at the end of an atom line. input polarisation, add values at the end of an atom line. On output, forces are added for each element at the end of the XYZ file: 2 angstroem freebc Na Cl forces Na E Cl E-2 0 0

18 Performing a DFT calculation run A self-consistent equation ρ(r) = Ψ i (r)ψ i (r), where ψ i satisfies i ( 12 ) 2 + V H [ρ] + V xc [ρ] + V ext + V pseudo ψ i = E i ψ i, (Kohn-Sham) DFT Ingredients A basis set for expressing the ψ i An potential, functional of the density several approximations exists (LDA,GGA,... ) A choice of the pseudopotential (if not all-electrons) (norm conserving, ultrasoft, PAW,... ) An (iterative) algorithm for finding the wavefunctions ψ i A (good) computer...

19 s in real space: Wavelet basis sets run Properties of wavelet basis sets: localized both in real and in Fourier space allow for adaptivity (for core electrons) are a systematic basis set A basis set both adaptive and systematic, real space based x φ(x) ψ(x)

20 A brief description of wavelet theory run Two kind of basis functions A Multi-Resolution real space basis The functions can be classified following the resolution level they span. Scaling Functions The functions of low resolution level are a linear combination of high-resolution functions = + m φ(x) = h j φ(2x j) j= m Centered on a resolution-dependent grid: φ j = φ 0 (x j).

21 A brief description of wavelet theory Wavelets They contain the DoF needed to complete the information which is lacking due to the coarseness of the resolution. run φ(2x) = m j= m = h j φ(x j) + m j= m g j ψ(x j) Increase the resolution without modifying grid space SF + W = same DoF of SF of higher resolution ψ(x) = m j= m g j φ(2x j) All functions have compact support, centered on grid points.

22 Adaptivity of the mesh run Adaptivity Resolution can be refined following the grid point. The grid is divided in: Data can thus be stored in compressed form. Localization property Low resolution pts (SF, 1 DoF) High resolution pts (SF + W, 8 DoF) Points of different resolution belong to the same grid. Empty regions must not be filled with basis functions. Optimal for big inhomogeneous systems, O(N) approach.

23 Adaptivity of the mesh Atomic positions (H 2 O), hgrid run

24 Adaptivity of the mesh Fine grid (high resolution, frmult) run

25 Adaptivity of the mesh Coarse grid (low resolution, crmult) run

26 Defining the basis set in input.dft Main specific variables to control the basis set hgrid the grid size run frmult the expansion around atoms for fine grid crmult the expansion around atoms for coarse grid Convergence properties Decreasing hgrid more degrees of freedom. Increasing crmult less box constraint. It is important to improve both parameters together to avoid error on one hiding improvement made on the other one.

27 input.dft: hgrid, crmult, frmult run hgrid Step grid: twice as bigger than the lowest gaussian coefficient of pseudopotential Roughly 0.45 (only orthorhombic mesh) crmult Extension of the coarse resolution (factor 6.): depends on the extension of the HOMO for the atom frmult Extension of the fine resolution (factor 8.): depends on the pseudopotential coefficient In practice, we use only hgrid from 0.3 to 0.55.

28 Wavelets: No integration error Orthogonality, scaling relation dx φ k (x)φ j (x) = δ kj φ(x) = 1 2 m j= m h j φ(2x j) run The hamiltonian-related quantities can be calculated up to machine precision in the given basis. The accuracy is only limited by the basis set (O ( h 14 grid) ) Exact evaluation of kinetic energy Obtained by convolution with filters: f(x) = c l φ l (x), 2 f(x) = c l φ l (x), l l c l = c j a l j, a l φ 0 (x) 2 xφ l (x), j

29 Wavelets: Separability in 3D The 3-dim scaling basis is a tensor product decomposition of 1-dim Scaling Functions/ Wavelets. φ e x,e y,e z j x,j y,j z (x,y,z) = φ e x j x (x)φ e y j y (y)φ e z j z (z) run With (j x,j y,j z ) the node coordinates, φ (0) j and φ (1) j the SF and the W respectively. Gaussians and wavelets The separability of the basis allows us to save computational time when performing scalar products with separable functions (e.g. gaussians): Initial wavefunctions (input guess) Poisson solver Non-local pseudopotentials

30 Performing a DFT calculation run A self-consistent equation ρ(r) = Ψ i (r)ψ i (r), where ψ i satisfies i ( 12 ) 2 + V H [ρ] + V xc [ρ] + V ext + V pseudo ψ i = E i ψ i, (Kohn-Sham) DFT Ingredients A basis set for expressing the ψ i An potential, functional of the density several approximations exists (LDA,GGA,... ) A choice of the pseudopotential (if not all-electrons) (norm conserving, ultrasoft, PAW,... ) An (iterative) algorithm for finding the wavefunctions ψ i A (good) computer...

31 Gaussian type separable s (HGH) run Local part V loc (r) = Z [ ] [ ion r erf + exp 1 ( ) ] 2 r r 2rloc 2 r loc { ( ) 2 ( ) 4 ( r r r C 1 + C 2 + C 3 + C 4 r loc r loc Nonlocal (separable) part H( r, r ) H sep ( r, r ) = p l 1(r) = 2 r l+ 3 2 l 2 i=1 r loc Y s,m (ˆr) p s i (r) h s i p s i (r ) Ys,m(ˆr ) m + Y p,m (ˆr) p p 1 (r) hp 1 pp 1 (r ) Yp,m(ˆr ) m r l+ 7 2 l ) 6 } r l e 1 2 ( r ) 2 r l p Γ(l l r l+2 e 1 2 ( r ) 2 r l 2(r) = ) Γ(l + 7) 2

32 All-electron accuracy with Norm Conserving PSP run Non-linear core correction added to HGH PSP J. Chem. Phys. 138, (2013) Simple analytic form (a single gaussian as ρ c ) Same hardness as HGH a systematic localized basis is fundamental Accuracy considerably improved Example: G2-1 test set (Atomization Energies) kcal/mol MAD RMSD MSD maxad minad Old HGH NLCC-HGH PAW Paier AE (geopt) AE accuracy for quantities in different environments Bond lengths, Pressure (Bulk systems), Dispersion-corrected interaction energies,...

33 file (as psppar.n) run No need if you use LDA or PBE functionals Default pseudopotentials inside! Put in the same directory as the calculation. Large library: Accurate and transferable

34 Performing a DFT calculation run A self-consistent equation ρ(r) = Ψ i (r)ψ i (r), where ψ i satisfies i ( 12 ) 2 + V H [ρ] + V xc [ρ] + V ext + V pseudo ψ i = E i ψ i, (Kohn-Sham) DFT Ingredients A basis set for expressing the ψ i An potential, functional of the density several approximations exists (LDA,GGA,... ) A choice of the pseudopotential (if not all-electrons) (norm conserving, ultrasoft, PAW,... ) An (iterative) algorithm for finding the wavefunctions ψ i A (good) computer...

35 Exchange-Correlation Energy (input.dft) E xc [ρ] = K exact [ρ] K KS [ρ] + V e e exact [ρ] V Hartree [ρ] run K KS [ρ]: Kinetic energy for a non-interaction electron gas Kohn-Sham formalism is exact (mapping of an interacting electron system into a non-interacting system) Many types from ABINIT: Use same codes (ixc: LDA=1, PBE=11, see manual) lib: code for exchange code for correlation ( see manual) Hybrid functionals from lib

36 Performing a DFT calculation run A self-consistent equation ρ(r) = Ψ i (r)ψ i (r), where ψ i satisfies i ( 12 ) 2 + V H [ρ] + V xc [ρ] + V ext + V pseudo ψ i = E i ψ i, (Kohn-Sham) DFT Ingredients A basis set for expressing the ψ i An potential, functional of the density several approximations exists (LDA,GGA,... ) A choice of the pseudopotential (if not all-electrons) (norm conserving, ultrasoft, PAW,... ) An (iterative) algorithm for finding the wavefunctions ψ i A (good) computer...

37 Kohn-Sham Equations: Operators Apply different operators run Having a one-electron hamiltonian in a mean field. [ 1 ] V eff (r)(r) ψ i = ε i ψ i V eff (r) = V ext (r) + V ρ(r ) r r dr + µ xc (r) E[ρ] can be expressed by the orthonormalized states of one particule: ψ i (r) with the fractional occupancy number f i (0 f i 1) : ρ(r) = f i ψ i (r) 2 i

38 Kohn-Sham Equations: Computing Energies Calculate different integrals E[ρ] = K [ρ] + U[ρ] run U[ρ] = K [ρ] = m e i V dr f iψ i 2 ψ i dr V ext(r)ρ(r)+ 1 ρ(r)ρ(r ) dr dr V 2 V r r }{{} Hartree We minimise with the variables ψ i (r) and f i with the constraint dr ρ(r) = N el. V + E xc [ρ] }{{} exchange correlation

39 KS Equations: Self-Consistent Field Set of self-consistent equations: { 1 } V eff ψ i = ε i ψ i 2 m e run with an effective potential: V eff (r) = V ext (r)+ ) dr ρ(r V r r }{{} Hartree δe xc + δρ(r) }{{} exchange correlation and: ρ(r) = 2 i f i ψ i (r) 2

40 KS Equations: Self-Consistent Field Set of self-consistent equations: { 1 } V eff ψ i = ε i ψ i 2 m e run with an effective potential: V eff (r) = V ext (r)+ ) dr ρ(r V r r }{{} Hartree δe xc + δρ(r) }{{} exchange correlation and: ρ(r) = 2 i f i ψ i (r) 2 Poisson Equation: V Hartree = ρ (Laplacian: = 2 x y z 2 )

41 KS Equations: Self-Consistent Field Set of self-consistent equations: { 1 } V eff ψ i = ε i ψ i 2 m e run with an effective potential: V eff (r) = V ext (r)+ ) dr ρ(r V r r }{{} Hartree δe xc + δρ(r) }{{} exchange correlation and: ρ(r) = 2 i f i ψ i (r) 2 Poisson Equation: V Hartree = ρ (Laplacian: = 2 x y z 2 )

42 KS Equations: Self-Consistent Field Set of self-consistent equations: { 1 } V eff ψ i = ε i ψ i 2 m e run with an effective potential: V eff (r) = V ext (r)+ ) dr ρ(r V r r }{{} Hartree δe xc + δρ(r) }{{} exchange correlation and: ρ(r) = 2 i f i ψ i (r) 2 Poisson Equation: V Hartree = ρ (Laplacian: = 2 x y z 2 )

43 KS Equations: Self-Consistent Field Set of self-consistent equations: { 1 } V eff ψ i = ε i ψ i 2 m e run with an effective potential: V eff (r) = V ext (r)+ ) dr ρ(r V r r }{{} Hartree δe xc + δρ(r) }{{} exchange correlation and: ρ(r) = 2 i f i ψ i (r) 2 Poisson Equation: V Hartree = ρ (Laplacian: = 2 x y z 2 )

44 KS Equations: Self-Consistent Field Set of self-consistent equations: { 1 } V eff ψ i = ε i ψ i 2 m e run with an effective potential: V eff (r) = V ext (r)+ ) dr ρ(r V r r }{{} Hartree δe xc + δρ(r) }{{} exchange correlation and: ρ(r) = 2 i f i ψ i (r) 2 Poisson Equation: V Hartree = ρ (Laplacian: = 2 x y z 2 )

45 Direct Minimisation: Flowchart { } ψ i = caφ i a a Basis: adaptive mesh (0,...,N φ ) Orthonormalized run

46 Direct Minimisation: Flowchart { } ψ i = caφ i a a inv FWT + Magic Filter Basis: adaptive mesh (0,...,N φ ) Orthonormalized occ ρ(r) = i ψ i (r) 2 Fine non-adaptive mesh: < 8N φ run

47 Direct Minimisation: Flowchart { } ψ i = caφ i a a inv FWT + Magic Filter Basis: adaptive mesh (0,...,N φ ) Orthonormalized run occ ρ(r) = i ψ i (r) 2 Fine non-adaptive mesh: < 8N φ Poisson solver V H (r) = V xc [ρ(r)] G(.)ρ V NL ({ψ i }) V effective

48 Direct Minimisation: Flowchart { } ψ i = caφ i a a inv FWT + Magic Filter Basis: adaptive mesh (0,...,N φ ) Orthonormalized run occ ρ(r) = i ψ i (r) 2 Fine non-adaptive mesh: < 8N φ Poisson solver V H (r) = V xc [ρ(r)] G(.)ρ V NL ({ψ i }) V effective Kinetic Term

49 Direct Minimisation: Flowchart { } ψ i = caφ i a a inv FWT + Magic Filter Basis: adaptive mesh (0,...,N φ ) Orthonormalized run occ ρ(r) = i ψ i (r) 2 Fine non-adaptive mesh: < 8N φ Poisson solver V H (r) = V xc [ρ(r)] G(.)ρ V NL ({ψ i }) FWT FWT δca i = E total c i (a) + Λ ij ca j j V effective Kinetic Term Λ ij =< ψ i H ψ j >

50 Direct Minimisation: Flowchart { } ψ i = caφ i a a inv FWT + Magic Filter Basis: adaptive mesh (0,...,N φ ) Orthonormalized run occ ρ(r) = i ψ i (r) 2 Fine non-adaptive mesh: < 8N φ Poisson solver V H (r) = V xc [ρ(r)] G(.)ρ V NL ({ψ i }) FWT δca i = E total c i (a) + Λ ij ca j j c new,i a FWT preconditioning = c i a + h step δc i a V effective Kinetic Term Λ ij =< ψ i H ψ j > Steepest Descent, DIIS

51 Direct Minimisation: Flowchart { } ψ i = caφ i a a inv FWT + Magic Filter Basis: adaptive mesh (0,...,N φ ) Orthonormalized run occ ρ(r) = i ψ i (r) 2 Fine non-adaptive mesh: < 8N φ Poisson solver V H (r) = V xc [ρ(r)] G(.)ρ V NL ({ψ i }) FWT Stop when δc i a small δca i = E total c i (a) + Λ ij ca j j c new,i a FWT preconditioning = c i a + h step δc i a V effective Kinetic Term Λ ij =< ψ i H ψ j > Steepest Descent, DIIS

52 input.dft: idsx DIIS history Use DIIS algorithm Direct Inversion in the Iterative Subspace run Use idsx=6 previous iterations Memory-consuming (decrease if too big) Steepest descent if idsx=0 itermax=50 Specify maximum number of iterations Typically 15 iterations to converge gnrm_cv=1.e-4 convergence criterion Residue δψ 2 < gnrm_cv

53 Description of the file input.dft run hx, hy, hz crmult, frmult, coarse and fine radius 1 ixc: parameter (LDA=1,PBE=11) ncharge: charge of the system, Electric field 1 0 nspin=1 non-spin polarization, total magnetic moment 1.E-04 gnrm_cv: convergence criterion gradient itermax, nrepmax 7 6 # CG (preconditioning), length of diis history 0 dispersion correction functional (0, 1, 2, 3) InputPsiId, output_wf, output_grid length of the tail, # tail CG iterations davidson treatment, # virtual orbitals, # plotted orbitals T disable the symmetry detection

54 Description of the file input.dft run hx, hy, hz crmult, frmult, coarse and fine radius 1 ixc: parameter (LDA=1,PBE=11) ncharge: charge of the system, Electric field 1 0 nspin=1 non-spin polarization, total magnetic moment 1.E-04 gnrm_cv: convergence criterion gradient itermax, nrepmax 7 6 # CG (preconditioning), length of diis history 0 dispersion correction functional (0, 1, 2, 3) InputPsiId, output_wf, output_grid length of the tail, # tail CG iterations davidson treatment, # virtual orbitals, # plotted orbitals T disable the symmetry detection

55 Description of the file input.dft run hx, hy, hz crmult, frmult, coarse and fine radius 1 ixc: parameter (LDA=1,PBE=11) ncharge: charge of the system, Electric field 1 0 nspin=1 non-spin polarization, total magnetic moment 1.E-04 gnrm_cv: convergence criterion gradient itermax, nrepmax 7 6 # CG (preconditioning), length of diis history 0 dispersion correction functional (0, 1, 2, 3) InputPsiId, output_wf, output_grid length of the tail, # tail CG iterations davidson treatment, # virtual orbitals, # plotted orbitals T disable the symmetry detection

56 Description of the file input.dft run hx, hy, hz crmult, frmult, coarse and fine radius 1 ixc: parameter (LDA=1,PBE=11) ncharge: charge of the system, Electric field 1 0 nspin=1 non-spin polarization, total magnetic moment 1.E-04 gnrm_cv: convergence criterion gradient itermax, nrepmax 7 6 # CG (preconditioning), length of diis history 0 dispersion correction functional (0, 1, 2, 3) InputPsiId, output_wf, output_grid length of the tail, # tail CG iterations davidson treatment, # virtual orbitals, # plotted orbitals T disable the symmetry detection

57 Description of the file input.dft run hx, hy, hz crmult, frmult, coarse and fine radius 1 ixc: parameter (LDA=1,PBE=11) ncharge: charge of the system, Electric field 1 0 nspin=1 non-spin polarization, total magnetic moment 1.E-04 gnrm_cv: convergence criterion gradient itermax, nrepmax 7 6 # CG (preconditioning), length of diis history 0 dispersion correction functional (0, 1, 2, 3) InputPsiId, output_wf, output_grid length of the tail, # tail CG iterations davidson treatment, # virtual orbitals, # plotted orbitals T disable the symmetry detection

58 Description of the file input.dft run hx, hy, hz crmult, frmult, coarse and fine radius 1 ixc: parameter (LDA=1,PBE=11) ncharge: charge of the system, Electric field 1 0 nspin=1 non-spin polarization, total magnetic moment 1.E-04 gnrm_cv: convergence criterion gradient itermax, nrepmax 7 6 # CG (preconditioning), length of diis history 0 dispersion correction functional (0, 1, 2, 3) InputPsiId, output_wf, output_grid length of the tail, # tail CG iterations davidson treatment, # virtual orbitals, # plotted orbitals T disable the symmetry detection

59 Description of the file input.dft run hx, hy, hz crmult, frmult, coarse and fine radius 1 ixc: parameter (LDA=1,PBE=11) ncharge: charge of the system, Electric field 1 0 nspin=1 non-spin polarization, total magnetic moment 1.E-04 gnrm_cv: convergence criterion gradient itermax, nrepmax 7 6 # CG (preconditioning), length of diis history 0 dispersion correction functional (0, 1, 2, 3) InputPsiId, output_wf, output_grid length of the tail, # tail CG iterations davidson treatment, # virtual orbitals, # plotted orbitals T disable the symmetry detection

60 Description of the file input.dft run hx, hy, hz crmult, frmult, coarse and fine radius 1 ixc: parameter (LDA=1,PBE=11) ncharge: charge of the system, Electric field 1 0 nspin=1 non-spin polarization, total magnetic moment 1.E-04 gnrm_cv: convergence criterion gradient itermax, nrepmax 7 6 # CG (preconditioning), length of diis history 0 dispersion correction functional (0, 1, 2, 3) InputPsiId, output_wf, output_grid length of the tail, # tail CG iterations davidson treatment, # virtual orbitals, # plotted orbitals T disable the symmetry detection

61 Description of the file input.dft run hx, hy, hz crmult, frmult, coarse and fine radius 1 ixc: parameter (LDA=1,PBE=11) ncharge: charge of the system, Electric field 1 0 nspin=1 non-spin polarization, total magnetic moment 1.E-04 gnrm_cv: convergence criterion gradient itermax, nrepmax 7 6 # CG (preconditioning), length of diis history 0 dispersion correction functional (0, 1, 2, 3) InputPsiId, output_wf, output_grid length of the tail, # tail CG iterations davidson treatment, # virtual orbitals, # plotted orbitals T disable the symmetry detection

62 Description of the file input.dft run hx, hy, hz crmult, frmult, coarse and fine radius 1 ixc: parameter (LDA=1,PBE=11) ncharge: charge of the system, Electric field 1 0 nspin=1 non-spin polarization, total magnetic moment 1.E-04 gnrm_cv: convergence criterion gradient itermax, nrepmax 7 6 # CG (preconditioning), length of diis history 0 dispersion correction functional (0, 1, 2, 3) InputPsiId, output_wf, output_grid length of the tail, # tail CG iterations davidson treatment, # virtual orbitals, # plotted orbitals T disable the symmetry detection

63 Description of the file input.dft run hx, hy, hz crmult, frmult, coarse and fine radius 1 ixc: parameter (LDA=1,PBE=11) ncharge: charge of the system, Electric field 1 0 nspin=1 non-spin polarization, total magnetic moment 1.E-04 gnrm_cv: convergence criterion gradient itermax, nrepmax 7 6 # CG (preconditioning), length of diis history 0 dispersion correction functional (0, 1, 2, 3) InputPsiId, output_wf, output_grid length of the tail, # tail CG iterations davidson treatment, # virtual orbitals, # plotted orbitals T disable the symmetry detection

64 Description of the file input.dft run hx, hy, hz crmult, frmult, coarse and fine radius 1 ixc: parameter (LDA=1,PBE=11) ncharge: charge of the system, Electric field 1 0 nspin=1 non-spin polarization, total magnetic moment 1.E-04 gnrm_cv: convergence criterion gradient itermax, nrepmax 7 6 # CG (preconditioning), length of diis history 0 dispersion correction functional (0, 1, 2, 3) InputPsiId, output_wf, output_grid length of the tail, # tail CG iterations davidson treatment, # virtual orbitals, # plotted orbitals T disable the symmetry detection

65 s: wavelets self-consistent (SCF) Harris-Foulkes functional relativistic pseudopotential norm-conserving all electrons PAW Hybrid functionals beyond LDA GW run non-relativistic [ N 3 scaling O(N) methods periodic non-periodic non-collinear collinear +V(r) non-spin polarized spin polarized LDA,GGA ] +µ xc (r) ψ k i = ε k i ψ k i atomic orbitals plane waves augmented real space LDA+U Gaussians Slater numerical finite difference Wavelet

66 Optimal for isolated systems 10 1 Test case: cinchonidine molecule (44 atoms) Plane waves run Absolute energy precision (Ha) h = 0.4bohr E c = 40 Ha h = 0.3bohr Wavelets E c = 90 Ha Number of degrees of freedom E c = 125 Ha Allows a systematic approach for molecules Considerably faster than Plane Waves codes. 10 (5) times faster than ABINIT (CPMD) Charged systems can be treated explicitly with the same time

67 Systematic basis set Two parameters for tuning the basis The grid spacing hgrid The extension of the low resolution points crmult run

68 Comparison with a code based on gaussian basis set The Daubechies expansion of a gaussian is known Results from gaussian codes can be imported in Gaussian code (CP2K) test, H 2 O and DZVP basis E [Ha] Input Guess Energy run CP2K Imported energy 6-31G Conv energy converged energy Wavelet Conv energy with finite-size corrections crmult (basis extension)

69 using interpolating scaling function The Hartree potential is calculated in the interpolating scaling function basis. Poisson solver with interpolating scaling functions From the density ρ( j) on an uniform grid it calculates: run ρ(r ) V H (r) = r r dr Very fast and accurate, optimal parallelization Can be used independently from the DFT code Integrated quantities (energies) are easy to extract Non-adaptive, needs data uncompression Explicitly free boundary conditions No need to subtract supercell interactions (charged systems).

70 for surface boundary conditions A Poisson solver for surface problems Based on a mixed reciprocal-direct space representation V px,p y (z) = 4π dz G( p ;z z )ρ px,p y (z), run Can be applied both in real or reciprocal space codes No supercell or screening functions More precise than other existing approaches Example of the plane capacitor: Periodic Hockney Our approach V V V y y y x z z

71 input.geopt: or molecular dynamics run DIIS 500 ncount_cluster: max steps during geometry relaxation 1.d0 1.d-3 frac_fluct: geometry optimization stops if force norm less than frac_fluct of noise maxval: maximum value of atomic forces 0.0d0 randdis: random amplitude for atoms 4.d0 5 betax: steepest descent step size, diis history Different algorithms: SDCG: Steepest Descent Conjugate Gradient DIIS: Direct Inversion in the iterative subspace VSSD: Variable Size Steepest Descent LBFGS: Limited BFGD AB6MD: Use molecular dynamics routines from ABINIT 6

72 input.geopt: or molecular dynamics run DIIS 500 ncount_cluster: max steps during geometry relaxation 1.d0 1.d-3 frac_fluct: geometry optimization stops if force norm less than frac_fluct of noise maxval: maximum value of atomic forces 0.0d0 randdis: random amplitude for atoms 4.d0 5 betax: steepest descent step size, diis history Different algorithms: SDCG: Steepest Descent Conjugate Gradient DIIS: Direct Inversion in the iterative subspace VSSD: Variable Size Steepest Descent LBFGS: Limited BFGD AB6MD: Use molecular dynamics routines from ABINIT 6

73 input.geopt: or molecular dynamics run DIIS 500 ncount_cluster: max steps during geometry relaxation 1.d0 1.d-3 frac_fluct: geometry optimization stops if force norm less than frac_fluct of noise maxval: maximum value of atomic forces 0.0d0 randdis: random amplitude for atoms 4.d0 5 betax: steepest descent step size, diis history Different algorithms: SDCG: Steepest Descent Conjugate Gradient DIIS: Direct Inversion in the iterative subspace VSSD: Variable Size Steepest Descent LBFGS: Limited BFGD AB6MD: Use molecular dynamics routines from ABINIT 6

74 input.geopt: or molecular dynamics run DIIS 500 ncount_cluster: max steps during geometry relaxation 1.d0 1.d-3 frac_fluct: geometry optimization stops if force norm less than frac_fluct of noise maxval: maximum value of atomic forces 0.0d0 randdis: random amplitude for atoms 4.d0 5 betax: steepest descent step size, diis history Different algorithms: SDCG: Steepest Descent Conjugate Gradient DIIS: Direct Inversion in the iterative subspace VSSD: Variable Size Steepest Descent LBFGS: Limited BFGD AB6MD: Use molecular dynamics routines from ABINIT 6

75 input.geopt: or molecular dynamics run DIIS 500 ncount_cluster: max steps during geometry relaxation 1.d0 1.d-3 frac_fluct: geometry optimization stops if force norm less than frac_fluct of noise maxval: maximum value of atomic forces 0.0d0 randdis: random amplitude for atoms 4.d0 5 betax: steepest descent step size, diis history Different algorithms: SDCG: Steepest Descent Conjugate Gradient DIIS: Direct Inversion in the iterative subspace VSSD: Variable Size Steepest Descent LBFGS: Limited BFGD AB6MD: Use molecular dynamics routines from ABINIT 6

76 input.geopt: or molecular dynamics run DIIS 500 ncount_cluster: max steps during geometry relaxation 1.d0 1.d-3 frac_fluct: geometry optimization stops if force norm less than frac_fluct of noise maxval: maximum value of atomic forces 0.0d0 randdis: random amplitude for atoms 4.d0 5 betax: steepest descent step size, diis history Different algorithms: SDCG: Steepest Descent Conjugate Gradient DIIS: Direct Inversion in the iterative subspace VSSD: Variable Size Steepest Descent LBFGS: Limited BFGD AB6MD: Use molecular dynamics routines from ABINIT 6

77 High-Performance Computing: Massively parallel Two kinds of parallelisation By orbitals (Hamiltonian application, preconditioning) By components (overlap matrices, orthogonalisation) run A few (but big) packets of data More demanding in bandwidth than in latency No need of fast network Optimal speedup (eff. 85%), also for big systems Cubic scaling code For systems bigger than 500 atomes (1500 orbitals) : orthonormalisation operation is predominant (N 3 )

78 Orbital distribution scheme Used for the application of the hamiltonian The hamiltonian (convolutions) is applied separately onto each wavefunction run ψ 1 MPI 0 ψ 2 ψ 3 ψ 4 MPI 1 ψ 5 MPI 2

79 Coefficient distribution scheme Used for scalar product & orthonormalisation BLAS routines (level 3) are called, then result is reduced MPI 0 MPI 1 MPI 2 ψ 1 run ψ 2 ψ 3 ψ 4 ψ 5 Communications are performed via MPI_ALLTOALLV

80 Performance in parallel () run Distribution per orbitals (wavelets) Nothing to specify in input files

81 GPU-ported operations in (double precision) 20 run Convolutions (OpenCL rewritten) GPU speedups between and 20 can be 6 obtained for different 4 sections 2 70 GPU speedup (Double prec.) locden locham precond Wavefunction size (MB) GPU speedup (Double prec.) DGEMM DSYRK Number of orbitals Linear algebra (CUBLAS library) The interfacing with CUBLAS is immediate, with considerable speedups

82 code on Hybrid architectures code can run on hybrid CPU/GPU supercomputers In multi-gpu environments, double precision calculations run No Hot-spot operations Different code sections can be ported on GPU up to 20x speedup for some operations, 7x for the full parallel code Percent Seconds (log. scale) CPU code Hybrid code (rel.) Number of cores 1 Time (sec) Comm Other PureCPU precond locham locden LinAlg

83 input.perf file OpenCL acceleration: Add this line in in input.perf accel OCLGPU run See the web page /Wiki/index.php?title=Input.perf for more information about all keywords (verbosity, input guess,...) associated to the performance of the code. The log file gives the list of possible keywords.

84 : Future developments self-consistent (SCF) Harris-Foulkes functional relativistic pseudopotential norm-conserving all electrons PAW Hybrid functionals beyond LDA GW run non-relativistic [ N 3 scaling O(N) methods periodic non-periodic non-collinear collinear +V(r) non-spin polarized spin polarized LDA,GGA ] +µ xc (r) ψ k i = ε k i ψ k i atomic orbitals plane waves augmented real space LDA+U Gaussians Slater numerical finite difference Wavelet

85 Linear scaling version (order N) run 16 min of CPU time: 1000 atoms with the cubic scaling, 8000 atoms with the linear scaling one

86 Localization regions (L. Ratcliff, P. Boulanger) Wavelets have compact support The behaviour of large systems is short-ranged Wavelets are ideal to implement nearsightedness principle The hamiltonian can be expressed analytically We can adapt the basis based on system s properties run Reduce DoF The domain can be partitioned in localization regions What about KS orbitals?

87 Improving the locality of the description Localized description of the system KS orbitals expressed by adaptive support functions: Ψ i (r) = α c α i φ α (r) With φ α given in wavelets on the localization regions We can therefore optimize both c α i and φ α, e.g. as in ONETEP, Conquest, SIESTA... or. run Localized form for the Density and the Hamiltonian ρ(r) = i f i Ψ i (r)ψ i (r) = α,β φ α (r)k αβ φ β (r) H = α,β φ α (r)h αβ φ β (r)

88 Overall scheme run Initial Guess: Atomic Orbitals Basis optimization: or Kernel Optimization: Diagonalize Hamiltonian Update potential Forces: Derivative basis functions Two-step optimization scheme The φ α minimize the trace of a confining KS hamiltionian Coefficients minimize KS energy High quality results Good precision No need of Pulay forces due to basis completeness!

89 : Results and performances run Nearsightedness and wavelets: it works (very) well! Convergence is not altered by system size is physically meaningful KS operators are expressed in this basis without truncation close to completeness Different schemes can be implemented with this basis set: O(N), embedding, QM/MM, TB,... Considerable gain 30 Example: 256 MPI tasks 20 Crossover point at few 10 hundred atoms 0 Lower with Geometry 8 6 optimization (easier 4 2 restart) 0 Time (min) Memory (GB) Cubic Total Lin. Alg. Total - Lin. Alg. Cubic Peak Mem. Peak Mem Number of atoms

90 Accuracy for sample systems Energy and forces with accuracy of systematic approach! run Energy (Ha) Forces (Ha/bohr) Linear Cubic (L - C)/at Linear Cubic Av(L - C) C300 H H2 O C19 H22 N2 O B Laboratoire de Simulation Atomistique Thierry Deutsch

91 Charged systems Basis represents physical degrees of freedom -SCF straightforwardly implemented in this formalism Increasing chain length of ladder polythiophene run abs(e - E cubic ) (ev) E (ev) E -2 - E 0 E -2 E 0 E +2 E 0 - E Charge state opt. unopt Number of atoms HOMO (E 0 - E +2 )/2 LUMO (E -2 - E 0 )/2 Charge-Constrained DFT is under implementation

92 What about wavelets for Post-DFT (excited states)? Initial work: excited states in isolated systems Free boundary conditions are explicitly implemented The number of interesting states increases with the simulation domain (continuum collapse) run Problem in TD-DFT and GW for large isolated systems Resolvent reads # bound states G(ω) = Density of states Plane Waves i= Energy (ev) Exact DOS N=780 N=1020 N=1320 Density of states ψ i )(ψ i ω E i + dk ψ k )(ψ k ω E k Gaussians Exact DOS DZP, N=780 TZP, N=1020 TZDP, N= Energy (ev) Sum Over States is out of reach... or not?

93 Resonant States: Motivation run Simplest example: cross section computation A function of the resolvent: S(ω) = 1 π Im ψ 0 Ô G(ω)Ô ψ 0 Strength Function ω exact 1st res. 2nd res. other Im[ E i ] Re[ E i ] Is it possible to associate to each peak a state discrete (metastable), physically justified?... Yes, but...

94 The complex scaling allows this! run Resonant States Rigorous definition of the Green s function: G(ω) = i ψ i )(ψ i ω E i + # res. states ψ r )(ψ r +... r=1 ω E r Complex energy The resonant states explode! The interesting states are not in L 2 space (norm not finite) The complex scaling Balslev-Combes Theorem Commun. Math. Phys. 22, 280 (1971) x x e iθ Ĥ Ĥ θ e 2iθ V(xe iθ ) With this transformation (some) resonant states become L 2! So far a big problem Not possible for numerical (e.g. DFT) potentials!

95 Complex Scaling Method in Wavelets Re[ V ( x e iθ, y e iθ, z = 0 ) ] run Recent work arxiv: Wavelets for complex scaling Can scale any 3D ab-initio (numerical) potential Provide the results on a numerical grid Very high precision Ongoing work A important bottleneck has been removed x Im[ V ( x e iθ, y e iθ, z = 0 ) ] x [S θ V ]( x ) - V ( x e iθ ) 10 y 10 y extraction procedure Usage in conjunction with φ α x y

96 Extracting information coming from resonant states run Density of states Plane Waves Energy (ev) Density of states Exact DOS N=780 N=1020 N=1320 Density of states Resonant States Exact DOS Eigenvalues N= Energy (ev) A meaningful one-particle excitations basis Gaussians Exact DOS DZP, N=780 TZP, N=1020 TZDP, N= Energy (ev) Unified description of bounds and metastable states Encode system s physical (metastable) excitations Appear as eigenstates of a complex-rotated hamiltonian Im Energy (ev)

97 Outlook run Interest - driven developments Unprecedented reliability for some approaches new things can be done Wavelet properties open new investigation directions: Traditional DFT functionalities have been implemented... and counting... The formalism is explicit and simplifies some approaches A different way of thinking to a development problem Future directions Improve locality of big systems (embedding QM/QM, use of Tight-Binding method) Usage of θ-resonant states for electronic properties Not to mention involvement...

98 Functionality: Mixed between physics and chemistry approach (real space basis set as wavelets) run Multi-scale approach (more than 1000 atoms feasible for a better parametrization) Beyond DFT (TD-DFT and GW methods with the resonant states) Numerical experience: One-day simulation Better exploration of atomic configurations Molecular Dynamics (4s per step for 32 water molecules)

99 Acknowledgments run Main maintainer Luigi Genovese Group of Stefan Goedecker A. Ghazemi, A. Willand, S. De, A. Sadeghi, N. Dugan (Basel University) Link with ABINIT and bindings Damien Caliste (CEA-Grenoble) methods S. Mohr, L. Ratcliff, P. Boulanger (Néel Institute, CNRS) Exploring the PES N. Mousseau (Montreal University) A. Cerioni, A. Mirone (ESRF, Grenoble), I. Duchemin (CEA) Optimized convolutions B. Videau (LIG, computer scientist, Grenoble) Applications P. Pochet, E. Machado, S. Krishnan, D. Timerkaeva (CEA-Grenoble)

100 Hands on run See /Wiki/index.php?title=Category:Tutorials First runs with Basis-set convergence Acceleration example on different platforms: Kohn-Sham DFT Operation with GPU acceleration

BigDFT tutorial. BigDFT tutorial FIRST YARMOUK SCHOOL. Thierry Deutsch. November, L_Sim - CEA Grenoble. Introduction DFT.

BigDFT tutorial. BigDFT tutorial FIRST YARMOUK SCHOOL. Thierry Deutsch. November, L_Sim - CEA Grenoble. Introduction DFT. Big tutorial FIRST YARMOUK SCHOOL Big tutorial Thierry Deutsch L_Sim - CEA Grenoble November, 2. 2010 Outline 1 2 Density Functional Theory (quick view) 3 4 A basis for nanosciences: the Big project STREP

More information

Electronic Structure Calculations, Density Functional Theory and its Modern Implementations

Electronic Structure Calculations, Density Functional Theory and its Modern Implementations Tutoriel Big RENOBLE Electronic Structure Calculations, Density Functional Theory and its Modern Implementations Thierry Deutsch L_Sim - CEA renoble 19 October 2011 Outline 1 of Atomistic calculations

More information

Poisson Solver, Pseudopotentials, Atomic Forces in the BigDFT code

Poisson Solver, Pseudopotentials, Atomic Forces in the BigDFT code CECAM Tutorial on Wavelets in DFT, CECAM - LYON,, in the BigDFT code Kernel Luigi Genovese L_Sim - CEA Grenoble 28 November 2007 Outline, Kernel 1 The with Interpolating Scaling Functions in DFT for Interpolating

More information

Adaptive and Localized Basis Functions for Linear Scaling, Large Systems and Complex QM Simulations

Adaptive and Localized Basis Functions for Linear Scaling, Large Systems and Complex QM Simulations Max Conference on the Materials Design Ecosystem at the Exascale: High-Performance and High-Throughput Computing TRIESTE Adaptive and Localized Basis Functions for Linear Scaling, Large Systems and Complex

More information

Wavelets for density functional calculations: Four families and three. applications

Wavelets for density functional calculations: Four families and three. applications Wavelets for density functional calculations: Four families and three Haar wavelets Daubechies wavelets: BigDFT code applications Stefan Goedecker Stefan.Goedecker@unibas.ch http://comphys.unibas.ch/ Interpolating

More information

Opportunities from Accurate and Efficient Density Functional Theory Calculations for Large Systems

Opportunities from Accurate and Efficient Density Functional Theory Calculations for Large Systems Seminar CENTRE FOR PREDICTIVE MODELLING, WARWICK Opportunities from Accurate and Efficient Density Functional Theory Calculations for Large Systems Luigi Genovese L_Sim CEA Grenoble October 30, 2017 http://bigdft.org

More information

Accuracy benchmarking of DFT results, domain libraries for electrostatics, hybrid functional and solvation

Accuracy benchmarking of DFT results, domain libraries for electrostatics, hybrid functional and solvation Accuracy benchmarking of DFT results, domain libraries for electrostatics, hybrid functional and solvation Stefan Goedecker Stefan.Goedecker@unibas.ch http://comphys.unibas.ch/ Multi-wavelets: High accuracy

More information

ELECTRONIC STRUCTURE CALCULATIONS FOR THE SOLID STATE PHYSICS

ELECTRONIC STRUCTURE CALCULATIONS FOR THE SOLID STATE PHYSICS FROM RESEARCH TO INDUSTRY 32 ème forum ORAP 10 octobre 2013 Maison de la Simulation, Saclay, France ELECTRONIC STRUCTURE CALCULATIONS FOR THE SOLID STATE PHYSICS APPLICATION ON HPC, BLOCKING POINTS, Marc

More information

Daubechies wavelets as a basis set for density functional pseudopotential calculations

Daubechies wavelets as a basis set for density functional pseudopotential calculations Daubechies wavelets as a basis set for density functional pseudopotential calculations Luigi Genovese, Alexey Neelov, 2 Stefan Goedecker, 2 Thierry Deutsch, Seyed Alireza Ghasemi, 2 Alexander Willand,

More information

Pseudopotentials for hybrid density functionals and SCAN

Pseudopotentials for hybrid density functionals and SCAN Pseudopotentials for hybrid density functionals and SCAN Jing Yang, Liang Z. Tan, Julian Gebhardt, and Andrew M. Rappe Department of Chemistry University of Pennsylvania Why do we need pseudopotentials?

More information

Exchange Correlation Functional Investigation of RT-TDDFT on a Sodium Chloride. Dimer. Philip Straughn

Exchange Correlation Functional Investigation of RT-TDDFT on a Sodium Chloride. Dimer. Philip Straughn Exchange Correlation Functional Investigation of RT-TDDFT on a Sodium Chloride Dimer Philip Straughn Abstract Charge transfer between Na and Cl ions is an important problem in physical chemistry. However,

More information

DFT and beyond: Hands-on Tutorial Workshop Tutorial 1: Basics of Electronic Structure Theory

DFT and beyond: Hands-on Tutorial Workshop Tutorial 1: Basics of Electronic Structure Theory DFT and beyond: Hands-on Tutorial Workshop 2011 Tutorial 1: Basics of Electronic Structure Theory V. Atalla, O. T. Hofmann, S. V. Levchenko Theory Department, Fritz-Haber-Institut der MPG Berlin July 13,

More information

Time-Dependent Density-Functional Theory

Time-Dependent Density-Functional Theory Summer School on First Principles Calculations for Condensed Matter and Nanoscience August 21 September 3, 2005 Santa Barbara, California Time-Dependent Density-Functional Theory X. Gonze, Université Catholique

More information

ab initio Electronic Structure Calculations

ab initio Electronic Structure Calculations ab initio Electronic Structure Calculations New scalability frontiers using the BG/L Supercomputer C. Bekas, A. Curioni and W. Andreoni IBM, Zurich Research Laboratory Rueschlikon 8803, Switzerland ab

More information

DFT / SIESTA algorithms

DFT / SIESTA algorithms DFT / SIESTA algorithms Javier Junquera José M. Soler References http://siesta.icmab.es Documentation Tutorials Atomic units e = m e = =1 atomic mass unit = m e atomic length unit = 1 Bohr = 0.5292 Ang

More information

Algorithms and Computational Aspects of DFT Calculations

Algorithms and Computational Aspects of DFT Calculations Algorithms and Computational Aspects of DFT Calculations Part I Juan Meza and Chao Yang High Performance Computing Research Lawrence Berkeley National Laboratory IMA Tutorial Mathematical and Computational

More information

Fundamentals and applications of Density Functional Theory Astrid Marthinsen PhD candidate, Department of Materials Science and Engineering

Fundamentals and applications of Density Functional Theory Astrid Marthinsen PhD candidate, Department of Materials Science and Engineering Fundamentals and applications of Density Functional Theory Astrid Marthinsen PhD candidate, Department of Materials Science and Engineering Outline PART 1: Fundamentals of Density functional theory (DFT)

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

VASP: running on HPC resources. University of Vienna, Faculty of Physics and Center for Computational Materials Science, Vienna, Austria

VASP: running on HPC resources. University of Vienna, Faculty of Physics and Center for Computational Materials Science, Vienna, Austria VASP: running on HPC resources University of Vienna, Faculty of Physics and Center for Computational Materials Science, Vienna, Austria The Many-Body Schrödinger equation 0 @ 1 2 X i i + X i Ĥ (r 1,...,r

More information

Large Scale Electronic Structure Calculations

Large Scale Electronic Structure Calculations Large Scale Electronic Structure Calculations Jürg Hutter University of Zurich 8. September, 2008 / Speedup08 CP2K Program System GNU General Public License Community Developers Platform on "Berlios" (cp2k.berlios.de)

More information

Density Functional Theory. Martin Lüders Daresbury Laboratory

Density Functional Theory. Martin Lüders Daresbury Laboratory Density Functional Theory Martin Lüders Daresbury Laboratory Ab initio Calculations Hamiltonian: (without external fields, non-relativistic) impossible to solve exactly!! Electrons Nuclei Electron-Nuclei

More information

References. Documentation Manuals Tutorials Publications

References.   Documentation Manuals Tutorials Publications References http://siesta.icmab.es Documentation Manuals Tutorials Publications Atomic units e = m e = =1 atomic mass unit = m e atomic length unit = 1 Bohr = 0.5292 Ang atomic energy unit = 1 Hartree =

More information

Reinhold Schneider, MATHEON TU Berlin. Direct Minimization for effective single particle models (DFT)

Reinhold Schneider, MATHEON TU Berlin. Direct Minimization for effective single particle models (DFT) Direct Minimization for effective single particle models (DFT) Partners joint work with: J. Blauert, T. Rohwedder (TU Berlin), A. Neelov (U Basel) joint EU NEST project BigDFT together with Dr. Thierry

More information

Optimized energy landscape exploration for nanosciences using ab-initio based methods

Optimized energy landscape exploration for nanosciences using ab-initio based methods Optimized energy landscape exploration for nanosciences using ab-initio based methods Eduardo Machado-Charry Nanosciences Foundation & Laboratoire de simulation atomistique (L Sim), SP2M, UMR-E CEA-Grenoble

More information

Key concepts in Density Functional Theory (I) Silvana Botti

Key concepts in Density Functional Theory (I) Silvana Botti From the many body problem to the Kohn-Sham scheme European Theoretical Spectroscopy Facility (ETSF) CNRS - Laboratoire des Solides Irradiés Ecole Polytechnique, Palaiseau - France Temporary Address: Centre

More information

Density Functional Theory

Density Functional Theory Density Functional Theory Iain Bethune EPCC ibethune@epcc.ed.ac.uk Overview Background Classical Atomistic Simulation Essential Quantum Mechanics DFT: Approximations and Theory DFT: Implementation using

More information

Introduction to Density Functional Theory

Introduction to Density Functional Theory Introduction to Density Functional Theory S. Sharma Institut für Physik Karl-Franzens-Universität Graz, Austria 19th October 2005 Synopsis Motivation 1 Motivation : where can one use DFT 2 : 1 Elementary

More information

Density Functional Theory

Density Functional Theory Density Functional Theory March 26, 2009 ? DENSITY FUNCTIONAL THEORY is a method to successfully describe the behavior of atomic and molecular systems and is used for instance for: structural prediction

More information

Introduction to DFTB. Marcus Elstner. July 28, 2006

Introduction to DFTB. Marcus Elstner. July 28, 2006 Introduction to DFTB Marcus Elstner July 28, 2006 I. Non-selfconsistent solution of the KS equations DFT can treat up to 100 atoms in routine applications, sometimes even more and about several ps in MD

More information

Before we start: Important setup of your Computer

Before we start: Important setup of your Computer Before we start: Important setup of your Computer change directory: cd /afs/ictp/public/shared/smr2475./setup-config.sh logout login again 1 st Tutorial: The Basics of DFT Lydia Nemec and Oliver T. Hofmann

More information

Why use pseudo potentials?

Why use pseudo potentials? Pseudo potentials Why use pseudo potentials? Reduction of basis set size effective speedup of calculation Reduction of number of electrons reduces the number of degrees of freedom For example in Pt: 10

More information

Session 1. Introduction to Computational Chemistry. Computational (chemistry education) and/or (Computational chemistry) education

Session 1. Introduction to Computational Chemistry. Computational (chemistry education) and/or (Computational chemistry) education Session 1 Introduction to Computational Chemistry 1 Introduction to Computational Chemistry Computational (chemistry education) and/or (Computational chemistry) education First one: Use computational tools

More information

Spring College on Computational Nanoscience May Variational Principles, the Hellmann-Feynman Theorem, Density Functional Theor

Spring College on Computational Nanoscience May Variational Principles, the Hellmann-Feynman Theorem, Density Functional Theor 2145-25 Spring College on Computational Nanoscience 17-28 May 2010 Variational Principles, the Hellmann-Feynman Theorem, Density Functional Theor Stefano BARONI SISSA & CNR-IOM DEMOCRITOS Simulation Center

More information

arxiv: v1 [physics.comp-ph] 22 Nov 2012

arxiv: v1 [physics.comp-ph] 22 Nov 2012 A Customized 3D GPU Poisson Solver for Free BCs Nazim Dugan a, Luigi Genovese b, Stefan Goedecker a, a Department of Physics, University of Basel, Klingelbergstr. 82, 4056 Basel, Switzerland b Laboratoire

More information

Charge Analysis: Atoms in Molecules

Charge Analysis: Atoms in Molecules Daubechies Wavelets in Electronic Structure Calculation: BigDFT Code Tutorial CECAM - GRENOBLE : Atoms in Molecules Ali Sadeghi Basel University 21 November 2011 An output of electronic structure calculations

More information

Basis sets for SIESTA. Emilio Artacho. Nanogune, Ikerbasque & DIPC, San Sebastian, Spain Cavendish Laboratory, University of Cambridge

Basis sets for SIESTA. Emilio Artacho. Nanogune, Ikerbasque & DIPC, San Sebastian, Spain Cavendish Laboratory, University of Cambridge Basis sets for SIESTA Emilio Artacho Nanogune, Ikerbasque & DIPC, San Sebastian, Spain Cavendish Laboratory, University of Cambridge Solving: Basis set Expand in terms of a finite set of basis functions

More information

Pseudopotential generation and test by the ld1.x atomic code: an introduction

Pseudopotential generation and test by the ld1.x atomic code: an introduction and test by the ld1.x atomic code: an introduction SISSA and DEMOCRITOS Trieste (Italy) Outline 1 2 3 Spherical symmetry - I The Kohn and Sham (KS) equation is (in atomic units): [ 1 ] 2 2 + V ext (r)

More information

CP2K: the gaussian plane wave (GPW) method

CP2K: the gaussian plane wave (GPW) method CP2K: the gaussian plane wave (GPW) method Basis sets and Kohn-Sham energy calculation R. Vuilleumier Département de chimie Ecole normale supérieure Paris Tutorial CPMD-CP2K CPMD and CP2K CPMD CP2K http://www.cpmd.org

More information

Electron Correlation

Electron Correlation Electron Correlation Levels of QM Theory HΨ=EΨ Born-Oppenheimer approximation Nuclear equation: H n Ψ n =E n Ψ n Electronic equation: H e Ψ e =E e Ψ e Single determinant SCF Semi-empirical methods Correlation

More information

Computational Methods. Chem 561

Computational Methods. Chem 561 Computational Methods Chem 561 Lecture Outline 1. Ab initio methods a) HF SCF b) Post-HF methods 2. Density Functional Theory 3. Semiempirical methods 4. Molecular Mechanics Computational Chemistry " Computational

More information

Electronic structure calculations with GPAW. Jussi Enkovaara CSC IT Center for Science, Finland

Electronic structure calculations with GPAW. Jussi Enkovaara CSC IT Center for Science, Finland Electronic structure calculations with GPAW Jussi Enkovaara CSC IT Center for Science, Finland Basics of density-functional theory Density-functional theory Many-body Schrödinger equation Can be solved

More information

Computational Chemistry I

Computational Chemistry I Computational Chemistry I Text book Cramer: Essentials of Quantum Chemistry, Wiley (2 ed.) Chapter 3. Post Hartree-Fock methods (Cramer: chapter 7) There are many ways to improve the HF method. Most of

More information

The Linearized Augmented Planewave (LAPW) Method

The Linearized Augmented Planewave (LAPW) Method The Linearized Augmented Planewave (LAPW) Method David J. Singh Oak Ridge National Laboratory E T [ ]=T s [ ]+E ei [ ]+E H [ ]+E xc [ ]+E ii {T s +V ks [,r]} I (r)= i i (r) Need tools that are reliable

More information

Electronic band structure, sx-lda, Hybrid DFT, LDA+U and all that. Keith Refson STFC Rutherford Appleton Laboratory

Electronic band structure, sx-lda, Hybrid DFT, LDA+U and all that. Keith Refson STFC Rutherford Appleton Laboratory Electronic band structure, sx-lda, Hybrid DFT, LDA+U and all that Keith Refson STFC Rutherford Appleton Laboratory LDA/GGA DFT is good but... Naive LDA/GGA calculation severely underestimates band-gaps.

More information

The Plane-Wave Pseudopotential Method

The Plane-Wave Pseudopotential Method Hands-on Workshop on Density Functional Theory and Beyond: Computational Materials Science for Real Materials Trieste, August 6-15, 2013 The Plane-Wave Pseudopotential Method Ralph Gebauer ICTP, Trieste

More information

Module 6 1. Density functional theory

Module 6 1. Density functional theory Module 6 1. Density functional theory Updated May 12, 2016 B A DDFT C K A bird s-eye view of density-functional theory Authors: Klaus Capelle G http://arxiv.org/abs/cond-mat/0211443 R https://trac.cc.jyu.fi/projects/toolbox/wiki/dft

More information

Density Functional Theory - II part

Density Functional Theory - II part Density Functional Theory - II part antonino.polimeno@unipd.it Overview From theory to practice Implementation Functionals Local functionals Gradient Others From theory to practice From now on, if not

More information

All-electron density functional theory on Intel MIC: Elk

All-electron density functional theory on Intel MIC: Elk All-electron density functional theory on Intel MIC: Elk W. Scott Thornton, R.J. Harrison Abstract We present the results of the porting of the full potential linear augmented plane-wave solver, Elk [1],

More information

Direct Minimization in Density Functional Theory

Direct Minimization in Density Functional Theory Direct Minimization in Density Functional Theory FOCM Hongkong 2008 Partners joint paper with: J. Blauert, T. Rohwedder (TU Berlin), A. Neelov (U Basel) joint EU NEST project BigDFT together with Dr. Thierry

More information

A Green Function Method for Large Scale Electronic Structure Calculations. Rudolf Zeller

A Green Function Method for Large Scale Electronic Structure Calculations. Rudolf Zeller A Green Function Method for Large Scale Electronic Structure Calculations Rudolf Zeller Institute for Advanced Simulation, Forschungszentrum Jülich Electronic structure calculations (density functional

More information

1 Density functional theory (DFT)

1 Density functional theory (DFT) 1 Density functional theory (DFT) 1.1 Introduction Density functional theory is an alternative to ab initio methods for solving the nonrelativistic, time-independent Schrödinger equation H Φ = E Φ. The

More information

The Projector Augmented Wave method

The Projector Augmented Wave method The Projector Augmented Wave method Advantages of PAW. The theory. Approximations. Convergence. 1 The PAW method is... What is PAW? A technique for doing DFT calculations efficiently and accurately. An

More information

Chapter 3. The (L)APW+lo Method. 3.1 Choosing A Basis Set

Chapter 3. The (L)APW+lo Method. 3.1 Choosing A Basis Set Chapter 3 The (L)APW+lo Method 3.1 Choosing A Basis Set The Kohn-Sham equations (Eq. (2.17)) provide a formulation of how to practically find a solution to the Hohenberg-Kohn functional (Eq. (2.15)). Nevertheless

More information

2. TranSIESTA 1. SIESTA. DFT In a Nutshell. Introduction to SIESTA. Boundary Conditions: Open systems. Greens functions and charge density

2. TranSIESTA 1. SIESTA. DFT In a Nutshell. Introduction to SIESTA. Boundary Conditions: Open systems. Greens functions and charge density 1. SIESTA DFT In a Nutshell Introduction to SIESTA Atomic Orbitals Capabilities Resources 2. TranSIESTA Transport in the Nanoscale - motivation Boundary Conditions: Open systems Greens functions and charge

More information

Walter Kohn was awarded with the Nobel Prize in Chemistry in 1998 for his development of the density functional theory.

Walter Kohn was awarded with the Nobel Prize in Chemistry in 1998 for his development of the density functional theory. Walter Kohn was awarded with the Nobel Prize in Chemistry in 1998 for his development of the density functional theory. Walter Kohn receiving his Nobel Prize from His Majesty the King at the Stockholm

More information

Speed-up of ATK compared to

Speed-up of ATK compared to What s new @ Speed-up of ATK 2008.10 compared to 2008.02 System Speed-up Memory reduction Azafulleroid (molecule, 97 atoms) 1.1 15% 6x6x6 MgO (bulk, 432 atoms, Gamma point) 3.5 38% 6x6x6 MgO (k-point sampling

More information

MODULE 2: QUANTUM MECHANICS. Practice: Quantum ESPRESSO

MODULE 2: QUANTUM MECHANICS. Practice: Quantum ESPRESSO MODULE 2: QUANTUM MECHANICS Practice: Quantum ESPRESSO I. What is Quantum ESPRESSO? 2 DFT software PW-DFT, PP, US-PP, PAW http://www.quantum-espresso.org FREE PW-DFT, PP, PAW http://www.abinit.org FREE

More information

Orbital Density Dependent Functionals

Orbital Density Dependent Functionals Orbital Density Dependent Functionals S. Kluepfel1, P. Kluepfel1, Hildur Guðmundsdóttir1 and Hannes Jónsson1,2 1. Univ. of Iceland; 2. Aalto University Outline: Problems with GGA approximation (PBE, RPBE,...)

More information

SPARSE SOLVERS POISSON EQUATION. Margreet Nool. November 9, 2015 FOR THE. CWI, Multiscale Dynamics

SPARSE SOLVERS POISSON EQUATION. Margreet Nool. November 9, 2015 FOR THE. CWI, Multiscale Dynamics SPARSE SOLVERS FOR THE POISSON EQUATION Margreet Nool CWI, Multiscale Dynamics November 9, 2015 OUTLINE OF THIS TALK 1 FISHPACK, LAPACK, PARDISO 2 SYSTEM OVERVIEW OF CARTESIUS 3 POISSON EQUATION 4 SOLVERS

More information

GEM4 Summer School OpenCourseWare

GEM4 Summer School OpenCourseWare GEM4 Summer School OpenCourseWare http://gem4.educommons.net/ http://www.gem4.org/ Lecture: Molecular Mechanics by Ju Li. Given August 9, 2006 during the GEM4 session at MIT in Cambridge, MA. Please use

More information

Dept of Mechanical Engineering MIT Nanoengineering group

Dept of Mechanical Engineering MIT Nanoengineering group 1 Dept of Mechanical Engineering MIT Nanoengineering group » Recap of HK theorems and KS equations» The physical meaning of the XC energy» Solution of a one-particle Schroedinger equation» Pseudo Potentials»

More information

DENSITY FUNCTIONAL THEORY FOR NON-THEORISTS JOHN P. PERDEW DEPARTMENTS OF PHYSICS AND CHEMISTRY TEMPLE UNIVERSITY

DENSITY FUNCTIONAL THEORY FOR NON-THEORISTS JOHN P. PERDEW DEPARTMENTS OF PHYSICS AND CHEMISTRY TEMPLE UNIVERSITY DENSITY FUNCTIONAL THEORY FOR NON-THEORISTS JOHN P. PERDEW DEPARTMENTS OF PHYSICS AND CHEMISTRY TEMPLE UNIVERSITY A TUTORIAL FOR PHYSICAL SCIENTISTS WHO MAY OR MAY NOT HATE EQUATIONS AND PROOFS REFERENCES

More information

1. Hydrogen atom in a box

1. Hydrogen atom in a box 1. Hydrogen atom in a box Recall H atom problem, V(r) = -1/r e r exact answer solved by expanding in Gaussian basis set, had to solve secular matrix involving matrix elements of basis functions place atom

More information

Molecular Mechanics: The Ab Initio Foundation

Molecular Mechanics: The Ab Initio Foundation Molecular Mechanics: The Ab Initio Foundation Ju Li GEM4 Summer School 2006 Cell and Molecular Mechanics in BioMedicine August 7 18, 2006, MIT, Cambridge, MA, USA 2 Outline Why are electrons quantum? Born-Oppenheimer

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

Electrons in Crystals. Chris J. Pickard

Electrons in Crystals. Chris J. Pickard Electrons in Crystals Chris J. Pickard Electrons in Crystals The electrons in a crystal experience a potential with the periodicity of the Bravais lattice: U(r + R) = U(r) The scale of the periodicity

More information

Band calculations: Theory and Applications

Band calculations: Theory and Applications Band calculations: Theory and Applications Lecture 2: Different approximations for the exchange-correlation correlation functional in DFT Local density approximation () Generalized gradient approximation

More information

DFT in practice : Part II. Ersen Mete

DFT in practice : Part II. Ersen Mete pseudopotentials Department of Physics Balıkesir University, Balıkesir - Turkey August 13, 2009 - NanoDFT 09, İzmir Institute of Technology, İzmir Outline Pseudopotentials Basic Ideas Norm-conserving pseudopotentials

More information

Introduction to First-Principles Method

Introduction to First-Principles Method Joint ICTP/CAS/IAEA School & Workshop on Plasma-Materials Interaction in Fusion Devices, July 18-22, 2016, Hefei Introduction to First-Principles Method by Guang-Hong LU ( 吕广宏 ) Beihang University Computer

More information

Quantum Mechanical Simulations

Quantum Mechanical Simulations Quantum Mechanical Simulations Prof. Yan Wang Woodruff School of Mechanical Engineering Georgia Institute of Technology Atlanta, GA 30332, U.S.A. yan.wang@me.gatech.edu Topics Quantum Monte Carlo Hartree-Fock

More information

Solid State Theory: Band Structure Methods

Solid State Theory: Band Structure Methods Solid State Theory: Band Structure Methods Lilia Boeri Wed., 11:15-12:45 HS P3 (PH02112) http://itp.tugraz.at/lv/boeri/ele/ Plan of the Lecture: DFT1+2: Hohenberg-Kohn Theorem and Kohn and Sham equations.

More information

Plane waves and pseudopotentials (Part II)

Plane waves and pseudopotentials (Part II) Bristol 2007 Plane waves and pseudopotentials (Part II) X. Gonze Université Catholique de Louvain, Louvain-la-neuve, Belgium Plane Waves - Pseudopotentials, Bristol March 2007 1 In view of practical calculations,

More information

The electronic structure of materials 2 - DFT

The electronic structure of materials 2 - DFT Quantum mechanics 2 - Lecture 9 December 19, 2012 1 Density functional theory (DFT) 2 Literature Contents 1 Density functional theory (DFT) 2 Literature Historical background The beginnings: L. de Broglie

More information

Introduction to first-principles modelling and CASTEP

Introduction to first-principles modelling and CASTEP to first-principles modelling and Phil Hasnip to + Atomistic Simulations If we know what the bonding in a material is beforehand, then we can often find good expressions for the forces between atoms, e.g.

More information

Electronic energy optimisation in ONETEP

Electronic energy optimisation in ONETEP Electronic energy optimisation in ONETEP Chris-Kriton Skylaris cks@soton.ac.uk 1 Outline 1. Kohn-Sham calculations Direct energy minimisation versus density mixing 2. ONETEP scheme: optimise both the density

More information

Electronic structure theory: Fundamentals to frontiers. 1. Hartree-Fock theory

Electronic structure theory: Fundamentals to frontiers. 1. Hartree-Fock theory Electronic structure theory: Fundamentals to frontiers. 1. Hartree-Fock theory MARTIN HEAD-GORDON, Department of Chemistry, University of California, and Chemical Sciences Division, Lawrence Berkeley National

More information

Practical Guide to Density Functional Theory (DFT)

Practical Guide to Density Functional Theory (DFT) Practical Guide to Density Functional Theory (DFT) Brad Malone, Sadas Shankar Quick recap of where we left off last time BD Malone, S Shankar Therefore there is a direct one-to-one correspondence between

More information

v(r i r j ) = h(r i )+ 1 N

v(r i r j ) = h(r i )+ 1 N Chapter 1 Hartree-Fock Theory 1.1 Formalism For N electrons in an external potential V ext (r), the many-electron Hamiltonian can be written as follows: N H = [ p i i=1 m +V ext(r i )]+ 1 N N v(r i r j

More information

Exchange-Correlation Functional

Exchange-Correlation Functional Exchange-Correlation Functional Aiichiro Nakano Collaboratory for Advanced Computing & Simulations Depts. of Computer Science, Physics & Astronomy, Chemical Engineering & Materials Science, and Biological

More information

MD simulation: output

MD simulation: output Properties MD simulation: output Trajectory of atoms positions: e. g. diffusion, mass transport velocities: e. g. v-v autocorrelation spectrum Energies temperature displacement fluctuations Mean square

More information

OVERVIEW OF QUANTUM CHEMISTRY METHODS

OVERVIEW OF QUANTUM CHEMISTRY METHODS OVERVIEW OF QUANTUM CHEMISTRY METHODS Outline I Generalities Correlation, basis sets Spin II Wavefunction methods Hartree-Fock Configuration interaction Coupled cluster Perturbative methods III Density

More information

Weile Jia 1, Long Wang 1, Zongyan Cao 1, Jiyun Fu 1, Xuebin Chi 1, Weiguo Gao 2, Lin-Wang Wang 3

Weile Jia 1, Long Wang 1, Zongyan Cao 1, Jiyun Fu 1, Xuebin Chi 1, Weiguo Gao 2, Lin-Wang Wang 3 A plane wave pseudopotential density functional theory molecular dynamics code on multi-gpu machine - GPU Technology Conference, San Jose, May 17th, 2012 Weile Jia 1, Long Wang 1, Zongyan Cao 1, Jiyun

More information

Intro to ab initio methods

Intro to ab initio methods Lecture 2 Part A Intro to ab initio methods Recommended reading: Leach, Chapters 2 & 3 for QM methods For more QM methods: Essentials of Computational Chemistry by C.J. Cramer, Wiley (2002) 1 ab initio

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

Computational Nanoscience: Do It Yourself!

Computational Nanoscience: Do It Yourself! John von Neumann Institute for Computing (NIC) Computational Nanoscience: Do It Yourself! edited by Johannes Grotendorst Stefan Blugel Dominik Marx Winter School, 14-22 February 2006 Forschungszentrum

More information

Lecture 5. Hartree-Fock Theory. WS2010/11: Introduction to Nuclear and Particle Physics

Lecture 5. Hartree-Fock Theory. WS2010/11: Introduction to Nuclear and Particle Physics Lecture 5 Hartree-Fock Theory WS2010/11: Introduction to Nuclear and Particle Physics Particle-number representation: General formalism The simplest starting point for a many-body state is a system of

More information

GWL Manual. September 30, 2013

GWL Manual. September 30, 2013 GWL Manual September 30, 2013 1 What is GWL GWL is a code for performing first-principles GW calculations according, at the moment, to the G 0 W 0 approximation[1]. It is based on plane-waves for representing

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

On the adaptive finite element analysis of the Kohn-Sham equations

On the adaptive finite element analysis of the Kohn-Sham equations On the adaptive finite element analysis of the Kohn-Sham equations Denis Davydov, Toby Young, Paul Steinmann Denis Davydov, LTM, Erlangen, Germany August 2015 Denis Davydov, LTM, Erlangen, Germany College

More information

Preface Introduction to the electron liquid

Preface Introduction to the electron liquid Table of Preface page xvii 1 Introduction to the electron liquid 1 1.1 A tale of many electrons 1 1.2 Where the electrons roam: physical realizations of the electron liquid 5 1.2.1 Three dimensions 5 1.2.2

More information

ALMA: All-scale predictive design of heat management material structures

ALMA: All-scale predictive design of heat management material structures ALMA: All-scale predictive design of heat management material structures Version Date: 2015.11.13. Last updated 2015.12.02 Purpose of this document: Definition of a data organisation that is applicable

More information

Answers Quantum Chemistry NWI-MOL406 G. C. Groenenboom and G. A. de Wijs, HG00.307, 8:30-11:30, 21 jan 2014

Answers Quantum Chemistry NWI-MOL406 G. C. Groenenboom and G. A. de Wijs, HG00.307, 8:30-11:30, 21 jan 2014 Answers Quantum Chemistry NWI-MOL406 G. C. Groenenboom and G. A. de Wijs, HG00.307, 8:30-11:30, 21 jan 2014 Question 1: Basis sets Consider the split valence SV3-21G one electron basis set for formaldehyde

More information

Spin in Density-Functional Theory

Spin in Density-Functional Theory Spin in Density-Functional Theory Christoph R. Jacob 1 and Markus Reiher 2 1 Karlsruhe Institute of Technology (KIT), Center for Functional Nanostructures and Institute of Physical Chemistry, Wolfgang-Gaede-Straße

More information

Introduction to Electronic Structure Theory

Introduction to Electronic Structure Theory Introduction to Electronic Structure Theory C. David Sherrill School of Chemistry and Biochemistry Georgia Institute of Technology June 2002 Last Revised: June 2003 1 Introduction The purpose of these

More information

An Approximate DFT Method: The Density-Functional Tight-Binding (DFTB) Method

An Approximate DFT Method: The Density-Functional Tight-Binding (DFTB) Method Fakultät für Mathematik und Naturwissenschaften - Lehrstuhl für Physikalische Chemie I / Theoretische Chemie An Approximate DFT Method: The Density-Functional Tight-Binding (DFTB) Method Jan-Ole Joswig

More information

CLIMBING THE LADDER OF DENSITY FUNCTIONAL APPROXIMATIONS JOHN P. PERDEW DEPARTMENT OF PHYSICS TEMPLE UNIVERSITY PHILADELPHIA, PA 19122

CLIMBING THE LADDER OF DENSITY FUNCTIONAL APPROXIMATIONS JOHN P. PERDEW DEPARTMENT OF PHYSICS TEMPLE UNIVERSITY PHILADELPHIA, PA 19122 CLIMBING THE LADDER OF DENSITY FUNCTIONAL APPROXIMATIONS JOHN P. PERDEW DEPARTMENT OF PHYSICS TEMPLE UNIVERSITY PHILADELPHIA, PA 191 THANKS TO MANY COLLABORATORS, INCLUDING SY VOSKO DAVID LANGRETH ALEX

More information

Conquest order N ab initio Electronic Structure simulation code for quantum mechanical modelling in large scale

Conquest order N ab initio Electronic Structure simulation code for quantum mechanical modelling in large scale Fortran Expo: 15 Jun 2012 Conquest order N ab initio Electronic Structure simulation code for quantum mechanical modelling in large scale Lianheng Tong Overview Overview of Conquest project Brief Introduction

More information

Localized Optimization: Exploiting non-orthogonality to efficiently minimize the Kohn-Sham Energy

Localized Optimization: Exploiting non-orthogonality to efficiently minimize the Kohn-Sham Energy Localized Optimization: Exploiting non-orthogonality to efficiently minimize the Kohn-Sham Energy Courant Institute of Mathematical Sciences, NYU Lawrence Berkeley National Lab 16 December 2009 Joint work

More information

Time reversible Born Oppenheimer molecular dynamics

Time reversible Born Oppenheimer molecular dynamics Time reversible Born Oppenheimer molecular dynamics Jianfeng Lu Mathematics Department Department of Physics Duke University jianfeng@math.duke.edu KI-Net Conference, CSCAMM, University of Maryland, May

More information

The Abinit project. Coding is based on modern software engineering principles

The Abinit project. Coding is based on modern software engineering principles The Abinit project Abinit is a robust, full-featured electronic-structure code based on density functional theory, plane waves, and pseudopotentials. Abinit is copyrighted and distributed under the GNU

More information