One-sided Communication Implementation in FMO Method

Size: px
Start display at page:

Download "One-sided Communication Implementation in FMO Method"

Transcription

1 One-sided Communication mplementation in FMO Method J. Maki, Y. nadomi, T. Takami, R. Susukita, H. Honda, J. Ooba, T. obayashi, R. Nogita,. noue and M. Aoyagi Computing and Communications Center, yushu University Fukuoka ndustry, Science & Technology Foundation

2 Overview of FMO method (1) FMO(Fragment Molecular Orbital method) has been developed by itaura (AST) and co-workers to calculate electronic states of a macromolecule such as a protein and nucleotide The target molecule is divided into fragments (monomers) ab initio molecular orbital (MO) calculation is carried out on each fragment and fragment pair (dimer). Usually executed with high parallel efficiency (>90%) The method can execute all-electron calculation on a protein molecule with 10,000 atoms.

3 Example of fragmentation

4 Overview of FMO method (2) monomer calculation Hamiltonian environmental electrostatic potential ρ J ( ri) [ ] J i H h V = + + i J i> j ( r) 1 r r (potential from other monomers) electron density of monomer J V J A monomer calculation depends on other monomers electron density A i j i, j ( r ) J Z ρ J A = + r R r r dr iterated until all electron densities unchanged (SCC procedure)

5 Overview of FMO method (3) Schrødinger equation H Ψ = E Ψ RHF (Restricted Hartree-Fock) SCF method Molecular Orbital (MO) { C ij} MO coefficients basis functions { χ } j electron density D = 2 CC jk i ji ki ϕi ( r) = χ ( r) C j j ρ = 2 χ χ CC = χ χ D ji j k ji ki j jk jk i jk density matrix elements N N b b N b number of basis functions

6 Overview of FMO method (4) dimer calculation Hamiltonian environmental electrostatic potential ( ri) [ ] i J H h V = + + i J, J i> j J V ( r) A A 1 r r i i, j j ( r ) Z ρ A = + r R r r dr Schrødinger equation Total energy H Ψ = E Ψ J J J J J E = E ( N 2) E > J not all dimers are calculated by SCF

7 dimer-es approximation For distant dimers, SCF calculation are not carried out Energy is calculated by electrostatic approximation ES (non-scf) dimer monomer SCF dimer ρ J ( r ) ρ ( r ) J J 1 2 E E + E dr1dr2 r1 r2

8 Flow chart of FMO calculation initial density calculation { D 0 } electronic structure calculation for monomer H not yet converged Ψ = E Ψ convergence check of SCC procedure already converged electronic structure calculation for SCF-dimer J J J J H Ψ = E Ψ SCC procedure ES dimer calculation J ρ ( r ) ρ ( r ) J J 1 2 E E + E dr1dr2 r1 r2 total energy calculation J E = E ( N 2) E > J For all monomers For all SCF-dimers For all separated dimers

9 Density requirements and update in FMO calculation initial density calculation { D 0 } electronic structure calculation for monomer H not yet converged convergence check of SCC procedure already converged electronic structure calculation for SCF-dimer J J J J H ES-dimer calculation J ρ ( r ) ρ ( r ) total energy calculation Ψ = E Ψ Ψ = E Ψ J J 1 2 E E + E dr1dr2 r1 r2 J E = E ( N 2) E > J SCC procedure update monomer density matrices refer monomer matrices needed in electronic structure calculation update monomer density matrices refer monomer matrices needed in electronic structure calculation refer two monomer matrices needed in dimer-es calculation For all monomers For all SCF-dimers For all separated dimers Update all monomer density matrices Refer some monomer density matrices

10 matrix element of χ V = χ r V r r dr ij i j A ( r ) ρ = χ r χ r r + χ r χ r dr dr kl, Z A i j d i j r RA i, j r r involves 4 center tow electron integrals ρ ( r ) χi ( r) dr χ j ( r) dr r r = V ij ( r) ( r) ( r ) ( r ) χ χ χ χ i j k l dr dr Dkl r r order of calculation costs Approximation of V J calculation (1) J V r (needed in SCF calculation) b N b O N b 4-center two electron integral calculations for all environment monomers are prohibitive number of basis functions

11 Approximation of V J J calculation (2) esp-aoc approximation ( r) i r i r D S ρ χ χ S i ( D S ) ii ( r ) χ ( r ) χ V ( r) + dr D S r R r r Z A i i A overlapmatrix of fragment ( S = χ r χ r dr ) Mulliken AO population of A i ii ij i j χi ( r) ii

12 Approximation of V J J calculation (3) esp-ptc approximation ρ ( r) δ ( r R ) Q Q A A A Q = D S = D S A A ii ij ji i A i A, j point charge approx. of Mulliken atomic charge of the nucleus A V A A ( r) Z Q + r R r R A A A A N4C number of environment monomers for which 4-center two electron integral calculations are carried out

