Efficient use of CP2K

Size: px
Start display at page:

Download "Efficient use of CP2K"

Transcription

1 Efficient use of CP2K Fawzi Mohamed 1 1 Department of Chemisty Humboldt University of Berlin June 10, 2009

2 cp2k Fortran 95 opensource (GPL) general framework for different methods DFT no official release

3 Atomistic simulation program Classical MD (FIST) DFT QS Semi empirical (SE) MC montecarlo Polarizable force fields (KG)

4 No release check the regtest cp2k is quite taxing for compilers

5 No release check the regtest cp2k is quite taxing for compilers check the regtest... of your executable

6 No release check the regtest cp2k is quite taxing for compilers check the regtest... of your executable look at regtests to understand input files, but understand the method: regtests are written to be fast never use blindly the parameters of a regtest

7 Documentation of cp2k can be found on the website can be generated by the cp2k executable itself cp2k.sopt [-c check] [-e echo] [-h help] [ html-manual] [ xml] [-r -run] [-o ouput file] [ permissive-echo] [[-i] input file] the documentation generated by the executable is always consistent with its version, website refers to the latest version.

8 Input Syntax sections that start with & and end with &END each section can contain other sections and keywords followed by values section names and the keyword names are case insensitive the special characters # and! denote the beginning of a comment that goes until the end of the line if the value of the keyword is expressed in units, preceding the value by the units in square bracket changes them. The units should have no space. [m] switches to meters. A long line of input can be split using the \ character at the end of the line keywords with a logical value (flags), often have a value that is false when the keyword is missing; the value true when one writes just the keyword, or they can be given an explicit value after the keyword as normal (for example KEYWORD FALSE).

9 Sections can have a default parameter that comes right after the section value. For example the OT section has a logical default parameter that controls the activation of the OT method. So, &OT... &END OT activates the OT method and &OT FALSE... &END OT (or the absence of the OT section) deactivates it.

10 Preprocessor limited preprocessing capabilities that can be filename.inc # includes the VAR value # sets variable ${VAR} or $VAR # expands # conditional statement, no else, no nesting, single condition check

11 Gaussian Plane Waves Density Functional Theory E = n(r)n(r ) 2 r r drdr + n(r)v I (r)+e XC [n]+e II (1) represent density with a localized basis set n(r) = P µν φ µ (r)φ ν (r) (2) use an uniform grid as auxiliary density ñ(r i,j,k ) = P µν φ µ (r i,j,k )φ ν (r i,j,k ) (3) used for the electrostatic part, and E XC

12 Pseudopotentials needed in this approach GTH pseudo are used analytic few parameters accurate harder than other pseudos no non-linear core correction

13 Multigrids Use a constant number of grid points for each gaussian pair combine different grids together memory cost of multi grids 1.5 O(N) collocation force eval/dft/qs/map consistent commensurate grids (QMMM)

14 Gaussian Basis Set Local atom centred ψ jlm (r) = i c j i r l Y lm e α i r 2 (4) basisset file: ATOM BASIS NAME N sets Nl min l max n exp n baslmin...n baslmax α 1 c 0 1 c c α 2 c 0 2 c c... P nbas 1 P nbas α nexp c 0 n exp c 2 n exp...c P n bas n exp 2

15 force eval/dft/mgrid rel cutoff: cutoff for α = 1, 30 reasonably accurate, 50 is very accurate. gaussian collocated on grid with at least α relative cutoff cutoff: cutoff of the finest grid often sharpest gaussians contribute little, if s orbital the cutoff can be a little lower than 2relCutoff (max i α i )

16 Basis Sets Core part is pseudopotential dependent, but rather xc functional independent (i.e. CP2K specific) DFT: e-e cusp description not so important Pseudopotentials less electrons, less BSSE Condensed phase: BSSE mostly a shift wrt. Gas Phase GTH BASISET: atom optimized core part and Dunnings inspired polarization/augmentation BASIS MOLOPT: molecularly optimized basis set, much higher quality for same size. SR (short range) basis set well suited for condensed phase. Normal very good for reference or gasphase (polarization,...) calculation BASIS ZIJLSTRA: fast calculations Diffuse basis (exponent<0.1) are important to describe the decay in gas phase, polarization, but give rise to very bad condition numbers of S in condensed phase

