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

Size: px
Start display at page:

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

Transcription

1

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

3 Basics of density-functional theory

4 Density-functional theory Many-body Schrödinger equation Can be solved analytically for one electron Storing 8 electron wavefunction in 6x6x6 cartesian grid requires ~1010 GB! Hohenberg and Kohn (1965): use electron density as basic quantity

5 Hohenberg-Kohn theorems Ground state properties of many-electron system are unique functionals of the the ground state density n(r) The ground state density minimizes the total energy functional Vext(r) n(r) Ψ(r1,...,rN)

6 Energy functional The energy functional can be written as where Approximations are contained in the exchange-correlation energy Exc

7 Kohn-Sham equations Minimizing the energy functional with respect to single particle orbitals gives: Non-linear single particle equations with multiplicative potential vs(r)

8 Self-consistent cycle

9 Notes on Kohn-Sham approach KS approach is in principle exact Everything unknown is put in into presumably small exchange-correlation energy/potential A set of single-particle equations is used instead of many-body wave function Strictly, KS eigenvalues and eigenvectors have no physical meaning Often used as approximation to real electronic states

10 Limitations of DFT Approximations to exchange-correlation limit the accuracy Only ground state properties DFT can be used as starting point to Green function based many-body e.g. GW for studying excitations Time-dependent density-functional theory provides access also to excited state properties

11 Overview of GPAW

12 GPAW Density-functional theory and time-dependent DFT Utilizes the projector augmented wave method Various basis sets: Uniform real-space grids, atomic orbitals, plane waves Massively parallelized Open source software licensed under GPL wiki.fysik.dtu.dk/gpaw J. J. Mortensen et al., Phys. Rev. B 71, (2005) J. Enkovaara et al., J. Phys. Condens. Matter 22, (2010)

13 GPAW features Total energies and forces, structural optimization, magnetic moments Analysis of electronic structure Band structures, density of states Wide range of XC functionals Excited state properties TD-DFT, GW, Bethe-Salpeter Electron transport, X-ray spectra, STM images,...

14 Real-space grids Wave functions, electron densities, and potentials are represented on grids. Single parameter, grid spacing h h Accuracy of calculation can be improved systematically Derivatives by finite differences

15 Atomic orbital basis Linear combination of atomic orbitals (LCAO) provide compact basis set The atomic orbitals are obtained from a free atom in a confining potential well Systematic improvement of accuracy is non-trivial Possible to switch between localized basis and real-space grids

16 Plane wave basis Functions which are periodic with respect to unit cell can be written as sum of plane waves The expansion is truncated according to Only periodic cells (supercells)

17 Comparison of basis sets Real-space grids systematic convergence with single parameter good parallelization prospects some integrals complicated in real-space Localized basis set compact basis systematic convergence can be difficult Plane waves systematic convergence with single parameter some integrals simplified in reciprocal space very efficient in small to medium size systems parallelization more limited due FFTs

18 Geometry optimization of CO molecule

19 Atomic Simulation Environment ASE is a Python package for building atomic structures structure optimization and molecular dynamics analysis and visualization ASE relies on external software which provides total energies, forces, etc. ASE atomic positions GPAW, Dacapo, Siesta Input files are Python scripts calculations are run as python input.py simple format, no knowledge of Python required knowledge of Python enables great flexibility Simple graphical user interface energies, forces, wfs, densities Calculator wiki.fysik.dtu.dk/ase

20 relax.py: from from from from ase import Atoms ase.io import write ase.optimize import QuasiNewton gpaw import GPAW d = 1.10 # Starting guess for the bond length atoms = Atoms('CO', positions=((0, 0, 0), (0, 0, d)), pbc=false) atoms.center(vacuum=4.0) write('co.cif', atoms) calc = GPAW(h=0.20, xc='pbe', txt='co_relax.txt') atoms.set_calculator(calc) relax = QuasiNewton(atoms, trajectory='co.traj', logfile='qn.log') relax.run(fmax=0.05)

21 wiki.fysik.dtu.dk/gpaw wiki.fysik.dtu.dk/ase

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

ASE: A programmable environment for calculations with many electronic structure codes

ASE: A programmable environment for calculations with many electronic structure codes ASE: A programmable environment for calculations with many electronic structure codes Ask Hjorth Larsen Center for Atomic-scale Materials Design, Technical University of Denmark 16th ETSF workshop September

More information

exciting in a nutshell

exciting in a nutshell http://exciting-code.org exciting in a nutshell Pasquale Pavone Humboldt-Universität zu Berlin http://exciting-code.org exciting in a (coco)nutshell Pasquale Pavone Humboldt-Universität zu Berlin Outline

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

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

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

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