13 Hypothetical petascale computing environment Number of CPUs : 1PFlops = 100,000 CPU (current one CPU peak performance ~10GFlops) Number of fragments N f : 10, ,000 (the current largest N f ~1,000)

14 Memory requirement in FMO Number of fragments The size of one density matrix D 350B nterfragment distance data N 2 f / 2 N f R J N f D R J 1, MB 4MB 5, GB 95MB 10, GB 380MB 50,000 17GB 9.3GB 100,000 34GB 37GB Memory per one CPU core > 10 GB t is difficult for each process to store all necessary data

15 OSC implementation in OpenFMO (1) n its execution, only the process of rank 0 is used as a server process for dynamic load balancing. All the other processes are worker processes and are divided into groups and the two-level parallelization is used as the other implementations. Group00 Group01 Group02 node00 node01 node02 node03 node

16 OSC implementation in OpenFMO (2) Group00 Group01 Group02 node00 node01 node02 node03 node MP_Get memory window created by MP_Win density matrix data

17 Estimation of communication cost (1) Assumptions 1. The sizes of all density matrices are the same.all groups have the same number of worker processes. 2. The time to put or get one density matrix is equal to the average point-to-point communication time. 3. MP_Bcast implements a binomial tree algorithm so that the time to broadcast one density matrix over N processes is obtained by t log N. p2p 2 4. And for OSC scheme, dynamic load balancing works well and the delay due to competing put or get requests is ignorable. Therefore all groups execute the same number of monomer and dimer jobs and this means that all groups have the same Nproc / Ngroup

18 Estimation of communication cost (2) N proc N f Nproc / N group 10, ,000 96, NSCC mon N4C dim N4C dim N SCF tp2p SCC iterations neighboring monomers (average) neighboring monomers (average) monomers with which a monomer forms a SCF dimer SCF dimers N N f dim /2 SCF point-to-point communication time to transfer one density matrix

19 Estimation of communication cost (3) OSC scheme number of monomer get requests total number of dimers number of SCF dimers number of SCFdimer get requests N N N N N mon mon get = SCC f 4C + 1 f N N f N 1/2 f dim /2 SCF dim dim dim get = f SCF 4C + 2 /2 N N N N number of ES dimers number of ES dimer get requests N N 1/2 N N /2 f f f dim SCF es dim Nget = N f N f 1/2 N fnscf /2 2 total number of get requests N = N + N + N mon dim es get get get get = N N ( N + 1) SCC f mon 4C + N N N /2+ N N 1 dim dim f SCF 4C f f

20 Estimation of communication cost (4) OSC scheme cost of MP_Bcast cost for one get requests tp2p log2 N t ( 1+ log N / N ) p2p 2 proc group total cost of put requests total cost per one group T = N N t / N OSC SCC f p2p group N N t / N SCC f p2p group + t 1+ log N / N N / N p2p 2 proc group get group Bcast scheme total cost per one group = T N N t log N Bcast SCC f p2p 2 proc

21 Estimation of communication cost (5)

22 Simulation using skelton code (1) FMO calculation was simulated using skelton code quantum calculation parts are removed Skelton code accumulates estimated time of : molecular integral calculation Fock matrix builging, SCF procedure Time of each communication are estimated and accumulated MP_Send, MP_recv, MP_get, MP_put estimated from measurements MP_Bcast, MP_Allreduce estimated from point to point communication time by assuming binomial tree, butterfly algorithm

23 Simulation using skelton code (2) integral calculation time estimation formula integrals required for environmental potential 1 electron f N = AN + BN A= E-05 B= E-08 f N = AN + BN 2 electron (3center) A= E-05 B= E-07 Fock builging time estimation env 2 1e b b b env 2 2e3C b b b 2 electron (4center) f N = AN + BN A= B= E-06 integrals required for SCF f N = AN + BN A= E-05 B= E-07 A= E-05 B= E-06 env 2 2e4C b b b 2 3 2e b b b 2 3 = + f N AN BN Fock b b b

24 simulation using skelton codes (3) Aquaporin protein PDBD 2F2B, N f =492, 14,492 atoms 6-31G* basis set Nproc / N group =16 N group =4, 8, 16, 32, 64 OSC cost < Bcast cost with Nproc > 512 ( Ngroup > 32) Linux cluster in REN Super Combined Cluster (RSCC) was used

25 Summary OSC of MP-2 standard has been implemented in a new FMO code to reduce the memory requirement per process. OSC implementation also makes the exchange of by broadcast unnecessary. Evaluation of communication costs shows that OSC scheme has an advantage over the Bcast scheme for N f =10, ,000, Nproc =96,000. Simulations using skelton code also show that OSC scheme has an advantage in communication cost with large Ngroup. These results show OSC scheme is prospective for the petascale computing environment. D