17 GAPW put only part of the density on the uniform grid residual density in the core region use projectors to extract the core region integrate the core density on local atomic grids compensating charge Cutoff can be chosen almost freely can cope with all electron Exact only if projectors are complete atomic grids (radial and lebedev grid) integrate the core density on local atomic grids less tested/robust than GPW

18 Accuracy GPW accuracy cutoff and basis force eval/dft/qs/eps default: convergence of integral calculation, overlap cutoff, neighboring lists... and sets a slew of other eps * keywords so that the KS matrix is calculated with the requested precision. eps scf which controls the convergence of the scf procedure. In general one should have an error ef on the forces one should have eps scf < ef and eps default < eps scf, and in general around 1.e 3 is the error that you need to have reasonable MD.

19 XC force eval/dft/xc important issue, unfortunately results can depend on it I will not discuss it, normally it is a good idea compare with the literature exact exchange or an hybrid functional normally improve the description of barriers and radicals, but are much more costly start with a GGA and meta GGA and switch to hybrid functionals if needed or to check the results

20 Exact exchange force eval/dft/xc/hf truncation needed in periodic systems There are short range exchange functionals all screening methods should be used (computational cost grows very quickly) multiple time step algorithms motion/md/respa should be used

21 Dispersion DFT with GGA or hybrid functionals misses the dispersion contribution Dispersion is important for many systems, especially organic ones Empirical solution use a damped 1 term. Grimme has r 6 parametrized parameters that seem to work quite well. One has to be careful with ions if the parameters were for neutral atoms

22 k-points important for metals CP2K does not (yet) support them, just gamma point supercell approach

23 Smearing fermions, Pauli repulsion, energy levels normally filled up to high level (wrt. kt) OK good approximation for electrons. small or 0 gap can have some smearing at finite temperature useful to simulate it to reduce computational cost force eval/dft/scf/added mos force eval/dft/scf/smear

24 Diagonalization Usual method needs full ao x ao matrixes (memory) Mixing, Broyden, DIIS, multisecant (careful: history increases memory footprint) works well with smearing

25 Orbital Transform minimize directly the occupied subspace, using a smart parameterization (orthogonality constraint becomes a linear), is a simpler problem with correct linesearch guaranteed to converge convergence speed depends preconditioner ao x nel matrices (more memory friendly) without rotations does not optimize the single eigenvectors restricted open shell, smearing

26 force eval/dft/scf/ot in general the usage of OT if possible is a good idea. if the gap is small the convergence slows down full all preconditioner is the best for non huge systems and difficult systems, but does not converge if gap of the H matrix < energy gap is normally a good choice kinetic preconditioner can cope with huge systems for difficult systems linesearch 3pnt and CG optimizing method should be used the force eval/dft/scf/outer scf section, with eps scf equal to the one of the scf loop, and chooing a outer max scf big enough (the total number of iteration is the product of internal and external max scf) as the preconditioner construction can be costly inner scf should be 20-30

27 Restarts, extrapolation force eval/dft/scf/scf guess restart controls how the initial density is built, normally one uses either ATOMIC or RESTART. During an MD this setting normally influences only the initial startup. force eval/dft/qs/extrapolation ASPC is a good extrapolation method extrapolation order controls the extrapolation order MD or continuos processes are advantaged by order like 3, more discontinuous processes work better with smaller values also this history vector uses memory

28 Geometry optimization when usable BFGS is normally the best choice if you are very far the trust radius can slow down convergence LBFGS uses less memory, CG even less, but normally this is relevant for classical systems as wave functions use much more memory (but geo opt memory is replicated) One can fix atoms, not all constraints are kept with all optimizers can be used also to find saddle points

29 Cell Optimization condensed phase, small change in the cell can give huge energy changes important to optimize the bulk cell for surfaces (unless they are fully frozen) pressure convergence is expensive, expect large oscillations variation of the cell introduces Basiset dependent forces in both planewaves and local basis sets energy changes discontinuously with respect to both

