Algorithms and Computational Aspects of DFT Calculations

Size: px
Start display at page:

Download "Algorithms and Computational Aspects of DFT Calculations"

Transcription

1 Algorithms and Computational Aspects of DFT Calculations Part II Juan Meza and Chao Yang High Performance Computing Research Lawrence Berkeley National Laboratory IMA Tutorial Mathematical and Computational Approaches to Quantum Chemistry Institute for Mathematics and its Applications, University of Minnesota September 26-27, 2008 Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

2 1 Goals and Motivation 2 Review of Equations 3 Plane Wave DFT Computational Components 4 Parallelization Strategies 5 Future Computational Challenges Linear Scaling Methods Parallelism Issues 6 Software Available Codes KSSOLV 7 Summary Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

3 1 Goals and Motivation 2 Review of Equations 3 Plane Wave DFT Computational Components 4 Parallelization Strategies 5 Future Computational Challenges Linear Scaling Methods Parallelism Issues 6 Software Available Codes KSSOLV 7 Summary Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

4 Goals 1 The Role of Computation 2 Review Equations and Solution Techniques 3 Discuss Major Computational Aspects of Plane Wave DFT codes 4 Present Some Parallelization Issues 5 Highlight Computational Challenges Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

5 Materials by design Advances in density functional theory coupled with multinode computational clusters now enable accurate simulation of the behavior of multi-thousand atom complexes that mediate the electronic and ionic transfers of solar energy conversion. These new and emerging nanoscience capabilities bring a fundamental understanding of the atomic and molecular processes of solar energy utilization within reach. Basic Research Needs for Solar Energy Utilization, Report of the BES Workshop on Solar Energy Utilization,April 18-21, 2005 Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

6 DFT codes are widely used for science applications 9470 nodes; 19,480 cores 13 Tflops/s SSP (100 Tflops/s peak) Upgrade to QuadCore (355 Tflops/s peak) DFT methods account for 75% of the materials sciences simulations at NERSC, totaling over 5 Million hours of computer time in 2006 Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

7 We can now simulate some realistic structures The charge density of a 15,000 atom quantum dot, Si 13607H Using 2048 processors at NERSC the calculation took about 5 hours. The calculated dipole moment of a 2633 atom CdSe quantum rod, Cd 961Se 724H 948. Using 2560 processors at NERSC the calculation took about 30 hours. Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

8 1 Goals and Motivation 2 Review of Equations 3 Plane Wave DFT Computational Components 4 Parallelization Strategies 5 Future Computational Challenges Linear Scaling Methods Parallelism Issues 6 Software Available Codes KSSOLV 7 Summary Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

9 Kohn-Sham Equations Recall our goal is to find the ground state energy by minimizing the Kohn-Sham total energy, E total Leads to: Kohn-Sham equations Hψ i = ɛ i ψ i, i = 1, 2,..., n [ e H = 1 ] V (ρ(r)), ρ V (ρ(r)) = V ext (r) + r r + V xc(ρ) Nonlinear eigenvalue problem since the Hamiltonian, H, depends on ψ through the charge density, ρ Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

10 Discretized Kohn-Sham Equations KKT conditions X L(X, Λ) = 0, X X = I ne. Discretized Kohn-Sham equations can now be written as: H(X)X = XΛ, X X = I ne. Kohn-Sham Hamiltonian given by: H(X) = 1 2 L + V (X), V (X) = V ext + Diag (L ρ(x)) + Diag g xc (ρ(x)) Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

11 The SCF Iteration [ 1 ]ψ Given an initial charge density ρ V (ρ(r)) i = E i ψ i compute a potential V k (ρ(r)) 2 Solve the linear eigenvalue problem {ψ i } i=1,...,ne ρ(r) = n e i ψ i (r) 2 V (ρ(r)) for the ψ i, i = 1,..., n e 3 Compute the new charge density ρ 4 Update ρ using your favorite mixing scheme 5 Compute V k+1 and repeat until converged Overall computational complexity is O(N n 2 e) due to linear algebra Major computational components CG method Orthogonalization Computation of potentials 3D FFT Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

