Open In Colab

Atom Grids

AtomGrid constructs an atomic grid by combining a radial and angular components for evaluation, integration, interpolation, and differentiation in three-dimensional (3D) space. In quantum chemistry, this is typically used for computations of atomic properties. However, this is a general purpose grid that can be used for any function in 3D space.

This notebook showcases various functionalities of AtomGrid. For computing properties on the grid, we use \(\textbf{He}\) in the triplet state (\(1s^1 2s^1\)) as an example. The corresponding wavefunction is obtained from formatted checkpoint file "doc/notebooks/He_t.fchk". The qc-iodata package is used for parsing the wavefuction data from the fchk file, and qc-gbasis package is used for analytical evaluation of various properties in the grid.

[8]:
from iodata import load_one

# Get the atomic coordinates array to use as the center of the grid
mol = load_one("He_t.fchk")

center = mol.atcoords.flatten()
print(f"Atomic Coordinates: {mol.atcoords}")
print(f"Atomic numbers    : {mol.atnums}")
print(f"Alpha MO occupations: {mol.mo.occsa}")
print(f"Beta MO occupations : {mol.mo.occsb}")
Atomic Coordinates: [[0. 0. 0.]]
Atomic numbers    : [2]
Alpha MO occupations: [1. 1.]
Beta MO occupations : [0. 0.]

Construct Atomic Grid

There are multiple ways to construct an atomic grid, for a complete description see the `Atomic_Grid_Construction.ipynb <>`__.

Here we construct an atomic grid from a radial grid instance and the degrees of the angular grid centered at the position of \(\textbf{He}\) nucleus. The radial grid is constructed by specifying the number of radial grid points. For more details on the radial and angular grids see One_dimensional_grids.ipynb and Angular_Grid.ipynb.

[9]:
import numpy as np
from grid import GaussLegendre, BeckeRTransform, AtomGrid

# construct a radial grid with 150 points
oned = GaussLegendre(npoints=150)
rgrid = BeckeRTransform(0.0, R=1.5).transform_1d_grid(oned)

print(f"Radial grid size : {rgrid.size}")
print(f"Radial grid r_min: {np.min(rgrid.points):.5f}")
print(f"Radial grid r_max: {np.max(rgrid.points):.5f}\n")

# construct atomic grid
atgrid = AtomGrid(rgrid, degrees=[22], center=center)

# atomic grid size = (radial grid size) * (angular grid size)
print(f"AtomGrid size          : {atgrid.size}")
print(f"AtomGrid points shape  : {atgrid.points.shape}")
print(f"AtomGrid weights shape : {atgrid.weights.shape}")
print(f"AtomGrid radial size   : {atgrid.rgrid.size}")
print(f"AtomGrid angular degree: {atgrid.degrees}")
print(f"AtomGrid center        : {atgrid.center}")
Radial grid size : 150
Radial grid r_min: 0.00010
Radial grid r_max: 23498.50372

AtomGrid size          : 29100
AtomGrid points shape  : (29100, 3)
AtomGrid weights shape : (29100,)
AtomGrid radial size   : 150
AtomGrid angular degree: [23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23, 23]
AtomGrid center        : [0. 0. 0.]

Example: Integrate Electron Density

To integrate a scalar function over the atomic grid, we first need to evaluate the function on the grid points. Here, we compute the electron density \(\rho(\mathbf{r})\) of the \(\textbf{He}\) in the triplet state (\(1s^1 2s^1\)) using the gbasis.evals.density function of the qc-gbasis package. The wavefunction data are loaded from the formatted checkpoint file using load_one function of qc-iodatapackage. The density values are then integrated using the AtomGrid.integrate method.

[10]:
from gbasis.wrappers import from_iodata
from gbasis.evals.density import evaluate_density

# Check that the atomic grid is centered at the position of atomic nucleus
assert np.all(mol.atcoords == atgrid.center)

# Construct molecular basis from wave-function information read by IOData
basis = from_iodata(mol)

# Evaluate the electron density on the grid points
rdm = mol.one_rdms["scf"]
dens = evaluate_density(rdm, basis, atgrid.points)
print(f"Shape of electron density array : {dens.shape}")

# Integrate electron density
print(f"Number of electrons in molecule : {np.sum(mol.atnums) - mol.charge}")
print(f"Integral of the electron density: {atgrid.integrate(dens)}")
Shape of electron density array : (29100,)
Number of electrons in molecule : 2.0
Integral of the electron density: 1.9999999911143622

Example: Calculate Radial Electron Density Distribution

The radial distribution of the electron density describes the probability of finding an electron in the spherical shell between \(r\) and \(r + dr\). This is calculated by integrating the electron density over the angular coordinates.

\[\rho(r) = \int_\theta \int_\phi \rho(r, \theta, \phi) r^{2} sin(\phi) d\theta d\phi\]

The \(r^{2} sin(\phi)\) in the integral is added because the electron density is defined in spherical coordinates and the volume element is given by \(dV = r^{2} sin(\phi) dr d\theta d\phi\). This integral can be written as a sum over the grid points:

\[\rho(r_i) = r_{i}^{2} \int \int \rho(r_{i}, \theta, \phi)sin(\phi) d\theta d\phi\]

where \(r_i\) is a radial grid point.

Here we calculate the radial electron density distribution for the \(\textbf{He}\) atom in the triplet (\(1s^2 2s^1\)) state using the previously defined atomic grid and the electron density values calculated on the grid points.

[11]:
import matplotlib.pyplot as plt

# Compute the radial electron density by angular integration
radial_dens_1 = atgrid.integrate_angular_coordinates(dens)
radial_dens_1 *= rgrid.points**2

