Exercise 1: Structure and dipole moment of a small molecule

Size: px
Start display at page:

Download "Exercise 1: Structure and dipole moment of a small molecule"

Transcription

1 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 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

2 QCISD CCSD(T) 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: ψ i = n c ij φ j (1) j=1 where ψ i is the i-th molecular orbital, c ij are the coefficients of linear combination, φ 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 with different exponents and coefficients. You can use several GTOs (4 5) to 2

3 represent an STO, and still calculate integrals faster than if the original STOs were used. The GTO is expressed as: φ GT O (α, 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 quantities n, l, and m are NOT QUANTUM NUMBERS but simply integral exponents at cartesian coordinates. The GTOs are not really orbitals, they are simpler functions. In recent literature they have been called gaussian primitives. How are the GTOs obtained? The following example shows how the variational principle can be employed to find the best possible basis function expressed by single gaussian function to the lowest symmetric level for hydrogen atom. Example 1. The exact eigenfunction corresponding to the 1s hydrogen atomic orbital (for which the corresponding energy is 0.5 Hartree), is given by the function: φ 1s = 1 π e r (4) It was mentioned earlier that in ab initio calculations, it is customary to approximate the monoelectronic functions as linear combinations of gaussians centred on the atoms, that is as linear combinations of functions of the kind: φ GF = Ne αr2 (5) where N is the normalization constant and α is unknown parameter. In this example we are limited to use only one gaussian in the trial function in order to calculate the lowest energy of hydrogen, which can be obtained by using the radial part of the Schrödinger equation when the angular momentum is zero: where E = φ GF φ GF r (6) 2 = 1 ( d r 2 d ) r 2 dr dr (7) The variation principle states that the energy calculated by your guessed wavefunction will be greater than (or equal to) the actual ground state energy. Thus, the problem is to find a value for the unknown parameter α that minimizes the energy. It turns out that the lowest energy using the trial function of Eq.(5) is E = 4 Hartree = Hartree, whereas 3π the exact value is E = 0.5 Hartree. Another more general approach to obtain basis functions is to numerically find such a linear combination of gaussian functions that maximizes the overlap between it and the Slater functions. In other words, the Slater functions are fitted 3

4 using linear combinations of gaussian functions. These functions are called STOnG basis functions where n refers to the number of gaussians used to express the Slater-Type-Orbital. For molecular calculations, it is obvious that the best results could be obtained if all coefficients in the gaussian expansion were allowed to vary during the calculation. In practice however, the gaussian primitives have to be contracted. The term contraction means a linear combination of gaussian primitives to be used as a basis function. Such a basis function will have its coefficients and exponents fixed. Minimal basis sets are not enough to describe the shapes of the molecular orbitals correctly. Thus, several basis functions (or contractions) are required for a more accurate treatment of electronic states 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. 4 Exercise In this exercise, the program Gaussian03 will be used to calculate the optimised structure and the dipole moment of a molecule (or molecules). First, prepare the input file jobname.com. An example of the Gaussian input is as follows: 4

5 #RHF/STO-3G Opt=z-matrix Water equilibrium geometry 0 1 O H1 O r1 H2 O r2 H1 a1 r r a In the first line, after the symbol #, the ab initio method and the basis set are specified. For the various methods, it will be sufficient to change the name of the method or the basis set (that is, MP2/AUG-cc-pVTZ for example). In the second line, the job type is specified. In this exercise, the geometry of a molecule is optimised. This is implemented with the Opt keyword in the input. The option z-matrix requests that the optimisation be performed in internal coordinates. The fourth line is reserved for the title which will be written in the output file. In the sixth line, the charge and spin multiplicity of the molecule are specified, respectively. In the following three lines, the z-matrix, i.e the geometry in internal coordinates, is specified in Å for bond lengths and degrees for bond angles and dihedral angles. After the empty line, the initial values for the coordinates are given. In the optimisation, the initial values are varied by Gaussian until the energy minimum is found. The exercise will be carried out using the methods B3LYP, RHF, MP2, QCISD, and CCSD(T) and at least 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 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-pVTZ: Dunning s correlation consistent basis set. Includes polarization functions by definition. The term TZ (triple zeta) means that three 5

6 contractions are used to represent a single Slater orbital. This 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 Corona, the Gaussian job is submitted by the command: subg03 00:20:00 jobname The dipole moment and the optimised geometry will be written in the end of the jobname.log file. For example, you can organise your results (for each coordinate and dipole moment) in a table of the following type: STO-3G 6-31G(d) AUG-cc-pVTZ RHF MP2 QCISD CCSD(T) * * is too resource heavy for the purpose of this exercise. Experimental structures and dipole moments of some molecules: CO dipole moment: D r=1.11 Å H 2 O dipole moment: 1.85 D r= Å a= degrees H 2 O 2 dipole moment: 2.26 D r(o-h)=0.96±0.01 Å r(o-o)=1.47 Å a(o-o-h)=97.0±2 degrees a(dihedral)=111.7±0.1 degrees NH 3 dipole moment: 1.42 D r(n-h)=1.017 a(h-n-h)=107.5 degrees 6

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

CHEMISTRY 4021/8021 MIDTERM EXAM 1 SPRING 2014

CHEMISTRY 4021/8021 MIDTERM EXAM 1 SPRING 2014 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

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

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

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

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

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

Final Exam Tuesday, May 8, 2012 Starting at 8:30 a.m., Hoyt Hall Duration: 2h 30m

Final Exam Tuesday, May 8, 2012 Starting at 8:30 a.m., Hoyt Hall Duration: 2h 30m Final Exam Tuesday, May 8, 2012 Starting at 8:30 a.m., Hoyt Hall. ------------------- Duration: 2h 30m Chapter 39 Quantum Mechanics of Atoms Units of Chapter 39 39-1 Quantum-Mechanical View of Atoms 39-2

More information

Quantum mechanics can be used to calculate any property of a molecule. The energy E of a wavefunction Ψ evaluated for the Hamiltonian H is,

Quantum mechanics can be used to calculate any property of a molecule. The energy E of a wavefunction Ψ evaluated for the Hamiltonian H is, Chapter : Molecules Quantum mechanics can be used to calculate any property of a molecule The energy E of a wavefunction Ψ evaluated for the Hamiltonian H is, E = Ψ H Ψ Ψ Ψ 1) At first this seems like

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

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

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

