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

Online Help

All Products    Maple    MapleSim


Home : Support : Online Help : Toolboxes : Quantum Chemistry : Courses : Lessons : VibrationalSpectroscopy

Vibrational Spectroscopy: Calculating the Rovibrational Spectrum of a Diatomic Molecule

Copyright (c) RDMCHEM LLC 2019

 

Overview

Initialize

Input Parameters 

Normal Mode Analysis

Ab initio Calculation: Density Functional Theory

Results

Appendix

Overview

 

In this exercise, you will calculate the rovibrational spectrum of a diatomic molecule of interest (e.g.HCl) using different levels of theory: a normal mode analysis and ab initio methods.  

 

Normal Mode Analysis:  

 

As a first approximation, you will use the harmonic oscillator / rigid rotor approximation to calculate the fundamental vibrational frequency, v0, and rotational energies. In this approximation,  the total rovibrational energy is given by Eq. (1):

 

En,l = hv0n+12+ll+122 μ R02       (1)  

 

where n = 0, 1, 2, ... is the vibrational quantum number, l = 0, 1, 2, ... is the rotational quantum number, R0is the equilibrium bond distance, and μ is the reduced mass of the diatomic.  

Using the Bohr correspondence principle, one can calculate a given transition between any two rovibrational states.  However, selection rules for a rotating/vibrating heteronuclear diatomic are Δl = ±1 and Δn = ±1.  Therefore, the (0,0) --> (1,0) fundamental transition would not be observed. What would be observed are the P-branch (corresponding to all transitions with Δl = -1) and the R-branch (all transitions corresponding to Δl = +1):

 

P-branch:   ΔE= E1, l1  E0,l  = hcλ         (2)

R-branch:   ΔE= E1, l+1  E0,l  = hcλ         (3)

Transition energies are typically expressed in wavenumbers (cm1):

 

ΔEhc=1λcm= v~.        (4)

  

You will use the GeometryOptimization function to calculate R0 for the diatomic of interest and then use the VibrationalModes function to calculate the fundamental frequency, v~0. You will then calculate the rotational energies given by the second term in Eq. (1) for l = 0, 1, ..., lmax.  You will then calculate P- and R-branches according to Eqs. (2) and (3) and compare to experimental values.    

 

Ab Initio Calculation

 

While the above approximation is simple, more sophisticated methods can be used to capture the inherent anharmonicity in the system. In the second portion of this activity, you will calculate the potential energy surface (PES), V(R), using density functional theory (DFT) and the 6-31g basis set for a range of internuclear distances, R.   Once V(R) has been constructed, the nuclear Schrodinger equation is given by

 

H Ψn,l (R) = En,l  Ψn,l (R).           (5)

 

where Ψn,l   is the corresponding rovibrational wavefunction, and the Hamiltonian, H, is given by

H = -ℏ22 μ1Rⅆⅆ R+VR+ll+122 μ R2,          (6)

 

While the details of how one solves Eq. (5) are beyond the scope of this exercise, the variational principle is used:  represent Eq. (5) in an underlying basis representation for Ψ and diagonalize the resulting matrix to get energy eigenvalues, En,l.  (For more on matrix representations and the variational principle, see Variational Theorem exercise).  Once En,l values have been calculated, the transition frequencies can again be calculated using the appropriate selection rules and Eqs. (2) and (3), and the results can be compared to experiment.

 

Initialize

restart:withLinearAlgebra:withScientificConstants: withplots:withQuantumChemistry:Digits15:

Input Parameters 

 

We begin by specifying the atoms in our diatomic.  Note that the energy levels and spacings will depend on the isotopes we specify!  The variables elementA and elementB are the element symbols for the atoms in our diatomic, and MassNumberA and MassNumberB are their respective mass numbers (integers).    The variables Rmin and Rmax define the range over which the PES is computed and determine the level of accuracy of the vibrational calculation. The smaller the range, the quicker the calculation but the less accurate the results.  Start with a reasonable guess and proceed through each step to calculate the fundamental frequency.  Vary Rmin and Rmax until some acceptable level of convergence has been reached.  Once this has been done, Rmin and Rmax remain fixed for the different electronic structure methods and basis sets.

 

