MBPT2 - Maple Help
For the best experience, we recommend viewing online help using Google Chrome or Microsoft Edge.

Online Help

All Products    Maple    MapleSim


Many-Body Perturbation Theory

Copyright (c) RDMCHEM LLC 2020

 

 

Overview

MP2

References

Overview

The energies and properties from the Hartree-Fock method can be improved by using Rayleigh-Schrödinger perturbation theory.  In this lesson we explore the theory and use of a form of Rayleigh-Schrödinger perturbation theory for many-particle quantum systems known as second-order many-body perturbation theory (MP2).  The Hamiltonian operator in MP2 is expressed as a reference Hamiltonian operator and a perturbation operator

H(l) = H0 + l V

where

H0 = F

and

V = H - F

in which F is the Fock operator whose eigenvalues are the molecular orbital energies of the Hartree-Fock method.  When the perturbation parameter equals one (l = 1), the Hamiltonian operator H(1) becomes equal to the exact Hamiltonian operator in the selected orbital basis set.  Computing the energy through second order in the perturbation parameter yields the MP2 method.  MP2 is one of the simplest methods to approximate the correlation energy, the energy difference between the energy from solution of the Schrödinger equation and the energy from Hartree-Fock method in the selected orbital basis set.

MP2

After loading the Quantum Chemistry package, we explore the equilibrium bond length, dipole moment and potential energy curve of carbon monoxide with comparisons to experiment.  

Quantum Chemistry

We set the number of Digits to be used in computations to 15 and load the Quantum Chemistry package using Maple's with command.

Digits  15;

Digits15

(2.1.1)

withQuantumChemistry;

AOLabels,ActiveSpaceCI,ActiveSpaceSCF,AtomicData,BondAngles,BondDistances,Charges,ChargesPlot,CorrelationEnergy,CoupledCluster,DensityFunctional,DensityPlot3D,Dipole,DipolePlot,Energy,ExcitationEnergies,ExcitationSpectra,ExcitationSpectraPlot,ExcitedStateEnergies,ExcitedStateSpins,FullCI,GeometryOptimization,HartreeFock,Interactive,Isotopes,MOCoefficients,MODiagram,MOEnergies,MOIntegrals,MOOccupations,MOOccupationsPlot,MOSymmetries,MP2,MolecularData,MolecularGeometry,NuclearEnergy,NuclearGradient,OscillatorStrengths,Parametric2RDM,PlotMolecule,Populations,RDM1,RDM2,RTM1,ReadXYZ,Restore,Save,SaveXYZ,SearchBasisSets,SearchFunctionals,SkeletalStructure,Thermodynamics,TransitionDipolePlot,TransitionDipoles,TransitionOrbitalPlot,TransitionOrbitals,Variational2RDM,VibrationalModeAnimation,VibrationalModes,Video

(2.1.2)

 

Carbon Monoxide

We compute the equilibrium bond length and the dipole moment of carbon monoxide.

Equilibrium Bond Length

To compute the equilibrium bond length, we select a set of bond distances from the roots of the sixth-order Chebyshev polynomial that are suitable for interpolation

bond_distances  mapx  x/10+1.11, fsolveexpandChebyshevT6,x;

bond_distances1.01340742,1.03928932,1.08411810,1.13588190,1.18071068,1.20659258

(2.2.1.1)

We define a list of molecular geometries with each geometry corresponding to one of the bond distances

molecules  seqC,0,0,0,O,0,0,R, R in bond_distances;

moleculesC,0,0,0,O,0,0,1.01340742,C,0,0,0,O,0,0,1.03928932,C,0,0,0,O,0,0,1.08411810,C,0,0,0,O,0,0,1.13588190,C,0,0,0,O,0,0,1.18071068,C,0,0,0,O,0,0,1.20659258

(2.2.1.2)

The energies for each geometry may be then readily computed with the Energy command in the Quantum Chemistry package in which we set method = MP2.

energies  seqEnergymolecule,method=MP2, basis=cc-pV5Z, molecule in molecules;

energies−113.21146174,−113.22841767,−113.24555326,−113.25064671,−113.24594169,−113.24039923

(2.2.1.3)

We use polynomial interpolation to generate a polynomial in the bond distance R

pes  interpbond_distances,energies,R;

pes9.66039475R5+62.38556861R4163.80401804R3+218.86658796R2148.46546961R72.52251752

(2.2.1.4)

The potential energy surface (curve) can be plotted

plotpesR, R=1.025..1.2, axes=boxed, labels='R','E', color=red, thickness=3;

Finally, we differential the potential energy curve with respect to R and set the derivative to zero.

eq  diffpes, R = 0;

eq48.30197374R4+249.54227445R3491.41205412R2+437.73317592R148.46546961=0

(2.2.1.5)

Solving the resulting equation yields the equilibrium bond length

R_eq  fsolveeq, R=1.0..1.2;

R_eq1.13054421

(2.2.1.6)

 


(a) By changing the basis keyword in the Energy command, repeat the above computations for the following larger basis sets: (i) cc-pVTZ, (ii) cc-pVQZ, and (iii) cc-pV5Z, and report your results as a table.  (Note that the basis sets are increasing in size as cc-pVDZ < cc-pVTZ < cc-pVQZ < cc-pV5Z)

 

(b) Does the bond length of CO from the MP2 method increase or decrease with larger basis sets?
 

