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

Size: px
Start display at page:

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

Transcription

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

2 1 Introduction In this exercise the equilibrium structure and the electronic energy of a small molecule (or molecules) are calculated using various ab initio methods. This exercise has three different purposes: to familiarize you with various ab initio methods and to let you understand their accuracy and their capabilities with respect to experimental data. to familiarize you with various ab initio basis set acronyms, to give you some hints on the methods which are used to obtain them, and to give you an idea of the computational efforts to obtain accurate results. to practise with tools and programs commonly used in computational chemistry research. 2 Ab initio methods The term ab initio means from first principles. It does not mean we are solving the Schrödinger equation exactly. It means that we are selecting a method that, in principle, can lead to a reasonable approximation to the solution of the Schrödinger equation, and then selecting a basis set that will implement that method in a reasonable way. By reasonable, we mean that the results are adequate for the application at hand. A method and basis set that is adequate for one application may be inadequate for another. We also have to take into account the cost of doing calculations and the total amount of time required. A wide range of methods have been employed, but in this exercise we will restrict ourselves to the density funtional method and some commonly used methods that use molecular orbital theory (i.e. Hartree-Fock). The methods used in this exercise are the following: RHF MP2 QCISD CCSD(T) 1

3 B3LYP The RHF method is the restricted Hartree-Fock method, where the electrons are paired, so they can be treated two at a time. The next three methods try to improve the Hartree-Fock electronic wavefunction: the MP2 (Møller- Plesset) method, employs perturbation theory at the second order. The QCISD (Quadratic Configurations Interaction of Single and Double excitations) calculates the electronic wavefunction as a linear combination of Hartree-Fock determinants in which all the single and double excitations are included. The CCSD(T) (Coupled-Cluster Single, Double, and perturbative Triple excitations) is based on an exponential approach. B3LYP is a density functional method; the electronic energy is expressed using the electronic density, not the wave function. 3 Basis functions Historically, quantum calculations for molecules were performed as LCAO MO, i.e. Linear Combination of Atomic Orbitals - Molecular Orbitals: n ψ i = c ij φ j (1) j=1 whereψ i isthei-thmolecularorbital, c ij arethecoefficientsoflinearcombination, φ j is the j-th atomic orbital, and n is the number of atomic orbitals. Atomic Orbitals (AO) are solutions of the Hartree-Fock equations for the atom, i.e. a wave functions for a single electron in the atom. More recently, the term atomic orbital has been replaced by basis function or contraction, when appropriate. Slater-Type-Orbitals (STOs) are similar to the AOs of the hydrogen atom. They are described by a function that depends on spherical coordinates: φ i (ζ,n,l;r,θ,φ) = Nr n 1 e ζr Y lm (θ,φ) (2) where N is the normalization constant and ζ is the exponential factor. The variables r,θ, and φ are spherical coordinates, and Y lm is the angular momentum part (function describing shape ). The integers n, l, and m are quantum numbers: principal, angular momentum, and magnetic, respectively. Unfortunately, STOs are not suitable for fast calculations of necessary two-electron integrals. That is why the Gaussian-Type-Orbitals (GTOs) were introduced. They can be used to approximate the shape of the STO function by summing up a number of GTOs 2

4 with different exponents and coefficients. You can use several GTOs (4-5) to represent an STO, and still calculate integrals faster than if the original STOs were used. The GTO is expressed as: φ GTO (α,l,m,n;x,y,z) = Ne αr2 x l y m z n (3) where N is the normalization constant and α is the exponential factor. The variables x, y, and z are cartesian coordinates. The GTOs are not really orbitals, they are simpler functions. In recent literature they have been called gaussian primitives. In order to describe the shapes of the molecular orbitals correctly, several basis functions(or contractions) are required for accurate treatment in molecules. Basis sets that possess more than one contraction to describe each electron are called extended basis sets. There are several types of extended basis sets: Double-Zeta, Triple-Zeta,... Multiple contractions are used to represent a single Slater orbital. Split-Valence Multiple contractions are used for only the valence (outer) orbitals. Polarized Sets The basic picture of atomic orbitals existing only as s, p, d, f etc. is modified by mixing the different types. This treatment takes into account the polarization effect which distorts the shape of the atomic orbitals when atoms are brought together. Diffuse Sets These basis sets utilize very small exponents to clarify the properties of the tail of the wave function. When an atom is in an anion, in an excited state or when long range effects are important for some other reason, the tail of the wave function becomes important. 3