Finally, we specify the electronic structure method and basis set here.  Begin with ESmethod = HartreeFock and AObasis = "sto-3g" and proceed.  Once the fundamental has been calculated, repeat each step with a new basis and/or method.

 

elementAH;

elementAH

(3.1)

MassNumberA1;

MassNumberA1

(3.2)

elementBCl;

elementBCl

(3.3)

MassNumberB35; 

MassNumberB35

(3.4)

wavenum_observed2885.8;               # in wavenumbers

wavenum_observed2885.80000000

(3.5)

Rmin0.8;     # in Angstroms

Rmin0.80000000

(3.6)

Rmax3.0;    # in Angstroms

Rmax3.00000000

(3.7)

ESmethod'DensityFunctional';     

ESmethodDensityFunctional

(3.8)

ESbasis6-31g ;   

ESbasis6-31g

(3.9)

Normal Mode Analysis

 

In this section, calculate the fundamental mode of the diatomic using a normal mode analysis, which approximates the vibration of the diatomic as a harmonic oscillator.  First define the molecule with a bond length of 1 Angstrom and then use the GeometryOptimization function to redefine the molecule with the optimum bond length for the desired method and basis. Then use the VibrationalModes function to determine the energy (in wavenumbers) of the fundamental.  Calculate the percent error.

 

molecconvertelementA,string,0,0,0,convertelementB,string,0,0,1;

molecH,0,0,0,Cl,0,0,1

(4.1)

molec,dataGeometryOptimizationmolec,ESmethod,basis=ESbasis;

emodes,vmodesVibrationalModesmolec,ESmethod,basis=ESbasis;

emodes,vmodes2713.23473969,−8.9766771110−72.3071925610−6−0.986080933.9158362910−8−2.8018922010−70.16626606

(4.2)

PercentErroremodes1wavenum_observedwavenum_observed100;

PercentError−5.97980665

(4.3)

 

 

Now, consider the rovibrational transitions allowed for a heteronuclear diatomic AB.   The vibrational selection rules are Δv = Δ±1,  Δl = ±1. Therefore, for transitions between v = 0 --> v = 1, there is a manifold of Δl = ±1 lines.

 

mAevalfElementelementAMassNumberA,atomicmass,system=SI;mBevalfElementelementBMassNumberB,atomicmass,system=SI;

mA1.6735339810−27

mB5.8067185710−26

(4.4)

lmax5;

lmax5

(4.5)

R01.32081083413467ⅇ−10;    # Value from GeometryOptimization calculation above

R01.3208108310−10

(4.6)

reduced_massmAmBmA+mB;

reduced_mass1.6266527910−27

(4.7)

moment_inertiareduced_massR02;

moment_inertia2.8377629110−47

(4.8)

for l from 0 by 1 to lmax do      Erotlll+1evalfConstanthbar22moment_inertia1evalfConstanthevalfConstantc100.0; end do

Erot00.

Erot119.72874569

Erot259.18623706

Erot3118.37247413

Erot4197.28745688

Erot5295.93118532

(4.9)

# Calculate P- and R-branches for l = 0, 1, 2, ..., lmax

  

P-branch: Dl = -1

 

for l from 1 by 1 to  lmax do      Pemodes1+Erotl1Erotl:  end do

P2693.50599401

P2673.77724832

P2654.04850263

P2634.31975694

P2614.59101125

(4.10)

 

R-branch: Dl = +1

for l from 0 by 1 to  lmax1 do     Remodes1+Erotl+1Erotl:  end do 

R2732.96348538

R2752.69223107

R2772.42097676

R2792.14972244

R2811.87846813

(4.11)

 

What do you notice about the spacing between lines in the P-branch?  in the R-branch? Are these observations consistent with an experimental IR spectrum of the diatomic AB?

Answer

There is equal spacing between lines in both P and R branches. This is consistent with a rigid rotor approximation!

 

 

Ab initio Calculation: Density Functional Theory

Construct Potential Energy Surface

 