Direct Self-Consistent Field Computations on GPU Clusters

Direct Self-Consistent Field Computations on GPU Clusters Direct Self-Consistent Field Computations on GPU Clusters Guochun Shi, Volodymyr Kindratenko National Center for Supercomputing Applications University of Illinois at UrbanaChampaign Ivan Ufimtsev, Todd

More information

Fragmentation methods

Fragmentation methods Fragmentation methods Scaling of QM Methods HF, DFT scale as N 4 MP2 scales as N 5 CC methods scale as N 7 What if we could freeze the value of N regardless of the size of the system? Then each method

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

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

Lecture 5: More about one- Final words about the Hartree-Fock theory. First step above it by the Møller-Plesset perturbation theory.

Lecture 5: More about one- Final words about the Hartree-Fock theory. First step above it by the Møller-Plesset perturbation theory. Lecture 5: More about one- determinant wave functions Final words about the Hartree-Fock theory. First step above it by the Møller-Plesset perturbation theory. Items from Lecture 4 Could the Koopmans theorem

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

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

ab initio Electronic Structure Calculations

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

More information

Using Web-Based Computations in Organic Chemistry

Using Web-Based Computations in Organic Chemistry 10/30/2017 1 Using Web-Based Computations in Organic Chemistry John Keller UAF Department of Chemistry & Biochemistry The UAF WebMO site Practical aspects of computational chemistry theory and nomenclature

More information

Performance evaluation of scalable optoelectronics application on large-scale Knights Landing cluster

Performance evaluation of scalable optoelectronics application on large-scale Knights Landing cluster Performance evaluation of scalable optoelectronics application on large-scale Knights Landing cluster Yuta Hirokawa Graduate School of Systems and Information Engineering, University of Tsukuba hirokawa@hpcs.cs.tsukuba.ac.jp

More information

IFM Chemistry Computational Chemistry 2010, 7.5 hp LAB2. Computer laboratory exercise 1 (LAB2): Quantum chemical calculations

IFM Chemistry Computational Chemistry 2010, 7.5 hp LAB2. Computer laboratory exercise 1 (LAB2): Quantum chemical calculations Computer laboratory exercise 1 (LAB2): Quantum chemical calculations Introduction: The objective of the second computer laboratory exercise is to get acquainted with a program for performing quantum chemical

More information

Lecture 4: Hartree-Fock Theory

Lecture 4: Hartree-Fock Theory Lecture 4: Hartree-Fock Theory One determinant to rule them all, One determinant to find them, One determinant to bring them all and in the darkness bind them Second quantization rehearsal The formalism

More information

Introduction to computational chemistry Exercise I: Structure and electronic energy of a small molecule. Vesa Hänninen

Introduction to computational chemistry Exercise I: Structure and electronic energy of a small molecule. Vesa Hänninen Introduction to computational chemistry Exercise I: Structure and electronic energy of a small molecule Vesa Hänninen 1 Introduction In this exercise the equilibrium structure and the electronic energy

More information

Introduction to Quantum Mechanics and Spectroscopy 3 Credits Fall Semester 2014 Laura Gagliardi. Lecture 27, December 5, 2014