12 What Are the Computational Issues? DFT methods account for 75% of the material science simulations at NERSC Parallel efficiencies can be quite high on plane wave basis can scale to 1000 processors on plane wave basis and wavefunction index can scale to 10, 000 processors Most codes still based on O(N 3 ) algorithms Not systematically improvable Inadequate for strong and/or non-local correlations Parallel efficiencies can be difficult to achieve; 10-20% parallel efficiency is not uncommon Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

13 1 Goals and Motivation 2 Review of Equations 3 Plane Wave DFT Computational Components 4 Parallelization Strategies 5 Future Computational Challenges Linear Scaling Methods Parallelism Issues 6 Software Available Codes KSSOLV 7 Summary Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

14 Major Computational Components of Plane Wave DFT Codes Eigenvalue solver Orthogonalization 3D FFTs Computation of potentials Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

15 Eigenvalue Solver Need to solve one N n e linear eigenvalue problem at each SCF iteration The size of N can easily be 10, ,000 Only need the n e ( number of atoms) lowest eigenvalues and corresponding eigenvectors Called diagonalization in chemistry/materials science circles Various approaches including CG, Grassmann CG, residual minimization Distinction is usually made between all band vs. band-by-band, which corresponds to solving for all eigenvectors simultaneously vs. solving for one eigenvector at a time. We would call this blocked vs. unblocked Use of optimized high-level BLAS3 routines can significantly improve performance Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

16 Orthogonalization Due to physical constraints, the electronic wavefunctions must be orthonormal This adds a constraint to the KS equations in the form of X X = I ne Can be time consuming for large systems Complexity is O(N n 2 e), where N is the size of the discretization and n e is the number of electrons Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

17 FFTs Recall that the kinetic energy operator takes on a particularly simple form in Fourier space (also called G-space) Most DFT codes take advantage of this fact by converting from real space to G-space for computation of the Hamiltonian Since systems are usually 3D, codes need to compute the 3D FFTs through a series of 1D FFTs This has a consequence both in the total amount of work and when trying to parallelize the codes Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

18 Computation of potentials The Hartree potential, V Hartree = ρ r r, can be computed in several ways The calculation can be posed as the solution of a Poisson problem. Fast Poisson solvers or multigrid can also be used Because the potential can be viewed a convolution, it can also be computed using FFTs Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

19 1 Goals and Motivation 2 Review of Equations 3 Plane Wave DFT Computational Components 4 Parallelization Strategies 5 Future Computational Challenges Linear Scaling Methods Parallelism Issues 6 Software Available Codes KSSOLV 7 Summary Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

20 Parallel Calculations Milestones 1991 Silicon surface reconstruction (7x7), Meiko I860, 64 processor, (Stich, Payne, King-Smith, Lin, Clarke) 1998 FeMn alloys (exchange bias), Cray T3E, 1500 procs; First > 1 Tflop simulation, Gordon Bell prize (Ujfalussy, Stocks, Canning, Y. Wang, Shelton et al.) atom Molybdenum simulation with Qbox, BlueGene/L at LLNL with 32,000 processors (F. Gygi et al.) 2008 Band-gap calculation of a 13,824 atom ZnTeO alloy proposed as a new solar cell material. Used 131,072 processors on Blue Gene/P at ANL achieved Tflops/s Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

21 Parallelization Strategies Parallel across k-points Not useful for large systems as k is usually small Parallel over electrons number of processors limited by number of electrons Parallel over the number of plane-wave basis, n g most commonly used in plane-wave codes Parallelization of DFT codes is nontrivial and most codes cannot scale to large numbers of processors with even moderate efficiencies. 30% parallel efficiency is usually considered very good Parallelization issues for Hartree-Fock codes are similar, especially for SCF Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

22 Parallelization of 3D FFT 3D FFTs are computed via 3 sets of 1D FFTs and 2 transposes Most of the communication is in global transpose (b) to (c) Ratio of flops/comm log N Many FFTs are computed at the same time to avoid latency issues Only non-zero elements computed/communicated For details see (Canning et al.): Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

23 1 Goals and Motivation 2 Review of Equations 3 Plane Wave DFT Computational Components 4 Parallelization Strategies 5 Future Computational Challenges Linear Scaling Methods Parallelism Issues 6 Software Available Codes KSSOLV 7 Summary Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

