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

Size: px
Start display at page:

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

Transcription

1 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

2 Joint work with Michael Overton NYU Juan Meza LBNL Chao Yang LBNL October SIAM ALA, Monterey CA

3

4 In the past Every attempt to employ mathematical methods in the study of chemical questions must be considered profoundly irrational and contrary to the spirit of chemistry. If mathematical analysis should ever hold a prominent place in chemistry - an aberration which is happily almost impossible - it would occasion a rapid and widespread degeneration of that science. Auguste Comte, 1830

5 Today Advances in density functional theory coupled with multinode computational clusters now enable accurate simulation of the behavior of multithousand 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

6 In the future Whereas computational methods nowadays mainly supplement experimentally obtained information, they are expected increasingly to supersede this information. Stephen Goedecker, 1999

7

8 CdSe Solar Cell CMOS electrons > 1,000,000 electrons > 50,000 electrons

9

10 The Problem is solved...in the Schrödinger equation we very nearly have the mathematical foundation for the solution of the whole problem of atomic and molecular structure G. N. Lewis, J. Chem. Phys. 1, 17 (1933)

11 Many-body Schrödinger Equation H Ψ ( r 1, r 2,..., r ne ) = λψ ( r 1, r 2,..., r ne ) If the n u nuclei are fixed in space at positions ˆr j, n e H = - 1 Δ ri 2 1 n u j=1 n e i=1 z j r i ˆr j + 1 r 1 i,j n i r j e Ψ contains all the information in the system and satisfies orthogonality and antisymmetry properties Ψ ( r 1, r 2,..., r ne ) 2 dr 1... dr ne gives probability density λ represents the quantized energy

12 The problem is solved almost...in the Schrödinger equation we very nearly have the mathematical foundation for the solution of the whole problem of atomic and molecular structure but the problem of the many bodies contained in the atom and the molecule cannot be completely solved without a great further development in mathematical technique. G. N. Lewis, J. Chem. Phys. 1, 17 (1933)

13 Many-body Schrödinger Equation (the but ) H Ψ ( r 1, r 2,..., r ne ) = λψ ( r 1, r 2,..., r ne ) If the n u nuclei are fixed in space at positions ˆr j, n e H = - 1 Δ ri 2 1 n u j=1 n e i=1 z j r i ˆr j + 1 r 1 i,j n i r j e Ψ contains all the information in the system and satisfies orthogonality and antisymmetry properties Ψ ( r 1, r 2,..., r ne ) 2 dr 1... dr ne gives probability density λ represents the quantized energy If we attempt to solve on a 32 x 32 x 32 grid, and n e = 5, H has dimension

14

15 Density Functional Theory Hohenberg and Kohn 1964: Proved that at ground state, total energy is function of charge density ρ ( r) = n e Ψ* ( r, r 2,..., r ne ) Ψ ( r, r 2,..., r ne ) dr 2 dr 3... dr ne Kohn and Sham 1965: Proposed a practical formulation, using n e single-particle, orthogonal wavefunctions ψ j that do not interact. Electron-electron interactions modeled by exchange-correlation energy.

16 The Kohn-Sham Equations Charge Density: n e ρ (r) = ψ* i (r ) ψ i ( r ) Exchange-correlation energy: E xc (ρ) = ρ (r ) ε xc [ρ ( r )]dr 1 Kohn-Sham energy: n e E KS [{ψ j }] = ψ j ( Δψ j ) dr + V ion ( r ) ρ ( r ) dr ρ ( r ) ρ ( r ) r r drdr + E xc ( ρ ).

17 Kohn-Sham Equations continued KKT Conditions: min E KS ( ψ j ) s.t. ψj * ψ j = δ i,j for i = 1, 2,..., n e H KS ( ρ ) ψ i = λ i ψ i, ψ j * ψ j = δ i,j, for i = 1, 2,..., n e where H KS = Δ + V ion ( r ) +ρ ( r ) * 1 r + V xc ( ρ) = V ( ρ ( r ) )

18 Non-orthogonal Kohn-Sham Equations Overlap matrix: S jk = ψ* j ψ k dr Charge-density: ρ (r) = j ψ* i (r ) (S -1 ) jk ψ i ( r) k Kohn-Sham Energy: E KS ( {ψ j }) = ( S -1 ) jk j k ψ j ( Δψ k ) dr + V ion ( r ) ρ ( r ) dr ρ ( r ) ρ ( r ) r r drdr + E xc ( ρ) This energy is independent of basis