5 4 Exercise In this exercise, the program Molpro will be used to calculate the optimised structure and the electronic energy of a molecule (or molecules). First, prepare the input file jobname.com. An example of the Molpro input is as follows: ***, H2, ang geometry={ h1; h2,h1,r12;} r12= basis=sto-3g hf ccsd(t) optg put,molden,nh3h2o.molden; First line describes the job. Geometry block describes the geometry of the molecule in internal coordinates. Bond lengths are given in ångstroms as indicated by ang keyword in the input. In this exercise, the geometry of a molecule is optimised. This is implemented with the optg keyword in the input. In the optimisation, the initial value is varied by Molpro until the energy minimum is found. r12 is the initial bond length. Basis set is defined after basis= keyword. Method is defined with a suitable keyword. All methods that need hf procedure (like mp2) need a line hf before the actual method. Tag put,molden,nh3h2o.molden tells Molpro to write input file for the visualization program. The exercise will be carried out using the methods B3LYP, RHF, MP2, QCISD, and CCSD(T) and for example some of the following basis sets: STO-3G: Minimal basis set. Each Slater-Type-Orbital expressed by 3 gaussians. 6-31G(d) (or 6-31G*): Pople s (Split Valence) basis set which includes 6 gaussian primitives for the inner shells and uses the 31 contraction scheme for the valence electrons. In this contraction scheme each orbital is described by two basis functions, the first of which includes three gaussian 4

6 primitives and the second of which contains one. Adding a single polarization function to 6-31G (i.e. 6-31G(d)) will result in one d function for first and second row atoms and one f function for first transition row atoms, since d functions are already present for the valence electrons in the latter. AUG-cc-pVXZ(X=D,T): Dunning s correlation consistent basis set. Includes polarization functions by definition. The terms DZ (double zeta) and TZ (triple zeta) mean that two (DZ) and three (TZ) contractions are used to represent a single Slater orbital. These basis set is augmented with diffuse functions by including the AUG- prefix to the basis set keyword. However, the elements He, Mg, Li, Be, and Na do not have diffuse functions defined within this basis set. In Hippu, the Molpro job is submitted by the command: molpro jobname.com. At the beginning of each session Molpro package needs to be loaded by the comman module load molpro. 5

7 Experimental structures of some molecules: H 2 r= Å CO r= Å H 2 O r= Å a= degrees H 2 O 2 r(o-h)=0.967 Å r(o-o)= Å a(o-o-h)= degrees a(dihedral)= degrees NH 3 r(n-h)=1.016 a(h-n-h)=106.7 degrees 6

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

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

Computational Material Science Part II. Ito Chao ( ) Institute of Chemistry Academia Sinica

Computational Material Science Part II. Ito Chao ( ) Institute of Chemistry Academia Sinica Computational Material Science Part II Ito Chao ( ) Institute of Chemistry Academia Sinica Ab Initio Implementations of Hartree-Fock Molecular Orbital Theory Fundamental assumption of HF theory: each electron

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

Basis Sets and Basis Set Notation

Basis Sets and Basis Set Notation Chemistry 46 Fall 215 Dr. Jean M. Standard November 29, 217 Basis Sets and Basis Set Notation Using the LCAO-MO approximation, molecular orbitals can be represented as linear combinations of atomic orbitals,

More information

Jack Simons, Henry Eyring Scientist and Professor Chemistry Department University of Utah

Jack Simons, Henry Eyring Scientist and Professor Chemistry Department University of Utah 1. Born-Oppenheimer approx.- energy surfaces 2. Mean-field (Hartree-Fock) theory- orbitals 3. Pros and cons of HF- RHF, UHF 4. Beyond HF- why? 5. First, one usually does HF-how? 6. Basis sets and notations

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

4 Post-Hartree Fock Methods: MPn and Configuration Interaction

4 Post-Hartree Fock Methods: MPn and Configuration Interaction 4 Post-Hartree Fock Methods: MPn and Configuration Interaction In the limit of a complete basis, the Hartree-Fock (HF) energy in the complete basis set limit (ECBS HF ) yields an upper boundary to the