24 Linear Scaling Electronic Structure Methods Goal is to reduce the computational work from O(N 3 ) to O(N) Quantum mechanical effects are near-sighted, e.g. treat the computation of the exchange-correlation potential locally Need to introduce concept of a localization region, inside which the quantity of interest is computed and is assumed to vanish outside the region Six strategies for taking advantage of this fact (see Goedecker (1999)): 1 Fermi operator expansion 2 Fermi operator projection 3 Divide-and-conquer 4 Density-matrix minimization 5 Orbital minimization approach 6 Optimal basis density-matrix minimization Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

25 LS3DF Based on Divide-and-Conquer approach Divide a large system into smaller sub-domains that can be solved independently, then stitch the sub-domains back together again Classical electrostatic interactions are long-ranged, i.e. solve one global Poisson equation Requires minimal communication between the sub-domains Artificial boundary effects due to sub-dividing domains can be cancelled out Based on ideas from fragment molecular method We call our method Linear Scaling 3D Fragment or LS3DF 1 1 L.W. Wang, Z. Zhao, J. Meza, LBNL (2006) Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

26 Parallelism Issues IBM Cell Blade. Same processor as found in a Sony Playstation 3 Multi-core and many-core is the wave of the future Current algorithms for parallelism are difficult to parallelize with high efficiency Many quantum chemistry codes do not parallelize well for even medium scaled paralellism Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

27 1 Goals and Motivation 2 Review of Equations 3 Plane Wave DFT Computational Components 4 Parallelization Strategies 5 Future Computational Challenges Linear Scaling Methods Parallelism Issues 6 Software Available Codes KSSOLV 7 Summary Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

28 Electronic Structure Codes ABINIT PARATEC PEtot hpcrd.lbl.gov/linwang/petot/petot.html PWscf NWChem Q-Chem Quantum Espresso Socorro dft.sandia.gov/socorro VASP cms.mpi.univie.ac.at/vasp Many, many more apologies if your favorite code was not listed Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

29 KSSOLV Matlab package KSSOLV Matlab code for solving the Kohn-Sham equations Open source package Handles SCF, DCM, Trust Region Example problems to get started with Object-oriented design - easy to extend Good starting point for students Beta version of KSSOLV available, ask one of us for more information! Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

30 Example: SiH 4 a1 = Atom( Si ); a2 = Atom( H ); alist = [a1 a2 a2 a2 a2]; xyzlist= [ ]; mol = Molecule(); mol = set(mol, supercell,c); mol = set(mol, atomlist,alist); mol = set(mol, xyzlist,xyzlist); mol = set(mol, ecut, 25); mol = set(mol, name, SiH4 );... isosurface(rho); Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

31 Convergence [Etot, X, vtot, rho] = scf(mol); [Etot, X, vtot, rho] = dcm(mol); Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

32 Charge Density isosurface(rho); Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

33 Example: P t 6 Ni 2 O cell: sampling size: n1 = 96, n2 = 48, n3 = 48 atoms and coordinates: 1 Pt Ni Ni O number of electrons : 86 spin type : 1 kinetic energy cutoff: 60.0 Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

34 Comparison of DCM vs. SCF Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

35 1 Goals and Motivation 2 Review of Equations 3 Plane Wave DFT Computational Components 4 Parallelization Strategies 5 Future Computational Challenges Linear Scaling Methods Parallelism Issues 6 Software Available Codes KSSOLV 7 Summary Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

36 Summary Described most common PW DFT computational components Overview of standard numerical methods used Brief introduction into some parallelization issues Listed some computational challenges Introduced KSSOLV, Matlab package for solving KS equations Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

37 References Aron J. Cohen, Paula Mori-Snchez, Weitao Yang, Insights into Current Limitations of Density Functional Theory, Science, Vol no. 5890, pp (2008). F. Gygi, R. K. Yates, J. Lorenz, E. W. Draeger, F. Franchetti, C. W. Ueberhuber, B. R. de Supinski, S. Kral, J. A. Gunnels, J. C. Sexton, Proceedings of the 2005 ACM/IEEE conference on Supercomputing (2005). G. Goedecker, Linear Scaling Electronic Structure Methods, Rev. Mod. Phys. 71, 1085 (1999). Curtis L. Janssen and Ida M.B. Nielsen, Parallel Computing in Quantum Chemistry, CRC Press, (2008). Juan Meza (LBNL) Algorithms and Computational Aspects of DFT Calculations September 27, / 37

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