30 MD Molecular dynamics a good method to perform themodynamical averages, and to look at dynamical properties. It also a good starting point for many other more advanced techniques. Born Oppenheimer MD: no fictitious mass (now also Erenfest dynamics is available) extrapolation improves much the timings (with ASPC there is also a method that does not converge the wavefunctions fully motion/print/trajectory controls the output of the trajectory the name of the file is by default projectname-pos-1.xyz and projectname is whatever you have written in global/project. the format can be changed from xyz to something else.

31 NVE least Energy conservation has normally two features, short time oscillations (that are larger when the system is not yet equilibrated) and a long range drift. expressed in K/atom and compared to the temperature it is a sensitive test if the system is correctly set up for very heterogeneous system with a small interesting part, checking that part of the system (oscillations, kinetic energy,...) is advisable. starting point should be equilibrated (apart when doing shooting or transition path sampling) build your system in some meaningful way, or from classical simulations temperature is not constant, but does oscillates oscillations connected with specific heat and inversely proportional with system size

32 NVT Needed to equilibrate motion/md/temp tol rescale if velocity is too far away from target CSVR Thermostat, correct oscillations of energy (from Langevin dynamics), a little expensive Nose Hoover chain thermostat, physical, has an extended conserved quantity, not good if far from equilibrium for very long trajectory a weakly coupled thermostat can be useful to compensate the drift

33 NPT equilibrate also the volume pressure is difficult to equilibrate in timescales accessible ab initio same thermostats as before also for the volume/pressure

34 Langevin Langevin introduces a viscous dissipative force and a random forces that are in equilibrium at the given temperature. to simulate removed degrees of freedom, like a solvent can be used also to equilibrate a system gamma of [1/fs] (or larger if you want to equilibrate faster) the smaller gamma the longer it takes to equilibrate, and the closer the trajectory is to an NVE trajectory, the larger gamma the more the environment influences the system similar to a massive CSVR thermostat reduces inhomogeneous energy distribution faster if your system is in a very bad initial configuration it is a good idea to set a temp tol, or first anneal a little the system.

35 Multiple timesteps motion/md/respa allows one to define several force eval advantageous when one has an approximate method that is fast to compute difference between the forges should be long range (low frequncy) evaluate costly method only each few steps can allow for large speedups

36 Conclusions Cp2k has a broad range of methods available that can be combined The DFT part (and GPW in particular) is highly efficient hybrid functionals can be used and their calculation scales well Several sampling methods are available (and we focused on MD based ones) much more is possible...

37 Thanks to the other cp2k developers M. Parinello Prof. J. Sauer and his group for support the Humboldt foundation for financial support the organizers for inviting me... you for your attention

XYZ file format Protein Data Bank (pdb) file format Z - matrix

XYZ file format Protein Data Bank (pdb) file format Z - matrix Chemistry block (exercise 1) In this exercise, students will be introduced how to preform simple quantum chemical calculations. Input files for Gaussian09. Output file structure. Geometry optimization,

More information

Calculating Vibrational Spectra from Molecular Dynamics

Calculating Vibrational Spectra from Molecular Dynamics Calculating Vibrational Spectra from Molecular Dynamics A Simulating a Trajectory with Wannier Centers To calculate IR spectra from Molecular Dynamics, it is necessary to have dipole information for the

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

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

What is Classical Molecular Dynamics?

What is Classical Molecular Dynamics? What is Classical Molecular Dynamics? Simulation of explicit particles (atoms, ions,... ) Particles interact via relatively simple analytical potential functions Newton s equations of motion are integrated

More information

Ab initio molecular dynamics. Simone Piccinin CNR-IOM DEMOCRITOS Trieste, Italy. Bangalore, 04 September 2014

Ab initio molecular dynamics. Simone Piccinin CNR-IOM DEMOCRITOS Trieste, Italy. Bangalore, 04 September 2014 Ab initio molecular dynamics Simone Piccinin CNR-IOM DEMOCRITOS Trieste, Italy Bangalore, 04 September 2014 What is MD? 1) Liquid 4) Dye/TiO2/electrolyte 2) Liquids 3) Solvated protein 5) Solid to liquid

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

A Nobel Prize for Molecular Dynamics and QM/MM What is Classical Molecular Dynamics? Simulation of explicit particles (atoms, ions,... ) Particles interact via relatively simple analytical potential

More information

CP2K: Past, Present, Future. Jürg Hutter Department of Chemistry, University of Zurich