More information

An Introduction to Basis Sets:

An Introduction to Basis Sets: An Introduction to Basis Sets: The "Holy Grail" of computational chemistry is the calculation of the molecular orbitals (MOs) for a given molecule. IF we can calculate the MOs for a molecule, THEN we can

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

QUANTUM CHEMISTRY PROJECT 3: ATOMIC AND MOLECULAR STRUCTURE

QUANTUM CHEMISTRY PROJECT 3: ATOMIC AND MOLECULAR STRUCTURE Chemistry 460 Fall 2017 Dr. Jean M. Standard November 1, 2017 QUANTUM CHEMISTRY PROJECT 3: ATOMIC AND MOLECULAR STRUCTURE OUTLINE In this project, you will carry out quantum mechanical calculations of

More information

Chemistry 334 Part 2: Computational Quantum Chemistry

Chemistry 334 Part 2: Computational Quantum Chemistry Chemistry 334 Part 2: Computational Quantum Chemistry 1. Definition Louis Scudiero, Ben Shepler and Kirk Peterson Washington State University January 2006 Computational chemistry is an area of theoretical

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

Performance of Hartree-Fock and Correlated Methods

Performance of Hartree-Fock and Correlated Methods Chemistry 460 Fall 2017 Dr. Jean M. Standard December 4, 2017 Performance of Hartree-Fock and Correlated Methods Hartree-Fock Methods Hartree-Fock methods generally yield optimized geomtries and molecular

More information

Computational Chemistry. An Introduction to Molecular Dynamic Simulations

Computational Chemistry. An Introduction to Molecular Dynamic Simulations Computational Chemistry An Introduction to Molecular Dynamic Simulations Computational chemistry simulates chemical structures and reactions numerically, based in full or in part on the fundamental laws

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

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

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~: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

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

Jack Simons, Henry Eyring Scientist and Professor Chemistry Department University of Utah

Jack Simons, Henry Eyring Scientist and Professor Chemistry Department University of Utah 1. Born-Oppenheimer approx.- energy surfaces 2. Mean-field (Hartree-Fock) theory- orbitals 3. Pros and cons of HF- RHF, UHF 4. Beyond HF- why? 5. First, one usually does HF-how? 6. Basis sets and notations

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

Lec20 Wed 1mar17 update 3mar 10am

Lec20 Wed 1mar17 update 3mar 10am 564-17 Lec20 Wed 1mar17 update 3mar 10am Figure 15.2 Shows that increasing the diversity of the basis set lowers The HF-SCF energy considerably, but comes nowhere near the exact experimental energy, regardless

More information

Introduction to Computational Chemistry: Theory

Introduction to Computational Chemistry: Theory Introduction to Computational Chemistry: Theory Dr Andrew Gilbert Rm 118, Craig Building, RSC andrew.gilbert@anu.edu.au 3023 Course Lectures Introduction Hartree Fock Theory Basis Sets Lecture 1 1 Introduction

More information

Introduction to Computational Quantum Chemistry: Theory

Introduction to Computational Quantum Chemistry: Theory Introduction to Computational Quantum Chemistry: Theory Dr Andrew Gilbert Rm 118, Craig Building, RSC 3108 Course Lectures 2007 Introduction Hartree Fock Theory Configuration Interaction Lectures 1 Introduction

More information

Lec20 Fri 3mar17

Lec20 Fri 3mar17 564-17 Lec20 Fri 3mar17 [PDF]GAUSSIAN 09W TUTORIAL www.molcalx.com.cn/wp-content/uploads/2015/01/gaussian09w_tutorial.pdf by A Tomberg - Cited by 8 - Related articles GAUSSIAN 09W TUTORIAL. AN INTRODUCTION

More information

Chemistry 4681 Module: Electronic Structure of Small Molecules Background Handout

Chemistry 4681 Module: Electronic Structure of Small Molecules Background Handout Chemistry 4681 Module: Electronic Structure of Small Molecules Background Handout C. David Sherrill Last Revised: 6 January 2000 1 Computational Chemistry The term computational chemistry is used to mean

More information