Minimization of the Kohn-Sham Energy with a Localized, Projected Search Direction

Minimization of the Kohn-Sham Energy with a Localized, Projected Search Direction Minimization of the Kohn-Sham Energy with a Localized, Projected Search Direction Courant Institute of Mathematical Sciences, NYU Lawrence Berkeley National Lab 29 October 2009 Joint work with Michael

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

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

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

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

CHEM3023: Spins, Atoms and Molecules

CHEM3023: Spins, Atoms and Molecules CHEM3023: Spins, Atoms and Molecules Lecture 5 The Hartree-Fock method C.-K. Skylaris Learning outcomes Be able to use the variational principle in quantum calculations Be able to construct Fock operators

More information

Self Consistent Cycle

Self Consistent Cycle Self Consistent Cycle Step 0 : defining your system namelist SYSTEM How to specify the System All periodic systems can be specified by a Bravais Lattice and and atomic basis How to specify the Bravais

More information

The Plane-wave Pseudopotential Method

The Plane-wave Pseudopotential Method The Plane-wave Pseudopotential Method k(r) = X G c k,g e i(g+k) r Chris J Pickard Electrons in a Solid Nearly Free Electrons Nearly Free Electrons Nearly Free Electrons Electronic Structures Methods Empirical

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

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

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

DGDFT: A Massively Parallel Method for Large Scale Density Functional Theory Calculations

DGDFT: A Massively Parallel Method for Large Scale Density Functional Theory Calculations DGDFT: A Massively Parallel Method for Large Scale Density Functional Theory Calculations The recently developed discontinuous Galerkin density functional theory (DGDFT)[21] aims at reducing the number

More information

Conjugate-Gradient Eigenvalue Solvers in Computing Electronic Properties of Nanostructure Architectures

Conjugate-Gradient Eigenvalue Solvers in Computing Electronic Properties of Nanostructure Architectures Conjugate-Gradient Eigenvalue Solvers in Computing Electronic Properties of Nanostructure Architectures Stanimire Tomov 1, Julien Langou 1, Andrew Canning 2, Lin-Wang Wang 2, and Jack Dongarra 1 1 Innovative

More information

Key concepts in Density Functional Theory (II)

Key concepts in Density Functional Theory (II) Kohn-Sham scheme and band structures European Theoretical Spectroscopy Facility (ETSF) CNRS - Laboratoire des Solides Irradiés Ecole Polytechnique, Palaiseau - France Present Address: LPMCN Université

More information

Recent developments of Discontinuous Galerkin Density functional theory

Recent developments of Discontinuous Galerkin Density functional theory Lin Lin Discontinuous Galerkin DFT 1 Recent developments of Discontinuous Galerkin Density functional theory Lin Lin Department of Mathematics, UC Berkeley; Computational Research Division, LBNL Numerical

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

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

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

CHEM6085: Density Functional Theory

CHEM6085: Density Functional Theory Lecture 5 CHEM6085: Density Functional Theory Orbital-free (or pure ) DFT C.-K. Skylaris 1 Consists of three terms The electronic Hamiltonian operator Electronic kinetic energy operator Electron-Electron

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

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

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

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

3: Density Functional Theory

3: Density Functional Theory The Nuts and Bolts of First-Principles Simulation 3: Density Functional Theory CASTEP Developers Group with support from the ESF ψ k Network Density functional theory Mike Gillan, University College London

More information

Density Functional Theory for Electrons in Materials

Density Functional Theory for Electrons in Materials Density Functional Theory for Electrons in Materials Richard M. Martin Department of Physics and Materials Research Laboratory University of Illinois at Urbana-Champaign 1 Density Functional Theory for

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

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

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

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

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

Teoría del Funcional de la Densidad (Density Functional Theory)

Teoría del Funcional de la Densidad (Density Functional Theory) Teoría del Funcional de la Densidad (Density Functional Theory) Motivation: limitations of the standard approach based on the wave function. The electronic density n(r) as the key variable: Functionals

More information

Electrochemistry project, Chemistry Department, November Ab-initio Molecular Dynamics Simulation