# Compute the radial electron density by spherical average interpolation
radial_dens_2 = atgrid.spherical_average(dens)(rgrid.points)
radial_dens_2 *= 4 * np.pi * rgrid.points**2

# Compare the two ways of computing radial electron density
max_diff = np.max(np.abs(radial_dens_1 - radial_dens_2))
print(f"Max difference between radial_dens_1 and radial_dens_2: {max_diff}")

# Plot radial electron density distribution
plt.plot(rgrid.points, radial_dens_1, c="r", marker="o", ls="", label="From angular integration")
plt.plot(rgrid.points, radial_dens_2, c="k", label="From spherical average")
plt.title("Radial Electron Density Distribution of He $(1s^{1}2s^{1})$", fontsize=14)
plt.xlabel("r (bohr)", fontsize=12)
plt.ylabel(r"Radial $\rho(r)$", fontsize=12)
plt.xlim(0, 10)
plt.legend(frameon=False, fontsize=14)
plt.show()
Max difference between radial_dens_1 and radial_dens_2: 2.220446049250313e-16
../_images/notebooks_atom_grid_8_1.png

To identify the local maxima of radial electron density and corresponding radii, the scipy.signal.find_peaks is used.

[12]:
from scipy.signal import find_peaks

peaks, _ = find_peaks(radial_dens_1)

for i, peak in enumerate(peaks):
    print(f"Peak {i} of radial electron density has:")
    print(f"   radius = {rgrid.points[peak]:.5f} bohr")
    print(f"   radial density = {radial_dens_1[peak]:.5f} a.u.\n")
Peak 0 of radial electron density has:
   radius = 0.40162 bohr
   radial density = 1.56127 a.u.

Peak 1 of radial electron density has:
   radius = 1.59695 bohr
   radial density = 0.75479 a.u.

The maximum values of the radial electron density distribution corresponds to the radial position with maximum probability of finding an electron. In this case there are two maximum values corresponding to the two electrons. The first one (left to right) corresponds to the \(1s\) orbital and the second one to the \(2s\) orbital. The radial electron density distribution also integrates to the total number of electrons in the system.

[13]:
print(f"Number of electrons in atom            : {np.sum(mol.atnums) - mol.charge}")
print(f"Integral of the radial electron density: {rgrid.integrate(radial_dens_1)}")
Number of electrons in atom            : 2.0
Integral of the radial electron density: 1.9999999911143642

Example: Calculate Classical Coulomb Repulsion Energy

The classical Coulomb repulsion energy \(\mathbf{J}\) is defined as:

\[\mathbf{J} = \frac{1}{2} \int \int \frac{\rho(\mathbf{r}) \rho(\mathbf{r}')}{|\mathbf{r} - \mathbf{r}'|} d\mathbf{r} d\mathbf{r}'\]

where \(\rho(\mathbf{r})\) is the electron density at point \(\mathbf{r}\). This double integral can be rewritten as a double sum over grids \(\text{G}_1\) and \(\text{G}_2\) each with sizes \(N_{\text{G}_1}\) and \(N_{\text{G}_2}\) respectively:

\[E_{rep} = \frac{1}{2} \sum_{i}^{N_{\text{G}_1}} \sum_{j}^{N_{\text{G}_2}} \frac{w(\mathbf{r}_i)\rho(\mathbf{r}_i) w(\mathbf{r}_j)\rho(\mathbf{r}_j)}{|\mathbf{r}_i - \mathbf{r}_j|} = \frac{1}{2} \sum_{i}^{N_{\text{G}_1}} w(\mathbf{r}_i)\rho(\mathbf{r}_i) \sum_{j}^{N_{\text{G}_2}} \frac{w(\mathbf{r}_j)\rho(\mathbf{r}_j)}{|\mathbf{r}_i - \mathbf{r}_j|}\]

where \(\mathbf{r}\) and \(w(\mathbf{r})\) represent the coordinates and weights of grid points. When \(i = j\), the denominator is zero denominator and the energy is undefined. To ensure that grid points do not coincide, different grids are used for \(\mathbf{r}_i\) and \(\mathbf{r}_j\) within the same spatial domain. This can be easily done by introducing a second atomic grid with different angular degree or one less radial grid points. The electron density values on this second grid can be either directly computed or obtained by interpolating from the values on the first grid using the AtomGrid.interpolate method.

[14]:
# Construct another radial grid with one less point
oned = GaussLegendre(npoints=atgrid.rgrid.size - 1)
rgrid = BeckeRTransform(0.0, R=1.5).transform_1d_grid(oned)

# Construct the second atomic grid (i.e., auxiliary grid) with the same angular degree
atgrid_aux = AtomGrid(rgrid, degrees=[23])

# interpolate the electron density on the auxiliary atomic gird points
func_interpolate_dens = atgrid.interpolate(dens)
dens_aux = func_interpolate_dens(atgrid_aux.points)

classic_coulomb = 0.0
# loop over grid points in the first grid
for i in range(atgrid.size):
    # compute its distance to all the points in the auxiliary atomgrid
    distances = np.linalg.norm(atgrid.points[i] - atgrid_aux.points, axis=1)
    # compute its Coulomb repulsion with the electron density at the auxiliary atomgrid points
    coulomb_points = atgrid.weights[i] * dens[i] * dens_aux / distances / 2
    classic_coulomb += atgrid_aux.integrate(coulomb_points)

print(f"Classic Coulomb Energy : {classic_coulomb} (hartree)")
Classic Coulomb Energy : 1.772374684606753 (hartree)