Introduction to Quantum Mechanics and Spectroscopy 3 Credits Fall Semester 2014 Laura Gagliardi. Lecture 27, December 5, 2014 Chem 4502 Introduction to Quantum Mechanics and Spectroscopy 3 Credits Fall Semester 2014 Laura Gagliardi Lecture 27, December 5, 2014 (Some material in this lecture has been adapted from Cramer, C. J.

More information

A needed response: Fragment molecular orbital analytic gradients

A needed response: Fragment molecular orbital analytic gradients Graduate Theses and Dissertations Graduate College 2014 A needed response: Fragment molecular orbital analytic gradients Kurt Ryan Brorsen Iowa State University Follow this and additional works at: http://lib.dr.iastate.edu/etd

More information

We will use C1 symmetry and assume an RHF reference throughout. Index classes to be used include,

We will use C1 symmetry and assume an RHF reference throughout. Index classes to be used include, 1 Common Notation We will use C1 symmetry and assume an RHF reference throughout. Index classes to be used include, µ, ν, λ, σ: Primary basis functions, i.e., atomic orbitals (AOs) {φ µ ( r)}. The size

More information

Gustavus Adolphus College. Lab #5: Computational Chemistry

Gustavus Adolphus College. Lab #5: Computational Chemistry CHE 372 Gustavus Adolphus College Lab #5: Computational Chemistry Introduction In this investigation we will apply the techniques of computational chemistry to several of the molecular systems that we

More information

Lazy matrices for contraction-based algorithms

Lazy matrices for contraction-based algorithms Lazy matrices for contraction-based algorithms Michael F. Herbst michael.herbst@iwr.uni-heidelberg.de https://michael-herbst.com Interdisziplinäres Zentrum für wissenschaftliches Rechnen Ruprecht-Karls-Universität

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

QR Factorization of Tall and Skinny Matrices in a Grid Computing Environment

QR Factorization of Tall and Skinny Matrices in a Grid Computing Environment QR Factorization of Tall and Skinny Matrices in a Grid Computing Environment Emmanuel AGULLO (INRIA / LaBRI) Camille COTI (Iowa State University) Jack DONGARRA (University of Tennessee) Thomas HÉRAULT

More information

( R)Ψ el ( r;r) = E el ( R)Ψ el ( r;r)

( R)Ψ el ( r;r) = E el ( R)Ψ el ( r;r) Born Oppenheimer Approximation: Ĥ el ( R)Ψ el ( r;r) = E el ( R)Ψ el ( r;r) For a molecule with N electrons and M nuclei: Ĥ el What is E el (R)? s* potential surface Reaction Barrier Unstable intermediate

More information

Quantum Chemical Calculations by Parallel Computer from Commodity PC Components

Quantum Chemical Calculations by Parallel Computer from Commodity PC Components Nonlinear Analysis: Modelling and Control, 2007, Vol. 12, No. 4, 461 468 Quantum Chemical Calculations by Parallel Computer from Commodity PC Components S. Bekešienė 1, S. Sėrikovienė 2 1 Institute of

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

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

Computational Chemistry Using the University of Alaska WebMO Site

Computational Chemistry Using the University of Alaska WebMO Site 2/7/2017 1 Computational Chemistry Using the University of Alaska WebMO Site John Keller Department of Chemistry & Biochemistry University of Alaska Fairbanks Intro and operation of WebMO and MOPAC Basic

More information

TRANSFERABILITY IN AB INITIO QUANTUM CHEMISTRY: CORRELATED ELECTRONIC STRUCTURE THEORY FOR LARGE MOLECULES

TRANSFERABILITY IN AB INITIO QUANTUM CHEMISTRY: CORRELATED ELECTRONIC STRUCTURE THEORY FOR LARGE MOLECULES TRANSFERABILITY IN AB INITIO QUANTUM CHEMISTRY: CORRELATED ELECTRONIC STRUCTURE THEORY FOR LARGE MOLECULES By THOMAS FRANK HUGHES A DISSERTATION PRESENTED TO THE GRADUATE SCHOOL OF THE UNIVERSITY OF FLORIDA

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

Efficient algorithms for symmetric tensor contractions

Efficient algorithms for symmetric tensor contractions Efficient algorithms for symmetric tensor contractions Edgar Solomonik 1 Department of EECS, UC Berkeley Oct 22, 2013 1 / 42 Edgar Solomonik Symmetric tensor contractions 1/ 42 Motivation The goal is to

More information

Computations of Properties of Atoms and Molecules Using Relativistic Coupled Cluster Theory

Computations of Properties of Atoms and Molecules Using Relativistic Coupled Cluster Theory Computations of Properties of Atoms and Molecules Using Relativistic Coupled Cluster Theory B P Das Department of Physics School of Science Tokyo Institute of Technology Collaborators: VS Prasannaa, Indian

More information

Electric properties of molecules

Electric properties of molecules Electric properties of molecules For a molecule in a uniform electric fielde the Hamiltonian has the form: Ĥ(E) = Ĥ + E ˆµ x where we assume that the field is directed along the x axis and ˆµ x is the

More information

Chemistry 4560/5560 Molecular Modeling Fall 2014

Chemistry 4560/5560 Molecular Modeling Fall 2014 Final Exam Name:. User s guide: 1. Read questions carefully and make sure you understand them before answering (if not, ask). 2. Answer only the question that is asked, not a different question. 3. Unless

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

Self-consistent Field

Self-consistent Field Chapter 6 Self-consistent Field A way to solve a system of many electrons is to consider each electron under the electrostatic field generated by all other electrons. The many-body problem is thus reduced

More information

COUPLED-CLUSTER CALCULATIONS OF GROUND AND EXCITED STATES OF NUCLEI

COUPLED-CLUSTER CALCULATIONS OF GROUND AND EXCITED STATES OF NUCLEI COUPLED-CLUSTER CALCULATIONS OF GROUND AND EXCITED STATES OF NUCLEI Marta Włoch, a Jeffrey R. Gour, a and Piotr Piecuch a,b a Department of Chemistry,Michigan State University, East Lansing, MI 48824 b

More information

Electron Correlation - Methods beyond Hartree-Fock

Electron Correlation - Methods beyond Hartree-Fock Electron Correlation - Methods beyond Hartree-Fock how to approach chemical accuracy Alexander A. Auer Max-Planck-Institute for Chemical Energy Conversion, Mülheim September 4, 2014 MMER Summerschool 2014

More information

Lecture 4: methods and terminology, part II

Lecture 4: methods and terminology, part II So theory guys have got it made in rooms free of pollution. Instead of problems with the reflux, they have only solutions... In other words, experimentalists will likely die of cancer From working hard,

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

H 2 in the minimal basis

H 2 in the minimal basis H 2 in the minimal basis Alston J. Misquitta Centre for Condensed Matter and Materials Physics Queen Mary, University of London January 27, 2016 Overview H 2 : The 1-electron basis. The two-electron basis

More information

Non-Born-Oppenheimer Effects Between Electrons and Protons

Non-Born-Oppenheimer Effects Between Electrons and Protons Non-Born-Oppenheimer Effects Between Electrons and Protons Kurt Brorsen Department of Chemistry University of Illinois at Urbana-Champaign PI: Sharon Hammes-Schiffer Funding: NSF, AFOSR Computer time:

More information

An Introduction to Quantum Chemistry and Potential Energy Surfaces. Benjamin G. Levine

An Introduction to Quantum Chemistry and Potential Energy Surfaces. Benjamin G. Levine An Introduction to Quantum Chemistry and Potential Energy Surfaces Benjamin G. Levine This Week s Lecture Potential energy surfaces What are they? What are they good for? How do we use them to solve chemical

More information

This is a very succinct primer intended as supplementary material for an undergraduate course in physical chemistry.

This is a very succinct primer intended as supplementary material for an undergraduate course in physical chemistry. 1 Computational Chemistry (Quantum Chemistry) Primer This is a very succinct primer intended as supplementary material for an undergraduate course in physical chemistry. TABLE OF CONTENTS Methods...1 Basis

More information

Electron Correlation Methods

Electron Correlation Methods Electron Correlation Methods HF method: electron-electron interaction is replaced by an average interaction E HF c = E 0 E HF E 0 exact ground state energy E HF HF energy for a given basis set HF E c

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

Study of Ozone in Tribhuvan University, Kathmandu, Nepal. Prof. S. Gurung Central Department of Physics, Tribhuvan University, Kathmandu, Nepal

Study of Ozone in Tribhuvan University, Kathmandu, Nepal. Prof. S. Gurung Central Department of Physics, Tribhuvan University, Kathmandu, Nepal Study of Ozone in Tribhuvan University, Kathmandu, Nepal Prof. S. Gurung Central Department of Physics, Tribhuvan University, Kathmandu, Nepal 1 Country of the Mt Everest 2 View of the Mt Everest 3 4 5

More information

Hartree, Hartree-Fock and post-hf methods

Hartree, Hartree-Fock and post-hf methods Hartree, Hartree-Fock and post-hf methods MSE697 fall 2015 Nicolas Onofrio School of Materials Engineering DLR 428 Purdue University nonofrio@purdue.edu 1 The curse of dimensionality Let s consider a multi

More information

Molecular mechanics. classical description of molecules. Marcus Elstner and Tomáš Kubař. April 29, 2016

Molecular mechanics. classical description of molecules. Marcus Elstner and Tomáš Kubař. April 29, 2016 classical description of molecules April 29, 2016 Chemical bond Conceptual and chemical basis quantum effect solution of the SR numerically expensive (only small molecules can be treated) approximations

More information

We also deduced that transformations between Slater determinants are always of the form

We also deduced that transformations between Slater determinants are always of the form .3 Hartree-Fock The Hartree-Fock method assumes that the true N-body ground state wave function can be approximated by a single Slater determinant and minimizes the energy among all possible choices of

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

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

计算物理作业二. Excercise 1: Illustration of the convergence of the dissociation energy for H 2 toward HF limit.

计算物理作业二. Excercise 1: Illustration of the convergence of the dissociation energy for H 2 toward HF limit. 计算物理作业二 Excercise 1: Illustration of the convergence of the dissociation energy for H 2 toward HF limit. In this exercise, basis indicates one of the following basis sets: STO-3G, cc-pvdz, cc-pvtz, cc-pvqz

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

Semi-Empirical MO Methods

Semi-Empirical MO Methods Semi-Empirical MO Methods the high cost of ab initio MO calculations is largely due to the many integrals that need to be calculated (esp. two electron integrals) semi-empirical MO methods start with the

More information

A Hybrid Method for the Wave Equation. beilina

A Hybrid Method for the Wave Equation.   beilina A Hybrid Method for the Wave Equation http://www.math.unibas.ch/ beilina 1 The mathematical model The model problem is the wave equation 2 u t 2 = (a 2 u) + f, x Ω R 3, t > 0, (1) u(x, 0) = 0, x Ω, (2)

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

I. CSFs Are Used to Express the Full N-Electron Wavefunction

I. CSFs Are Used to Express the Full N-Electron Wavefunction Chapter 11 One Must be Able to Evaluate the Matrix Elements Among Properly Symmetry Adapted N- Electron Configuration Functions for Any Operator, the Electronic Hamiltonian in Particular. The Slater-Condon

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

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

Close agreement between the orientation dependence of hydrogen bonds observed in protein structures and quantum mechanical calculations

Close agreement between the orientation dependence of hydrogen bonds observed in protein structures and quantum mechanical calculations Close agreement between the orientation dependence of hydrogen bonds observed in protein structures and quantum mechanical calculations Alexandre V. Morozov, Tanja Kortemme, Kiril Tsemekhman, David Baker

More information

Molecular properties in quantum chemistry

Molecular properties in quantum chemistry Molecular properties in quantum chemistry Monika Musiał Department of Theoretical Chemistry Outline 1 Main computational schemes for correlated calculations 2 Developmentoftheabinitiomethodsforthe calculation

More information

Computational chemistry with GAMESS: a very brief overview with examples

Computational chemistry with GAMESS: a very brief overview with examples Computational chemistry with GAMESS: a very brief overview with examples PHY-6120 Molecular Physics (Spring 2015), UConn Phys. Dept. Feb 17 th 2015 H = ħ2 2μ i Intro: V(R) for diatomic molecules + k Z

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

Introduction to MCTDH

Introduction to MCTDH Introduction to MCTDH Hans-Dieter Meyer Theoretische Chemie Universität Heidelberg 2nd HDQD workshop, Montpellier, February 2008 1 Historical Overview The Beginning 2 MCTDH 3 Potential representations

More information

Computation of the mtx-vec product based on storage scheme on vector CPUs

Computation of the mtx-vec product based on storage scheme on vector CPUs BLAS: Basic Linear Algebra Subroutines BLAS: Basic Linear Algebra Subroutines BLAS: Basic Linear Algebra Subroutines Analysis of the Matrix Computation of the mtx-vec product based on storage scheme on

More information

4πε. me 1,2,3,... 1 n. H atom 4. in a.u. atomic units. energy: 1 a.u. = ev distance 1 a.u. = Å

4πε. me 1,2,3,... 1 n. H atom 4. in a.u. atomic units. energy: 1 a.u. = ev distance 1 a.u. = Å H atom 4 E a me =, n=,,3,... 8ε 0 0 π me e e 0 hn ε h = = 0.59Å E = me (4 πε ) 4 e 0 n n in a.u. atomic units E = r = Z n nao Z = e = me = 4πε = 0 energy: a.u. = 7. ev distance a.u. = 0.59 Å General results

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

Electronic structure calculations: fundamentals George C. Schatz Northwestern University

Electronic structure calculations: fundamentals George C. Schatz Northwestern University Electronic structure calculations: fundamentals George C. Schatz Northwestern University Electronic Structure (often called Quantum Chemistry) calculations use quantum mechanics to determine the wavefunctions

More information

Simulation Methods II

Simulation Methods II Simulation Methods II Maria Fyta Institute for Computational Physics Universität Stuttgart Summer Term 2018 SM II - contents First principles methods Hartree-Fock and beyond Density-funtional-theory Ab

More information

Population Analysis. Mulliken Population Analysis APPENDIX S

Population Analysis. Mulliken Population Analysis APPENDIX S APPENDIX S Population Analysis On p. 665, electronic density ρ is defined. If the wave function is a Slater determinant p. 397) and assuming the double occupancy of orbitals ϕ i, we have see 11.7) ρ r