(c) How does the computed bond length of CO compare with experiment?  (Hint: Check the NIST web site https://cccbdb.nist.gov/expgeom2x.asp?casno=630080)

 

Dipole Moment

Let us compute the electric dipole moment of CO from MP2 at the equilibrium bond length in the cc-pVDZ basis set.  First, we define the molecule's geometry as a Maple list of lists giving the atom's names and xyz coordinates

molecule  C&comma;0&comma;0&comma;0&comma;O&comma;0&comma;0&comma;1.11014350&semi;

moleculeC&comma;0&comma;0&comma;0&comma;O&comma;0&comma;0&comma;1.11014350

(2.2.2.1)

Using the Dipole command, we can compute the dipole from the MP2 method in the cc-pVDZ basis set

Dipolemolecule&comma; method&equals;MP2&comma; basis&equals;cc-pVDZ&semi;

X0.Y0.Z−0.01274002

(2.2.2.2)

For comparison we can also compute the dipole from the Hartree-Fock method

Dipolemolecule&comma; method&equals;HartreeFock&comma; basis&equals;cc-pVDZ&semi;

X0.Y0.Z−0.14581806

(2.2.2.3)

 

(d) By changing the basis keyword in the Energy command, repeat the above computations for the following larger basis sets: (i) cc-pVTZ, (ii) cc-pVQZ, and (iii) cc-pV5Z, and report your results as a table.
   
(e) Does the dipole moment of CO from the MP2 method increase or decrease with larger basis sets?  Does it appear to converge in the large-basis-set limit?

 

(f) Is the dipole moment of CO from either Hartree-Fock or MP2 in agreement with the experimental value available at NIST (https://cccbdb.nist.gov/diplistx.asp)?  Which is closer?  

 

Potential Energy Curve

To compute the potential energy curve, we select a set of bond distances from the roots of the sixth-order Chebyshev polynomial that are suitable for interpolation

bond_distances  mapx  x&sol;1.7&plus;1.55&comma; fsolveexpandChebyshevT6&comma;x&semi;

bond_distances0.98180834&comma;1.13405483&comma;1.39775350&comma;1.70224650&comma;1.96594517&comma;2.11819166

(2.2.3.1)

We define a list of molecular geometries with each geometry corresponding to one of the bond distances

molecules  seqC&comma;0&comma;0&comma;0&comma;O&comma;0&comma;0&comma;R&comma; R in bond_distances&semi;

moleculesC&comma;0&comma;0&comma;0&comma;O&comma;0&comma;0&comma;0.98180834&comma;C&comma;0&comma;0&comma;0&comma;O&comma;0&comma;0&comma;1.13405483&comma;C&comma;0&comma;0&comma;0&comma;O&comma;0&comma;0&comma;1.39775350&comma;C&comma;0&comma;0&comma;0&comma;O&comma;0&comma;0&comma;1.70224650&comma;C&comma;0&comma;0&comma;0&comma;O&comma;0&comma;0&comma;1.96594517&comma;C&comma;0&comma;0&comma;0&comma;O&comma;0&comma;0&comma;2.11819166

(2.2.3.2)

The energies for each geometry may be then readily computed with the Energy command in the Quantum Chemistry package.

energies_mp2  seqEnergymolecule&comma;method&equals;MP2&comma; basis&equals;cc-pVDZ&comma; molecule in molecules&semi;

energies_mp2−112.95544897&comma;−113.04050587&comma;−112.96547532&comma;−112.80294666&comma;−112.60289471&comma;−112.54447209

(2.2.3.3)

We use polynomial interpolation to generate a polynomial in the bond distance R

pes_mp2 interpbond_distances&comma;energies_mp2&comma;R&semi;

pes_mp23.48933102R5+27.24786757R484.47258157R3+130.33469869R299.84887326R82.74826166

(2.2.3.4)

Similarly, for comparison we can compute the energies with the Hartree-Fock method

energies_hf seqEnergymolecule&comma;method&equals;HartreeFock&comma;basis&equals;cc-pVDZ&comma; molecule in molecules&semi;

energies_hf−112.68907086&comma;−112.74866568&comma;−112.62428645&comma;−112.43823734&comma;−112.34119827&comma;−112.31450377

(2.2.3.5)

We use polynomial interpolation to generate a polynomial in the bond distance R

pes_hf  interpbond_distances&comma;energies_hf&comma;R&semi;

pes_hf0.86844042R5+7.99580630R429.34827331R3+53.21006552R246.83555798R96.85908538

(2.2.3.6)

The potential energy curves from the Hartree-Fock method (red) and the MP2 method (blue) can be plotted together

p_hf  plotpes_hf&comma; R&equals;1.0..2.1&comma; axes&equals;boxed&comma; labels&equals;&apos;R&apos;&comma;&apos;E&apos;&comma; color&equals;red&comma; thickness&equals;3&colon; p_mp2  plotpes_mp2&comma; R&equals;1.0..2.1&comma; axes&equals;boxed&comma; labels&equals;&apos;R&apos;&comma;&apos;E&apos;&comma; color&equals;blue&comma; thickness&equals;3&colon;plots:-displayp_hf&comma;p_mp2&semi;

 

 

(g) Does the MP2 method improve upon the Hartree-Fock method around the equilibrium bond length?

(h) Explain what MP2 predicts upon dissociation.  Is this behavior physical or an artifact of the second-order perturbation theory?

 

References

1. 

C. Møller and M. S. Plesset, Phys. Rev. 46, 618–622 (1934). "Note on an Approximation Treatment for Many-Electron Systems"

2. 

A. Szabo and N. S. Ostlund, Modern Quantum Chemistry: Introduction to Advanced Electronic Structure Theory (Dover Books, New York, 1996).