19

20 Numerical Methods Step 1: Choose a discretization Plane-waves basis: ψ ( r) = k α k e ig k r 1 Advantages: ρ ( r ) * r Matrix Multiplication (FFT) Disadvantages: Inherently nonlocal Finite-differences: ψ ( r j ) = 1 h [ψ ( r j + h ) ψ ( r j h)] Advantages: Localized, highly sparse 1 Disadvantages:ρ ( r ) * r requires solution to a Poisson problem

21 Discretized Kohn-Sham Equations ( ( E (X) = trace (X*X ) -1 1 X* 2 L + α ) ) 1 2 V (r) X + α 2 4 ρt L -1 ρ [ ρ = diag X ( X*X ) -1 ] X* Look Familiar? x*ax ( x*x trace (X*X ) -1 ) X*AX Observe: E (XG) = E (X)

22 Numerical Methods Step 1: Choose a discretization Step 2: Compute a solution SCF: Solve the nonlinear Kohn-Sham equations CG: Directly minimize the Kohn-Sham Energy

23 Self-Consistent Field Iteration O ( n 3 e ) Convergence slow, non-monotonic Charge-mixing to accelerate convergence

24 CG (Fletcher-Reeves) 1. RM = - X E ( X 0 ) 2. PM = RM 3. XM = X 0 4. repeat until convergence criteria are satisfied 5. Choose αm from a line search on E ( XM + αpm) 6. X k+1 = XM + αmpm 7. R k+1 = - X E ( X k+1 ) 8. β k+1 = (rk+1 ) T r k+1 (r k ) T r k 9. P k+1 = R k+1 + β k+1 ( PM) 10. k = k end loop

25

26 Two Equal Solutions Orthogonal Solution A Localized Solution Student Version of MATLAB Student Version of MATLAB

27 Sparsity Pattern nz = 150 Sparsity structure of X: Support region size 30, n = 100, n e = 5

28

29 Maintaining Localization/sparsity An iterative algorithm need not maintain the sparsity pattern. Naive approach: Truncate, i.e. set X k+1 = (X k+1 ) T E and Gao approach: Minimize truncation error (localize) Compute invertible G which minimizes XG (XG) T F Remember E (XG) = E (X) for any invertible G

30 Sparse Subspace (XMG) T E(XMG) = E(XM) XM

31 CG + Localization (CG L by E and Gao) 1. RM = - X E ( X 0 ) 2. PM = RM 3. XM = X 0 4. repeat until convergence criteria are satisfied 5. Choose αm from a line search on E ( XM + αpm) 6. X k+1 = XM + αmpm 7. G = arg min G X k+1 G (X k+1 G ) T 8. X k+1 = (X k+1 G) T 9. R k+1 = - X E ( X k+1 ) 10. β k+1 = (rk+1 ) T r k+1 (r k ) T r k 11. P k+1 = R k+1 + β k+1 ( PMG) T 12. k = k end loop

32 Avoiding Local Minima: CG L versus truncation n = 100, n e = localized truncated