More information

Efficient implementation of the overlap operator on multi-gpus

Efficient implementation of the overlap operator on multi-gpus Efficient implementation of the overlap operator on multi-gpus Andrei Alexandru Mike Lujan, Craig Pelissier, Ben Gamari, Frank Lee SAAHPC 2011 - University of Tennessee Outline Motivation Overlap operator

More information

Highly accurate quantum-chemical calculations

Highly accurate quantum-chemical calculations 1 Highly accurate quantum-chemical calculations T. Helgaker Centre for Theoretical and Computational Chemistry, Department of Chemistry, University of Oslo, Norway A. C. Hennum and T. Ruden, University

More information

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

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

More information

Basis sets for electron correlation

Basis sets for electron correlation Basis sets for electron correlation Trygve Helgaker Centre for Theoretical and Computational Chemistry Department of Chemistry, University of Oslo, Norway The 12th Sostrup Summer School Quantum Chemistry

More information

Course SS18. Organization

Course SS18. Organization 0-0 Course SS18 Stefan.Goedecker@unibas.ch Organization Lecture with script: http://comphys.unibas.ch/teaching.htm Simple exercises: Traditional analytic problems and numerical problems (on your own laptop?)

More information

Tutorial I: IQ MOL and Basic DFT and MP2 Calculations 1 / 30

