4.5.18. Improving the H Variational Approximation#
4.5.18.1. Motivation:#
The linear combination of atomic orbital (LCAO) description of the H
4.5.18.2. Learning Goals:#
After working through these notes, you will be able to:
Define the difference between a Hydrogen-atom orbital and a Slater orbital
Describe how using Slater 1s orbitals allows us to get an improved variational result for the H
molecule as compared to hydrogen-atom 1s orbitalsDescribe what it means to include polarization functions in atomic orbitals.
4.5.18.3. Coding Concepts:#
The following coding concepts are used in this notebook:
4.5.18.4. Background#
We saw in the previous notes that the variational solution to H
There are two obvious ways to improve the variational solution:
Increase the basis set size
Improve the basis functions
In these notes we will address option two. We will do so in two ways: first by adding a variational parameter to the basis functions themselves and second by including polarization functions.
4.5.18.5. Including Variational Parameters in the Basis Functions#
In the previous notes we used a trial wave function of
where
In our variational example of the helium atom we introduced the idea of using the effective nuclear charge as a variational parameter. We will do so again here. This is a fairly general procedure and the hydrogen atom functions with nuclear charge as a variable (e.g. as
We will thus propose the following wave function
If you recall from our discussion of the variational solution in the minimal basis, there was no need to determine
where
You will show for homework that this integral is
Using this trial wave function it can be shown that
Differentiating
Note that this is only strictly true at the value for
Below I plot
Show code cell source
from scipy.optimize import minimize
import matplotlib.pyplot as plt
%matplotlib inline
import numpy as np
def J(R):
return np.exp(-2*R)*(1+1/R) - 1/R
def K(R):
return -np.exp(-R)*(1+R)
def S(R):
return np.exp(-R)*(1+ R + R*R/3)
def E(Z,R):
T = Z**2/2-Z**2*(S(Z*R)/2 + K(Z*R))
T /= (1+S(Z*R))
V = -Z + Z*J(Z*R) + 2*Z*K(Z*R)
V /= (1+S(Z*R))
V += 1.0/R
return T + V
R = np.arange(1,8,0.001)
plt.figure(figsize=(8,6),dpi= 80, facecolor='w', edgecolor='k')
plt.tick_params(axis='both',labelsize=20)
plt.grid( which='major', axis='both', color='#808080', linestyle='--')
E_1s_basis = np.empty(R.size)
E_slater_basis = np.empty(R.size)
Z_min = np.empty(R.size)
for i, r in enumerate(R):
E_1s_basis[i] = E(1,r)
Z_min[i] = minimize(E,1.0,args=(r)).x[0]
E_slater_basis[i] = E(Z_min[i],r)
plt.plot(R,E_1s_basis,lw=4, label=r'E - 1s basis')
plt.plot(R,E_slater_basis,lw=4, label=r'E - Slater basis')
plt.xlabel(r'R/$a_0$',fontsize=20)
plt.ylabel(r'$E_0 (Hartree)$',fontsize=20)
#plt.ylim(-0.6,-0.2)
plt.legend(fontsize=20)
plt.title(r'Variational Solution to the H$_2^+$ Molecule in Slater Basis',fontsize=16);

We see that allowing the function to be modified at each value of
4.5.18.5.1. Including Polarization Functions#
In the previous example we modified the effective nuclear charge for a 1s-like orbital and saw significant improvement in doing so. The spherical symmetry of the 1s orbital is still maintained in this process. If we think about what our intuition tells us that a
Regardless, it is likely the spherically symmetric behavior of a 1s orbital is not ideal to create a molecular covalent bond. Thus, it is natural to hypothesize that basis functions that allow the breaking of the spherical symmetry and the creation of a lobe of density between the two nuclei to yield better results for the H
We must remember, however, that the 1s orbital is the correct solution at infinte separation. Thus, a good basis will still allow for this behavior while becoming non-spherically symmetric as the two nuclei become close together. We will achieve this behavior by adding a
Our trial wave function will thus look like
where
Notice that we can treat the effective nuclear charge for the 1s and 2p
Show code cell source
# make two plots of the same spherical harmonic
from mpl_toolkits.mplot3d import Axes3D
from matplotlib import cm, colors
import numpy as np
import matplotlib.pyplot as plt
from scipy.special import sph_harm
from scipy.special import eval_genlaguerre
from scipy.special import lpmv
from scipy.special import factorial
%matplotlib inline
from scipy.optimize import root
a0 = 1.0 # radial unit of Bohr!
def hydrogen_atom_wf(r,theta,phi,n,l,m):
Y_norm = np.sqrt((2*l+1)*factorial(l-np.abs(m))/(4*np.pi*factorial(l+np.abs(m))))
R_prefactor = -np.sqrt(factorial(n-l-1)/(2*n*factorial(n+l)))*(2.0/(n*a0))**(l+1.5)*np.power(r,l)*np.exp(-r/(n*a0))
R = R_prefactor*eval_genlaguerre(n-l-1,2*l+1,2*r/(n*a0))
return Y_norm*sph_harm(m, l, phi, theta).real*R
def plot_polarize_hydrogen_atom_wf_xz_projection(n1,l1,m1,n2,l2,m2,a,ax_obj):
x = np.linspace(-10,10,1000)
z = np.linspace(-10,10,1000)
X, Z= np.meshgrid(x, z)
Y = np.zeros(X.shape)
R = np.sqrt(X*X + Y*Y + Z*Z).flatten()
THETA = np.arccos(Z.flatten()/R)
PHI = np.arctan2(Y,X).flatten()
wf = np.zeros(R.shape)
wf = hydrogen_atom_wf(R,THETA,PHI,n1,l1,m1)
wf += a*hydrogen_atom_wf(R,THETA,PHI,n2,l2,m2)
wf = wf.reshape(X.shape)
vmax = max(np.abs(np.amin(wf)),np.abs(np.amax(wf)))
vmin = -vmax
# plot
ax_obj.set_title(rf'$a={a}$', fontsize=18)
c = ax_obj.pcolormesh(X, Z, wf, cmap='RdBu', vmin=vmin, vmax=vmax)
# set the limits of the plot to the limits of the data
ax_obj.axis([-10, 10, -10, 10])
ax_obj.set_aspect('equal')
#ax_obj.set_axis_off()
return c
fig, ax = plt.subplots(1,4,figsize=(12,4),dpi= 80, facecolor='w', edgecolor='k')
A = [0,1.0, 2.0, 10.0]
for i, a in enumerate(A):
plot_polarize_hydrogen_atom_wf_xz_projection(1,0,0,2,1,0,a, ax[i])

I will not solve this all the way out but it is doable. The integrals get even messier etc but are still all solvable. Instead I will just provide you with the results for the minimum energy and
This value for the energy and bond distance are very close to the exact solution. The inclusion of the polarization dramatically improved the energy (though didn’t have such a dramatic impact on the bond distance) as compared to just varationally optimizing the 1s-like orbitals.