G1-3 These methods are based on ab initio molecular orbital calculations. Electron correlation is calculated using MP2 or MP4 and QCI.

G1-3 These methods are based on ab initio molecular orbital calculations. Electron correlation is calculated using MP2 or MP4 and QCI. 23. High Accuracy Energy Methods 23.1 Gaussian-n Methods The method keywords G1, G2, G2MP2, G3, G3MP2, G3B3, G3MP2B3, G4, and G4MP2 perform high accuracy complex energy computations in Gaussian. Essentially,

More information

Quantum Chemical Simulations and Descriptors. Dr. Antonio Chana, Dr. Mosè Casalegno

Quantum Chemical Simulations and Descriptors. Dr. Antonio Chana, Dr. Mosè Casalegno Quantum Chemical Simulations and Descriptors Dr. Antonio Chana, Dr. Mosè Casalegno Classical Mechanics: basics It models real-world objects as point particles, objects with negligible size. The motion

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

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

QUANTUM CHEMISTRY PROJECT 3: PARTS B AND C

QUANTUM CHEMISTRY PROJECT 3: PARTS B AND C Chemistry 460 Fall 2017 Dr. Jean M. Standard November 6, 2017 QUANTUM CHEMISTRY PROJECT 3: PARTS B AND C PART B: POTENTIAL CURVE, SPECTROSCOPIC CONSTANTS, AND DISSOCIATION ENERGY OF DIATOMIC HYDROGEN (20

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

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

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

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

Vol. 9 COMPUTATIONAL CHEMISTRY 319

Vol. 9 COMPUTATIONAL CHEMISTRY 319 Vol. 9 COMPUTATIONAL CHEMISTRY 319 COMPUTATIONAL QUANTUM CHEMISTRY FOR FREE-RADICAL POLYMERIZATION Introduction Chemistry is traditionally thought of as an experimental science, but recent rapid and continuing

More information

Gaussian Basis Sets for Solid-State Calculations

Gaussian Basis Sets for Solid-State Calculations Gaussian Basis Sets for Solid-State Calculations K. Doll Molpro Quantum Chemistry Software Institute of Theoretical Chemistry, D-70569 Stuttgart, Germany MW-MSSC 2017, Minneapolis, July 10, 2017 Introduction

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

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

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

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

Lab #3: Choice of Theoretical Method

Lab #3: Choice of Theoretical Method Lab #3: Choice of Theoretical Method These directions assume the user is familiar with the WebMO interface and can build molecules, set up calculations, etc. Exercise 1 - Determine the Proton Affinity

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

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

COPYRIGHTED MATERIAL. Quantum Mechanics for Organic Chemistry &CHAPTER 1

COPYRIGHTED MATERIAL. Quantum Mechanics for Organic Chemistry &CHAPTER 1 &CHAPTER 1 Quantum Mechanics for Organic Chemistry Computational chemistry, as explored in this book, will be restricted to quantum mechanical descriptions of the molecules of interest. This should not

More information

Quantum Chemical and Dynamical Tools for Solving Photochemical Problems

Quantum Chemical and Dynamical Tools for Solving Photochemical Problems 2.165430 3.413060 3.889592 9 H 3.413060 2.165430 1.099610 2.165430 3.413060 10 H 3.889592 3.413060 2.165430 1.099610 2.165430 11 H 3.413060 3.889592 3.413060 2.165430 1.099610 12 H 2.165430 3.413060 3.889592

More information

MODELING MATTER AT NANOSCALES

MODELING MATTER AT NANOSCALES MODELING MATTER AT NANOSCALES 6. The theory of molecular orbitals for the description of nanosystems (part II) 6.0. Ab initio methods. Basis functions. Luis A. Monte ro Firmado digitalmente por Luis A.

More information

Quantum Chemistry Methods

Quantum Chemistry Methods 1 Quantum Chemistry Methods T. Helgaker, Department of Chemistry, University of Oslo, Norway The electronic Schrödinger equation Hartree Fock theory self-consistent field theory basis functions and basis

More information

Homework Problem Set 5 Solutions. E e + H corr (a.u.) a.) Determine the bond dissociation enthalpy of ethane in kcal/mol (1 a.u. = kcal/mol).