33 Our Approach: Localize the search direction { Sparse Dense { Pk { Sparse + Pk Localization (( + Pk)Gk) T

34 Localized Search Direction 1. RM = - X E ( X 0 ) 2. PM = RM 3. XM = X 0 4. repeat until convergence criteria are satisfied 5. G = arg min G ( XM + PM ) G (( XM + PM ) G ) T 6. PM = (( XM + PM ) G ) T XM 7. Choose αm from a line search on E ( XM + α PM) 8. X k+1 = XM + αm PM 9. R k+1 = - X E ( X k+1 ) 10. β k+1 = (rk+1 ) T r k+1 (r k ) T r k 11. P k+1 = R k+1 + β k+1 PM 12. k = k end loop

35 Avoiding Local Minima: Us vs: CG L!0.625! E and Gao o - Our method!0.635!0.64!0.645!0.65! Tolerance = 10 ⁷; n e = 5, n = 100

36 Monotonic Convergence !1 - E and Gao - Our method log(e - E*) 10!2 10!3 10!4 10!5 10!6 10!7 10!8 10! n e = 5, n = 100

37 Some timings on a bigger problem Method Mean(sec) Std. Dev. #evals time/eval Truncation E and Gao Proposed Method runs, n=5000, n e =10, Support =850

38 Where are the savings? The Gradient! S = X*X E = -XS -1 X* ( L + V ) XS -1 + (L + V ) XS -1 +α (Diag ( L -1 ρ ) XS -1 XS -1 X*Diag ( L -1 ρ ) XS -1)

39 The Overlap Matrix x S S -1 Student Version of MATLAB Student Version of MATLAB

40

41 Deeper Analysis: Maintaining Descent ( trace E T P ) < 0 ( trace ( E ) T ( )) T ( XM + PM ) G < 0.

42 Integration with BFGS 10 2 CG !2 BFGS 10!4 10!6 10!8 10!10 10!12 10!14 10! n e = 5, n = 100. Bad Search Directions: CG (0), BFGS (7)

43 Solve real problems by Chelikowsky, Troullier, and Saad Open-source Fortran code In real-space, using finite-differences Exploits parallel linear algebra routines and MPI for parallelization

44

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

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

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

Algorithms and Computational Aspects of DFT Calculations

Algorithms and Computational Aspects of DFT Calculations 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

More information

A new future for finite-element methods in Quantum Chemistry?

A new future for finite-element methods in Quantum Chemistry? A new future for finite-element methods in Quantum Chemistry? Kenneth Ruud Department of Chemistry University of Tromsø 9037 Tromsø Norway Geilo, 29/1 2007 A new future for finite-element methods in Quantum

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

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

COMPUTATIONAL CHEMISTRY. Introduction to the Theory and Applications of Molecular and Quantum Mechanics

COMPUTATIONAL CHEMISTRY. Introduction to the Theory and Applications of Molecular and Quantum Mechanics COMPUTATIONAL CHEMISTRY Introduction to the Theory and Applications of Molecular and Quantum Mechanics COMPUTATIONAL CHEMISTRY Introduction to the Theory and Applications of Molecular and Quantum Mechanics

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

Molecular Modelling for Medicinal Chemistry (F13MMM) Room A36

Molecular Modelling for Medicinal Chemistry (F13MMM) Room A36 Molecular Modelling for Medicinal Chemistry (F13MMM) jonathan.hirst@nottingham.ac.uk Room A36 http://comp.chem.nottingham.ac.uk Assisted reading Molecular Modelling: Principles and Applications. Andrew

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

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

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

Compressed representation of Kohn-Sham orbitals via selected columns of the density matrix

Compressed representation of Kohn-Sham orbitals via selected columns of the density matrix Lin Lin Compressed Kohn-Sham Orbitals 1 Compressed representation of Kohn-Sham orbitals via selected columns of the density matrix Lin Lin Department of Mathematics, UC Berkeley; Computational Research

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

Numerical Methods I Non-Square and Sparse Linear Systems

Numerical Methods I Non-Square and Sparse Linear Systems Numerical Methods I Non-Square and Sparse Linear Systems Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 MATH-GA 2011.003 / CSCI-GA 2945.003, Fall 2014 September 25th, 2014 A. Donev (Courant

More information

Density Functional Theory

Density Functional Theory Chemistry 380.37 Fall 2015 Dr. Jean M. Standard October 28, 2015 Density Functional Theory What is a Functional? A functional is a general mathematical quantity that represents a rule to convert a function

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

Notes on PCG for Sparse Linear Systems

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

More information

Introduction to density-functional theory. Emmanuel Fromager

Introduction to density-functional theory. Emmanuel Fromager Institut de Chimie, Strasbourg, France Page 1 Emmanuel Fromager Institut de Chimie de Strasbourg - Laboratoire de Chimie Quantique - Université de Strasbourg /CNRS M2 lecture, Strasbourg, France. Institut

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

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

7.3 The Jacobi and Gauss-Siedel Iterative Techniques. Problem: To solve Ax = b for A R n n. Methodology: Iteratively approximate solution x. No GEPP.

7.3 The Jacobi and Gauss-Siedel Iterative Techniques. Problem: To solve Ax = b for A R n n. Methodology: Iteratively approximate solution x. No GEPP. 7.3 The Jacobi and Gauss-Siedel Iterative Techniques Problem: To solve Ax = b for A R n n. Methodology: Iteratively approximate solution x. No GEPP. 7.3 The Jacobi and Gauss-Siedel Iterative Techniques

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

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

Steepest Descent. Juan C. Meza 1. Lawrence Berkeley National Laboratory Berkeley, California 94720

Steepest Descent. Juan C. Meza 1. Lawrence Berkeley National Laboratory Berkeley, California 94720 Steepest Descent Juan C. Meza Lawrence Berkeley National Laboratory Berkeley, California 94720 Abstract The steepest descent method has a rich history and is one of the simplest and best known methods

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

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

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

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

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

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

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

Electronic structure, plane waves and pseudopotentials

Electronic structure, plane waves and pseudopotentials Electronic structure, plane waves and pseudopotentials P.J. Hasnip Spectroscopy Workshop 2009 We want to be able to predict what electrons and nuclei will do from first principles, without needing to know

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

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

Orbital dependent correlation potentials in ab initio density functional theory

Orbital dependent correlation potentials in ab initio density functional theory Orbital dependent correlation potentials in ab initio density functional theory noniterative - one step - calculations Ireneusz Grabowski Institute of Physics Nicolaus Copernicus University Toruń, Poland

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

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

Applied Machine Learning for Biomedical Engineering. Enrico Grisan

Applied Machine Learning for Biomedical Engineering. Enrico Grisan Applied Machine Learning for Biomedical Engineering Enrico Grisan enrico.grisan@dei.unipd.it Data representation To find a representation that approximates elements of a signal class with a linear combination

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

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

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

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

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

Solutions to selected problems from Giuliani, Vignale : Quantum Theory of the Electron Liquid

Solutions to selected problems from Giuliani, Vignale : Quantum Theory of the Electron Liquid Solutions to selected problems from Giuliani, Vignale : Quantum Theory of the Electron Liquid These problems have been solved as a part of the Independent study class with prof. Neepa Maitra. Compiled

More information

Programming, numerics and optimization

Programming, numerics and optimization Programming, numerics and optimization Lecture C-3: Unconstrained optimization II Łukasz Jankowski ljank@ippt.pan.pl Institute of Fundamental Technological Research Room 4.32, Phone +22.8261281 ext. 428

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

Linear Solvers. Andrew Hazel

Linear Solvers. Andrew Hazel Linear Solvers Andrew Hazel Introduction Thus far we have talked about the formulation and discretisation of physical problems...... and stopped when we got to a discrete linear system of equations. Introduction

More information

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

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

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

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

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

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

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

Introduction to Computational Chemistry Computational (chemistry education) and/or. (Computational chemistry) education Introduction to Computational Chemistry Computational (chemistry education) and/or (Computational chemistry) education First one: Use computational tools to help increase student understanding of material

More information

The Conjugate Gradient Method

The Conjugate Gradient Method The Conjugate Gradient Method Jason E. Hicken Aerospace Design Lab Department of Aeronautics & Astronautics Stanford University 14 July 2011 Lecture Objectives describe when CG can be used to solve Ax

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

Exploring the energy landscape

Exploring the energy landscape Exploring the energy landscape ChE210D Today's lecture: what are general features of the potential energy surface and how can we locate and characterize minima on it Derivatives of the potential energy

More information

Advanced Quantum Chemistry III: Part 3. Haruyuki Nakano. Kyushu University

Advanced Quantum Chemistry III: Part 3. Haruyuki Nakano. Kyushu University Advanced Quantum Chemistry III: Part 3 Haruyuki Nakano Kyushu University 2013 Winter Term 1. Hartree-Fock theory Density Functional Theory 2. Hohenberg-Kohn theorem 3. Kohn-Sham method 4. Exchange-correlation

More information

Unconstrained optimization

Unconstrained optimization Chapter 4 Unconstrained optimization An unconstrained optimization problem takes the form min x Rnf(x) (4.1) for a target functional (also called objective function) f : R n R. In this chapter and throughout

More information

On the Numerics of 3D Kohn-Sham System

On the Numerics of 3D Kohn-Sham System On the of 3D Kohn-Sham System Weierstrass Institute for Applied Analysis and Stochastics Workshop: Mathematical Models for Transport in Macroscopic and Mesoscopic Systems, Feb. 2008 On the of 3D Kohn-Sham

More information

CP2K. New Frontiers. ab initio Molecular Dynamics

CP2K. New Frontiers. ab initio Molecular Dynamics CP2K New Frontiers in ab initio Molecular Dynamics Jürg Hutter, Joost VandeVondele, Valery Weber Physical-Chemistry Institute, University of Zurich Ab Initio Molecular Dynamics Molecular Dynamics Sampling

More information

An Active Set Strategy for Solving Optimization Problems with up to 200,000,000 Nonlinear Constraints

An Active Set Strategy for Solving Optimization Problems with up to 200,000,000 Nonlinear Constraints An Active Set Strategy for Solving Optimization Problems with up to 200,000,000 Nonlinear Constraints Klaus Schittkowski Department of Computer Science, University of Bayreuth 95440 Bayreuth, Germany e-mail:

More information

Numerical Methods I Eigenvalue Problems

Numerical Methods I Eigenvalue Problems Numerical Methods I Eigenvalue Problems Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 MATH-GA 2011.003 / CSCI-GA 2945.003, Fall 2014 October 2nd, 2014 A. Donev (Courant Institute) Lecture

More information

Density Functional Theory for the Electron Gas and for Jellium. Abstract

Density Functional Theory for the Electron Gas and for Jellium. Abstract Density Functional Theory for the Electron Gas and for Jellium. J. W. Dufty 1 1 Department of Physics, University of Florida, Gainesville, FL 32611 (Dated: April 26, 2017) Abstract Density Functional Theory

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

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

Chapter 4. Unconstrained optimization

Chapter 4. Unconstrained optimization Chapter 4. Unconstrained optimization Version: 28-10-2012 Material: (for details see) Chapter 11 in [FKS] (pp.251-276) A reference e.g. L.11.2 refers to the corresponding Lemma in the book [FKS] PDF-file

More information

Car-Parrinello Molecular Dynamics

Car-Parrinello Molecular Dynamics Car-Parrinello Molecular Dynamics Eric J. Bylaska HPCC Group Moral: A man dreams of a miracle and wakes up with loaves of bread Erich Maria Remarque Molecular Dynamics Loop (1) Compute Forces on atoms,

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

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

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

Making Electronic Structure Theory work

Making Electronic Structure Theory work Making Electronic Structure Theory work Ralf Gehrke Fritz-Haber-Institut der Max-Planck-Gesellschaft Berlin, 23 th June 2009 Hands-on Tutorial on Ab Initio Molecular Simulations: Toward a First-Principles

More information

Computational Nanoscience

Computational Nanoscience Computational Nanoscience Applications for Molecules, Clusters, and Solids KALMÄN VARGA AND JOSEPH A. DRISCOLL Vanderbilt University, Tennessee Щ CAMBRIDGE HP UNIVERSITY PRESS Preface Part I One-dimensional

More information

FEAST eigenvalue algorithm and solver: review and perspectives

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

More information

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

Improving the Convergence of Back-Propogation Learning with Second Order Methods

Improving the Convergence of Back-Propogation Learning with Second Order Methods the of Back-Propogation Learning with Second Order Methods Sue Becker and Yann le Cun, Sept 1988 Kasey Bray, October 2017 Table of Contents 1 with Back-Propagation 2 the of BP 3 A Computationally Feasible

More information

January 29, Non-linear conjugate gradient method(s): Fletcher Reeves Polak Ribière January 29, 2014 Hestenes Stiefel 1 / 13

January 29, Non-linear conjugate gradient method(s): Fletcher Reeves Polak Ribière January 29, 2014 Hestenes Stiefel 1 / 13 Non-linear conjugate gradient method(s): Fletcher Reeves Polak Ribière Hestenes Stiefel January 29, 2014 Non-linear conjugate gradient method(s): Fletcher Reeves Polak Ribière January 29, 2014 Hestenes

More information

1 Conjugate gradients

1 Conjugate gradients Notes for 2016-11-18 1 Conjugate gradients We now turn to the method of conjugate gradients (CG), perhaps the best known of the Krylov subspace solvers. The CG iteration can be characterized as the iteration

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 Scientific Computing

Introduction to Scientific Computing (Lecture 5: Linear system of equations / Matrix Splitting) Bojana Rosić, Thilo Moshagen Institute of Scientific Computing Motivation Let us resolve the problem scheme by using Kirchhoff s laws: the algebraic

More information

Matrix Derivatives and Descent Optimization Methods

Matrix Derivatives and Descent Optimization Methods Matrix Derivatives and Descent Optimization Methods 1 Qiang Ning Department of Electrical and Computer Engineering Beckman Institute for Advanced Science and Techonology University of Illinois at Urbana-Champaign

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

Parallel implementation of primal-dual interior-point methods for semidefinite programs

Parallel implementation of primal-dual interior-point methods for semidefinite programs Parallel implementation of primal-dual interior-point methods for semidefinite programs Masakazu Kojima, Kazuhide Nakata Katsuki Fujisawa and Makoto Yamashita 3rd Annual McMaster Optimization Conference:

More information

Reactivity and Organocatalysis. (Adalgisa Sinicropi and Massimo Olivucci)

Reactivity and Organocatalysis. (Adalgisa Sinicropi and Massimo Olivucci) Reactivity and Organocatalysis (Adalgisa Sinicropi and Massimo Olivucci) The Aldol Reaction - O R 1 O R 1 + - O O OH * * H R 2 R 1 R 2 The (1957) Zimmerman-Traxler Transition State Counterion (e.g. Li

More information

Computational Physics, Spring Homework Assignment # 9

Computational Physics, Spring Homework Assignment # 9 Cornell University Department of Physics Phys 480/680, Astro 690 April 26, 2007 Computational Physics, Spring 2007 Homework Assignment # 9 (Due Wednesday, April 25 at 5:00pm) Agenda and readings: Goal:

More information

Introduction, basic but important concepts

Introduction, basic but important concepts Introduction, basic but important concepts Felix Kubler 1 1 DBF, University of Zurich and Swiss Finance Institute October 7, 2017 Felix Kubler Comp.Econ. Gerzensee, Ch1 October 7, 2017 1 / 31 Economics

More information

An Accelerated Block-Parallel Newton Method via Overlapped Partitioning

An Accelerated Block-Parallel Newton Method via Overlapped Partitioning An Accelerated Block-Parallel Newton Method via Overlapped Partitioning Yurong Chen Lab. of Parallel Computing, Institute of Software, CAS (http://www.rdcps.ac.cn/~ychen/english.htm) Summary. This paper

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

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

Electronic communication through molecular bridges Supporting Information

Electronic communication through molecular bridges Supporting Information Electronic communication through molecular bridges Supporting Information Carmen Herrmann and Jan Elmisz Institute of Inorganic and Applied Chemistry, University of Hamburg, Martin-Luther-King-Platz 6,

More information

A self-interaction free non-local correlation functional derived from exact criteria

A self-interaction free non-local correlation functional derived from exact criteria A self-interaction free non-local correlation functional derived from exact criteria Tobias Schmidt and Stephan Kümmel Theoretical Physics IV University of Bayreuth Germany - International Workshop DFT

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

Computational Modeling of Protein-Ligand Interactions

Computational Modeling of Protein-Ligand Interactions Computational Modeling of Protein-Ligand Interactions Steven R. Gwaltney Department of Chemistry Mississippi State University Mississippi State, MS 39762 Auguste Comte, 1830 Every attempt to refer chemical

More information

Iterative Methods for Solving A x = b

Iterative Methods for Solving A x = b Iterative Methods for Solving A x = b A good (free) online source for iterative methods for solving A x = b is given in the description of a set of iterative solvers called templates found at netlib: http

More information

Department of Computer Science and Engineering

Department of Computer Science and Engineering Linear algebra methods for data mining with applications to materials Yousef Saad Department of Computer Science and Engineering University of Minnesota ICSC 2012, Hong Kong, Jan 4-7, 2012 HAPPY BIRTHDAY

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

Time-dependent density functional theory

Time-dependent density functional theory Time-dependent density functional theory E.K.U. Gross Max-Planck Institute for Microstructure Physics OUTLINE LECTURE I Phenomena to be described by TDDFT Some generalities on functional theories LECTURE

More information

Phani Motamarri and Vikram Gavini Department of Mechanical Engineering, University of Michigan, Ann Arbor, MI 48109, USA

Phani Motamarri and Vikram Gavini Department of Mechanical Engineering, University of Michigan, Ann Arbor, MI 48109, USA A subquadratic-scaling subspace projection method for large-scale Kohn-Sham density functional theory calculations using spectral finite-element discretization Phani Motamarri and Vikram Gavini Department

More information