Pseudopotentials: design, testing, typical errors

Pseudopotentials: design, testing, typical errors Pseudopotentials: design, testing, typical errors Kevin F. Garrity Part 1 National Institute of Standards and Technology (NIST) Uncertainty Quantification in Materials Modeling 2015 Parameter free calculations.

More information

The electronic structure of materials 2 - DFT

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

More information

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

Behind the "exciting" curtain: The (L)APW+lo method

Behind the exciting curtain: The (L)APW+lo method Behind the "exciting" curtain: The (L)APW+lo method Aug 7, 2016 Andris Gulans Humboldt-Universität zu Berlin Kohn-Sham equation Potential due to nuclei Exchange-correlation potential Potential due to electron

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

The Projector Augmented Wave method

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

More information

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

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

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

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

Electronic structure calculations with the GPAW code. History of GPAW New PAW setups for GPAW Plane-wave implementation Future work

Electronic structure calculations with the GPAW code. History of GPAW New PAW setups for GPAW Plane-wave implementation Future work Electronic structure calculations with the GPAW code History of GPAW New PAW setups for GPAW Plane-wave implementation Future work The not very accurate history of GPAW Around 2002: We need an improved

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

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

Speed-up of ATK compared to

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

More information

Orbital Density Dependent Functionals

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

More information

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

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

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

More information

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

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

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

More information

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

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

André Schleife Department of Materials Science and Engineering

André Schleife Department of Materials Science and Engineering André Schleife Department of Materials Science and Engineering Yesterday you (should have) learned this: http://upload.wikimedia.org/wikipedia/commons/e/ea/ Simple_Harmonic_Motion_Orbit.gif 1. deterministic

More information

Introduction to bulk properties. KEMS409 Demo #2

Introduction to bulk properties. KEMS409 Demo #2 Introduction to bulk properties KEMS409 Demo #2 Useful links ASE atomic simulation environment https://wiki.fysik.dtu.dk/ase/ GPAW grid-based projected augmented wave https://wiki.fysik.dtu.dk/gpaw/ AMCSD

More information

Independent electrons in an effective potential

Independent electrons in an effective potential ABC of DFT Adiabatic approximation Independent electrons in an effective potential Hartree Fock Density Functional Theory MBPT - GW Density Functional Theory in a nutshell Every observable quantity of

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

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

Time-dependent density functional theory (TDDFT)

Time-dependent density functional theory (TDDFT) Advanced Workshop on High-Performance & High-Throughput Materials Simulations using Quantum ESPRESSO ICTP, Trieste, Italy, January 16 to 27, 2017 Time-dependent density functional theory (TDDFT) Ralph

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

Tutorial on DFPT and TD-DFPT: calculations of phonons and absorption spectra

Tutorial on DFPT and TD-DFPT: calculations of phonons and absorption spectra Tutorial on DFPT and TD-DFPT: calculations of phonons and absorption spectra Iurii Timrov SISSA Scuola Internazionale Superiore di Studi Avanzati, Trieste Italy itimrov@sissa.it Computer modelling of materials

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

How to run SIESTA. Introduction to input & output files

How to run SIESTA. Introduction to input & output files How to run SIESTA Introduction to input & output files Linear-scaling DFT based on Numerical Atomic Orbitals (NAOs) Born-Oppenheimer DFT Pseudopotentials Numerical atomic orbitals relaxations, MD, phonons.

More information

Supporting information

Supporting information Supporting information Toward a Janus Cluster: Regiospecific Decarboxylation of Ag 44 (4- MBA) 30 @Ag Nanoparticles Indranath Chakraborty, Anirban Som, Tuhina Adit Maark, Biswajit Mondal, Depanjan Sarkar

More information

Due: since the calculation takes longer than before, we ll make it due on 02/05/2016, Friday

Due: since the calculation takes longer than before, we ll make it due on 02/05/2016, Friday Homework 3 Due: since the calculation takes longer than before, we ll make it due on 02/05/2016, Friday Email to: jqian@caltech.edu Introduction In this assignment, you will be using a commercial periodic

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

Introduction to Density Functional Theory (DFT)

Introduction to Density Functional Theory (DFT) Introduction to Density Functional Theory (DFT) Brad Malone, Sadas Shankar The Problem: What's the big deal? Materials we are often interested in contain a macroscopically large number of particles (~1023

More information

Time-dependent density functional theory (TDDFT)

Time-dependent density functional theory (TDDFT) 04/05/16 Hands-on workshop and Humboldt-Kolleg: Density-Functional Theory and Beyond - Basic Principles and Modern Insights Isfahan University of Technology, Isfahan, Iran, May 2 to 13, 2016 Time-dependent

More information