In this section, use DFT to solve for the potential energy surface of diatomic AB.  Begin by using the ScientificConstants package to get the mass of each of the elements A and B. Use the QuantumChemistry package to calculate the PES for a range of separation values between Rmin and Rmax.     (Note, DFT may not converge for at larger values of R. This should not affect the final results.)   

 

mAevalfElementelementAMassNumberA,atomicmass,system=Atomic;mBevalfElementelementBMassNumberB,atomicmass,system=Atomic;

mA1837.15393006

mB63744.36349535

(5.1.1)

#mA≔evalfElementelementA,atomicweight,system=Atomic;mBevalfElementelementB,atomicweight,system=Atomic;

RdataseqR,R=Rmin..Rmax,0.05:   # Determines the points at which our PES will be explicitly calculated molecules  seqconvertelementA,string,0,0,0,convertelementB,string,0,0,i, i=Rmin..Rmax,0.05:edata mapEnergy,molecules, method=ESmethod,basis=ESbasis:pes  splineRdata,edata,r,3: plot_pes plot pes, r=Rmin..Rmax, axes=BOXED, font=ROMAN,16, labelfont=ROMAN,16, labels='r','E', color=blue;

Calculate Vibrational Energy Levels

 

Once you have a PES, you can solve the vibrational Schrodinger equation.  Calculate the energies for a range of angular momentum values and to calculate the P- and R-branches.

 

ntrunc20RmaxRmin:lmax5:

EvlMatrixn,lmax+1:HDVRMatrixn,n:rVectorn:VVectorn :redmmAmBmA+mB: drRmaxRminn1:dxdr 0.52917721092: 

for i from 1 by 1 to n do            riRmin+i1.dr:                 #Vi0.16971  exp0.9890ri0.52917721092   2.4092:     # Morse potential for HCl...           VisplineRdata,edata,ri,3:end do:

for l from 0 by 1 to  lmax  do     for i from 1 by 1 to n do          for j from 1 by 1 to n do               if i=j then                    HDVRi,j0.5redmdx21 ijPi23.00.5i2+Vi  +ll+12redmri2               else                   HDVRi,j0.5redmdx21 ij2ij22i+j2              end if          end do      end do :   EEigenvaluesMatrixHDVR,shape=symmetric: for i from 1 by 1 to n do Evli,l+1Ei end do end do:

Results

Fundamental Transition Frequency

We can now calculate the fundamental frequency ( in wavenumbers, 1/cm). This number can be compared to the experimental value for the AB diatomic of interest.  Enter the results into Table 1 below!

 

wavenumEvl2,1Evl1,1219476.329478

wavenum2621.54229484

(6.1.1)

PercentErrorwavenumwavenum_observedwavenum_observed100

PercentError−9.15717323

(6.1.2)

 

Table 1: Fundamental  Frequencies for Diatomic AB   (v0 = 2872.3 cm-1 for HCl.)

 

ESMethod

AObasis

Fundamental Frequency v0 (cm-1)

%Error

Density Functional Theory

6-31G

 

 

 

 P-Branch and R-Branch

 

As a final exercise, we consider the rovibrational transitions allowed for a heteronuclear diatomic AB using the method/basis that gave the best results in Table 1.   If necessary, recompute the rovibrational eigenvalues for this combination before proceeding.

 

  

P-branch: DJ = -1

 

for l from 1 by 1 to  lmax do      PEvl2,l1+1Evl1,l+1219476.329478:  end do

P2552.23818551

P2480.89533062

P2407.67319968

P2332.73352161

P2256.23985068

(6.2.1)

 

R-branch: DJ = +1

for l from 0 by 1 to  lmax1 do      REvl2,l+1+1Evl1,l+1219476.329478:  end do 

R2688.65090282

R2753.41043599

R2815.67098378

R2875.28678878

R2932.11674112

(6.2.2)

 

What do you notice about the spacing between lines in the P-branch?  in the R-branch? Are these observations consistent with an experimental IR spectrum of the diatomic AB?

Answer

P-branch: spacing increases as J increases.
R-branch: spacing decreases as J increases.

Appendix

References

J. C.Light, I. P.Hamilton, and J. V. Vill, J. Chem. Phys. 82 ,1400 (1985).