Electrochemistry project, Chemistry Department, November Ab-initio Molecular Dynamics Simulation Electrochemistry project, Chemistry Department, November 2006 Ab-initio Molecular Dynamics Simulation Outline Introduction Ab-initio concepts Total energy concepts Adsorption energy calculation Project

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

Key concepts in Density Functional Theory (II) Silvana Botti

Key concepts in Density Functional Theory (II) Silvana Botti Kohn-Sham scheme, band structure and optical spectra European Theoretical Spectroscopy Facility (ETSF) CNRS - Laboratoire des Solides Irradiés Ecole Polytechnique, Palaiseau - France Temporary Address:

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

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

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

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

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

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

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 Density Functional Theory

Introduction to Density Functional Theory 1 Introduction to Density Functional Theory 21 February 2011; V172 P.Ravindran, FME-course on Ab initio Modelling of solar cell Materials 21 February 2011 Introduction to DFT 2 3 4 Ab initio Computational

More information

Key concepts in Density Functional Theory

Key concepts in Density Functional Theory From the many body problem to the Kohn-Sham scheme ILM (LPMCN) CNRS, Université Lyon 1 - France European Theoretical Spectroscopy Facility (ETSF) December 12, 2012 Lyon Outline 1 The many-body problem

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

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

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

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

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

Lecture 8: Introduction to Density Functional Theory

Lecture 8: Introduction to Density Functional Theory Lecture 8: Introduction to Density Functional Theory Marie Curie Tutorial Series: Modeling Biomolecules December 6-11, 2004 Mark Tuckerman Dept. of Chemistry and Courant Institute of Mathematical Science

More information

First-principles Molecular Dynamics Simulations

First-principles Molecular Dynamics Simulations First-principles Molecular Dynamics Simulations François Gygi University of California, Davis fgygi@ucdavis.edu http://eslab.ucdavis.edu http://www.quantum-simulation.org MICCoM Computational School, Jul

More information

7/29/2014. Electronic Structure. Electrons in Momentum Space. Electron Density Matrices FKF FKF. Ulrich Wedig

7/29/2014. Electronic Structure. Electrons in Momentum Space. Electron Density Matrices FKF FKF. Ulrich Wedig Electron Density Matrices Density matrices Γ, an alternative to the wavefunction Ψ, for the description of a quantum system Electronic Structure The N-particle density matrix Electrons in Momentum Space

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

Projector augmented wave Implementation

Projector augmented wave Implementation Projector augmented wave Implementation Peter. E. Blöchl Institute for Theoretical Physics Clausthal University of Technology, Germany http://www.pt.tu-clausthal.de/atp/ 1 = Projector augmented wave +

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

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

GW quasiparticle energies

GW quasiparticle energies Chapter 4 GW quasiparticle energies Density functional theory provides a good description of ground state properties by mapping the problem of interacting electrons onto a KS system of independent particles

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

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

Introduction to Hartree-Fock Molecular Orbital Theory