Multi-reference Density Functional Theory. COLUMBUS Workshop Argonne National Laboratory 15 August 2005

Multi-reference Density Functional Theory. COLUMBUS Workshop Argonne National Laboratory 15 August 2005 Multi-reference Density Functional Theory COLUMBUS Workshop Argonne National Laboratory 15 August 2005 Capt Eric V. Beck Air Force Institute of Technology Department of Engineering Physics 2950 Hobson

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

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

6: Plane waves, unit cells, k- points and all that

6: Plane waves, unit cells, k- points and all that The Nuts and Bolts of First-Principles Simulation 6: Plane waves, unit cells, k- points and all that Durham, 6th- 13th December 2001 CASTEP Developers Group with support from the ESF ψ k Network Overview

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

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

Electronic Structure Methodology 1

Electronic Structure Methodology 1 Electronic Structure Methodology 1 Chris J. Pickard Lecture Two Working with Density Functional Theory In the last lecture we learnt how to write the total energy as a functional of the density n(r): E

More information

Multi-Scale Modeling from First Principles

Multi-Scale Modeling from First Principles m mm Multi-Scale Modeling from First Principles μm nm m mm μm nm space space Predictive modeling and simulations must address all time and Continuum Equations, densityfunctional space scales Rate Equations

More information

All electron optimized effective potential method for solids

All electron optimized effective potential method for solids All electron optimized effective potential method for solids Institut für Theoretische Physik Freie Universität Berlin, Germany and Fritz Haber Institute of the Max Planck Society, Berlin, Germany. 22

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

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

COMPUTATIONAL TOOL. Fig. 4.1 Opening screen of w2web

COMPUTATIONAL TOOL. Fig. 4.1 Opening screen of w2web CHAPTER -4 COMPUTATIONAL TOOL Ph.D. Thesis: J. Maibam CHAPTER: 4 4.1 The WIEN2k code In this work, all the calculations presented are performed using the WIEN2k software package (Blaha et al., 2001). The

More information

DFT calculations of NMR indirect spin spin coupling constants

DFT calculations of NMR indirect spin spin coupling constants DFT calculations of NMR indirect spin spin coupling constants Dalton program system Program capabilities Density functional theory Kohn Sham theory LDA, GGA and hybrid theories Indirect NMR spin spin coupling

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

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

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

More information

Multiple Exciton Generation in Si and Ge Nanoparticles with High Pressure Core Structures

Multiple Exciton Generation in Si and Ge Nanoparticles with High Pressure Core Structures Multiple Exciton Generation in Si and Ge Nanoparticles with High Pressure Core Structures S. Wippermann, M. Vörös, D. Rocca, A. Gali, G. Zimanyi, G. Galli NanoMatFutur DPG-214, 4/3/214 Multiple Exciton

More information

Linear response time-dependent density functional theory

Linear response time-dependent density functional theory Linear response time-dependent density functional theory Emmanuel Fromager Laboratoire de Chimie Quantique, Université de Strasbourg, France fromagere@unistra.fr Emmanuel Fromager (UdS) Cours RFCT, Strasbourg,

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

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

MO Calculation for a Diatomic Molecule. /4 0 ) i=1 j>i (1/r ij )

MO Calculation for a Diatomic Molecule. /4 0 ) i=1 j>i (1/r ij ) MO Calculation for a Diatomic Molecule Introduction The properties of any molecular system can in principle be found by looking at the solutions to the corresponding time independent Schrodinger equation

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

Atomic orbitals of finite range as basis sets. Javier Junquera

Atomic orbitals of finite range as basis sets. Javier Junquera Atomic orbitals of finite range as basis sets Javier Junquera Most important reference followed in this lecture in previous chapters: the many body problem reduced to a problem of independent particles

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

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

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

Computational Methods. Chem 561

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

More information

ELECTRONIC STRUCTURE CALCULATIONS 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

quantum ESPRESSO stands for Quantum open-source Package for Research in Electronic Structure, Simulation, and Optimization

quantum ESPRESSO stands for Quantum open-source Package for Research in Electronic Structure, Simulation, and Optimization The quantum ESPRESSO distribution The IOM-DEMOCRITOS center of Italian CNR is dedicated to atomistic simulations of materials, with a strong emphasis on the development of high-quality scientific software

More information

Pseudopotentials and Basis Sets. How to generate and test them

Pseudopotentials and Basis Sets. How to generate and test them Pseudopotentials and Basis Sets How to generate and test them Pseudopotential idea Atomic Si Core electrons highly localized very depth energy are chemically inert 1s 2 2s 2 2p 6 3s 2 3p 2 Valence wave

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

Electron energy loss spectroscopy (EELS)