CP2K: Past, Present, Future. Jürg Hutter Department of Chemistry, University of Zurich CP2K: Past, Present, Future Jürg Hutter Department of Chemistry, University of Zurich Outline Past History of CP2K Development of features Present Quickstep DFT code Post-HF methods (RPA, MP2) Libraries

More information

Day 1 : Introduction to AIMD and PIMD

Day 1 : Introduction to AIMD and PIMD Day 1 : Introduction to AIMD and PIMD Aug 2018 In today s exercise, we perform ab-initio molecular dynamics (AIMD) and path integral molecular dynamics (PIMD) using CP2K[?]. We will use the Zundel s cation

More information

Institut Néel Institut Laue Langevin. Introduction to electronic structure calculations

Institut Néel Institut Laue Langevin. Introduction to electronic structure calculations Institut Néel Institut Laue Langevin Introduction to electronic structure calculations 1 Institut Néel - 25 rue des Martyrs - Grenoble - France 2 Institut Laue Langevin - 71 avenue des Martyrs - Grenoble

More information

DFT with Hybrid Functionals

DFT with Hybrid Functionals DFT with Hybrid Functionals Sanliang Ling University College London 4th CP2K Tutorial, 31st August 4th September 2015, Zurich What are hybrid functionals? Hybrid functionals: mixing non-local Hartree-Fock

More information

Post Hartree-Fock: MP2 and RPA in CP2K

Post Hartree-Fock: MP2 and RPA in CP2K Post Hartree-Fock: MP2 and RPA in CP2K A tutorial Jan Wilhelm jan.wilhelm@chem.uzh.ch 4 September 2015 Further reading MP2 and RPA by Mauro Del Ben, Jürg Hutter, Joost VandeVondele Del Ben, M; Hutter,

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

MD Thermodynamics. Lecture 12 3/26/18. Harvard SEAS AP 275 Atomistic Modeling of Materials Boris Kozinsky