Chemistry 881 Lecture Topics Fall 2001

Chemistry 881 Lecture Topics Fall 2001 Chemistry 881 Lecture Topics Fall 2001 Texts PHYSICAL CHEMISTRY A Molecular Approach McQuarrie and Simon MATHEMATICS for PHYSICAL CHEMISTRY, Mortimer i. Mathematics Review (M, Chapters 1,2,3 & 4; M&S,

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

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

(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

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

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

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

0 belonging to the unperturbed Hamiltonian H 0 are known

0 belonging to the unperturbed Hamiltonian H 0 are known Time Independent Perturbation Theory D Perturbation theory is used in two qualitatively different contexts in quantum chemistry. It allows one to estimate (because perturbation theory is usually employed

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

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

Chapter 1 - Basic Concepts: atoms

Chapter 1 - Basic Concepts: atoms Chapter 1 - Basic Concepts: atoms Discovery of atomic structure Rutherford (1910) JJ Thomson (1897) Milliken (1909) Rutherford (1911) 1 Symbol p + e - n 0 Mass (amu) 1.0073 0.000549 1.00870 Discovery 1919,

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

CHAPTER 11 MOLECULAR ORBITAL THEORY

CHAPTER 11 MOLECULAR ORBITAL THEORY CHAPTER 11 MOLECULAR ORBITAL THEORY Molecular orbital theory is a conceptual extension of the orbital model, which was so successfully applied to atomic structure. As was once playfuly remarked, a molecue

More information

Problem 1: Spin 1 2. particles (10 points)

Problem 1: Spin 1 2. particles (10 points) Problem 1: Spin 1 particles 1 points 1 Consider a system made up of spin 1/ particles. If one measures the spin of the particles, one can only measure spin up or spin down. The general spin state of a

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

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

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

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

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

FROM MOLECULAR STRUCTURE TO FUNCTION

FROM MOLECULAR STRUCTURE TO FUNCTION CEM421 FROM MOLECULAR STRUCTURE TO FUNCTION PARMACOLOGY MEDICINE MATERIAL SCIENCE BIOCEMISTRY CEMICAL ENGINEERING ORGANIC CEMISTRY ORGANOMETALLIC CEMISTRY INORGANIC CEMISTRY MOLECULAR STRUCTURE STRUCTURE

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

3: Many electrons. Orbital symmetries. l =2 1. m l

3: Many electrons. Orbital symmetries. l =2 1. m l 3: Many electrons Orbital symmetries Atomic orbitals are labelled according to the principal quantum number, n, and the orbital angular momentum quantum number, l. Electrons in a diatomic molecule experience

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

Lecture 9 Electronic Spectroscopy

Lecture 9 Electronic Spectroscopy Lecture 9 Electronic Spectroscopy Molecular Orbital Theory: A Review - LCAO approximaton & AO overlap - Variation Principle & Secular Determinant - Homonuclear Diatomic MOs - Energy Levels, Bond Order

More information

Lecture 9: Molecular integral. Integrals of the Hamiltonian matrix over Gaussian-type orbitals

Lecture 9: Molecular integral. Integrals of the Hamiltonian matrix over Gaussian-type orbitals Lecture 9: Molecular integral evaluation Integrals of the Hamiltonian matrix over Gaussian-type orbitals Gaussian-type orbitals The de-facto standard for electronic-structure calculations is to use Gaussian-type

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

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

Hints on Using the Orca Program

Hints on Using the Orca Program Computational Chemistry Workshops West Ridge Research Building-UAF Campus 9:00am-4:00pm, Room 009 Electronic Structure - July 19-21, 2016 Molecular Dynamics - July 26-28, 2016 Hints on Using the Orca Program

More information

1s atomic orbital 2s atomic orbital 2s atomic orbital (with node) 2px orbital 2py orbital 2pz orbital

1s atomic orbital 2s atomic orbital 2s atomic orbital (with node) 2px orbital 2py orbital 2pz orbital Atomic Orbitals 1s atomic orbital 2s atomic orbital 2s atomic orbital (with node) 2px orbital 2py orbital 2pz orbital Valence Bond Theory and ybridized Atomic Orbitals Bonding in 2 1s 1s Atomic Orbital

More information

2.4. Quantum Mechanical description of hydrogen atom

2.4. Quantum Mechanical description of hydrogen atom 2.4. Quantum Mechanical description of hydrogen atom Atomic units Quantity Atomic unit SI Conversion Ang. mom. h [J s] h = 1, 05459 10 34 Js Mass m e [kg] m e = 9, 1094 10 31 kg Charge e [C] e = 1, 6022

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

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

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

Line spectrum (contd.) Bohr s Planetary Atom

Line spectrum (contd.) Bohr s Planetary Atom Line spectrum (contd.) Hydrogen shows lines in the visible region of the spectrum (red, blue-green, blue and violet). The wavelengths of these lines can be calculated by an equation proposed by J. J. Balmer:

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

Lecture 3: methods and terminology, part I

Lecture 3: methods and terminology, part I Eritis sicut Deus, scientes bonum et malum. Lecture 3: methods and terminology, part I Molecular dynamics, internal coordinates, Z-matrices, force fields, periodic boundary conditions, Hartree-Fock theory,

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

Introduction to Electronic Structure Theory

Introduction to Electronic Structure Theory Introduction to Electronic Structure Theory C. David Sherrill School of Chemistry and Biochemistry Georgia Institute of Technology June 2002 Last Revised: June 2003 1 Introduction The purpose of these

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

CHEMISTRY Topic #1: Atomic Structure and Nuclear Chemistry Fall 2017 Dr. Susan Findlay See Exercises 5.1 to 5.2

CHEMISTRY Topic #1: Atomic Structure and Nuclear Chemistry Fall 2017 Dr. Susan Findlay See Exercises 5.1 to 5.2 CHEMISTRY 1000 Topic #1: Atomic Structure and Nuclear Chemistry Fall 2017 Dr. Susan Findlay See Exercises 5.1 to 5.2 Electron Spin and Magnetism We have seen that an atomic orbital is described by three

More information

Oslo node. Highly accurate calculations benchmarking and extrapolations

Oslo node. Highly accurate calculations benchmarking and extrapolations Oslo node Highly accurate calculations benchmarking and extrapolations Torgeir Ruden, with A. Halkier, P. Jørgensen, J. Olsen, W. Klopper, J. Gauss, P. Taylor Explicitly correlated methods Pål Dahle, collaboration

More information

Exam 4 Review. Exam Review: A exam review sheet for exam 4 will be posted on the course webpage. Additionally, a practice exam will also be posted.

Exam 4 Review. Exam Review: A exam review sheet for exam 4 will be posted on the course webpage. Additionally, a practice exam will also be posted. Chem 4502 Quantum Mechanics & Spectroscopy (Jason Goodpaster) Exam 4 Review Exam Review: A exam review sheet for exam 4 will be posted on the course webpage. Additionally, a practice exam will also be

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

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

DFT calculations of NMR indirect spin spin coupling constants

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

More information

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