Tutorial I: IQ MOL and Basic DFT and MP2 Calculations 1 / 30 Tutorial I: IQ MOL and Basic DFT and MP2 Calculations Q-Chem User Workshop, Denver March 21, 2015 1 / 30 2 / 30 Introduction to IQMOL DFT and MP2 Calculations 3 / 30 IQMOL and Q-CHEM IQMOL is an open-source

More information

Benzene Dimer: dispersion forces and electronic correlation

Benzene Dimer: dispersion forces and electronic correlation Benzene Dimer: dispersion forces and electronic correlation Introduction The Benzene dimer is an ideal example of a system bound by π-π interaction, which is in several cases present in many biologically

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

Ψ = Σ m C i,m φ 1...φ m...φ N + φ 1...φ i...φ N.

Ψ = Σ m C i,m φ 1...φ m...φ N + φ 1...φ i...φ N. Chapter 19 Corrections to the mean-field model are needed to describe the instantaneous Coulombic interactions among the electrons. This is achieved by including more than one Slater determinant in the

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

NTChem. ntprep. ntprep

NTChem. ntprep. ntprep NTChem NTChem.inp ) bash ) csh RCCS)) ntprep ntprep /opt/aics/ntchem/scripts RCCS) ccpg: /local/apl/pg/ntchem/scripts ccuv: /local/apl/uv/ntchem/scripts Focus: /home1/share/ntchem/ntchem2013.4.0/scripts