Homework Problem Set 5 Solutions. E e + H corr (a.u.) a.) Determine the bond dissociation enthalpy of ethane in kcal/mol (1 a.u. = kcal/mol). Chemistry 380.37 Dr. Jean M. Standard Homework Problem Set 5 Solutions 1. Given below are the sum of electronic and thermal enthalpies, E e + H corr, from Hartree-Fock calculations using a 6-31G(d) basis

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

MODERN ELECTRONIC STRUCTURE THEORY

MODERN ELECTRONIC STRUCTURE THEORY 1 MODERN ELECTRONIC STRUCTURE THEORY At this point, we have more or less exhausted the list of electronic structure problems we can solve by hand. If we were limited to solving problems manually, there

More information

Experiment 15: Atomic Orbitals, Bond Length, and Molecular Orbitals

Experiment 15: Atomic Orbitals, Bond Length, and Molecular Orbitals Experiment 15: Atomic Orbitals, Bond Length, and Molecular Orbitals Introduction Molecular orbitals result from the mixing of atomic orbitals that overlap during the bonding process allowing the delocalization

More information

Molecular simulation of copper(ii)-bound organic compounds for use in metal-organic chemical vapor deposition (MOCVD) of copper films

Molecular simulation of copper(ii)-bound organic compounds for use in metal-organic chemical vapor deposition (MOCVD) of copper films Molecular simulation of copper(ii)-bound organic compounds for use in metal-organic chemical vapor deposition (MOCVD) of copper films Alexis A. Rivera-Montalvo Chemical Engineering Department University

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

Beyond the Hartree-Fock Approximation: Configuration Interaction

Beyond the Hartree-Fock Approximation: Configuration Interaction Beyond the Hartree-Fock Approximation: Configuration Interaction The Hartree-Fock (HF) method uses a single determinant (single electronic configuration) description of the electronic wavefunction. For

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

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

Basis Sets for Computational Chemistry

Basis Sets for Computational Chemistry Chapter 3 Basis Sets for Computational Chemistry J.M. García de la Vega and B. Miguel Departamento de Química Física Aplicada, Facultad de Ciencias, Universidad Autónoma de Madrid, 28049 Madrid, Spain

More information

Chapter 1 Chemical Bonding

Chapter 1 Chemical Bonding Chapter 1 Chemical Bonding 1.1 Atoms, Electrons, and Orbitals Atoms are composed of + Protons positively charged mass = 1.6726 X 10-27 kg Neutrons neutral mass = 1.6750 X 10-27 kg Electrons negatively

More information

Is Band better than ADF? The core of the issue

Is Band better than ADF? The core of the issue Is Band better than ADF? The core of the issue Introduction Introduction What is Band? Introduction What is Band? Slightly different basis set for ADF/Band Introduction What is Band? Slightly different

More information

Methods for Treating Electron Correlation CHEM 430

Methods for Treating Electron Correlation CHEM 430 Methods for Treating Electron Correlation CHEM 430 Electron Correlation Energy in the Hartree-Fock approximation, each electron sees the average density of all of the other electrons two electrons cannot

More information

Yingwei Wang Computational Quantum Chemistry 1 Hartree energy 2. 2 Many-body system 2. 3 Born-Oppenheimer approximation 2

Yingwei Wang Computational Quantum Chemistry 1 Hartree energy 2. 2 Many-body system 2. 3 Born-Oppenheimer approximation 2 Purdue University CHM 67300 Computational Quantum Chemistry REVIEW Yingwei Wang October 10, 2013 Review: Prof Slipchenko s class, Fall 2013 Contents 1 Hartree energy 2 2 Many-body system 2 3 Born-Oppenheimer

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

The successful wavefunction can be written as a determinant: # 1 (2) # 2 (2) Electrons. This can be generalized to our 2N-electron wavefunction:

The successful wavefunction can be written as a determinant: # 1 (2) # 2 (2) Electrons. This can be generalized to our 2N-electron wavefunction: T2. CNDO to AM1: The Semiempirical Molecular Orbital Models The discussion in sections T2.1 T2.3 applies also to ab initio molecular orbital calculations. T2.1 Slater Determinants Consider the general

More information

MRCI calculations in MOLPRO