MD Thermodynamics. Lecture 12 3/26/18. Harvard SEAS AP 275 Atomistic Modeling of Materials Boris Kozinsky MD Thermodynamics Lecture 1 3/6/18 1 Molecular dynamics The force depends on positions only (not velocities) Total energy is conserved (micro canonical evolution) Newton s equations of motion (second order

More information

Practical calculations using first-principles QM Convergence, convergence, convergence

Practical calculations using first-principles QM Convergence, convergence, convergence Practical calculations using first-principles QM Convergence, convergence, convergence Keith Refson STFC Rutherford Appleton Laboratory September 18, 2007 Results of First-Principles Simulations..........................................................

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

Pseudopotential methods for DFT calculations

Pseudopotential methods for DFT calculations Pseudopotential methods for DFT calculations Lorenzo Paulatto Scuola Internazionale Superiore di Studi Avanzati and CNR-INFM DEMOCRITOS National Simulation Center Tieste Italy July 9, 2008 Outline pseudopotential

More information

Ab initio molecular dynamics

Ab initio molecular dynamics Ab initio molecular dynamics Kari Laasonen, Physical Chemistry, Aalto University, Espoo, Finland (Atte Sillanpää, Jaakko Saukkoriipi, Giorgio Lanzani, University of Oulu) Computational chemistry is a field

More information

Geometry Optimisation

Geometry Optimisation Geometry Optimisation Matt Probert Condensed Matter Dynamics Group Department of Physics, University of York, UK http://www.cmt.york.ac.uk/cmd http://www.castep.org Motivation Overview of Talk Background

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

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

Computational Chemistry I

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

More information

Advanced Molecular Molecular Dynamics

Advanced Molecular Molecular Dynamics Advanced Molecular Molecular Dynamics Technical details May 12, 2014 Integration of harmonic oscillator r m period = 2 k k and the temperature T determine the sampling of x (here T is related with v 0

More information

Hybrid Functionals, van der Waals Corrections and ASE Interface to CP2K

Hybrid Functionals, van der Waals Corrections and ASE Interface to CP2K Hybrid Functionals, van der Waals Corrections and ASE Interface to CP2K Sanliang Ling University College London CP2K Summer School, 23rd - 26th August 2016, King's College London Part I: Hybrid Functionals

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

Ab Initio Molecular Dynamics

Ab Initio Molecular Dynamics Ab Initio Molecular Dynamics Molecular Dynamics Classical equations of motion for the ions: F=ma NVE and other ensembles (NVT, NPT) Crucial for systems including liquids 'Ab Initio' or 'First Principles'

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

Example questions for Molecular modelling (Level 4) Dr. Adrian Mulholland

Example questions for Molecular modelling (Level 4) Dr. Adrian Mulholland Example questions for Molecular modelling (Level 4) Dr. Adrian Mulholland 1) Question. Two methods which are widely used for the optimization of molecular geometies are the Steepest descents and Newton-Raphson

More information

Ab initio molecular dynamics

Ab initio molecular dynamics Ab initio molecular dynamics Molecular dynamics Why? allows realistic simulation of equilibrium and transport properties in Nature ensemble averages can be used for statistical mechanics time evolution

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

Introduction to CPMD 1

Introduction to CPMD 1 Introduction to CPMD 1 CPMD program ab initio electronic structure (DFT) and molecular dynamics program plane wave basis set (PBC), pseudopotentials massively parallelized, linear scaling up to thousands

More information

Langevin Dynamics in Constant Pressure Extended Systems

Langevin Dynamics in Constant Pressure Extended Systems Langevin Dynamics in Constant Pressure Extended Systems D. Quigley and M.I.J. Probert CMMP 2004 1 Talk Outline Molecular dynamics and ensembles. Existing methods for sampling at NPT. Langevin dynamics

More information

Systematic convergence for realistic projects Fast versus accurate

Systematic convergence for realistic projects Fast versus accurate Systematic convergence for realistic projects Fast versus accurate Daniel Sánchez-Portal Centro de Física de Materiales, Centro Mixto CSIC- UPV/EHU,San Sebastián, Spain Email: sqbsapod@sc.ehu.es Thanks

More information

Supporting Information for. Dynamics Study"

Supporting Information for. Dynamics Study Supporting Information for "CO 2 Adsorption and Reactivity on Rutile TiO 2 (110) in Water: An Ab Initio Molecular Dynamics Study" Konstantin Klyukin and Vitaly Alexandrov,, Department of Chemical and Biomolecular

More information

Hands-on : Model Potential Molecular Dynamics

Hands-on : Model Potential Molecular Dynamics Hands-on : Model Potential Molecular Dynamics OUTLINE 0. DL_POLY code introduction 0.a Input files 1. THF solvent molecule 1.a Geometry optimization 1.b NVE/NVT dynamics 2. Liquid THF 2.a Equilibration

More information

Exercise 1: Structure and dipole moment of a small molecule

Exercise 1: Structure and dipole moment of a small molecule Introduction to computational chemistry Exercise 1: Structure and dipole moment of a small molecule Vesa Hänninen 1 Introduction In this exercise the equilibrium structure and the dipole moment of a small

More information

Ab initio molecular dynamics: Basic Theory and Advanced Met

Ab initio molecular dynamics: Basic Theory and Advanced Met Ab initio molecular dynamics: Basic Theory and Advanced Methods Uni Mainz October 30, 2016 Bio-inspired catalyst for hydrogen production Ab-initio MD simulations are used to learn how the active site

More information

Introduction to molecular dynamics

Introduction to molecular dynamics 1 Introduction to molecular dynamics Yves Lansac Université François Rabelais, Tours, France Visiting MSE, GIST for the summer Molecular Simulation 2 Molecular simulation is a computational experiment.

More information

Accelerated Quantum Molecular Dynamics

Accelerated Quantum Molecular Dynamics Accelerated Quantum Molecular Dynamics Enrique Martinez, Christian Negre, Marc J. Cawkwell, Danny Perez, Arthur F. Voter and Anders M. N. Niklasson Outline Quantum MD Current approaches Challenges Extended

More information

Basic introduction of NWChem software

Basic introduction of NWChem software Basic introduction of NWChem software Background NWChem is part of the Molecular Science Software Suite Designed and developed to be a highly efficient and portable Massively Parallel computational chemistry

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

CHE3935. Lecture 4 Quantum Mechanical Simulation Methods Continued

CHE3935. Lecture 4 Quantum Mechanical Simulation Methods Continued CHE3935 Lecture 4 Quantum Mechanical Simulation Methods Continued 1 OUTLINE Review Introduction to CPMD MD and ensembles The functionals of density functional theory Return to ab initio methods Binding

More information

Introduction to Density Functional Theory with Applications to Graphene Branislav K. Nikolić

Introduction to Density Functional Theory with Applications to Graphene Branislav K. Nikolić Introduction to Density Functional Theory with Applications to Graphene Branislav K. Nikolić Department of Physics and Astronomy, University of Delaware, Newark, DE 19716, U.S.A. http://wiki.physics.udel.edu/phys824

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

Ab initio molecular dynamics and nuclear quantum effects

Ab initio molecular dynamics and nuclear quantum effects Ab initio molecular dynamics and nuclear quantum effects Luca M. Ghiringhelli Fritz Haber Institute Hands on workshop density functional theory and beyond: First principles simulations of molecules and

More information

Classical Molecular Dynamics

Classical Molecular Dynamics Classical Molecular Dynamics Matt Probert Condensed Matter Dynamics Group Department of Physics, University of York, U.K. http://www-users.york.ac.uk/~mijp1 Overview of lecture n Motivation n Types of

More information

Basis Set for Molecular Orbital Theory

Basis Set for Molecular Orbital Theory Basis Set for Molecular Orbital Theory! Different Types of Basis Functions! Different Types of Atom Center Basis Functions! Classifications of Gaussian Basis Sets! Pseudopotentials! Molecular Properties

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

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

Supporting information

Supporting information Electronic Supplementary Material ESI for Physical Chemistry Chemical Physics. This journal is the Owner Societies 2018 Supporting information Understanding three-body contributions to coarse-grained force

More information

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

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

More information

Interatomic Potentials. The electronic-structure problem

Interatomic Potentials. The electronic-structure problem Interatomic Potentials Before we can start a simulation, we need the model! Interaction between atoms and molecules is determined by quantum mechanics: Schrödinger Equation + Born-Oppenheimer approximation

More information

DFT in practice. Sergey V. Levchenko. Fritz-Haber-Institut der MPG, Berlin, DE

DFT in practice. Sergey V. Levchenko. Fritz-Haber-Institut der MPG, Berlin, DE DFT in practice Sergey V. Levchenko Fritz-Haber-Institut der MPG, Berlin, DE Outline From fundamental theory to practical solutions General concepts: - basis sets - integrals and grids, electrostatics,

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

Electronic Structure of Surfaces

Electronic Structure of Surfaces Electronic Structure of Surfaces When solids made of an infinite number of atoms are formed, it is a common misconception to consider each atom individually. Rather, we must consider the structure of the

More information

Potentials, periodicity

Potentials, periodicity Potentials, periodicity Lecture 2 1/23/18 1 Survey responses 2 Topic requests DFT (10), Molecular dynamics (7), Monte Carlo (5) Machine Learning (4), High-throughput, Databases (4) NEB, phonons, Non-equilibrium

More information

CPMD Tutorial Atosim/RFCT 2009/10

CPMD Tutorial Atosim/RFCT 2009/10 These exercices were inspired by the CPMD Tutorial of Axel Kohlmeyer http://www.theochem.ruhruni-bochum.de/ axel.kohlmeyer/cpmd-tutor/index.html and by other tutorials. Here is a summary of what we will

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

AN INTRODUCTION TO QUANTUM CHEMISTRY. Mark S. Gordon Iowa State University

AN INTRODUCTION TO QUANTUM CHEMISTRY. Mark S. Gordon Iowa State University AN INTRODUCTION TO QUANTUM CHEMISTRY Mark S. Gordon Iowa State University 1 OUTLINE Theoretical Background in Quantum Chemistry Overview of GAMESS Program Applications 2 QUANTUM CHEMISTRY In principle,

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

Same idea for polyatomics, keep track of identical atom e.g. NH 3 consider only valence electrons F(2s,2p) H(1s)

Same idea for polyatomics, keep track of identical atom e.g. NH 3 consider only valence electrons F(2s,2p) H(1s) XIII 63 Polyatomic bonding -09 -mod, Notes (13) Engel 16-17 Balance: nuclear repulsion, positive e-n attraction, neg. united atom AO ε i applies to all bonding, just more nuclei repulsion biggest at low

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

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

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

HECToR CSE technical meeting, Oxford Parallel Algorithms for the Materials Modelling code CRYSTAL

HECToR CSE technical meeting, Oxford Parallel Algorithms for the Materials Modelling code CRYSTAL HECToR CSE technical meeting, Oxford 2009 Parallel Algorithms for the Materials Modelling code CRYSTAL Dr Stanko Tomi Computational Science & Engineering Department, STFC Daresbury Laboratory, UK Acknowledgements

More information

OPENATOM for GW calculations

OPENATOM for GW calculations OPENATOM for GW calculations by OPENATOM developers 1 Introduction The GW method is one of the most accurate ab initio methods for the prediction of electronic band structures. Despite its power, the GW

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

OVERVIEW OF QUANTUM CHEMISTRY METHODS

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

More information

Materials that you may find helpful when working through this exercise

Materials that you may find helpful when working through this exercise Detailed steps illustrating how to use VASP on the Suns in Fitz 177 For use in lab: 11/10/2009 (Original file by Dr. Rachel Getman, 11/18/2007. Editted for use by Dorrell McCalman 11/09/2009.) Note on

More information

Recent advances in development of single-point orbital-free kinetic energy functionals

Recent advances in development of single-point orbital-free kinetic energy functionals PacifiChem 2010 p. 1/29 Recent advances in development of single-point orbital-free kinetic energy functionals Valentin V. Karasiev vkarasev@qtp.ufl.edu Quantum Theory Project, Departments of Physics and

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

Computer simulation methods (2) Dr. Vania Calandrini

Computer simulation methods (2) Dr. Vania Calandrini Computer simulation methods (2) Dr. Vania Calandrini in the previous lecture: time average versus ensemble average MC versus MD simulations equipartition theorem (=> computing T) virial theorem (=> computing

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

CP2K: Selected Developments

CP2K: Selected Developments CP2K: Selected Developments Jürg Hutter Department of Chemistry University of Zurich Outline Introduction History and Performance Current and Future Developments Post-Hartree-Fock Methods GW Methods RPA

More information

Simulation of molecular systems by molecular dynamics

Simulation of molecular systems by molecular dynamics Simulation of molecular systems by molecular dynamics Yohann Moreau yohann.moreau@ujf-grenoble.fr November 26, 2015 Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, 2015 1 / 35 Introduction

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

Summary of the new Modelling Vocabulary

Summary of the new Modelling Vocabulary Summary of the new Modelling Vocabulary These two pages attempts to summarise in a concise manner the Modelling Vocabulary. What are Models? What are Simulations? Materials Models consist of Physics or

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

Molecular Mechanics. I. Quantum mechanical treatment of molecular systems

Molecular Mechanics. I. Quantum mechanical treatment of molecular systems Molecular Mechanics I. Quantum mechanical treatment of molecular systems The first principle approach for describing the properties of molecules, including proteins, involves quantum mechanics. For example,

More information

Molecular Orbitals for Ozone

Molecular Orbitals for Ozone Molecular Orbitals for Ozone Purpose: In this exercise you will do semi-empirical molecular orbital calculations on ozone with the goal of understanding the molecular orbital print out provided by Spartan

More information

Exercise 2: Solvating the Structure Before you continue, follow these steps: Setting up Periodic Boundary Conditions

Exercise 2: Solvating the Structure Before you continue, follow these steps: Setting up Periodic Boundary Conditions Exercise 2: Solvating the Structure HyperChem lets you place a molecular system in a periodic box of water molecules to simulate behavior in aqueous solution, as in a biological system. In this exercise,

More information

Molecular Simulation I

Molecular Simulation I Molecular Simulation I Quantum Chemistry Classical Mechanics E = Ψ H Ψ ΨΨ U = E bond +E angle +E torsion +E non-bond Jeffry D. Madura Department of Chemistry & Biochemistry Center for Computational Sciences

More information

2 Electronic structure theory

2 Electronic structure theory Electronic structure theory. Generalities.. Born-Oppenheimer approximation revisited In Sec..3 (lecture 3) the Born-Oppenheimer approximation was introduced (see also, for instance, [Tannor.]). We are

More information

Chm 331 Fall 2015, Exercise Set 4 NMR Review Problems

Chm 331 Fall 2015, Exercise Set 4 NMR Review Problems Chm 331 Fall 015, Exercise Set 4 NMR Review Problems Mr. Linck Version.0. Compiled December 1, 015 at 11:04:44 4.1 Diagonal Matrix Elements for the nmr H 0 Find the diagonal matrix elements for H 0 (the

More information

Translation Symmetry, Space Groups, Bloch functions, Fermi energy

Translation Symmetry, Space Groups, Bloch functions, Fermi energy Translation Symmetry, Space Groups, Bloch functions, Fermi energy Roberto Orlando and Silvia Casassa Università degli Studi di Torino July 20, 2015 School Ab initio Modelling of Solids (UniTo) Symmetry

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

Density Functional Theory: from theory to Applications

Density Functional Theory: from theory to Applications Density Functional Theory: from theory to Applications Uni Mainz May 14, 2012 All electrons vs pseudopotentials Classes of Basis-set Condensed phase: Bloch s th and PBC Hamann-Schlüter-Chiang pseudopotentials

More information

Handbook of Computational Quantum Chemistry. DAVID B. COOK The Department of Chemistry, University of Sheffield

Handbook of Computational Quantum Chemistry. DAVID B. COOK The Department of Chemistry, University of Sheffield Handbook of Computational Quantum Chemistry DAVID B. COOK The Department of Chemistry, University of Sheffield Oxford New York Tokyo OXFORD UNIVERSITY PRESS 1998 CONTENTS 1 Mechanics and molecules 1 1.1

More information

Supporting Information for. Ab Initio Metadynamics Study of VO + 2 /VO2+ Redox Reaction Mechanism at the Graphite. Edge Water Interface

Supporting Information for. Ab Initio Metadynamics Study of VO + 2 /VO2+ Redox Reaction Mechanism at the Graphite. Edge Water Interface Supporting Information for Ab Initio Metadynamics Study of VO + 2 /VO2+ Redox Reaction Mechanism at the Graphite Edge Water Interface Zhen Jiang, Konstantin Klyukin, and Vitaly Alexandrov,, Department

More information

Wavefunction and electronic struture in solids: Bloch functions, Fermi level and other concepts.

Wavefunction and electronic struture in solids: Bloch functions, Fermi level and other concepts. Wavefunction and electronic struture in solids: Bloch functions, Fermi level and other concepts. Silvia Casassa Università degli Studi di Torino July 12, 2017 Minnesota Workshop on ab initio MSC Symmetry

More information

Many electrons: Density functional theory Part II. Bedřich Velický VI.

Many electrons: Density functional theory Part II. Bedřich Velický VI. Many electrons: Density functional theory Part II. Bedřich Velický velicky@karlov.mff.cuni.cz VI. NEVF 514 Surface Physics Winter Term 013-014 Troja 1 st November 013 This class is the second devoted to

More information

All-electron density functional theory on Intel MIC: Elk

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

More information

GWL tutorial. Paolo Umari, Università degli Studi di Padova, Italy Democritos, Trieste

GWL tutorial. Paolo Umari, Università degli Studi di Padova, Italy Democritos, Trieste GWL tutorial Paolo Umari, Università degli Studi di Padova, Italy Democritos, Trieste GW calculation with QE and GWL Benfits: Optimal basis (reduced) for representing polarizabilty operators Full convergence

More information

NWChem: Hartree-Fock, Density Functional Theory, Time-Dependent Density Functional Theory

NWChem: Hartree-Fock, Density Functional Theory, Time-Dependent Density Functional Theory NWChem: Hartree-Fock, Density Functional Theory, Time-Depent Density Functional Theory Hartree-Fock! Functionality! Input! Wavefunctions! Initial MO vectors! Direct and semidirect algorithms! Convergence,

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

Non-bonded interactions

Non-bonded interactions speeding up the number-crunching continued Marcus Elstner and Tomáš Kubař December 3, 2013 why care? number of individual pair-wise interactions bonded interactions proportional to N: O(N) non-bonded interactions

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

Density Functional Theory: from theory to Applications

Density Functional Theory: from theory to Applications Density Functional Theory: from theory to Applications Uni Mainz May 27, 2012 Large barrier-activated processes time-dependent bias potential extended Lagrangian formalism Basic idea: during the MD dynamics

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