More information

Calculations of electron-molecule scattering cross sections using the Rmatrix method

Calculations of electron-molecule scattering cross sections using the Rmatrix method Calculations of electron-molecule scattering cross sections using the Rmatrix method Jimena Gorfinkiel Department of Physical Sciences The Open University Milton Keynes, UK Jimena.Gorfinkiel@open.ac.uk

More information

APPENDIX 2. Semiempirical PM3 (Parametrization Method #3) When analytical solutions cannot be obtained, Schrödinger equation may be solved:

APPENDIX 2. Semiempirical PM3 (Parametrization Method #3) When analytical solutions cannot be obtained, Schrödinger equation may be solved: WRNING NOTICE: The experiments described in these materials are potentially hazardous and require a high level of safety training, special facilities and equipment, and supervision by appropriate individuals.

More information

one ν im: transition state saddle point

one ν im: transition state saddle point Hypothetical Potential Energy Surface Ethane conformations Hartree-Fock theory, basis set stationary points all ν s >0: minimum eclipsed one ν im: transition state saddle point multiple ν im: hilltop 1

More information

Gaussian: Basic Tutorial

Gaussian: Basic Tutorial Input file: # hf sto-g pop=full Water - Single Point Energy 0 H.0 H.0 H 04.5 Route Section Start with # Contains the keywords Gaussian: Basic Tutorial Route Section Title Section Charge-Multiplicity Molecule

More information

Chemistry 3502 Physical Chemistry II (Quantum Mechanics) 3 Credits Fall Semester 2003 Christopher J. Cramer. Lecture 25, November 5, 2003

Chemistry 3502 Physical Chemistry II (Quantum Mechanics) 3 Credits Fall Semester 2003 Christopher J. Cramer. Lecture 25, November 5, 2003 Chemistry 3502 Physical Chemistry II (Quantum Mechanics) 3 Credits Fall Semester 2003 Christopher J. Cramer Lecture 25, November 5, 2003 (Some material in this lecture has been adapted from Cramer, C.

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

Full Electron Calculation Beyond 20,000 Atoms: Ground Electronic State of Photosynthetic Proteins

Full Electron Calculation Beyond 20,000 Atoms: Ground Electronic State of Photosynthetic Proteins Full Electron Calculation Beyond 20,000 Atoms: Ground Electronic State of Photosynthetic Proteins TSUTOMU IKEGAMI, TOYOKAZU ISHIDA, DMITRI G. FEDOROV, KAZUO KI- TAURA, YUICHI INADOMI, HIROAKI UMEDA, MITSUO

More information

Tests of fundamental symmetries with atoms and molecules

Tests of fundamental symmetries with atoms and molecules Tests of fundamental symmetries with atoms and molecules 1 Listening to an atom q Coulomb forces + Quantum Electro-Dynamics => a relatively simple interpretation q Unprecedented control over internal and

More information

Quantum Chemistry. NC State University. Lecture 5. The electronic structure of molecules Absorption spectroscopy Fluorescence spectroscopy

Quantum Chemistry. NC State University. Lecture 5. The electronic structure of molecules Absorption spectroscopy Fluorescence spectroscopy Quantum Chemistry Lecture 5 The electronic structure of molecules Absorption spectroscopy Fluorescence spectroscopy NC State University 3.5 Selective absorption and emission by atmospheric gases (source:

More information

Jack Smith. Center for Environmental, Geotechnical and Applied Science. Marshall University

Jack Smith. Center for Environmental, Geotechnical and Applied Science. Marshall University Jack Smith Center for Environmental, Geotechnical and Applied Science Marshall University -- Division of Science and Research WV Higher Education Policy Commission WVU HPC Summer Institute June 20, 2014

More information

2~:J~ -ryej- r- 2 Jr. A - f3. sr(djk nv~tor rn~ +~ rvjs (::-CJ) ::;-1-.'--~ -. rhd. ('-.Ji.L.~ )- r'-d)c, -r/~ JJr - 2~d ~2-Jr fn'6.

2~:J~ -ryej- r- 2 Jr. A - f3. sr(djk nv~tor rn~ +~ rvjs (::-CJ) ::;-1-.'--~ -. rhd. ('-.Ji.L.~ )- r'-d)c, -r/~ JJr - 2~d ~2-Jr fn'6. .~, ~ I, sr(djk nv~tor rn~ +~ rvjs (::-CJ) ::;-1-.'--~ -. rhd. ('-.Ji.L.~ )- r'-d)c, -r/~ JJr - 2~d ~2-Jr fn'6.)1e'" 21t-ol Je C'...-------- lj-vi, J? Jr Jr \Ji 2~:J~ -ryej- r- 2 Jr A - f3 c _,~,= ~,.,w._..._.

More information

Department of Physics, Chemistry and Biology

Department of Physics, Chemistry and Biology Department of Physics, Chemistry and Biology Bachelor s Thesis Chemical bond analysis in the ten-electron series Thomas Fransson LITH-IFM-G-EX 09/2112 SE Department of Physics, Chemistry and Biology Linköpings

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

A One-Slide Summary of Quantum Mechanics

A One-Slide Summary of Quantum Mechanics A One-Slide Summary of Quantum Mechanics Fundamental Postulate: O! = a! What is!?! is an oracle! operator wave function (scalar) observable Where does! come from?! is refined Variational Process H! = E!

More information

EA = I 3 = E = i=1, i k

EA = I 3 = E = i=1, i k MTH5 Spring 7 HW Assignment : Sec.., # (a) and (c), 5,, 8; Sec.., #, 5; Sec.., #7 (a), 8; Sec.., # (a), 5 The due date for this assignment is //7. Sec.., # (a) and (c). Use the proof of Theorem. to obtain

More information

QMC dissociation energy of the water dimer: Time step errors and backflow calculations

QMC dissociation energy of the water dimer: Time step errors and backflow calculations QMC dissociation energy of the water dimer: Time step errors and backflow calculations Idoia G. de Gurtubay and Richard J. Needs TCM group. Cavendish Laboratory University of Cambridge Idoia G. de Gurtubay.

More information

Neural networks. Chapter 20. Chapter 20 1

Neural networks. Chapter 20. Chapter 20 1 Neural networks Chapter 20 Chapter 20 1 Outline Brains Neural networks Perceptrons Multilayer networks Applications of neural networks Chapter 20 2 Brains 10 11 neurons of > 20 types, 10 14 synapses, 1ms

More information

Introduction to Computational Chemistry

Introduction to Computational Chemistry Introduction to Computational Chemistry Vesa Hänninen Laboratory of Physical Chemistry Chemicum 4th floor vesa.hanninen@helsinki.fi September 10, 2013 Lecture 3. Electron correlation methods September

More information

SCF calculation on HeH +

SCF calculation on HeH + SCF calculation on HeH + Markus Meuwly Department of Chemistry, University of Basel, Basel, Switzerland Abstract This document describes the main steps involved in carrying out a SCF calculation on the

More information

Introduction to Hartree-Fock Molecular Orbital Theory

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

More information

Chemistry 433 Computational Chemistry Fall Semester 2002 Dr. Rainer Glaser

Chemistry 433 Computational Chemistry Fall Semester 2002 Dr. Rainer Glaser Chemistry 433 Computational Chemistry Fall Semester 2002 Dr. Rainer Glaser Second 1-Hour Examination Electron Correlation Methods Wednesday, November 6, 2002, 11:00-11:50 Name: Answer Key Question 1. Electron

More information