MRCI calculations in MOLPRO 1 MRCI calculations in MOLPRO Molpro is a software package written in Fortran and maintained by H.J. Werner and P.J. Knowles. It is often used for performing sophisticated electronic structure calculations,

More information

Conformational energy analysis

Conformational energy analysis Lab 3 Conformational energy analysis Objective This computational project deals with molecular conformations the spatial arrangement of atoms of molecules. Conformations are determined by energy, so the

More information

Lecture January 18, Quantum Numbers Electronic Configurations Ionization Energies Effective Nuclear Charge Slater s Rules

Lecture January 18, Quantum Numbers Electronic Configurations Ionization Energies Effective Nuclear Charge Slater s Rules Lecture 3 362 January 18, 2019 Quantum Numbers Electronic Configurations Ionization Energies Effective Nuclear Charge Slater s Rules Inorganic Chemistry Chapter 1: Figure 1.4 Time independent Schrödinger

More information

use the backs of pages as needed

use the backs of pages as needed CHEMISTRY 4021/8021 Q1) Propose a simple, united-atom molecular mechanics force-field needed to generate a potential energy surface for an isolated molecule of acetone (Me 2 CO). I.e., provide an energy

More information

MODERN ELECTRONIC STRUCTURE THEORY: Basis Sets

MODERN ELECTRONIC STRUCTURE THEORY: Basis Sets 5.61 Physical Chemistry Lecture #29 1 MODERN ELECTRONIC STRUCTURE THEORY: Basis Sets At this point, we have more or less exhausted the list of electronic structure problems we can solve by hand. If we

More information

Diatomic Molecules. 14th May Chemical Bonds in Diatomic Molecules: Overlaps and Delocalization of Electrons