Introduction to Hartree-Fock Molecular Orbital Theory Introduction to Hartree-Fock Molecular Orbital Theory C. David Sherrill School of Chemistry and Biochemistry Georgia Institute of Technology Origins of Mathematical Modeling in Chemistry Plato (ca. 428-347

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

Quantum Monte Carlo Benchmarks Density Functionals: Si Defects

Quantum Monte Carlo Benchmarks Density Functionals: Si Defects Quantum Monte Carlo Benchmarks Density Functionals: Si Defects K P Driver, W D Parker, R G Hennig, J W Wilkins (OSU) C J Umrigar (Cornell), R Martin, E Batista, B Uberuaga (LANL), J Heyd, G Scuseria (Rice)

More information

Density matrix functional theory vis-á-vis density functional theory

Density matrix functional theory vis-á-vis density functional theory Density matrix functional theory vis-á-vis density functional theory 16.4.007 Ryan Requist Oleg Pankratov 1 Introduction Recently, there has been renewed interest in density matrix functional theory (DMFT)

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

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

A very efficient two-density approach to atomistic simulations and a proof of principle for small atoms and molecules

A very efficient two-density approach to atomistic simulations and a proof of principle for small atoms and molecules A very efficient two-density approach to atomistic simulations and a proof of principle for small atoms and molecules Werner A Hofer and Thomas Pope School of Natural and Environmental Sciences Newcastle

More information

Electronic structure theory: Fundamentals to frontiers. 2. Density functional theory

Electronic structure theory: Fundamentals to frontiers. 2. Density functional theory Electronic structure theory: Fundamentals to frontiers. 2. Density functional theory MARTIN HEAD-GORDON, Department of Chemistry, University of California, and Chemical Sciences Division, Lawrence Berkeley

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

Density Functional Theory: from theory to Applications

Density Functional Theory: from theory to Applications Density Functional Theory: from theory to Applications Uni Mainz November 29, 2010 The self interaction error and its correction Perdew-Zunger SIC Average-density approximation Weighted density approximation

More information

Self-Consistent Implementation of Self-Interaction Corrected DFT and of the Exact Exchange Functionals in Plane-Wave DFT

Self-Consistent Implementation of Self-Interaction Corrected DFT and of the Exact Exchange Functionals in Plane-Wave DFT Self-Consistent Implementation of Self-Interaction Corrected DFT and of the Exact Exchange Functionals in Plane-Wave DFT Kiril Tsemekhman (a), Eric Bylaska (b), Hannes Jonsson (a,c) (a) Department of Chemistry,

More information

Massively parallel electronic structure calculations with Python software. Jussi Enkovaara Software Engineering CSC the finnish IT center for science

Massively parallel electronic structure calculations with Python software. Jussi Enkovaara Software Engineering CSC the finnish IT center for science Massively parallel electronic structure calculations with Python software Jussi Enkovaara Software Engineering CSC the finnish IT center for science GPAW Software package for electronic structure calculations

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

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

Parallel Eigensolver Performance on High Performance Computers 1

Parallel Eigensolver Performance on High Performance Computers 1 Parallel Eigensolver Performance on High Performance Computers 1 Andrew Sunderland STFC Daresbury Laboratory, Warrington, UK Abstract Eigenvalue and eigenvector computations arise in a wide range of scientific

More information

Parallel Eigensolver Performance on the HPCx System

Parallel Eigensolver Performance on the HPCx System Parallel Eigensolver Performance on the HPCx System Andrew Sunderland, Elena Breitmoser Terascaling Applications Group CCLRC Daresbury Laboratory EPCC, University of Edinburgh Outline 1. Brief Introduction

More information

Toward an O(N) method for the non-equilibrium Green's function calculation

Toward an O(N) method for the non-equilibrium Green's function calculation Toward an O(N) method for the non-equilibrium Green's function calculation Masahiro FUKUDA Institute for Solid State Physics, University of Tokyo, Japan Table of Content Introduction Non equilibrium Green

More information

Non-linear optics, k p perturbation theory, and the Sternheimer equation

Non-linear optics, k p perturbation theory, and the Sternheimer equation Non-linear optics, k p perturbation theory, and the Sternheimer equation David A. Strubbe Department of Materials Science and Engineering Massachusetts Institute of Technology, Cambridge, MA Formerly Department

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

Compression Algorithms for Electronic Structure Computations

Compression Algorithms for Electronic Structure Computations Compression Algorithms for Electronic Structure Computations François Gygi University of California, Davis fgygi@ucdavis.edu http://eslab.ucdavis.edu http://www.quantum-simulation.org IPAM Workshop, Computation

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 » To calculate all the properties of a molecule or crystalline system knowing its atomic information: Atomic species Their coordinates The Symmetry

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

PBS: FROM SOLIDS TO CLUSTERS

PBS: FROM SOLIDS TO CLUSTERS PBS: FROM SOLIDS TO CLUSTERS E. HOFFMANN AND P. ENTEL Theoretische Tieftemperaturphysik Gerhard-Mercator-Universität Duisburg, Lotharstraße 1 47048 Duisburg, Germany Semiconducting nanocrystallites like

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

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

Introduction to Parallelism in CASTEP

Introduction to Parallelism in CASTEP to ism in CASTEP Stewart Clark Band University of Durham 21 September 2012 Solve for all the bands/electrons (Band-) Band CASTEP solves the Kohn-Sham equations for electrons in a periodic array of nuclei:

More information

Applications of Matrix Functions Part III: Quantum Chemistry

Applications of Matrix Functions Part III: Quantum Chemistry Applications of Matrix Functions Part III: Quantum Chemistry Emory University Department of Mathematics and Computer Science Atlanta, GA 30322, USA Prologue The main purpose of this lecture is to present

More information

Conjugate-Gradient Eigenvalue Solvers in Computing Electronic Properties of Nanostructure Architectures

Conjugate-Gradient Eigenvalue Solvers in Computing Electronic Properties of Nanostructure Architectures Conjugate-Gradient Eigenvalue Solvers in Computing Electronic Properties of Nanostructure Architectures Stanimire Tomov 1, Julien Langou 1, Andrew Canning 2, Lin-Wang Wang 2, and Jack Dongarra 1 1 Innovative

More information

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

Journal of Theoretical Physics

Journal of Theoretical Physics 1 Journal of Theoretical Physics Founded and Edited by M. Apostol 53 (2000) ISSN 1453-4428 Ionization potential for metallic clusters L. C. Cune and M. Apostol Department of Theoretical Physics, Institute

More information

arxiv: v1 [physics.comp-ph] 22 Oct 2015

arxiv: v1 [physics.comp-ph] 22 Oct 2015 arxiv:1510.06489v1 [physics.comp-ph] 22 Oct 2015 Adaptive local basis set for Kohn-Sham density functional theory in a discontinuous Galerkin framework II: Force, vibration, and molecular dynamics calculations

More information

Advanced Solid State Theory SS Roser Valentí and Harald Jeschke Institut für Theoretische Physik, Goethe-Universität Frankfurt

Advanced Solid State Theory SS Roser Valentí and Harald Jeschke Institut für Theoretische Physik, Goethe-Universität Frankfurt Advanced Solid State Theory SS 2010 Roser Valentí and Harald Jeschke Institut für Theoretische Physik, Goethe-Universität Frankfurt i 0. Literatur R. M. Martin, Electronic Structure: Basic Theory and

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

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

Introduction to DFT and Density Functionals. by Michel Côté Université de Montréal Département de physique

Introduction to DFT and Density Functionals. by Michel Côté Université de Montréal Département de physique Introduction to DFT and Density Functionals by Michel Côté Université de Montréal Département de physique Eamples Carbazole molecule Inside of diamant Réf: Jean-François Brière http://www.phys.umontreal.ca/~michel_

More information

Generalized generalized gradient approximation: An improved density-functional theory for accurate orbital eigenvalues

Generalized generalized gradient approximation: An improved density-functional theory for accurate orbital eigenvalues PHYSICAL REVIEW B VOLUME 55, NUMBER 24 15 JUNE 1997-II Generalized generalized gradient approximation: An improved density-functional theory for accurate orbital eigenvalues Xinlei Hua, Xiaojie Chen, and

More information

The Gutzwiller Density Functional Theory

The Gutzwiller Density Functional Theory The Gutzwiller Density Functional Theory Jörg Bünemann, BTU Cottbus I) Introduction 1. Model for an H 2 -molecule 2. Transition metals and their compounds II) Gutzwiller variational theory 1. Gutzwiller

More information

Comparing the Efficiency of Iterative Eigenvalue Solvers: the Quantum ESPRESSO experience

Comparing the Efficiency of Iterative Eigenvalue Solvers: the Quantum ESPRESSO experience Comparing the Efficiency of Iterative Eigenvalue Solvers: the Quantum ESPRESSO experience Stefano de Gironcoli Scuola Internazionale Superiore di Studi Avanzati Trieste-Italy 0 Diagonalization of the Kohn-Sham

More information

Band Structure Calculations; Electronic and Optical Properties

Band Structure Calculations; Electronic and Optical Properties ; Electronic and Optical Properties Stewart Clark University of Outline Introduction to band structures Calculating band structures using Castep Calculating optical properties Examples results Some applications

More information

Energy and Forces in DFT

Energy and Forces in DFT Energy and Forces in DFT Total Energy as a function of nuclear positions {R} E tot ({R}) = E DF T ({R}) + E II ({R}) (1) where E DF T ({R}) = DFT energy calculated for the ground-state density charge-density

More information