Electron energy loss spectroscopy (EELS) Electron energy loss spectroscopy (EELS) Phil Hasnip Condensed Matter Dynamics Group Department of Physics, University of York, U.K. http://www-users.york.ac.uk/~pjh503 Many slides courtesy of Jonathan

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

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

High pressure core structures of Si nanoparticles for solar energy conversion

High pressure core structures of Si nanoparticles for solar energy conversion High pressure core structures of Si nanoparticles for solar energy conversion S. Wippermann, M. Vörös, D. Rocca, A. Gali, G. Zimanyi, G. Galli [Phys. Rev. Lett. 11, 4684 (213)] NSF/Solar DMR-135468 NISE-project

More information

Band calculations: Theory and Applications

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

More information

The Quantum ESPRESSO Software Distribution

The Quantum ESPRESSO Software Distribution The Quantum ESPRESSO Software Distribution The DEMOCRITOS center of Italian INFM is dedicated to atomistic simulations of materials, with a strong emphasis on the development of high-quality scientific

More information

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

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

More information

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

Plane waves, pseudopotentials and PAW. X. Gonze Université catholique de Louvain, Louvain-la-neuve, Belgium

Plane waves, pseudopotentials and PAW. X. Gonze Université catholique de Louvain, Louvain-la-neuve, Belgium Plane waves, pseudopotentials and PAW X. Gonze Université catholique de Louvain, Louvain-la-neuve, Belgium 1 Basic equations in DFT Solve self-consistently the Kohn-Sham equation H ψ n = ε n ψ n!!! ρ(r

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

Introduction to DFT and its Application to Defects in Semiconductors

Introduction to DFT and its Application to Defects in Semiconductors Introduction to DFT and its Application to Defects in Semiconductors Noa Marom Physics and Engineering Physics Tulane University New Orleans The Future: Computer-Aided Materials Design Can access the space

More information

Ab initio study of Mn doped BN nanosheets Tudor Luca Mitran

Ab initio study of Mn doped BN nanosheets Tudor Luca Mitran Ab initio study of Mn doped BN nanosheets Tudor Luca Mitran MDEO Research Center University of Bucharest, Faculty of Physics, Bucharest-Magurele, Romania Oldenburg 20.04.2012 Table of contents 1. Density

More information

Atomic orbitals of finite range as basis sets. Javier Junquera

Atomic orbitals of finite range as basis sets. Javier Junquera Atomic orbitals of finite range as basis sets Javier Junquera Most important reference followed in this lecture in previous chapters: the many body problem reduced to a problem of independent particles

More information

Ab initio calculations for potential energy surfaces. D. Talbi GRAAL- Montpellier

Ab initio calculations for potential energy surfaces. D. Talbi GRAAL- Montpellier Ab initio calculations for potential energy surfaces D. Talbi GRAAL- Montpellier A theoretical study of a reaction is a two step process I-Electronic calculations : techniques of quantum chemistry potential

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

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

Finite Element Analysis of Molecular Rydberg States

Finite Element Analysis of Molecular Rydberg States Excerpt from the Proceedings of the COMSOL Conference 2009 Boston Finite Element Analysis of Molecular Rydberg States M. G. Levy, R. M. Stratt, and P. M. Weber* Brown University Department of Chemistry

More information

Optical & Transport Properties of Carbon Nanotubes II

Optical & Transport Properties of Carbon Nanotubes II Optical & Transport Properties of Carbon Nanotubes II Duncan J. Mowbray Nano-Bio Spectroscopy Group European Theoretical Spectroscopy Facility (ETSF) Donostia International Physics Center (DIPC) Universidad

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

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

Solving Many-Body Schrödinger Equation Using Density Functional Theory and Finite Elements

Solving Many-Body Schrödinger Equation Using Density Functional Theory and Finite Elements Solving Many-Body Schrödinger Equation Using Density Functional Theory and Finite Elements Institute of Physics, Academy of Sciences of the Czech Republic June 21, 2008 Introduction Contens Density Functional

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

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

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

DFT: Exchange-Correlation

DFT: Exchange-Correlation DFT: Local functionals, exact exchange and other post-dft methods Stewart Clark University of Outline Introduction What is exchange and correlation? Quick tour of XC functionals (Semi-)local: LDA, PBE,

More information

The Nature of the Interlayer Interaction in Bulk. and Few-Layer Phosphorus

The Nature of the Interlayer Interaction in Bulk. and Few-Layer Phosphorus Supporting Information for: The Nature of the Interlayer Interaction in Bulk and Few-Layer Phosphorus L. Shulenburger, A.D. Baczewski, Z. Zhu, J. Guan, and D. Tománek, Sandia National Laboratories, Albuquerque,

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