Diatomic Molecules. 14th May Chemical Bonds in Diatomic Molecules: Overlaps and Delocalization of Electrons Diatomic Molecules 14th May 2009 1 Chemical Bonds in Diatomic Molecules: Overlaps and Delocalization of Electrons 1.1 H + 2 Molecule Consider the process where 2 atomic nuclei and associated electron (1

More information

Chem 442 Review for Exam 2. Exact separation of the Hamiltonian of a hydrogenic atom into center-of-mass (3D) and relative (3D) components.

Chem 442 Review for Exam 2. Exact separation of the Hamiltonian of a hydrogenic atom into center-of-mass (3D) and relative (3D) components. Chem 44 Review for Exam Hydrogenic atoms: The Coulomb energy between two point charges Ze and e: V r Ze r Exact separation of the Hamiltonian of a hydrogenic atom into center-of-mass (3D) and relative

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

This is called a singlet or spin singlet, because the so called multiplicity, or number of possible orientations of the total spin, which is

This is called a singlet or spin singlet, because the so called multiplicity, or number of possible orientations of the total spin, which is 9. Open shell systems The derivation of Hartree-Fock equations (Chapter 7) was done for a special case of a closed shell systems. Closed shell means that each MO is occupied by two electrons with the opposite

More information

Full configuration interaction potential energy curves for breaking bonds to hydrogen: An assessment of single-reference correlation methods

Full configuration interaction potential energy curves for breaking bonds to hydrogen: An assessment of single-reference correlation methods JOURNAL OF CHEMICAL PHYSICS VOLUME 118, NUMBER 4 22 JANUARY 2003 Full configuration interaction potential energy curves for breaking bonds to hydrogen: An assessment of single-reference correlation methods

More information

Joint ICTP-IAEA Workshop on Fusion Plasma Modelling using Atomic and Molecular Data January 2012

Joint ICTP-IAEA Workshop on Fusion Plasma Modelling using Atomic and Molecular Data January 2012 2327-3 Joint ICTP-IAEA Workshop on Fusion Plasma Modelling using Atomic and Molecular Data 23-27 January 2012 Qunatum Methods for Plasma-Facing Materials Alain ALLOUCHE Univ.de Provence, Lab.de la Phys.

More information

Ab initio asymptotic-expansion coefficients for pair energies in Møller-Plesset perturbation theory for atoms

Ab initio asymptotic-expansion coefficients for pair energies in Møller-Plesset perturbation theory for atoms Ab initio asymptotic-expansion coefficients for pair energies in Møller-Plesset perturbation theory for atoms K. JANKOWSKI a, R. SŁUPSKI a, and J. R. FLORES b a Nicholas Copernicus University 87-100 Toruń,

More information

A Computer Study of Molecular Electronic Structure

A Computer Study of Molecular Electronic Structure A Computer Study of Molecular Electronic Structure The following exercises are designed to give you a brief introduction to some of the types of information that are now readily accessible from electronic

More information

5.111 Lecture Summary #6

5.111 Lecture Summary #6 5.111 Lecture Summary #6 Readings for today: Section 1.9 (1.8 in 3 rd ed) Atomic Orbitals. Read for Lecture #7: Section 1.10 (1.9 in 3 rd ed) Electron Spin, Section 1.11 (1.10 in 3 rd ed) The Electronic

More information

(1/2) M α 2 α, ˆTe = i. 1 r i r j, ˆV NN = α>β

(1/2) M α 2 α, ˆTe = i. 1 r i r j, ˆV NN = α>β Chemistry 26 Spectroscopy Week # The Born-Oppenheimer Approximation, H + 2. Born-Oppenheimer approximation As for atoms, all information about a molecule is contained in the wave function Ψ, which is the

More information

Computational Chemistry: Molecular Simulations with Chemical and Biological Applications. Prof. M. Meuwly, Dr. PA Cazade, Dr. M.-W.

Computational Chemistry: Molecular Simulations with Chemical and Biological Applications. Prof. M. Meuwly, Dr. PA Cazade, Dr. M.-W. Computational Chemistry: Molecular Simulations with Chemical and Biological Applications Prof. M. Meuwly, Dr. PA Cazade, Dr. M.-W. Lee Overview 1. Electronic Structure of Molecules 1.1 The Electronic Problem

More information

The Accurate Calculation of Molecular Energies and Properties: A Tour of High-Accuracy Quantum-Chemical Methods

The Accurate Calculation of Molecular Energies and Properties: A Tour of High-Accuracy Quantum-Chemical Methods 1 The Accurate Calculation of Molecular Energies and Properties: A Tour of High-Accuracy Quantum-Chemical Methods T. Helgaker Centre for Theoretical and Computational Chemistry Department of Chemistry,

More information

T. Helgaker, Department of Chemistry, University of Oslo, Norway. T. Ruden, University of Oslo, Norway. W. Klopper, University of Karlsruhe, Germany

T. Helgaker, Department of Chemistry, University of Oslo, Norway. T. Ruden, University of Oslo, Norway. W. Klopper, University of Karlsruhe, Germany 1 The a priori calculation of molecular properties to chemical accuarcy T. Helgaker, Department of Chemistry, University of Oslo, Norway T. Ruden, University of Oslo, Norway W. Klopper, University of Karlsruhe,

More information

The Electronic Structure of Atoms

The Electronic Structure of Atoms The Electronic Structure of Atoms Classical Hydrogen-like atoms: Atomic Scale: 10-10 m or 1 Å + - Proton mass : Electron mass 1836 : 1 Problems with classical interpretation: - Should not be stable (electron

More information

Chapter 2 Approximation Methods Can be Used When Exact Solutions to the Schrödinger Equation Can Not be Found.

Chapter 2 Approximation Methods Can be Used When Exact Solutions to the Schrödinger Equation Can Not be Found. Chapter 2 Approximation Methods Can be Used When Exact Solutions to the Schrödinger Equation Can Not be Found. In applying quantum mechanics to 'real' chemical problems, one is usually faced with a Schrödinger

More information

NMR and IR spectra & vibrational analysis

NMR and IR spectra & vibrational analysis Lab 5: NMR and IR spectra & vibrational analysis A brief theoretical background 1 Some of the available chemical quantum methods for calculating NMR chemical shifts are based on the Hartree-Fock self-consistent

More information

Chem 6, 10 Section Spring Exam 2 Solutions

Chem 6, 10 Section Spring Exam 2 Solutions Exam 2 Solutions 1. (4 + 6 + 5 points) Dartmouth s FM radio station, WDCR, broadcasts by emitting from its antenna photons of frequency 99.3 MHz (99.3 10 6 Hz). (a) What is the energy of a single WDCR

More information

Answers Quantum Chemistry NWI-MOL406 G. C. Groenenboom and G. A. de Wijs, HG00.307, 8:30-11:30, 21 jan 2014

Answers Quantum Chemistry NWI-MOL406 G. C. Groenenboom and G. A. de Wijs, HG00.307, 8:30-11:30, 21 jan 2014 Answers Quantum Chemistry NWI-MOL406 G. C. Groenenboom and G. A. de Wijs, HG00.307, 8:30-11:30, 21 jan 2014 Question 1: Basis sets Consider the split valence SV3-21G one electron basis set for formaldehyde

More information

Sparks CH301. Quantum Mechanics. Waves? Particles? What and where are the electrons!? UNIT 2 Day 3. LM 14, 15 & 16 + HW due Friday, 8:45 am

Sparks CH301. Quantum Mechanics. Waves? Particles? What and where are the electrons!? UNIT 2 Day 3. LM 14, 15 & 16 + HW due Friday, 8:45 am Sparks CH301 Quantum Mechanics Waves? Particles? What and where are the electrons!? UNIT 2 Day 3 LM 14, 15 & 16 + HW due Friday, 8:45 am What are we going to learn today? The Simplest Atom - Hydrogen Relate

More information

Chemistry, Physics and the Born- Oppenheimer Approximation

Chemistry, Physics and the Born- Oppenheimer Approximation Chemistry, Physics and the Born- Oppenheimer Approximation Hendrik J. Monkhorst Quantum Theory Project University of Florida Gainesville, FL 32611-8435 Outline 1. Structure of Matter 2. Shell Models 3.

More information

Lecture B6 Molecular Orbital Theory. Sometimes it's good to be alone.

Lecture B6 Molecular Orbital Theory. Sometimes it's good to be alone. Lecture B6 Molecular Orbital Theory Sometimes it's good to be alone. Covalent Bond Theories 1. VSEPR (valence shell electron pair repulsion model). A set of empirical rules for predicting a molecular geometry

More information

Quantum Monte Carlo wave functions and their optimization for quantum chemistry

Quantum Monte Carlo wave functions and their optimization for quantum chemistry Quantum Monte Carlo wave functions and their optimization for quantum chemistry Julien Toulouse Université Pierre & Marie Curie and CNRS, Paris, France CEA Saclay, SPhN Orme des Merisiers April 2015 Outline

More information

Systematically convergent basis sets for transition metals. I. All-electron correlation consistent basis sets for the 3d elements Sc Zn

Systematically convergent basis sets for transition metals. I. All-electron correlation consistent basis sets for the 3d elements Sc Zn THE JOURNAL OF CHEMICAL PHYSICS 123, 064107 2005 Systematically convergent basis sets for transition metals. I. All-electron correlation consistent basis sets for the 3d elements Sc Zn Nikolai B. Balabanov

More information

QUANTUM MECHANICS AND MOLECULAR STRUCTURE

QUANTUM MECHANICS AND MOLECULAR STRUCTURE 6 QUANTUM MECHANICS AND MOLECULAR STRUCTURE 6.1 Quantum Picture of the Chemical Bond 6.2 Exact Molecular Orbital for the Simplest Molecule: H + 2 6.3 Molecular Orbital Theory and the Linear Combination

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

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

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

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

EXAM INFORMATION. Radial Distribution Function: B is the normalization constant. d dx. p 2 Operator: Heisenberg Uncertainty Principle:

EXAM INFORMATION. Radial Distribution Function: B is the normalization constant. d dx. p 2 Operator: Heisenberg Uncertainty Principle: EXAM INFORMATION Radial Distribution Function: P() r RDF() r Br R() r B is the normalization constant., p Operator: p ^ d dx Heisenberg Uncertainty Principle: n ax n! Integrals: xe dx n1 a x p Particle

More information

Overview of Molecular Modelling and Ab initio Molecular Orbital Methods Suitable for Use with Energetic Materials

Overview of Molecular Modelling and Ab initio Molecular Orbital Methods Suitable for Use with Energetic Materials Overview of Molecular Modelling and Ab initio Molecular Orbital Methods Suitable for Use with Energetic Materials H. Dorsett and A. White Weapons Systems Division Aeronautical and Maritime Research Laboratory

More information