This commit is contained in:
Pierre-Francois Loos 2021-05-20 15:13:48 +02:00
parent b04467367f
commit 0d26f2702f
74 changed files with 14250 additions and 0 deletions

View File

@ -0,0 +1,431 @@
%****************************************************************
\section{Schr\"odinger equation}
%****************************************************************
In this memoir, we consider atomic and molecular quantum systems (i.e.~systems composed by nuclei and electrons) within the Born-Oppenheimer approximation \cite{Szabo, Helgaker}.
This means that we neglect the kinetic energy of the nuclei and treat the nuclear coordinates as parameters.
We therefore concentrate our attention on the electronic degrees of freedom.
Unless otherwise stated, atomic units are used throughout this memoir.
A chemical system is completely defined at a time $t$ by its electronic wave function $\Psi(\bX,t)$, solution of the time-dependent Schr\"odinger equation
\begin{equation}
\label{eq:time-dependent-schrodinger-equation}
i \pdv{\Psi(\bX,t)}{t} = \HOp \Psi(\bX,t),
\end{equation}
where $\HOp$ is the so-called Hamiltonian and $\bX = (\bx_1,\dots,\bx_n) = (\bs,\bR)$ is a composite coordinate vector gathering the spin coordinates $\bs = (s_1,\ldots,s_n)$ and spatial coordinates $\bR = (\br_1,\ldots,\br_n)$ of the $n$ electrons.
In the case of a stationary system, the time-independent Schr\"odinger equation reads
\begin{equation}
\label{eq:time-independent-schrodinger-equation}
\HOp \Psi(\bX,t) = E\,\Psi(\bX,t),
\end{equation}
where $E$ is the energy of the system and the non-relativistic Hamiltonian is explicitly given by
\begin{equation}
\label{eq:Hamiltonian}
\begin{split}
\HOp & = \TeOp + \VenOp + \VeeOp + \VnnOp
\\
& = - \sum_i^n \frac{\nabla^2_i}{2}
- \sum_i^n \sum_A^\nuc \frac{Z_A}{\abs{\brA - \bri}}
+ \sum_{i < j}^n \frac{1}{\abs{\bri - \brj}}
+ \sum_{A<B}^\nuc \frac{Z_A Z_B}{\abs{\brB - \brA}},
\end{split}
\end{equation}
where $\nabla_i^2$ is the Laplace operator associated with the $i$th electron, $\brA$ and $Z_A$ are the nuclear coordinates and charge of nucleus $A$.
The first term $\TeOp$ is the kinetic energy operator of the electrons, the next term $\VenOp$ corresponds to the Coulombic attraction between electrons and nuclei, while the last two terms corresponds to the interelectronic ($\VeeOp$) and internuclear ($\VnnOp$) Coulombic repulsions, respectively.
Note that the last term $\VnnOp$ is a constant as, within the Born-Oppenheimer approximation, it does not depend on the electronic coordinates, and will be omitted for the sake of clarity.
%****************************************************************
\section{Hartree-Fock approximation}
%****************************************************************
Within the Hartree-Fock (HF) approximation \cite{Szabo}, the electronic wave function $\PsiHF$ is written as a Slater determinant of $n$ spin orbitals
\begin{equation}
\label{eq:Psi-HF}
\PsiHF(\bx_1,\ldots,\bx_n) = \frac{1}{\sqrt{n!}}
\begin{vmatrix}
\sMO{1}(\bx_1) & \sMO{2}(\bx_1) & \ldots & \sMO{n}(\bx_1) \\
\sMO{1}(\bx_2) & \sMO{2}(\bx_2) & \ldots & \sMO{n}(\bx_2) \\
\vdots & \vdots & \ddots & \vdots \\
\sMO{1}(\bx_n) & \sMO{2}(\bx_n) & \ldots & \sMO{n}(\bx_n) \\
\end{vmatrix}.
\end{equation}
Each spin orbital $\sMO{i}(\bx)$ is a product of a spin part $\omega(s)$ and a spatial part $\MO{i}(\br)$ --- also known as a molecular orbital (MO) ---
\begin{equation}
\sMO{i}(\bx) = \omega(s) \MO{i}(\br),
\end{equation}
where
\begin{equation}
\omega(s) =
\begin{cases}
\alpha(s), & \text{for spin-up electrons,}
\\
\beta(s), & \text{for spin-down electrons.}
\end{cases}
\end{equation}
The spin orbitals form an orthonormal set, i.e.
\begin{equation}
\braket{\sMO{i}}{\sMO{j}} = \delta_{ij},
\end{equation}
where
\begin{equation}
\delta_{ij} =
\begin{cases}
1, & \text{if $i = j$},\\
0, & \text{otherwise},
\end{cases}
\end{equation}
is the Kronecker delta \cite{NISTbook}.
The HF energy is defined as
\begin{equation}
\EHF = \mel{\PsiHF}{\HOp}{\PsiHF},
\end{equation}
and yields the following expression:
\begin{equation}
\begin{split}
\EHF & = \sum_i^n \mel{\sMO{i}(\br_1)}{\HcOp}{\sMO{i}(\br_1)}
\\
& + \sum_{i<j}^n \qty[
\mel{\sMO{i}(\br_1)\sMO{j}(\br_2)}{\ree^{-1}}{\sMO{i}(\br_1)\sMO{j}(\br_2)}
- \mel{\sMO{i}(\br_1)\sMO{j}(\br_2)}{\ree^{-1}}{\sMO{j}(\br_1)\sMO{i}(\br_2)} ],
\end{split}
\end{equation}
where the so-called core Hamiltonian (i.e.~the one-electron part of the electronic Hamiltonian) is defined as
\begin{equation}
\HcOp = \TeOp + \VenOp.
\end{equation}
We define the Fock operator as
\begin{gather}
\FOp \sMO{i}(\br_1) = \MOev{i} \sMO{i}(\br_1),
\\
\FOp(\br_1) = \HcOp(\br_1) + \sum_i^n \qty[ \JOp_i(\br_1) - \KOp_i(\br_1) ],
\end{gather}
where $\JOp_i(\br_1)$ and $\KOp_i(\br_1)$ are the Coulomb and exchange operators respectively:
\begin{subequations}
\begin{align}
\JOp_i(\br_1) \sMO{j}(\br_1) & = \sMO{j}(\br_1) \int \sMO{i}(\br_2) \ree^{-1} \sMO{i}(\br_2) d\br_2,
\\
\KOp_i(\br_1) \sMO{j}(\br_1) & = \sMO{i}(\br_1) \int \sMO{i}(\br_2) \ree^{-1} \sMO{j}(\br_2) d\br_2.
\end{align}
\end{subequations}
In the following, we adopt the restricted HF (RHF) formalism which means that we assume that the spatial part of the spin orbital is independent of the spin state of the electron occupying this orbital \cite{Szabo}.
Moreover, unless otherwise stated, the systems treated here are closed-shell systems, i.e.~each MO is doubly occupied by one spin-up and one spin-down electron.
%****************************************************************
\subsection{Roothaan-Hall equations}
%****************************************************************
Within the LCAO approximation, we expand each MO as a linear combination of $N$ atomic orbitals (AOs), such as
\begin{equation}
\label{eq:LCAO}
\MO{i}(\br) = \sum_\mu \cMO{\mu}{i} \AO{\mu}(\br).
\end{equation}
In practice, the AOs $\AO{\mu}(\br)$ are usually chosen as cartesian Gaussian functions due to their computational convenience.
However, other choices (such a Slater functions) are possible depending on the type of systems and the target accuracy.
We will come back to this particular point later in this memoir.
In the AO basis, we have
\begin{align}
\label{eq:FAO}
\FkEl{\mu}{\nu} = \mel{\AO{\mu}}{\FOp}{\AO{\nu}}
\equiv \mel{\mu}{\FOp}{\nu}
& = \HcEl{\mu}{\nu} + \sum_{\lambda \sigma} \PEl{\lambda}{\sigma}
\qty[ \braket{\mu \lambda}{\nu \sigma} - \frac{1}{2} \braket{\mu\lambda}{\sigma \nu} ],
\end{align}
with
\begin{gather}
\HcEl{\mu}{\nu} = \mel{\mu}{\HcOp}{\nu},
\\
\braket{\mu \lambda}{\nu \sigma} = \iint \AO{\mu}(\br_1) \AO{\lambda}(\br_2) \ree^{-1} \AO{\nu}(\br_1) \AO{\sigma}(\br_2) d\br_1 d\br_2,
\end{gather}
and where the density matrix is defined as
\begin{equation}
\PEl{\mu}{\nu} = 2 \sum_i^\occ \cMO{\mu}{i} \cMO{\nu}{i}.
\end{equation}
The HF electronic energy of the system is then given by
\begin{equation}
\label{eq:E-elec}
\EHF = \sum_{\mu \nu} \PEl{\mu}{\nu} \HcEl{\mu}{\nu}
+ \frac{1}{2} \sum_{\mu \nu \lambda \sigma}^N \PEl{\mu}{\nu} \PEl{\lambda}{\sigma} G_{\mu \nu \lambda \sigma}.
\end{equation}
In matrix form, the Fock matrix $\FkMat$ can be decomposed as
\begin{equation}
\FkMat = \HcMat + \GMat,
\end{equation}
where
\begin{align}
\GEl{\mu}{\nu} & = \sum_{\lambda \sigma} \PEl{\lambda}{\sigma} \GEl{\mu\nu}{\lambda\sigma},
&
\GEl{\mu\nu}{\lambda\sigma} & = \braket{\mu \lambda}{\nu \sigma} - \frac{1}{2} \braket{\mu\lambda}{\sigma \nu}.
\end{align}
The stationnarity of the energy with respect to the coefficients $\cMO{\mu}{i}$ yields the Roothaan-Hall equations:
\begin{equation}
\label{eq:Roothaan-Hall}
\sum_\nu \FEl{\mu}{\nu} \cMO{\nu}{i} = \sum_\nu \SEl{\mu}{\nu} \cMO{\nu}{i} \MOev{i},
\end{equation}
or in matrix form
\begin{equation}
\label{eq:Roothaan-Hall-mat}
\FkMat \CMat = \SMat \CMat \MOevMat,
\end{equation}
where the elements of the overlap matrix $\SMat$ are given by
\begin{equation}
\SEl{\mu}{\nu} = \braket{\mu}{\nu}.
\end{equation}
The coefficient matrix $\bC$ gathers the MO coefficients $\cMO{\mu}{i}$, while the diagonal matrix $\MOevMat$ gathers the MO energies $\MOev{i}$.
We introduce the orthogonalization matrix $\bX$ such as
\begin{equation}
\XMat^\dag \SMat \XMat = \IdMat
\end{equation}
in order to work in an orthogonal AO basis (where $\IdMat$ is the identity matrix).
There are two main orthogonalisation methods, namely the L\"owdin orthogonalisation for which $\XMat = \SMat^{-1/2}$ and the canonical orthogonalisation for which $\XMat = \UMat \sMat^{-1/2}$ (where $\UMat$ and $\sMat$ are the eigenvectors of eigenvalues matrices of $\SMat$, respectively).
Nowadays, the usual procedure consists in performing a singular value decomposition (SVD) of the overlap matrix $\SMat$.
This procedure is efficient, numerically stable and allows to remove the linear dependencies which might be present in the AO basis.
Rotating the Fock matrix $\FMat$ into the orthogonal basis yields
\begin{equation}
\label{eq:Fprime}
\FkMat^{\prime} \CMat^{\prime} = \CMat^{\prime} \MOevMat,
\end{equation}
where
\begin{equation}
\FkMat^{\prime} = \XMat^{\dag} \FMat \XMat.
\end{equation}
The matrices $\CMat^{\prime}$ and $\MOevMat$ can be determined by a straightforward diagonalisation of Eq.~\eqref{eq:Fprime}, and the matrix $\CMat$ is obtained by back-transforming the eigenvectors in the original basis:
\begin{equation}
\CMat = \XMat \CMat^{\prime}.
\end{equation}
%****************************************************************
\subsection{Self-consistent field calculation}
%****************************************************************
In order to obtain the MO coefficients $\CMat$, one must diagonalise the Fock matrix $\FkMat$.
However, this matrix does depend on the MO coefficients itself.
Therefore, one must employ an iterative procedure called self-consistent field (SCF) method.
The SCF algorithm is described below:
\begin{enumerate}
\item Obtain an estimate of the density matrix $\PMat$.
\item Build the Fock matrix: $\FMat = \HcMat + \GMat$.
\item Transform the Fock matrix in the orthogonal matrix: $\FMat^{\prime} = \XMat^{\dag} \FMat \XMat$.
\item Diagonalize $\FMat^{\prime}$ to obtain $\CMat^{\prime}$ and $\MOevMat$.
\item Back-transform the MOs in the original basis: $\CMat = \XMat \CMat^{\prime}$.
\item Compute the new density matrix $\PMat = \CMat \CMat^{\dag}$, as well as the HF energy:
\begin{equation}
\EHF = \frac{1}{2} \Tr{\PMat \qty( \HcMat + \FkMat )}.
\end{equation}
\item Convergence test. If not satisfied, go back to $2.$
\end{enumerate}
Unfortunately, the HF method cannot be used to obtain the exact energy of the system even in the complete basis set (CBS) limit due to the approximate treatment of the electron-electron interaction.
Within the HF method, this interaction is averaged over all the electrons.
In other word, a given electron ``feels'' the averaged repulsion of the $n-1$ remaining electrons (mean-field approach).
We will see in the next section how one can go beyond the HF approximation.
%****************************************************************
\section{Post Hartree-Fock methods}
%****************************************************************
The correlation energy $\Ec$ is defined as the error in the HF approximation, i.e.~the energy difference between the exact energy and the energy calculated within the HF approximation:
\begin{equation}
\label{eq:Ec}
\Ec = E - \EHF.
\end{equation}
Thanks to the variational principle, $\Ec$ is always a negative quantity.
The purpose of post HF methods is to recover some or all of the correlation energy \cite{JensenBook, CramerBook}.
%****************************************************************
\subsection{Configuration interaction methods}
%****************************************************************
One of the most conceptually simple (albeit expensive) approach to recover a large fraction of the correlation energy is the configuration interaction (CI) method.
The general idea is to expand the wave function as a linear combination of ``excited'' determinants.
These excited determinants are built by promoting electrons from occupied to unoccupied (virtual) MOs usually based on the HF orbitals, i.e.
\begin{equation}
\label{eq:Psi-CI}
\PsiCI = \cCI{0}{} \PsiHF
+ \sum_i^\occ \sum_a^\virt \cCI{i}{a} \ExDet{i}{a}
+ \sum_{ij}^\occ \sum_{ab}^\virt \cCI{ij}{ab} \ExDet{ij}{ab}
+ \sum_{ijk}^\occ \sum_{abc}^\virt \cCI{ijk}{abc} \ExDet{ijk}{abc}
+ \ldots,
\end{equation}
where $\ExDet{i}{a}$, $\ExDet{ij}{ab}$ and $\ExDet{ijk}{abc}$ are singly-, doubly- and triply-excited determinants.
$\ExDet{ij}{ab}$ corresponds to the excitations of two electrons from the occupied spinorbitals $i$ and $j$ to virtual spinorbitals $a$ and $b$.
It is easy to show that the CI energy
\begin{equation}
\ECI = \mel{\PsiCI}{\HOp}{\PsiCI}
\end{equation}
is an upper bound to the exact energy of the system.
When all possible excitations are taken into account, the method is called full CI (FCI) and it recovers the entire correlation energy for a given basis set.
Albeit elegant, FCI is very expensive due to the exponential increase of the number of excited determinants.
For example, when only singles and doubles are taken into account, the method is called CISD.
It recovers an important chunk of the correlation.
However, it has the disadvantage to be size-inconsistent.
A method is said to be size-consistent if the correlation energy of two non-interaction systems is egal to twice the correlation energy of the isolated system.
Size-extensivity means that the correlation energy grows linearly with the system size.
%****************************************************************
\subsection{Density-functional theory}
%****************************************************************
Density-functional theory (DFT) is based on two theorems known as the Hohenberg-Kohn (HK) theorems \cite{Hohenberg64}, which states that it exists a non-interacting reference system with an electronic density $\rho(\br)$ equal to the real, interaction system.
The first theorem proves the existence of a one-to-one mapping between the electron density and the external potential, while the second HK theorem guarantees the existence of a variational principle for the ground-state electron density.
%****************************************************************
\subsection{Kohn-Sham equations}
%****************************************************************
Present-day DFT calculations are almost exclusively done within the so-called Kohn-Sham (KS) formalism, which corresponds to an exact dressed one-electron theory \cite{Kohn65}.
In analogy to the HF theory, the electrons are treated as independent particles moving in the average field of all others but now with exchange an correlation included by virtue of an ``exchange-correlation'' functional.
Following the work of Kohn and Sham \cite{Kohn65}, we introduce KS orbitals $\sMO{i}(\br)$, and the energy can be decomposed as
\begin{equation}
\EKS \qty[\rho(\br)] = \Ts \qty[\rho(\br)]
+ \Ene \qty[\rho(\br)]
+ J \qty[\rho(\br)]
+ \Exc \qty[\rho(\br)],
\end{equation}
where
\begin{equation}
\Ts \qty[\rho(\br)] = - \frac{1}{2} \sum_i^\occ \mel{\sMO{i}}{\nabla_i^2}{\sMO{i}}
\end{equation}
is the non-interacting kinetic energy,
\begin{equation}
\Ene \qty[\rho(\br)] = - \sum_A^\nuc \int \frac{Z_A \rho(\br)}{\abs{\brA - \br}} d\br
\end{equation}
is the electron-nucleus attraction energy,
\begin{equation}
J \qty[\rho(\br)] = \frac{1}{2} \iint \frac{\rho(\br_1) \rho(\br_2)}{\abs{\br_1 - \br_2}} d\br_1 d\br_2
\end{equation}
is the classical electronic repulsion, and the one-electron density is
\begin{equation}
\rho(\br) = \sum_i^\occ \abs{\sMO{i}(\br)}^2.
\end{equation}
The exchange-correlation energy
\begin{equation}
\Exc \qty[\rho(\br)] = \qty{ T \qty[\rho(\br)] - \Ts \qty[\rho(\br)] } + \qty{ \Eee \qty[\rho(\br)] - J \qty[\rho(\br)]}
\end{equation}
is the sum of two terms: one coming from the difference between the exact kinetic energy $T\qty[\rho(\br)]$ and the non-interacting kinetic energy $\Ts \qty[\rho(\br)]$, and the other one coming from the difference between the exact interelectronic repulsion $\Eee \qty[\rho(\br)]$ and the classical Coulomb repulsion $J \qty[\rho(\br)]$.
Here, we will only consider the second term as the ``kinetic'' correlation energy is usually much smaller than its ``Coulomb'' counterpart.
Also, as it is usually done, we will split the exchange-correlation energy as a sum of an exchange and correlation components, i.e.
\begin{equation}
\Exc \qty[\rho(\br)] = \Ex \qty[\rho(\br)] + \Ec \qty[\rho(\br)].
\end{equation}
Similarly to the Roothaan-Hall equations, the condition of stationarity of the KS energy with respect to the electron density
\begin{equation}
\frac{\delta E \left[ \rho (\mathbf{r}) \right]}{\delta \rho (\mathbf{r})} = \mu
\end{equation}
(where $\mu$ is the chemical potential) yields the KS equations
\begin{equation}
\qty[ - \frac{\nabla_{\br}^2}{2}
- \sum_A^\nuc \frac{Z_A}{\abs{\br - \brA}}
+ \int \frac{\rho(\br^{\prime})}{\abs{\br - \br^{\prime}}} d\br^{\prime}
+ \fdv{\Exc\qty[\rho(\br)]}{\rho(\br)} ] \sMO{i}(\br)
= \MOev{i} \sMO{i}(\br),
\end{equation}
which can be re-written as
\begin{equation}
\FOp_\text{KS} \sMO{i}(\br) = \MOev{i} \sMO{i}(\br).
\end{equation}
These equations are solved iteratively, just like the HF equations, by expanding the KS MOs in a AO basis, yielding
\begin{equation}
\FkMat_\text{KS} \CMat = \SMat \CMat \MOevMat.
\end{equation}
%****************************************************************
\subsection{Exchange-correlation functionals}
%****************************************************************
Due to its moderate computational cost and its reasonable accuracy, KS DFT \cite{Hohenberg64, Kohn65} has become the workhorse of electronic structure calculations for atoms, molecules and solids \cite{ParrYang}.
To obtain accurate results within DFT, one only requires the exchange and correlation functionals, which can be classified in various families depending on their physical input quantities \cite{Becke14, Yu16}.
These various types of functionals are classified by the Jacob's ladder of DFT \cite{Perdew01, Pewdew05} (see Fig.~\ref{fig:Jacob-ladder}).
%%% FIGURE 1 %%%
\begin{figure}
\centering
\includegraphics[width=0.25\linewidth]{../Chapter1/fig/fig1}
\caption{
\label{fig:Jacob-ladder}
Jacob's ladder of DFT.
$\rho$, $x$, $\tau$ and $\Ex^\text{HF}$ are the electron density, the reduced gradient, the kinetic energy density, and the HF exchange energy, respectively.}
\end{figure}
%%%
\begin{itemize}
\item The local-density approximation (LDA) sits on the first rung of the Jacob's ladder and only uses as input the electron density $\rho$.
The oldest and probably most famous LDA functional is the Dirac exchange functional (D30) \cite{Dirac30} based on the uniform electron gas (UEG) \cite{WIREs16}.
Based on the work of Ceperley and Alder who used quantum Monte Carlo calculations (see below) to determine the correlation energy of the UEG with respect to the density \cite{Ceperley80},
Vosko, Wilk and Nusair (VWN) proposed a LDA correlation functional by fitting their data \cite{VWN80}.
\item The generalized-gradient approximation (GGA) corresponds to the second rung and adds the gradient of the electron density $\nabla \rho$ as an extra ingredient.
The well-known B88, G96, PW91 and PBE exchange functionals are examples of GGA exchange functionals \cite{B88, G96, PW91, PBE}.
Probably the most famous GGA correlation functional is LYP \cite{LYP}, which gave birth to the GGA exchange-correlation functional BLYP \cite{Becke88b} by combination with B88.
\item The third rung is composed by the so-called meta-GGA (MGGA) functionals \cite{Sala16} which uses, in addition to $\rho$ and $\nabla \rho$, the kinetic energy density
\begin{equation}
\tau = \sum_i^\occ \abs{\nabla\sMO{i} }^2.
\end{equation}
The M06-L functional from Zhao and Truhlar \cite{M06L}, the mBEEF functional from Wellendorff et al.~\cite{mBEEF} and the SCAN \cite{SCAN} and MS \cite{MS0,MS1_MS2} family of functionals from Sun et al.~are examples of widely-used MGGA functionals.
\item The fourth rung (hyper-GGAs or HGGAs) includes the widely-used hybrid functionals, introduced by Becke in 1993 \cite{Becke93}, which add a certain percentage of HF exchange.
Example of such functionals are B3LYP \cite{Becke93}, B3PW91 \cite{PW92, Becke93, Perdew96}, BH\&HLYP \cite{Becke93b} or PBE0 \cite{PBE0}.
Hybrids functionals are known for their accuracy in electronic structure theory.
However, they are more computationally expensive than LDA or GGA functionals due to the calculation of the costly HF exchange.
\item The fifth rung includes double hybrids and RPA-like functionals but we will not be discussing such types of functionals in the present memoir.
\end{itemize}
%****************************************************************
\section{Quantum Monte Carlo methods}
%****************************************************************
%-----------------------------------------------
\subsection{Variational Monte Carlo}
%-----------------------------------------------
In the VMC method, the expectation value of the Hamiltonian with respect to a trial wave function is obtained using a stochastic integration technique.
Within this approach a variational trial wave function $\PsiT(\bR)$ is introduced, and one then calculates its variational energy
\begin{equation}
\EVMC = \frac{\int \PsiT(\bR) \HOp \PsiT(\bR) d\bR}{\int \PsiT(\bR)^2 d\bR},
\end{equation}
using the Metropolis Monte Carlo method of integration \cite{Umrigar99}.
The resulting VMC energy is an upper bound to the exact ground-state energy, within the statistical Monte Carlo error.
Unfortunately, any resulting observables are biased by the form of the trial wave function, and the method is therefore only as good as the chosen $\PsiT$.
%--------------------------------------------
\subsection{Diffusion Monte Carlo}
%--------------------------------------------
DMC is a stochastic projector technique for solving the many-body Schr\"odinger equation \cite{Kalos74, Ceperley79, Reynolds82}.
Its starting point is the time-dependent Schr\"odinger equation in imaginary time
\begin{equation}
\label{eq:DMC}
-\pdv{\Psi(\bR,\tau)}{\tau} = (\HOp - S) \Psi(\bR,\tau).
\end{equation}
For $\tau \to \infty$, the steady-state solution of Eq.~\eqref{eq:DMC} for $S$ close to the ground-state energy is the ground-state $\Psi(\bR)$ \cite{Kolorenc11}.
DMC generates configurations distributed according to the product of the trial and exact ground-state wave functions.
If the trial wave function has the correct nodes, the DMC method yields the exact energy, within a statistical error that can be made arbitrarily small by increasing the number of Monte Carlo steps.
Thus, as in VMC, a high quality trial wave function is essential in order to achieve high accuracy \cite{Umrigar93, Huang97}.
%------------------------------------------
\subsection{Trial wave functions}
%------------------------------------------
Within QMC, trial wave functions are usually defined as \cite{Huang97, Drummond04, LopezRios12}
\begin{equation}
\label{eq:Psi-trial}
\PsiT(\bR) = e^{\Js(\bR)} \sum_I \cCI{I}{} \sdet_I^{\uparrow}(\br^{\uparrow}) \, \sdet_I^{\downarrow}(\br^{\downarrow}),
\end{equation}
where $D_I^{\sigma}$ are determinants of the spin-$\sigma$ electrons.
The fermionic nature of the wave function is imposed by a single- or multi-determinant expansion of Slater determinants made of HF or KS MOs.
$\Js(\bR)$ is called the Jastrow factor and $e^{\Js(\bR)}$ is a nodeless function.
Hence, the nodes of $\PsiT$ are completely determined by the determinantal part of the trial wave function.
%---------------------------------------------------
\subsection{Fixed-node approximation}
%---------------------------------------------------
Considering an antisymmetric (real) electronic wave function $\Psi(\bR)$, the nodal hypersurface (or simply ``nodes'') is a $(n\, D-1)$-dimensional manifold defined by the set of configuration points $\bN$ for which $\Psi(\bN)=0$.
The nodes divide the configuration space into nodal cells or domains which are either positive or negative depending on the sign of the electronic wave function in each of these domains.
In recent years, strong evidence has been gathered showing that, for the lowest state of any given symmetry, there is a single nodal hypersurface (up to all permutations) that divides configuration space into only two nodal domains (one positive and one negative) \cite{Ceperley91, Glauser92, Bressanini01, Bressanini05a, Bajdich05, Bressanini05b, Scott07, Mitas06, Mitas08, Bressanini08, Bressanini12}.
Except in some particular cases, electronic or more generally fermionic nodes are poorly understood due to their high dimensionality and complex topology \cite{Ceperley91, Bajdich05}.
The number of systems for which the exact nodes are known analytically is very limited \cite{Klein76, Bressanini05a, Bajdich05, Nodes15}.
The quality of fermion nodes is of prime importance in QMC calculations due to the fermion sign problem, which continues to preclude the application of in principle exact QMC methods to large systems.
The dependence of the DMC energy on the quality of $\PsiT$ is often significant in practice, and is due to the fixed-node approximation which segregates the walkers in regions defined by $\PsiT$ \cite{Ceperley91}.
The fixed-node error is only proportional to the square of the nodal displacement error, but it is uncontrolled and its accuracy difficult to assess \cite{Kwon98, Luchow07a, Luchow07b}.
The DMC method then finds the best energy \emph{for that chosen nodal surface}, providing an upper bound for the ground-state energy.
The exact ground-state energy is reached only if the nodal surface is exact.
Therefore, one of greatest challenge of QMC methods is to design a well-defined protocol to control the fixed-node error or, equivalently, to be able to build chemical meaningful nodal surfaces for any chemical system.

Binary file not shown.

View File

@ -0,0 +1,18 @@
\relax
\providecommand\hyper@newdestlabel[2]{}
\providecommand\HyperFirstAtBeginDocument{\AtBeginDocument}
\HyperFirstAtBeginDocument{\ifx\hyper@anchor\@undefined
\global\let\oldcontentsline\contentsline
\gdef\contentsline#1#2#3#4{\oldcontentsline{#1}{#2}{#3}}
\global\let\oldnewlabel\newlabel
\gdef\newlabel#1#2{\newlabelxx{#1}#2}
\gdef\newlabelxx#1#2#3#4#5#6{\oldnewlabel{#1}{{#2}{#3}}}
\AtEndDocument{\ifx\hyper@anchor\@undefined
\let\contentsline\oldcontentsline
\let\newlabel\oldnewlabel
\fi}
\fi}
\global\let\hyper@last\relax
\gdef\HyperFirstAtBeginDocument#1{#1}
\providecommand\HyField@AuxAddToFields[1]{}
\providecommand\HyField@AuxAddToCoFields[2]{}

File diff suppressed because it is too large Load Diff

View File

Binary file not shown.

Binary file not shown.

View File

@ -0,0 +1,93 @@
\documentclass[aip,jcp,preprint,amsmath,amsfonts,amssymb,showkeys]{standalone}
\usepackage{graphicx,dcolumn,bm,xcolor,microtype,hyperref,physics,float}
\usepackage[version=4]{mhchem}
\newcommand{\Ec}{E_{\rm c}}
\newcommand{\Fx}{F_{\text{x}}}
%
\newcommand{\gX}{gX}
\newcommand{\HgX}{HgX}
\newcommand{\GX}{GX}
\newcommand{\HGX}{HGX}
\newcommand{\PBEGX}{PBE-GX}
%
\newcommand{\FxgX}{F_{\text{x}}^\text{\gX}}
\newcommand{\FxHgX}{F_{\text{x}}^\text{\HgX}}
\newcommand{\FxGX}{F_{\text{x}}^\text{\GX}}
\newcommand{\FxHGX}{F_{\text{x}}^\text{\HGX}}
\newcommand{\FxPBEGX}{F_{\text{x}}^\text{\PBEGX}}
%
\newcommand{\ExLDA}{E_{\text{x}}^\text{LDA}}
\newcommand{\FxGGA}{F_{\text{x}}^\text{GGA}}
\newcommand{\FxGLDA}{F_{\text{x}}^\text{GLDA}}
\newcommand{\FxMGGA}{F_{\text{x}}^\text{MGGA}}
\newcommand{\FxFMGGA}{F_{\text{x}}^\text{FMGGA}}
\newcommand{\ExsLDA}{E_{\text{x},\sigma}^\text{LDA}}
\newcommand{\ExsGGA}{E_{\text{x},\sigma}^\text{GGA}}
\newcommand{\ExsGLDA}{E_{\text{x},\sigma}^\text{GLDA}}
\newcommand{\exsLDA}{e_{\text{x},\sigma}^\text{LDA}}
\newcommand{\exsGGA}{e_{\text{x},\sigma}^\text{GGA}}
\newcommand{\exsGLDA}{e_{\text{x},\sigma}^\text{GLDA}}
\newcommand{\exsMGGA}{e_{\text{x},\sigma}^\text{MGGA}}
\newcommand{\exsFMGGA}{e_{\text{x},\sigma}^\text{FMGGA}}
\newcommand{\CxLDA}{C_\text{x}^\text{LDA}}
\newcommand{\CxGLDA}{C_\text{x}^\text{GLDA}}
\newcommand{\Cx}{C_\text{x}}
\newcommand{\Cf}{C_\text{F}}
\newcommand{\rs}{\rho_\sigma}
\newcommand{\xs}{x_\sigma}
\newcommand{\ts}{\tau_\sigma}
\newcommand{\as}{\alpha_\sigma}
\newcommand{\ns}{n_\sigma}
\newcommand{\Ls}{L_\sigma}
\newcommand\upa{\uparrow}
\newcommand\dwa{\downarrow}
\newcommand{\br}{\bm{r}}
\newcommand{\mc}{\multicolumn}
\newcommand{\purple}[1]{\textcolor{purple}{#1}}
\newcommand{\red}[1]{\textcolor{red}{#1}}
\newcommand{\orange}[1]{\textcolor{orange}{#1}}
\newcommand{\green}[1]{\textcolor{green}{#1}}
\newcommand{\blue}[1]{\textcolor{blue}{#1}}
\newcommand{\pub}[1]{\small \textcolor{purple}{#1}}
\usepackage{tikz}
\usetikzlibrary{arrows,positioning,shapes.geometric}
\usetikzlibrary{decorations.pathmorphing}
\begin{document}
\begin{tikzpicture}
\begin{scope}[
very thick,
node distance=1.75cm,on grid,>=stealth',
hartree/.style={rectangle,draw,fill=gray!40},
rung1/.style={rectangle,draw,fill=purple!40},
rung2/.style={rectangle,draw,fill=magenta!40},
rung3/.style={rectangle,draw,fill=red!40},
rung4/.style={rectangle,draw,fill=orange!40},
heaven/.style={rectangle,draw,fill=green!40},
],
\node [hartree, align=center] (HA) {\textbf{Hartree}};
\node [rung1, align=center] [above=of HA] (R1) {\textbf{Rung 1:} \\ LDA ($\rho$)};
\node [rung2, align=center] [above=of R1] (R2) {\textbf{Rung 2:} \\ GGA ($\rho,x$)};
\node [rung3, align=center] [above=of R1,yshift=2cm] (R3) {\textbf{Rung 3:} \\ MGGA ($\rho,x,\tau$)};
\node [rung4, align=center] [above=of R3] (R4) {\textbf{Rung 4:} \\ HGGA ($\rho,x,\tau, E_\text{x}^\text{HF}$)};
\node [heaven, align=center] [above=of R4] (H) {\textbf{Chemical accuracy}};
\path
(HA) edge[->] (R1)
(R1) edge[->] (R2)
(R2) edge[->] (R3)
(R3) edge[->] (R4)
(R4) edge[->,dashed] (H)
;
\end{scope}
\end{tikzpicture}
%%%
\end{document}

View File

@ -0,0 +1,47 @@
By solving the Schr\"odinger equation, one can predict some of the chemistry and most of the physics of a given system.
However, although this statement is true and philosophically important, it was realised many years ago that, for more than \textit{one} electron, it is usually far too difficult from the mathematical point of view to solve this mighty equation.
As Dirac pointed out,
\begin{quote}
\textit{``The aim of science is to make difficult things understandable in a simpler way.''}
\end{quote}
Consequently, it is essential to develop simple approximations that are accurate enough to have chemical and physical usefulness.
To do this, quantum chemists and physicists have developed a variety of simple models that, despite their simplicity, contain the key physics of more complicated and realistic systems.
A few examples are:
\begin{itemize}
\item the Born-Oppenheimer model: the motions of nuclei and electrons are independent;
\item the orbital model: electrons occupy orbitals and move independently of one another;
\item the local density model: the molecular electron density is built as an assembly of uniform electron gas densities.
\end{itemize}
Nowadays, all of these models are routinely applied in theoretical and/or computational studies.
Spherical models are another example.
One of the most popular starting points for modelling complex real life phenomenon by a highly simplified scientific model is the spherical geometry, and the most famous illustration of this is probably the so-called \textit{spherical cow} (Fig.~\ref{fig:cow}).
While appearing completely nonsensical to most people outside the scientific area, these spherical models can be extremely powerful for understanding, explaining and even predicting physical and chemical phenomena in a wide range of disciplines of physics and chemistry.
Besides, they offer unparalleled mathematical simplicity, while retaining much of the key physics.
An explicit example is the spherical model introduced by Haldane \cite{Haldane83} to explain the fractional quantum Hall effect (FQHE), for which Laughlin, St\"ormer and Tsui received the Nobel prize in physics.
This geometry has been instrumental in establishing the validity of the FQHE theory, and provides the cleanest proof for many properties.
In this chapter, we will show that the spherical geometry can be also useful to better understand the structure of the exact electronic wave function.
Almost ten years ago, following this idea, we undertook a comprehensive study of two electrons on the surface of a sphere of radius $R$ \cite{TEOAS09, Concentric10, Hook10}.
We used quantum chemistry electronic structure models ranging from HF to state-of-the-art explicitly correlated treatments, the last of which leads to near-exact wave functions and energies.
This helped us to understand not only the complicated relative motion of electrons, but also the errors inherent to each method.
It eventually led to the important discovery that the system composed of two electrons restricted to the surface of a $D$-sphere (where $D$ is the dimensionality of the surface of the sphere) is exactly solvable for a countable infinite set of values of $R$ \cite{QuasiExact09, ExSpherium10, QR12, ConcentricExact14}.
In other words, it means that the \textit{exact} solution of the Schr\"odinger equation can be obtained for certain ``magic'' values of the radius of the sphere \cite{QuasiExact09}.
This discovery propelled the two-electrons-on-a-sphere model (subsequently named spherium), into the exclusive family of exactly solvable two-electron models.
Moreover, after an exhaustive study of the ground state of two electrons confined by various external potentials \cite{EcLimit09, Ballium10}, we noticed that the correlation energy is weakly dependent on the external potential, and we conjectured that the behaviour of the two-electron correlation energy, in the limit of large dimension, is \textit{universal}!
The rigorous proof of this conjecture has been published in Ref.~\cite{EcProof10}.
In particular, we showed that the limiting correlation energy at high-density in helium and spherium are amazingly similar \cite{Frontiers10}.
However, while the closed-form expression of the limiting correlation energy has never been found for helium, the value for spherium is quite simple to obtain.
This shows the superiority of the spherical geometry approach and that it can be used in quantum chemistry to provide robust and trustworthy models for understanding, studying and explaining ``real world'' chemical systems.
In this chapter, we will summarise some of our key discoveries.
%%% FIG 1 %%%
\begin{figure}
\centering
\includegraphics[width=0.2\textwidth]{../Chapter2/fig/sphericalcow}
\caption{\label{fig:cow} A spherical cow.}
\end{figure}
%%% %%%

View File

@ -0,0 +1,336 @@
%****************************************************************
\section{Quasi-exactly solvable models}
%****************************************************************
Quantum mechanical models for which it is possible to solve explicitly for a finite portion of the energy spectrum are said to be quasi-exactly solvable \cite{Ushveridze}.
They have ongoing value and are useful both for illuminating more complicated systems and for testing and developing theoretical approaches, such as DFT \cite{Hohenberg64, Kohn65, ParrYang} and explicitly-correlated methods \cite{Kutzelnigg85, Kutzelnigg91, Henderson04, Bokhan08}.
One of the most famous quasi-solvable model is the Hooke's law atom which consists of a pair of electrons, repelling Coulombically but trapped in a harmonic external potential with force constant $k$.
This system was first considered nearly 50 years ago by Kestner and Sinanoglu \cite{Kestner62}, solved analytically in 1989 for one particular $k$ value \cite{Kais89}, and later for a countably infinite set of $k$ values \cite{Taut93}.
A related system consists of two electrons trapped on the surface of a sphere of radius $R$.
This has been used by Berry and collaborators \cite{Ezra82, Ezra83, Ojha87, Hinde90} to understand both weakly and strongly correlated systems and to suggest an ``alternating'' version of Hund's rule \cite{Warner85}.
Seidl utilised this system to develop new correlation functionals \cite{Seidl00a, Seidl00b} within the adiabatic connection in DFT \cite{Seidl07b}.
As mentioned earlier, we will use the term ``spherium'' to describe this two-electron system.
In Ref.~\cite{TEOAS09}, we examined various schemes and described a method for obtaining near-exact estimates of the $^1S$ ground state energy of spherium for any given $R$.
Because the corresponding HF energies are also known exactly, this is now one of the most complete theoretical models for understanding electron correlation effects.
In this section, we consider the $D$-dimensional generalisation of this system in which the two electrons are trapped on a $D$-sphere of radius $R$.
We adopt the convention that a $D$-sphere is the surface of a ($D+1$)-dimensional ball.
Here, we show that the Schr\"odinger equation for the $^1S$ and the $^3P$ states can be solved exactly for a countably infinite set of $R$ values and that the resulting wave functions are polynomials in the interelectronic distance $\ree = \abs{\br_1-\br_2}$.
Other spin and angular momentum states can be addressed in the same way using the ansatz derived by Breit \cite{Breit30} and we will discuss these excited states later in this section \cite{ExSpherium10}.
We have also published dedicated studies of the 1D system (that we dubbed ringium) \cite{QR12, Ringium13, NatRing16}.
The case of two concentric spheres has also been considered in two separate publications \cite{Concentric10, ConcentricExact14}, as well as the extension to excitonic wave functions \cite{Exciton12}.
Finally, the nodal structures of these systems has been investigated in collaboration with Dario Bressanini \cite{Nodes15}.
%****************************************************************
\subsection{Singlet ground state}
%****************************************************************
The electronic Hamiltonian is
\begin{equation}
\HOp = - \frac{\nabla_1^2}{2} - \frac{\nabla_2^2}{2} + \frac{1}{\ree},
\end{equation}
and because each electron moves on a $D$-sphere, it is natural to adopt hyperspherical coordinates \cite{Louck60}.
For $^1S$ states, it can be then shown \cite{TEOAS09} that the wave function $S(\ree)$ satisfies the Schr{\"o}dinger equation
\begin{equation}
\label{eq:S-singlet}
\qty[ \frac{\ree^2}{4R^2} - 1 ] \dv[2]{S(\ree)}{\ree} + \qty[ \frac{(2D-1)\ree}{4R^2} - \frac{D-1}{\ree} ] \dv{S(\ree)}{\ree} + \frac{S(\ree)}{\ree} = E\,S(\ree).
\end{equation}
By introducing the dimensionless variable $x = \ree/2R$, this becomes a Heun equation \cite{Ronveaux} with singular points at $x = -1, 0, +1$.
Based on our previous work \cite{TEOAS09} and the known solutions of the Heun equation \cite{Polyanin}, we seek wave functions of the form
\begin{equation}
\label{eq:S_series}
S(\ree) = \sum_{k=0}^\infty s_k\,\ree^k,
\end{equation}
and substitution into \eqref{eq:S-singlet} yields the recurrence relation
\begin{equation}
\label{eq:recurrence-singlet}
s_{k+2} = \frac{ s_{k+1} + \qty[ k(k+2D-2) \frac{1}{4R^2} - E ] s_k }{(k+2)(k+D)},
\end{equation}
with the starting values
\begin{equation}
\{s_0,s_1\} = \begin{cases}
\qty{0,1}, & D = 1,
\\
\qty{1,1/(D-1)}, & D \ge 2.
\end{cases}
\end{equation}
Thus, the Kato cusp conditions \cite{Kato57} are
\begin{align}
\label{eq:cusp-circle}
S(0) & = 0,
&
\frac{S''(0)}{S'(0)} & = 1,
\end{align}
for electrons on a ring ($D=1$), i.e.~ringium, and
\begin{equation}
\label{eq:S-cusp}
\frac{S'(0)}{S(0)} = \frac{1}{D-1},
\end{equation}
in higher dimensions.
We note that the ``normal'' Kato value of 1/2 arises for $D=3$ --- a system we called glomium as the name of a 3-sphere is a glome --- suggesting that this may the most appropriate model for atomic or molecular systems.
We will return to this point below.
The wave function \eqref{eq:S_series} reduces to the polynomial
\begin{equation}
S_{n,m}(\ree) = \sum_{k=0}^n s_k\,\ree^k,
\end{equation}
(where $m$ the number of roots between $0$ and $2R$) if, and only if, $s_{n+1} = s_{n+2} = 0$.
Thus, the energy $E_{n,m}$ is a root of the polynomial equation $s_{n+1} = 0$ (where $\deg s_{n+1} = \lfloor (n+1)/2 \rfloor$) and the corresponding radius $R_{n,m}$ is found from \eqref{eq:recurrence-singlet} which yields
\begin{equation}
\label{eq:E_S}
R_{n,m}^2 E_{n,m} = \frac{n}{2}\qty(\frac{n}{2}+D-1).
\end{equation}
$S_{n,m}(\ree)$ is the exact wave function of the $m$-th excited state of $^1S$ symmetry for the radius $R_{n,m}$.
%%%%%%%%%%%%%%%%%%%%%%%%%
\begin{table}
\centering
\caption{\label{tab:lowest} Radius $R$, energy $E$ and wave function $S(\ree)$ or $T(\ree)$ of the first $^1S$ and $^3P$ polynomial solutions for two electrons on a $D$-sphere}
\centering
\begin{tabular}{ccccc}
\hline
State & $D$ & $2R$ & $E$ & $S(\ree)$ or $T(\ree)$ \\
\hline
\mr{4}{*}{$^1S$} & 1 & $\sqrt{6}$ & 2/3 & $\ree(1 + \ree/2)$ \\
& 2 & $\sqrt{3}$ & 1 & $1 + \ree$ \\
& 3 & $\sqrt{10}$ & 1/2 & $1 + \ree/2$ \\
& 4 & $\sqrt{21}$ & 1/3 & $1 + \ree/3$ \\
\hline
\mr{4}{*}{$^3P$} & 1 & $\sqrt{6}$ & 1/2 & $1 + \ree/2$ \\
& 2 & $\sqrt{15}$ & 1/3 & $1 + \ree/3$ \\
& 3 & $\sqrt{28}$ & 1/4 & $1 + \ree/4$ \\
& 4 & $\sqrt{45}$ & 1/5 & $1 + \ree/5$ \\
\hline
\end{tabular}
\end{table}
%%%%%%%%%%%%%%%%%%%%%%%%%
%****************************************************************
\subsection{Triplet excited state}
%****************************************************************
If we write the $^3P$ state wave function as \cite{Breit30}
\begin{equation}
^3\Psi = (\cos \theta_1 - \cos \theta_2)\,T(\ree),
\end{equation}
where $\theta_1$ and $\theta_2$ are the $D$-th hyperspherical angles of the two electrons \cite{Louck60}, the symmetric part satisfies the Schr{\"o}dinger equation
\begin{equation}
\label{eq:S-triplet}
\qty[ \frac{\ree^2}{4R^2} - 1 ] \dv[2]{T(\ree)}{\ree} + \qty[ \frac{(2D+1)\ree}{4R^2} - \frac{D+1}{\ree} ] \dv{T(\ree)}{\ree} + \frac{T(\ree)}{\ree} = E\,T(\ree),
\end{equation}
and the antisymmetric part provides an additional kinetic energy contribution $D/(2R^2)$.
Substituting the power series expansion
\begin{equation}
\label{eq:T_series}
T(\ree) = \sum_{k=0}^\infty t_k\,\ree^k
\end{equation}
into \eqref{eq:S-triplet} yields the recurrence relation
\begin{equation}
\label{eq:recurrence-triplet}
t_{k+2} = \frac{ t_{k+1} + \qty[ k(k+2D) \frac{1}{4R^2} - E ] t_k }{(k+2)(k+D+2)},
\end{equation}
with the starting values
\begin{equation}
\qty{t_0,t_1} = \qty{1, 1/(D+1)},
\end{equation}
yielding the cusp condition
\begin{equation}
\label{eq:T-cusp}
\frac{T'(0)}{T(0)} = \frac{1}{D+1}.
\end{equation}
The wave function \eqref{eq:T_series} reduces to the polynomial
\begin{equation}
T_{n,m}(\ree) = \sum_{k=0}^n t_k\,\ree^k,
\end{equation}
when the energy $E_{n,m}$ is a root of $t_{n+1} = 0$ and the corresponding radius $R_{n,m}$ is found from \eqref{eq:recurrence-triplet} which yields
\begin{equation}
\label{eq:E_T}
R_{n,m}^2 E_{n,m} = \frac{n}{2}\qty(\frac{n}{2}+D).
\end{equation}
$T_{n,m}(\ree)$ is the exact wave function of the $m$-th excited state of $^3P$ symmetry for the radius $R_{n,m}$.
It is illuminating to begin by examining the simplest $^1S$ and $^3P$ polynomial solutions.
Except in the $D=1$ case, the first $^1S$ solution has
\begin{align}
R_{1,0} & = \sqrt{\frac{(2D-1)(2D-2)}{8}}, & E_{1,0} & = \frac{1}{D-1},
\end{align}
and the first $^3P$ solution has
\begin{align}
R_{1,0} & = \sqrt{\frac{(2D+1)(2D+2)}{8}}, & E_{1,0} & = \frac{1}{D+1}.
\end{align}
These are tabulated for $D = 1, 2, 3, 4$, together with the associated wave functions, in Table \ref{tab:lowest}.
In the ringium ($D=1$) case (\textit{i.e.}~two electrons on a ring), the first singlet and triplet solutions have $E_{2,0} = 2/3$ and $E_{1,0} = 1/2$, respectively, for the same value of the radius ($\sqrt{6}/2 \approx 1.2247$).
The corresponding wave functions are related by $S_{2,0} = \ree\,T_{1,0}$.
Unlike $T_{1,0}$, the singlet wavefunction $S_{2,0}$ vanishes at $\ree = 0$, and exhibits a second-order cusp condition, as shown in \eqref{eq:cusp-circle}.
For spherium ($D=2$ case), we know from our previous work \cite{TEOAS09} that the HF energy of the lowest $^1S$ state is $\EHF = 1/R$.
It follows that the exact correlation energy for $R = \sqrt{3}/2$ is $\Ec = 1-2/\sqrt{3} \approx -0.1547$ which is much larger than the limiting correlation energies of the helium-like ions ($-0.0467$) \cite{Baker90} or Hooke's law atoms ($-0.0497$) \cite{Gill05}.
This confirms our view that electron correlation on the surface of a sphere is qualitatively different from that in three-dimensional physical space.
For glomium ($D=3$ case), in contrast, possesses the same singlet and triplet cusp conditions --- Eqs.~\eqref{eq:S-cusp} and \eqref{eq:T-cusp} --- as those for electrons moving in three-dimensional physical space.
Indeed, the wave functions in Table \ref{tab:lowest}
\begin{align}
S_{1,0}(\ree) & = 1 + \ree/2, & (R & = \sqrt{5/2}),
\\
T_{1,0}(\ree) & = 1 + \ree/4, & (R & = \sqrt{7}),
\end{align}
have precisely the form of the ansatz used in Kutzelnigg's increasingly popular R12 methods \cite{Kutzelnigg85, Kutzelnigg91}.
Moreover, it can be shown \cite{EcLimit09} that, as $R \to 0$, the correlation energy $\Ec$ approaches $-0.0476$, which nestles nicely between the corresponding values for the helium-like ions ($-0.0467$) \cite{Baker90} and the Hooke's law atom ($-0.0497$) \cite{Gill05}.
Again, this suggests that the $D=3$ model (``electrons on a glome'') bears more similarity to common physical systems than the $D=2$ model (``electrons on a sphere'').
We will investigate this observation further in the next section.
%For fixed $D$, the radii increase with $n$ but decrease with $m$, and the energies behave in exactly the opposite way.
%As $R$ (or equivalently $n$) increases, the electrons tend to localize on opposite sides of the sphere, a phenomenon known as Wigner crystallization \cite{Wigner34} which has also been observed in other systems \cite{Thompson04a, Thompson04b, Taut93}.
%As a result, for large $R$, the ground state energies of both the singlet and triplet state approach $1/(2R)$.
%Analogous behavior is observed when $D \to \infty$ \cite{Yaffe82, Goodson87}.
%****************************************************************
\subsection{Other electronic states}
%****************************************************************
As shown in Ref.~\cite{ExSpherium10}, one can determine exact wave functions for other electronic states, but not all of them.
These states are inter-connected by subtile interdimensional degeneracies (see Table \ref{tab:summary}) using the transformation $(D,L) \rightarrow (D+2,L-1)$, where $L$ is the total angular momentum of the state.
We refer the interested readers to Refs.~\cite{Herrick75a, Herrick75b, ExSpherium10, eee15, Nodes15} for more details.
The energies of the $S$, $P$ and $D$ states ($m=0$) for glomium are plotted in Fig.~\ref{fig:ES} (the quasi-exact solutions are indicated by markers), while density plots of spherium ($n=1$ and $m=0$) are represented on Fig. \ref{fig:ES-on-sphere}.
% FIGURE 1
\begin{figure}
\centering
\includegraphics[width=0.6\textwidth]{../Chapter2/fig/ES}
\caption{
\label{fig:ES}
Energy of the $S$, $P$ and $D$ states of glomium
(${}^1S^{\rm e} < {}^3P^{\rm o} \leq {}^1P^{\rm o} < {}^3P^{\rm e} < {}^3D^{\rm e} < {}^1D^{\rm o} \leq {}^3D^{\rm o}$).
The quasi-exact solutions are shown by the markers.}
\end{figure}
% FIGURE 2
\begin{figure}
\centering
\includegraphics[width=0.6\textwidth]{../Chapter2/fig/ES-on-sphere}
\caption{
\label{fig:ES-on-sphere}
Density plots of the $S$, $P$ and $D$ states of spherium.
The squares of the wave functions when one electron is fixed at the north pole are represented.
The radii are $\sqrt{3}/2$, $\sqrt{15}/2$, $\sqrt{5}/2$, $\sqrt{21}/2$, $\sqrt{21}/2$, $3\sqrt{5}/2$ and $3\sqrt{3}/2$ for the ${}^1S^{\rm e}$, ${}^3P^{\rm o}$, ${}^1P^{\rm o}$, ${}^3P^{\rm e}$, ${}^3D^{\rm e}$, ${}^1D^{\rm o}$ and ${}^3D^{\rm o}$ states, respectively.}
\end{figure}
%****************************************************************
\subsection{Natural/unnatural parity}
%****************************************************************
In attempting to explain Hund's rules \cite{Hund25} and the ``alternating'' rule \cite{Russel27, Condon} (see also Refs.~\cite{Boyd84, Warner85}), Morgan and Kutzelnigg \cite{Kutzelnigg92, Morgan93, Kutzelnigg96} have proposed that the two-electron atomic states be classified as:
\begin{quote}
\textit{A two-electron state, composed of one-electron spatial orbitals with individual parities $(-1)^{\ell_1}$ and $(-1)^{\ell_1}$ and hence with overall parities $(-1)^{\ell_1+\ell_2}$, is said to have natural parity if its parity is $(-1)^L$. [\ldots] If the parity of the two-electron state is $-(-1)^{L}$, the state is said to be of unnatural parity.}
\end{quote}
After introducing spin, three classes emerge.
In a three-dimensional space, the states with a cusp value of $1/2$ are known as the {\em natural parity singlet states} \cite{Kato51,Kato57}, those with a cusp value of $1/4$ are the {\em natural and unnatural parity triplet states} \cite{Pack66}, and those with a cusp value of $1/6$, are the {\em unnatural parity singlet states} \cite{Kutzelnigg92}.
%In the previous section, we have observed that the $^1S^{\rm e}$ ground state and the first excited $^3P^{\rm o}$ state of glomium possess the same singlet ($1/2$) and triplet ($1/4$) cusp conditions as those for electrons moving in three-dimensional physical space and we have therefore argued that glomium may be the most appropriate model for studying ``real'' atomic or molecular systems.
%As mentioned previously, this is supported by the similarity of the correlation energy of glomium to that in other two-electron systems.
Most of the higher angular momentum states of glomium, possess the ``normal'' cusp values of $1/2$ and $1/4$.
However, the unnatural $^1D^{\rm o}$ and $^1F^{\rm e}$ states have the cusp value of $1/6$.
%****************************************************************
\subsection{First-order cusp condition}
%****************************************************************
The wave function, radius and energy of the lowest states are given by
\begin{align}
\Psi_{1,0} (\ree) & = 1 + \gamma\,\ree,
&
R_{1,0}^2 & = \frac{\delta}{4\gamma},
&
E_{1,0} & = \gamma,
\end{align}
which are closely related to the Kato cusp condition \cite{Kato57}
\begin{equation}
\label{eq:Kato}
\frac{\Psi^{\prime}(0)}{\Psi(0)} = \gamma.
\end{equation}
We now generalise the Morgan-Kutzelnigg classification \cite{Morgan93} to a $D$-dimensional space.
Writing the interparticle wave function as
\begin{equation}
\label{eq:Psi-1}
\Psi(\ree) = 1 + \frac{\ree}{2\kappa+D-1} + O(\ree^2),
\end{equation}
we have
\begin{equation}
\label{eq:classification}
\begin{split}
\kappa = 0, & \text{ for natural parity singlet states,}
\\
\kappa = 1, & \text{ for triplet states,}
\\
\kappa = 2, & \text{ for unnatural parity singlet states.}
\end{split}
\end{equation}
The labels for states of two electrons on a $D$-sphere are given in Table \ref{tab:summary}.
% TABLE 1
\begin{table*}
\centering
\caption{
\label{tab:summary}
Ground state and excited states of two electrons on a $D$-sphere}
\begin{tabular}{ccccccc}
\hline
State & Configuration & $\delta$ & $\gamma^{-1}$ & $\Lambda$ & $\kappa$ & Degeneracy \\
\hline
$^1S^{\rm e}$ & $s^2$ & $2D-1$ & $D-1$ & 0 & 0 & $^3P^{\rm e}$ \\
\hline
$^3P^{\rm o}$ & $sp$ & $2D+1$ & $D+1$ & $D/2$ & 1 & $^1D^{\rm o}$ \\
$^1P^{\rm o}$ & $sp$ & $2D+1$ & $D-1$ & $D/2$ & 0 & $^3D^{\rm o}$ \\
$^3P^{\rm e}$ & $p^2$ & $2D+3$ & $D+1$ & $D$ & 1 & \\
\hline
$^3D^{\rm e}$ & $sd$ & $2D+3$ & $D+1$ & $D+1$ & 1 & $^1F^{\rm e}$ \\
$^1D^{\rm o}$ & $pd$ & $2D+5$ & $D+3$ & $3D/2+1$ & 2 & \\
$^3D^{\rm o}$ & $pd$ & $2D+5$ & $D+1$ & $3D/2+1$ & 1 & \\
\hline
$^1F^{\rm e}$ & $pf$ & $2D+7$ & $D+3$ & $2D+3$ & 2 & \\
\hline
\end{tabular}
\end{table*}
%****************************************************************
\subsection{Second-order cusp condition}
%****************************************************************
The second solution is associated with
\begin{gather}
\Psi_{2,0} (\ree) = \Psi_{1,0} (\ree)
+ \frac{\gamma ^2 (\delta +2)}{2 \gamma (\delta +2)+4 \delta +6} \ree^2,
\\
R_{2,0}^2 = \frac{(\gamma+2)(\delta+2)-1}{2\gamma},
\\
E_{2,0} = \frac{\gamma(\delta+1)}{(\gamma+2)(\delta+2)-1}.
\end{gather}
For two electrons on a $D$-sphere, the second-order cusp condition is
\begin{equation}
\label{eq:Psi2}
\frac{\Psi^{\prime\prime}(0)}{\Psi(0)}
= \frac{1}{2D} \left( \frac{1}{D-1} - E \right).
\end{equation}
Following \eqref{eq:Psi2}, the classification \eqref{eq:classification} can be extended to the second-order coalescence condition, where the wave function (correct up to second-order in $u$) is
\begin{equation}
\Psi(\ree)
= 1 + \frac{\ree}{2\kappa+D-1}
+ \frac{\ree^2}{2(2\kappa+D)} \left( \frac{1}{2\kappa+D-1} - E \right) + O(\ree^3).
\end{equation}
Thus, we have, for $D = 3$,
\begin{equation}
\frac{\Psi^{\prime\prime}(0)}{\Psi(0)} =
\begin{cases}
\frac{1}{6} \qty( \frac{1}{2} - E ), & \text{ for } \kappa = 0,
\\
\frac{1}{10} \qty( \frac{1}{4} - E ), & \text{ for } \kappa = 1,
\\
\frac{1}{14} \qty( \frac{1}{6} - E ), & \text{ for } \kappa = 2.
\end{cases}
\end{equation}
For the natural parity singlet states ($\kappa=0$), the second-order cusp condition of glomium is precisely the second-order coalescence condition derived by Tew \cite{Tew08}, reiterating that glomium is an appropriate model for normal physical systems.

View File

@ -0,0 +1,274 @@
%****************************************************************
\section{Universality of correlation effects}
%****************************************************************
Understanding and calculating the electronic correlation energy is one of the most important and difficult problems in theoretical chemistry.
In this pursuit, the study of high-density correlation energy using perturbation theory has been particularly profitable, shedding light on the physically relevant density regime and providing {\em exact} results for key systems, such as the uniform electron gas \cite{GellMann57} and two-electron systems \cite{BetheSalpeter}.
The former is the cornerstone of the most popular density functional paradigm (the local-density approximation) in solid-state physics \cite{ParrYang}; the latter provide important test cases in the development of new explicitly-correlated methods \cite{Kutzelnigg85,Nakashima07} for electronic structure calculations \cite{Helgaker}.
%****************************************************************
\subsection{High-density correlation energy}
%****************************************************************
The high-density correlation energy of the helium-like ions is obtained by expanding both the exact \cite{Hylleraas30} and HF \cite{Linderberg61} energies as series in $1/Z$, yielding
\begin{subequations}
\begin{align}
\label{eq:Eex}
E(Z,D,V)
& = E^{(0)}(D,V) Z^2
+ E^{(1)}(D,V) Z
+ E^{(2)}(D,V)
+ \frac{E^{(3)}(D,V)}{Z}
+ \ldots,
\\
\label{eq:EHF}
E_{\rm HF}(Z,D,V)
& = E^{(0)}(D,V) Z^2
+ E^{(1)}(D,V) Z
+ E_{\rm HF}^{(2)}(D,V)
+ \frac{E_{\rm HF}^{(3)}(D,V)}{Z}
+ \ldots,
\end{align}
\end{subequations}
where $Z$ is the nuclear charge, $D$ is the dimension of the space and $V$ is the external Coulomb potential.
Equations \eqref{eq:Eex} and \eqref{eq:EHF} share the same zeroth- and first-order energies because the exact and the HF treatment have the same zeroth-order Hamiltonian.
Thus, in the high-density (large-$Z$) limit, the correlation energy is
\begin{equation}
\begin{split}
\Ec^{(2)}(D,V)
& = \lim_{Z\to\infty} \Ec(Z,D,V)
\\
& = \lim_{Z\to\infty} \qty[ E(Z,D,V)-E_{\rm HF}(Z,D,V) ]
\\
& = E^{(2)}(D,V) - E_{\rm HF}^{(2)}(D,V).
\end{split}
\end{equation}
Despite intensive study \cite{Schwartz62, Baker90}, the coefficient $E^{(2)}(D,V)$ has not yet been reported in closed form.
However, the accurate numerical estimate
\begin{equation}
\label{eq:E2-He-3D}
E^{(2)} = -0.157\;666\;429\;469\;14
\end{equation}
has been determined for the important $D=3$ case \cite{Baker90}.
Combining \eqref{eq:E2-He-3D} with the exact result \cite{Linderberg61}
\begin{equation}
\label{eq:E2HF-He-3D}
E_{\rm HF}^{(2)} = \frac{9}{32} \ln \frac{3}{4} - \frac{13}{432}
\end{equation}
yields a value of
\begin{equation}
\Ec^{(2)} = -0.046\;663\;253\;999\;48
\end{equation}
for the helium-like ions in a three-dimensional space.
In the large-$D$ limit, the quantum world reduces to a simpler semi-classical one \cite{Yaffe82} and problems that defy solution in $D=3$ sometimes become exactly solvable.
In favorable cases, such solutions provide useful insight into the $D=3$ case and this strategy has been successfully applied in many fields of physics \cite{Witten80, Yaffe83}.
Indeed, just as one learns something about interacting systems by studying non-interacting ones and introducing the interaction perturbatively, one learns something about $D = 3$ by studying the large-$D$ case and introducing dimension-reduction perturbatively.
Singularity analysis \cite{Doren87} reveals that the energies of two-electron atoms possess first- and second-order poles at $D=1$, and that the Kato cusp \cite{Kato57, Morgan93} is directly responsible for the second-order pole.
In our previous work \cite{EcLimit09, Ballium10}, we have expanded the correlation energy as a series in $1/(D-1)$ but, although this is formally correct if summed to infinite order, such expansions falsely imply higher-order poles at $D=1$.
For this reason, we now follow Herschbach and Goodson \cite{Herschbach86, Goodson87}, and expand both the exact and HF energies as series in $1/D$.
Although various possibilities exist for this dimensional expansion \cite{Doren86, Doren87, Goodson92, Goodson93}, it is convenient to write
\begin{subequations}
\begin{align}
E^{(2)}(D,V)
& = \frac{E^{(2,0)}(V)}{D^2}
+ \frac{E^{(2,1)}(V)}{D^3}
+ \ldots,
\label{eq:E2DV}
\\
E_{\rm HF}^{(2)}(D,V)
& = \frac{E_{\rm HF}^{(2,0)}(V)}{D^2}
+ \frac{E_{\rm HF}^{(2,1)}(V)}{D^3}
+ \ldots,
\label{eq:EHF2DV}
\\
\Ec^{(2)}(D,V)
& = \frac{\Ec^{(2,0)}(V)}{D^2}
+ \frac{\Ec^{(2,1)}(V)}{D^3}
+ \ldots,
\label{eq:Ec2DV}
\end{align}
\end{subequations}
where
\begin{subequations}
\begin{align}
\Ec^{(2,0)}(V)
& = E^{(2,0)}(V) - E_{\rm HF}^{(2,0)}(V),
\\
\Ec^{(2,1)}(V)
& = E^{(2,1)}(V) - E_{\rm HF}^{(2,1)}(V).
\end{align}
\end{subequations}
Such double expansions of the correlation energy were originally introduced for the helium-like ions, and have lead to accurate estimations of correlation \cite{Loeser87a, Loeser87b} and atomic energies \cite{Loeser87c, Kais93} {\em via} interpolation and renormalisation techniques.
Equations \eqref{eq:E2DV}, \eqref{eq:EHF2DV} and \eqref{eq:Ec2DV} apply equally to the $^1S$ ground state of any two-electron system confined by a spherical potential $V(r)$.
%****************************************************************
\subsection{The conjecture}
%****************************************************************
For the helium-like ions, it is known \cite{Mlodinow81, Herschbach86, Goodson87} that
\begin{align}
\Ec^{(2,0)}(V) & = - \frac{1}{8},
&
\Ec^{(2,1)}(V) & = - \frac{163}{384},
\end{align}
and we have recently found \cite{EcLimit09} that $\Ec^{(2,0)}(V)$ takes the same value in hookium (two electrons in a parabolic well \cite{Kestner62, White70, Kais89, Taut93}), spherium (two electrons on a sphere \cite{Ezra82, Seidl07b, TEOAS09, QuasiExact09}) and ballium (two electrons in a ball \cite{Thompson02, Thompson05, Ballium10}).
In contrast, we found that $\Ec^{(2,1)}(V)$ is $V$-dependent.
The fact that the term $\Ec^{(2,0)}$ is invariant, while $\Ec^{(2,1)}$ varies with the confinement potential allowed us to explain why the high-density correlation energy of the previous two-electron systems are similar, but not identical, for $D=3$ \cite{EcLimit09, Ballium10}.
On this basis, we conjectured \cite{EcLimit09} that
\begin{equation}
\label{eq:conjecture}
\Ec^{(2)}(D,V) \sim - \frac{1}{8D^2} - \frac{C(V)}{D^3}
\end{equation}
holds for \emph{any} spherical confining potential, where the coefficient $C(V)$ varies slowly with $V(r)$.
% BEGIN TABLE 1
\begin{table}
\centering
\caption{
\label{tab:Ec}
$E^{(2,0)}$, $E_{\rm HF}^{(2,0)}$, $\Ec^{(2,0)}$ and $\Ec^{(2,1)}$ coefficients for various systems and $v(r) = 1$.}
\begin{tabular}{lrcccc}
\hline
System & $m$ & $-E^{(2,0)}$ & $-E_{\rm HF}^{(2,0)}$ & $-\Ec^{(2,0)}$ & $-\Ec^{(2,1)}$ \\
\hline
Helium & $-1$ & $5/8$ & $1/2$ & $1/8$ & $0.424479$ \\
Airium & $1$ & $7/24$ & $1/6$ & $1/8$ & $0.412767$ \\
Hookium & $2$ & $1/4$ & $1/8$ & $1/8$ & $0.433594$ \\
Quartium & $4$ & $5/24$ & $1/12$ & $1/8$ & $0.465028$ \\
Sextium & $6$ & $3/16$ & $1/16$ & $1/8$ & $0.486771$ \\
Ballium & $\infty$ & $1/8$ & $0$ & $1/8$ & $0.664063$ \\
\hline
\end{tabular}
\end{table}
% END TABLE 1
%****************************************************************
\subsection{The proof}
%****************************************************************
Here, we will summarise our proof of the conjecture \eqref{eq:conjecture}.
More details can be found in Ref.~\cite{EcProof10}.
We prove that $\Ec^{(2,0)}$ is universal, and that, for large $D$, the high-density correlation energy of the $^1S$ ground state of two electrons is given by \eqref{eq:conjecture} for any confining potential of the form
\begin{equation}
\label{eq:V-proof}
V(r) = \text{sgn}(m) r^m v(r),
\end{equation}
where $v(r)$ possesses a Maclaurin series expansion
\begin{equation}
v(r) = v_0 + v_1 r + v_2 \frac{r^2}{2} + \ldots.
\end{equation}
After transforming both the dependent and independent variables \cite{EcProof10}, the Schr\"odinger equation can be brought to the simple form
\begin{equation}
\label{eq:Hersch-trans}
\qty( \frac{1}{\Lambda} \Hat{\mathcal{T}}
+ \Hat{\mathcal{U}}
+ \Hat{\mathcal{V}}
+ \frac{1}{Z} \Hat{\mathcal{W}} ) \Phi_D
= \mathcal{E}_D \Phi_D,
\end{equation}
in which, for $S$ states, the kinetic, centrifugal, external potential and Coulomb operators are, respectively,
\begin{gather}
-2 \Hat{\mathcal{T}} =
\qty( \frac{\partial^2}{\partial r_1^2} + \frac{\partial^2}{\partial r_2^2} )
+ \qty( \frac{1}{r_1^2} + \frac{1}{r_1^2} )
\qty( \frac{\partial^2}{\partial \theta^2} + \frac{1}{4} ),
\\
\Hat{\mathcal{U}} =
\frac{1}{2 \sin^2 \theta}
\qty( \frac{1}{r_1^2} + \frac{1}{r_1^2} ),
\\
\Hat{\mathcal{V}} =
V(r_1) + V(r_2),
\\
\Hat{\mathcal{W}} =
\frac{1}{\sqrt{r_1^2 + r_2^2 -2 r_1 r_2 \cos \theta}},
\end{gather}
and the dimensional perturbation parameter is
\begin{equation}
\Lambda = \frac{(D-2)(D-4)}{4}.
\end{equation}
In this form, double perturbation theory can be used to expand the energy in terms of both $1/Z$ and $1/\Lambda$.
For $D=\infty$, the kinetic term vanishes and the electrons settle into a fixed (``Lewis'') structure \cite{Herschbach86} that minimises the effective potential
\begin{equation}
\label{eq:X}
\Hat{\mathcal{X}}
= \Hat{\mathcal{U}} + \Hat{\mathcal{V}}
+ \frac{1}{Z} \Hat{\mathcal{W}}.
\end{equation}
The minimization conditions are
\begin{gather}
\frac{\partial \Hat{\mathcal{X}}(r_1,r_2,\theta)}{\partial r_1} =
\frac{\partial \Hat{\mathcal{X}}(r_1,r_2,\theta)}{\partial r_2} = 0,
\label{eq:dW-r}
\\
\frac{\partial \Hat{\mathcal{X}}(r_1,r_2,\theta)}{\partial \theta} = 0,
\label{eq:dW-theta}
\end{gather}
and the stability condition implies $m > -2$. Assuming that the two electrons are equivalent, the resulting exact energy is
\begin{equation}
\label{eq:Einf}
\mathcal{E}_{\infty}
= \Hat{\mathcal{X}} (r_{\infty},r_{\infty},\theta_{\infty}).
\end{equation}
It is easy to show that
\begin{gather}
r_{\infty} = \alpha + \frac{\alpha^2}{m+2}
\qty(\frac{1}{2\sqrt{2}} - \Lambda \frac{m+1}{m} \frac{v_1}{v_0} ) \frac{1}{Z}
+ \ldots,
\label{eq:r-eq}
\\
\cos \theta_{\infty} = - \frac{\alpha}{4\sqrt{2}} \frac{1}{Z}
+ \ldots,
\label{eq:tetha-eq}
\end{gather}
where $\alpha^{-(m+2)} = \text{sgn}(m) m v_0$.
For the HF treatment, we have $\theta_{\infty}^{\rm HF} = \pi/2$.
Indeed, the HF wave function itself is independent of $\theta$, and the only $\theta$ dependence comes from the $D$-dimensional Jacobian, which becomes a Dirac delta function centred at $\pi/2$ as $D\to\infty$.
Solving \eqref{eq:dW-r}, one finds that $r_{\infty}^{\rm HF}$ and $r_{\infty}$ are equal to second-order in $1/Z$.
Thus, in the large-$D$ limit, the HF energy is
\begin{equation}
\label{eq:EinfHF}
\mathcal{E}_{\infty}^{\rm HF}
= \Hat{\mathcal{X}} \qty(r_{\infty}^{\rm HF},r_{\infty}^{\rm HF},\frac{\pi}{2}),
\end{equation}
and correlation effects originate entirely from the fact that $\theta_\infty$ is slightly greater than $\pi/2$ for finite $Z$.
Expanding \eqref{eq:Einf} and \eqref{eq:EinfHF} in terms of $Z$ and $D$ yields
\begin{align}
E^{(2,0)}(V)
& = - \frac{1}{8} - \frac{1}{2(m+2)},
\\
E_{\rm HF}^{(2,0)}(V)
& = - \frac{1}{2(m+2)},
\label{eqEHF20}
\end{align}
thus showing that both $E^{(2,0)}$ and $E_{\rm HF}^{(2,0)}$ depend on the leading power $m$ of the external potential but not on $v(r)$.
Subtracting these energies yields
\begin{equation}
\label{eq:Ec00}
\Ec^{(2,0)}(V) = - \frac{1}{8},
\end{equation}
and this completes the proof that, in the high-density limit, the leading coefficient $\Ec^{(2,0)}$ of the large-$D$ expansion of the correlation energy is universal, {\em i.e.} it does not depend on the external potential $V(r)$.
The result \eqref{eq:Ec00} is related to the cusp condition \cite{Kato57, Morgan93, Pan03}
\begin{equation}
\label{eq:cusp}
\left. \pdv{\Psi_D}{\ree}\right|_{\ree=0}
= \frac{1}{D-1} \Psi_D(\ree=0),
\end{equation}
which arises from the cancellation of the Coulomb operator singularity by the $D$-dependent angular part of the kinetic operator \cite{Helgaker}.
The $E^{(2,1)}$ and $\EHF^{(2,1)}$ coefficients can be found by considering the Langmuir vibrations of the electrons around their equilibrium positions \cite{Herschbach86, Goodson87}.
The general expressions depend on $v_0$ and $v_1$, but are not reported here.
However, for $v(r)=1$, which includes many of the most common external potentials, we find
\begin{equation}
\Ec^{(2,1)}(V) = - \frac{85}{128} - \frac{9/32}{(m+2)^{3/2}}
+ \frac{1/2}{(m+2)^{1/2}} + \frac{1/16}{(m+2)^{1/2}+2},
\end{equation}
showing that $\Ec^{(2,1)}$, unlike $\Ec^{(2,0)}$, is potential-dependent.
Numerical values of $\Ec^{(2,1)}$ are reported in Table \ref{tab:Ec} for various systems.

Binary file not shown.

Binary file not shown.

Binary file not shown.

View File

@ -0,0 +1,11 @@
%****************************************************************
\section{Summary}
%****************************************************************
In the first section of this chapter, we have reported exact solutions of a Coulomb correlation problem, consisting of two electrons on a $D$-dimensional sphere.
The Coulomb problem can be solved exactly for an infinite set of values of the radius $R$ for both the ground and excited states, on both the singlet and triplet manifolds.
The corresponding exact solutions are polynomials in the interelectronic distance $\ree$.
The cusp conditions, which are related to the behaviour of the wave function at the electron-electron coalescence point, have been analysed and classified according to the natural or unnatural parity of the state considered.
In the second section, we proved that the leading term in the large-$D$ expansion of the high-density correlation energy of an electron pair is invariant to the nature of the confining potential.
For any such system, the correlation energy is given by $\Ec \sim -\gamma^2/8$, where $\gamma = 1/(D-1)$ is the Kato cusp factor in a $D$-dimensional space.

View File

@ -0,0 +1,21 @@
The final decades of the twentieth century witnessed a major revolution in solid-state and molecular physics, as the introduction of sophisticated exchange-correlation models \cite{ParrYang} propelled DFT from qualitative to quantitative usefulness.
The apotheosis of this development was probably the award of the 1998 Nobel Prize for Chemistry to Walter Kohn and John Pople but its origins can be traced to the prescient efforts by Thomas \cite{Thomas27}, Fermi \cite{Fermi26} and Dirac \cite{Dirac30}, more than 70 years earlier, to understand the behaviour of ensembles of electrons without explicitly constructing their full wave functions.
These days, DFT so dominates the popular perception of molecular orbital calculations that many non-specialists now regard the two as synonymous.
In principle, the cornerstone of modern DFT is the HK theorem \cite{Hohenberg64} but, in practice, it rests largely on the presumed similarity between the electronic behaviour in a real system and that in the hypothetical ``infinite'' uniform electron gas (IUEG) or jellium \cite{Fermi26, Thomas27, Dirac30, Wigner34, Macke50, GellMann57, Onsager66, Stern73, Rajagopal77, Isihara80, Hoffman92, Seidl04, Sun10, 2DEG11, 3DEG11, WIREs16, Vignale}.
In 1965, Kohn and Sham \cite{Kohn65} showed that the knowledge of an analytical parametrisation of the IUEG correlation energy allows one to perform approximate calculations for atoms, molecules and solids.
The idea --- the local-density approximation (LDA) --- is attractively simple: if we know the properties of jellium, we can understand the electron cloud in a molecule by dividing it into tiny chunks of density and treating each as a piece of jellium.
The good news is that the properties of jellium are known from DMC calculations \cite{Ceperley80, Tanatar89, Kwon93, Ortiz94, Rapisarda96, Kwon98, Ortiz99, Attaccalite02, Zong02, Drummond09a, Drummond09b}.
Such calculations are possible because jellium is characterised by just a \emph{single} parameter $\rho$, the electron density.
This spurred the development of a wide variety of spin-density correlation functionals (VWN \cite{VWN80}, PZ \cite{PZ81}, PW92 \cite{PW92}, etc), each of which requires information on the high- and low-density regimes of the spin-polarised IUEG, and are parametrised using numerical results from QMC calculations \cite{Ceperley78, Ceperley80}, together with analytic perturbative results.
The bad news is that jellium has an infinite number of electrons in an infinite volume and this unboundedness renders it, in some respects, a poor model for the electrons in molecules.
Indeed, the simple LDA described above predicts bond energies that are much too large and this led many chemists in the 70's to dismiss DFT as a quantitatively worthless theory.
Most of the progress since these days has resulted from concocting ingenious corrections for jellium's deficiencies (GGAs, MGGAs, HGGAs, etc).
However, notwithstanding the impressive progress since the 70's, modern DFT approximations still exhibit fundamental deficiencies in large systems \cite{Curtiss00}, conjugated molecules \cite{Woodcock02}, charge-transfer excited states \cite{Dreuw04}, dispersion-stabilised systems \cite{Wodrich06}, systems with fractional spin or charge \cite{Yang08}, isodesmic reactions \cite{Brittain09}, and elsewhere.
Because DFT is in principle an exact theory, many of these problems can be traced ultimately to the use of jellium as a reference system and the \textit{ad hoc} corrections that its use subsequently necessitates.

View File

@ -0,0 +1,184 @@
%****************************************************************
\section{Uniform electron gases}
%****************************************************************
In the previous chapter, we considered the behaviour of electrons that are confined to the surface of a sphere.
This work yielded a number of unexpected discoveries \cite{TEOAS09, EcLimit09, QuasiExact09, Concentric10, Hook10, EcProof10, ExSpherium10, Frontiers10, Glomium11} but the one of relevance here is that such systems provide a beautiful new family of UEGs.
These finite UEGs (FUEGs) have been thoroughly studied in Ref.~\cite{Glomium11}.
Here, we only report their main characteristics \cite{UEGs12}.
\begin{table}
\centering
\caption{
\label{tab:Ylm}
The lowest free-particle orbitals on a 2-sphere}
\begin{tabular}{lccc}
\hline
Name & $l$ & $m$ & $\sqrt{4\pi} \,Y_{lm}(\theta,\phi)$ \\
\hline
$s$ & $0$ & $0$ & $1$ \\
\hline
$p_0$ & $1$ & $0$ & $3^{1/2} \cos\theta$ \\
$p_{+1}$ & $1$ & $+1$ & $(3/2)^{1/2} \sin\theta \exp(+i\phi)$ \\
$p_{-1}$ & $1$ & $-1$ & $(3/2)^{1/2} \sin\theta \exp(-i\phi)$ \\
\hline
$d_0$ & $2$ & $0$ & $(5/4)^{1/2} (3\cos^2\theta-1)$ \\
$d_{+1}$ & $2$ & $+1$ & $(15/2)^{1/2} \sin\theta \cos\theta \exp(+i\phi)$ \\
$d_{-1}$ & $2$ & $-1$ & $(15/2)^{1/2} \sin\theta \cos\theta \exp(-i\phi)$ \\
$d_{+2}$ & $2$ & $+2$ & $(15/8)^{1/2} \sin^2\theta \exp(+2i\phi)$ \\
$d_{-2}$ & $2$ & $-2$ & $(15/8)^{1/2} \sin^2\theta \exp(-2i\phi)$ \\
\hline
\end{tabular}
\end{table}
\begin{table}
\centering
\caption{Number of electrons in $L$-spherium and $L$-glomium atoms}
\label{tab:fullshell}
\begin{tabular}{ccccccccc}
\hline
$L$ & 0 & 1 & 2 & 3 & 4 & 5 & 6 & 7 \\
\hline
$L$-spherium & 2 & 8 & 18 & 32 & 50 & 72 & 98 & 128 \\
$L$-glomium & 2 & 10 & 28 & 60 & 110 & 182 & 280 & 408 \\
\hline
\end{tabular}
\end{table}
\begin{table}
\centering
\caption{The lowest free-particle orbitals on a glome (\textit{i.e.}~a 3-sphere)}
\label{tab:Ylmn}
\begin{tabular}{lcccc}
\hline
Name & $l$ & $m$ & $n$ & $\pi\, Y_{lmn}(\chi,\theta,\phi)$ \\
\hline
$1s$ & $0$ & $0$ & $0$ & $2^{-1/2}$ \\
\hline
$2s$ & $1$ & $0$ & $0$ & $2^{1/2} \cos\chi$ \\
$2p_0$ & $1$ & $1$ & $0$ & $2^{1/2} \sin\chi \cos\theta$ \\
$2p_{+1}$ & $1$ & $1$ & $+1$ & $\sin\chi \sin\theta \exp(+i\phi)$ \\
$2p_{-1}$ & $1$ & $1$ & $-1$ & $\sin\chi \sin\theta \exp(-i\phi)$ \\
\hline
$3s$ & $2$ & $0$ & $0$ & $2^{-1/2} (4\cos^2\chi-1)$ \\
$3p_0$ & $2$ & $1$ & $0$ & $12^{1/2}\sin\chi \cos\chi \cos\theta$ \\
$3p_{+1}$ & $2$ & $1$ & $+1$ & $6^{1/2}\sin\chi \cos\chi \sin\theta \exp(+i\phi)$ \\
$3p_{-1}$ & $2$ & $1$ & $-1$ & $6^{1/2}\sin\chi \cos\chi \sin\theta \exp(-i\phi)$ \\
$3d_0$ & $2$ & $2$ & $0$ & $\sin^2\chi \ (3\cos^2\theta-1)$ \\
$3d_{+1}$ & $2$ & $2$ & $+1$ & $6^{1/2}\sin^2\chi \sin\theta \cos\theta \exp(+i\phi)$ \\
$3d_{-1}$ & $2$ & $2$ & $-1$ & $6^{1/2}\sin^2\chi \sin\theta \cos\theta \exp(-i\phi)$ \\
$3d_{+2}$ & $2$ & $2$ & $+2$ & $(3/2)^{1/2}\sin^2\chi \sin^2\theta \exp(+2i\phi)$ \\
$3d_{-2}$ & $2$ & $2$ & $-2$ & $(3/2)^{1/2}\sin^2\chi \sin^2\theta \exp(-2i\phi)$ \\
\hline
\end{tabular}
\end{table}
%-----------------------------------------------------------------------
\subsection{Spherium atoms}
%-----------------------------------------------------------------------
The surface of a three-dimensional ball is called a 2-sphere (for it is two-dimensional) and its free-particle orbitals (Table \ref{tab:Ylm}) are the spherical harmonics $Y_{lm}(\theta,\phi)$.
It is known that
\begin{equation}
\sum_{m=-l}^l \abs{Y_{lm}(\theta,\phi) }^2 = \frac{2l+1}{4\pi},
\end{equation}
and doubly occupying all the orbitals with $0 \le l \le L$ thus yields a UEG.
We call this system $L$-spherium and will compare it to \emph{two}-dimensional jellium \cite{Vignale}.
The number of electrons (Table \ref{tab:fullshell}) in $L$-spherium is
\begin{equation}
n = 2(L+1)^2,
\end{equation}
the volume of a 2-sphere is $V = 4\pi R^2$ and, therefore,
\begin{equation} \label{eq:rho2d}
\rho = \frac{(L+1)^2}{2\pi R^2}.
\end{equation}
%---------------------------------------------------------------------
\subsection{Glomium atoms}
%---------------------------------------------------------------------
The surface of a four-dimensional ball is a 3-sphere (or ``glome'') and its free-particle orbitals (Table \ref{tab:Ylmn}) are the hyperspherical harmonics $Y_{lmn}(\chi,\theta,\phi)$.
It is known \cite{Avery} that
\begin{equation}
\sum_{m=0}^l \sum_{n=-m}^m \abs{Y_{lmn}(\chi,\theta,\phi) }^2 = \frac{(l+1)^2}{2\pi^2},
\end{equation}
and doubly occupying all the orbitals with $0 \le l \le L$ thus yields a UEG.
We call this system $L$-glomium and will compare it to \emph{three}-dimensional jellium \cite{Vignale}.
The number of electrons (Table \ref{tab:fullshell}) in $L$-glomium is
\begin{equation}
n = (L+1)(L+2)(2L+3)/3,
\end{equation}
the volume of a 3-sphere is $V = 2\pi^2 R^3$ and, therefore,
\begin{equation}
\rho = \frac{(L+1)(L+2)(2L+3)}{6\pi^2 R^3}.
\end{equation}
%============================================
\subsection{The non-uniqueness problem}
%============================================
The deeply disturbing aspect of jellium-based DFT models --- and the launching-pad for the remainder of this chapter --- is the countercultural claim, that
\begin{quote}
\textit{``The uniform electron gas with density $\rho$ is not unique.''}
\end{quote}
Though it may seem heretical to someone who has worked with jellium for many years, or to someone who suspects that the claim violates the HK theorem, we claim that two $D$-dimensional UEGs with the same density parameter $\rho$ may have different energies.
To illustrate this, we now show that density functionals \cite{Dirac30, PW92, Attaccalite02} which are exact for jellium are wrong for 0-spherium and 0-glomium.
The energy contributions for 0-spherium and 0-glomium are easy to find.
There is no external potential, so $\Ene = 0$.
The density $\rho(\br)$ is constant, so the KS orbital $\psi(\br) = \sqrt{\rho(\br)}$ is constant, and $\Ts=0$.
The Hartree energy is the self-repulsion of a uniform spherical shell of charge of radius $R$ and one finds \cite{EcLimit09}
\begin{equation}
J = \frac{\Gamma(D-1)}{\Gamma(D-1/2)} \frac{\Gamma(D/2+1/2)}{ \Gamma(D/2)} \frac{1}{R},
\end{equation}
where $\Gamma(x)$ is the Gamma function \cite{NISTbook}.
The exchange energy is predicted to be \cite{Glomium11}
\begin{equation}
\Ex = - \frac{2D}{(D^2-1)\pi R} \left(\frac{D!}{2} \right)^{1/D},
\end{equation}
and the correlation energy is predicted by conventional jellium-based functionals \cite{Dirac30, PW92, Attaccalite02}.
Applying these formulae to the exactly solvable states of 0-spherium and 0-glomium considered in the previous chapter yields the results in the right half of Table \ref{tab:properties}.
In all cases, the KS-DFT energies are too high by 10 -- 20\%, indicating that the correlation functional that is exact for the UEG in jellium grossly underestimates the correlation energy of the UEGs in 0-spherium and 0-glomium.
\begin{table*}
\centering
\footnotesize
\caption{Exact and KS reduced energies of the ground states of 0-spherium and 0-glomium for various eigenradii $R$}
\label{tab:properties}
\begin{tabular}{ccccclcccccc}
\hline
& & \mc{3}{c}{Exact} & \mc{6}{c}{Jellium-based KS DFT} & Error \\
\cline{3-5} \cline{6-11} \cline{12-12}
& $2R$ & $T$ & $\Eee$ & $E$ & $\Ts$ &$\Ene$ & $J$ & $-\Ex$ & $-\Ec$ & $\EKS$ & $\EKS-E$ \\
\hline
0-spherium & $\sqrt{3}$ & 0.051982 & 0.448018 & 1/2 & 0 & 0 & 1.154701 & 0.490070 & 0.1028 & 0.562 & 0.062 \\
& $\sqrt{28}$ & 0.018594 & 0.124263 & 1/7 & 0 & 0 & 0.377964 & 0.160413 & 0.0593 & 0.158 & 0.015 \\
\hline
0-glomium & $\sqrt{10}$ & 0.014213 & 0.235787 & 1/4 & 0 & 0 & 0.536845 & 0.217762 & 0.0437 & 0.275 & 0.025 \\
& $\sqrt{66}$ & 0.007772 & 0.083137 & 1/11 & 0 & 0 & 0.208967 & 0.084764 & 0.0270 & 0.097 & 0.006 \\
\hline
\end{tabular}
\end{table*}
We know that it is possible for two UEGs to have the same density $\rho$ but different reduced energies $E$.
But how can this be, given that the probability of finding an electron in a given volume is identical in the two systems?
The key insight is that the probability of finding \emph{two} electrons in that volume is different.
This is illustrated in Fig.~\ref{fig:PuR}, which compare the probability distributions of the interelectronic distance $u$ \cite{Coulson61, GoriGiorgi04, Concentric10} in various two-dimensional UEGs.
These reveal that, although similar for $u \approx 0$ (because of the Kato cusp condition \cite{Kato57}), the specific Coulomb holes (i.e.~the holes per unit volume \cite{Overview03}) in two gases with the same one-electron density $\rho$ can be strikingly different.
In each case, the jellium hole is both deeper and wider than the corresponding spherium hole, indicating that the jellium electrons exclude one another more strongly, and one is much less likely to find two electrons in a given small volume of jellium than in the same volume of spherium.
\begin{figure}
\centering
\includegraphics[width=0.45\textwidth]{../Chapter3/fig/PuR1}
\includegraphics[width=0.45\textwidth]{../Chapter3/fig/PuR2}
\caption{
\label{fig:PuR}
Specific Coulomb holes for 0-spherium (dotted) with $R=\sqrt{3}/2$ (left) and $R=\sqrt{7}$ (right), and 2D jellium (solid).
Both are uniform gases with $\rho = 2/(3\pi)$ (left) and $\rho = 1/(14\pi)$ (right)}
\end{figure}
We conclude from these comparisons that (at least) two parameters are required to characterise a UEG.
Although the parameter choice is not unique, we believe that the first should be a one-electron quantity, such as the density $\rho$ and the second should be a two-electron quantity.
A possible choice of a two-electron local variable will be presented in the next section.

View File

@ -0,0 +1,379 @@
%****************************************************************
\section{
\label{sec:ExGLDA}
Exchange functionals based on finite uniform electron gases}
%****************************************************************
In this section, we show how to use these finite UEGs (FUEGs) to create a new type of exchange functionals applicable to atoms, molecules and solids \cite{ExGLDA17}.
We have successfully applied this strategy to one-dimensional systems \cite{1DChem15, SBLDA16, Leglag17, ESWC17}, for which we have created a correlation functional based on this idea \cite{gLDA14, Wirium14}.
%****************************************************************
\subsection{Theory}
%****************************************************************
Within DFT, one can write the total exchange energy as the sum of its spin-up ($\sigma=$ $\upa$) and spin-down ($\sigma=$ $\dwa$) contributions:
\begin{equation}
E_\text{x} = E_{\text{x},\upa} + E_{\text{x},\dwa},
\end{equation}
where
\begin{equation}
E_{\text{x},\sigma} = \int e_{\text{x},\sigma}(\rho_\sigma,\nabla \rho_\sigma, \tau_\sigma, \ldots) \, \rho_\sigma(\br) \, d\br,
\end{equation}
and $\rs$ is the electron density of the spin-$\sigma$ electrons.
Although, for sake of simplicity, we sometimes remove the subscript $\sigma$, we only use spin-polarised quantities from hereon.
The first-rung LDA exchange functional (or D30 \cite{Dirac30}) is based on the IUEG \cite{WIREs16} and reads
\begin{equation}
\exsLDA(\rs) = \CxLDA \rs^{1/3},
\end{equation}
where
\begin{equation}
\CxLDA = - \frac{3}{2} \qty( \frac{3}{4\pi} )^{1/3}.
\end{equation}
A GGA functional (second rung) is defined as
\begin{equation}
\label{eq:GGA}
\exsGGA(\rs,\xs)
= e_{\text{x},\sigma}^\text{LDA}(\rs) \FxGGA(\xs),
\end{equation}
where $\FxGGA$ is the GGA enhancement factor depending only on the reduced gradient
\begin{equation}
x = \frac{\abs{\nabla \rho}}{\rho^{4/3}},
\end{equation}
and
\begin{equation}
\lim_{x \to 0} \FxGGA(x) = 1,
\end{equation}
i.e.~a well thought-out GGA functional reduces to the LDA for homogeneous systems.
Similarly, motivated by the work of Becke \cite{Becke00} and our previous investigations \cite{gLDA14, Wirium14}, we define an alternative second-rung functional (see Fig.~\ref{fig:Jacob-rev}) that we call generalised LDA (GLDA)
\begin{equation}
\label{eq:GLDA}
\exsGLDA(\rs,\as) = \exsLDA(\rs) \FxGLDA(\as).
\end{equation}
%%% FIGURE 1 %%%
\begin{figure}
\centering
\includegraphics[width=0.5\linewidth]{../Chapter3/fig/Jacob-rev}
\caption{
\label{fig:Jacob-rev}
Jacob's ladder of DFT revisited.}
\end{figure}
%%%
By definition, a GLDA functional only depends on the electron density and the curvature of the Fermi hole (see Fig.~\ref{fig:Jacob-rev}):
\begin{equation}
\label{eq:eta-def}
\alpha = \frac{\tau - \tau_\text{W}}{\tau_\text{IUEG}} = \frac{\tau}{\tau_\text{IUEG}} - \frac{x^2}{4 \Cf},
\end{equation}
which measures the tightness of the exchange hole around an electron \cite{Becke83, Dobson91}.
In Eq.~\eqref{eq:eta-def},
\begin{equation}
\tau_\text{W} = \frac{\abs{\nabla\rho}^2}{4\,\rho}
\end{equation}
is the von Weizs{\"a}cker kinetic energy density \cite{vonWeizsacker35}, and
\begin{equation}
\tau_\text{IUEG} = \Cf \rho^{5/3}
\end{equation}
is the kinetic energy density of the IUEG \cite{WIREs16}, where
\begin{equation}
\Cf = \frac{3}{5} (6\pi^2)^{2/3}.
\end{equation}
The dimensionless parameter $\alpha$ has two characteristic features: i) $\alpha=0$ for any one-electron system, and ii) $\alpha=1$ for the IUEG.
Some authors call $\alpha$ the inhomogeneity parameter but we will avoid using this term as we are going to show that $\alpha$ can have distinct values in homogeneous systems.
For well-designed GLDA functionals, we must ensure that
\begin{equation}
\label{eq:limGLDA}
\lim_{\alpha \to 1} \FxGLDA(\alpha) = 1,
\end{equation}
i.e.~the GLDA reduces to the LDA for the IUEG.\footnote{While some functionals only use the variable $\tau$ \cite{Ernzerhof99, Eich14}, we are not aware of any functional only requiring $\alpha$.}
Although any functional depending on the reduced gradient $x$ and the kinetic energy density $\tau$ is said to be of MGGA type, here we will define a third-rung MGGA functional as depending on $\rho$, $x$ and $\alpha$:
\begin{equation}
\exsMGGA(\rs,\xs,\as) = \exsLDA(\rs) \FxMGGA(\xs,\as),
\end{equation}
where one should ensure that
\begin{equation}
\label{eq:limMGGA}
\lim_{x \to 0} \lim_{\alpha \to 1} \FxMGGA(x,\alpha) = 1,
\end{equation}
i.e.~the MGGA reduces to the LDA for an infinite homogeneous system.
The Fermi hole curvature $\alpha$ has been shown to be a better variable than the kinetic energy density $\tau$ as one can discriminate between covalent ($\alpha=0$), metallic ($\alpha \approx 1$) and weak bonds ($\alpha \gg 0$) \cite{Kurth99, TPSS, revTPSS, MS0, Sun13a, MS1_MS2, MVS, SCAN, Sun16b}.
The variable $\alpha$ is also related to the electron localisation function (ELF) designed to identify chemical bonds in molecules \cite{Becke83, ELF}.
Moreover, by using the variables $x$ and $\alpha$, we satisfy the correct uniform coordinate density-scaling behaviour \cite{Levy85}.
In conventional MGGAs, the dependence in $x$ and $\alpha$ can be strongly entangled, while, in GGAs for example, $\rho$ and $x$ are strictly disentangled as illustrated in Eq.~\eqref{eq:GGA}.
Therefore, it feels natural to follow the same strategy for MGGAs.
Thus, we consider a special class of MGGA functionals (rung $2.9$ in Fig.~\ref{fig:Jacob-rev}) that we call factorable MGGAs (FMGGAs)
\begin{equation}
\exsFMGGA(\rs,\xs,\as) = \exsLDA(\rs) \FxFMGGA(\xs,\as),
\end{equation}
where the enhancement factor is written as
\begin{equation}
\FxFMGGA(x,\alpha) = \FxGGA(x) \FxGLDA(\alpha).
\end{equation}
By construction, $\FxFMGGA$ fulfills Eq.~\eqref{eq:limMGGA} and the additional physical limits
\begin{subequations}
\begin{align}
\lim_{x \to 0} \FxFMGGA(x,\alpha) & = \FxGLDA(\alpha),
\\
\lim_{\alpha \to 1} \FxFMGGA(x,\alpha) & = \FxGGA(x).
\end{align}
\end{subequations}
The MVS functional designed by Sun, Perdew and Ruzsinszky is an example of FMGGA functional \cite{MVS}.
Unless otherwise stated, all calculations have been performed self-consistently with a development version of the Q-Chem4.4 package \cite{qchem4} using the aug-cc-pVTZ basis set \cite{Dunning89, Kendall92, Woon93, Woon94, Woon95, Peterson02}.
To remove quadrature errors, we have used a very large quadrature grids consisting of 100 radial points (Euler-MacLaurin quadrature) and 590 angular points (Lebedev quadrature).
As a benchmark, we have calculated the (exact) unrestricted HF (UHF) exchange energies.
%****************************************************************
\subsection{GLDA exchange functionals}
%****************************************************************
As stated in the previous section, the orbitals for an electron on a 3-sphere of unit radius are the normalised hyperspherical harmonics $Y_{\ell\mu}$, where $\ell$ is the principal quantum number and $\mu$ is a composite index of the remaining two quantum numbers \cite{Avery, Avery93}.
We confine our attention to ferromagnetic (i.e.~spin-polarised) systems in which each orbital with $\ell = 0, 1, \ldots , L_{\sigma}$ is occupied by one spin-up or spin-down electron.
As mentioned in the previous section, this yields an electron density that is uniform over the surface of the sphere.
Note that the present paradigm is equivalent to the jellium model \cite{WIREs16} for $L_{\sigma} \to \infty$.
We refer the reader to Ref.~\cite{Glomium11} for more details about this paradigm.
The number of spin-$\sigma$ electrons is
\begin{equation}
\ns = \frac{1}{3} (\Ls+1)(\Ls+3/2)(\Ls+2),
\end{equation}
and their one-electron uniform density around the 3-sphere is
\begin{equation}
\rs = \frac{\ns}{V} = \frac{(\Ls+2)(\Ls+3/2)(\Ls+1)}{6 \pi^2 R^3},
\end{equation}
where $V = 2 \pi^2 R^3$ is the surface of a 3-sphere of radius $R$.
Moreover, using Eq.~\eqref{eq:eta-def}, one can easily derive that \cite{gLDA14, Wirium14}
\begin{equation}
\label{eq:alpha}
\as = \frac{\Ls(\Ls+3)}{\qty[ (\Ls+1)(\Ls+3/2)(\Ls+2) ]^{2/3}},
\end{equation}
which yields
\begin{align}
\lim_{\ns \to 1 } \as & = 0,
&
\lim_{\ns \to \infty } \as & = 1.
\end{align}
We recover the results that $\alpha = 0$ in a one-electron system (here a one-electron FUEG), and that $\alpha = 1$ in the IUEG.
In particular, we have shown that the exchange energy of these systems can be written as \cite{Glomium11, Jellook12}
\begin{equation}
\label{eq:Ex}
E_{\text{x},\sigma}(\Ls) = \Cx(\Ls) \int \rs^{4/3} d\bm{r}.
\end{equation}
where
\begin{equation}
\label{eq:CxGLDA}
\Cx(L)
= \CxLDA \frac{\frac{1}{2} \qty( L+\frac{5}{4}) \qty(L+\frac{7}{4}) \qty[\frac{1}{2} H_{2 L+\frac{5}{2}} + \ln 2]
+ \qty(L+\frac{3}{2})^2 \qty(L^2+3 L+\frac{13}{8})}
{\qty[(L+1) \qty(L+\frac{3}{2}) (L+2)]^{4/3}}
\end{equation}
and $H_{k}$ is an harmonic number \cite{NISTbook}.
Therefore, thanks to the one-to-one mapping between $\Ls$ and $\as$ evidenced by Eq.~\eqref{eq:alpha}, we have created the \gX~functional
\begin{equation}
\label{eq:FxGLDA}
\FxgX(\alpha) = \frac{\CxGLDA(0)}{\CxGLDA(1)}
\\
+ \alpha \frac{c_0+c_1\,\alpha}{1+(c_0+c_1-1)\alpha} \qty[ 1 - \frac{\CxGLDA(0)}{\CxGLDA(1)} ],
\end{equation}
where $c_0 = +0.827 411$, $c_1 = -0.643 560$, and
\begin{align}
\CxGLDA(1) & = \CxLDA = - \frac{3}{2} \qty( \frac{3}{4\pi} )^{1/3},
\\
\CxGLDA(0) & = -\frac{4}{3} \qty(\frac{2}{\pi})^{1/3}.
\end{align}
The parameters $c_0$ and $c_1$ of the \gX~enhancement factor \eqref{eq:FxGLDA} have been obtained by fitting the exchange energies of these FUEGs for $ 1 \le L \le 10$ given by Eq.~\eqref{eq:Ex}.
$\FxgX$ automatically fulfils the constraint given by Eq.~\eqref{eq:limGLDA}.
Moreover, because $ 1\le \FxgX \le 1.233$, it breaks only slightly the tight Lieb-Oxford bound \cite{Lieb81, Chan99, Odashima09} $\Fx < 1.174$ derived by Perdew and coworkers for two-electron systems \cite{Perdew14, Sun16a}.
This is probably due to the non-zero curvature of these FUEGs.
Albeit very simple, the functional form \eqref{eq:FxGLDA} is an excellent fit to Eq.~\eqref{eq:CxGLDA}.
In particular, $\FxgX$ is linear in $\alpha$ for small $\alpha$, which is in agreement with Eq.~\eqref{eq:CxGLDA} \cite{Glomium11}.
Also, Eq.~\eqref{eq:CxGLDA} should have an infinite derivative at $\alpha=1$ and approached as $\sqrt{1-\alpha} \ln(1-\alpha)$.
Equation \eqref{eq:FxGLDA} does not behave that way.
However, it has a marginal impact on the numerical results.
As one can see in Fig.~\ref{fig:FxGLDA}, albeit being created with FUEGs, the \gX~functional has a fairly similar form to the common MGGA functionals, such as MS0 \cite{MS0}, MS1 \cite{MS1_MS2}, MS2 \cite{MS1_MS2}, MVS \cite{MVS}, and SCAN \cite{SCAN} for $ 0 \le \alpha \le 1$.
This is good news for DFT as it shows that we recover functionals with similar physics independently of the paradigm used to design them.
However, around $\alpha \approx 1$, the behaviour of $\FxgX$ is very different from other MGGAs (except for MVS) due to the constraint of the second-order gradient expansion (which is not satisfied in our case) \cite{Ma68}.
For $ 0 \le \alpha \le 1$, it is also instructive to note that the \gX~functional is an upper bound of all the MGGA functionals.
Taking into account the inhomogeneity of the system via the introduction of $x$ should have the effect of decreasing the MGGA enhancement factor (at least for $0 \le \alpha \le 1$).
Unlike other functionals, we follow a rather different approach and guide our functional between $\alpha=0$ and $1$ using FUEGs.
For example, the MS0 functional uses the exact exchange energies of non-interacting hydrogenic anions to construct the functional from $\alpha = 0$ to $1$ \cite{Staroverov04, MS0}, while revTPSS has no constraint to guide itself for this range of $\alpha$ \cite{revTPSS}.
Nonetheless, because these uniform systems only give valuable information in the range $0 \le \alpha \le 1$, we must find a different way to guide our functional for $\alpha > 1$.\footnote{Except for one- and two-electron systems, any atomic and molecular systems has region of space with $\alpha_\sigma > 1$, as discussed in details by Sun et al.\cite{Sun13a}}
To do so, we have extended the \gX~functional beyond $\alpha = 1$ using a simple one-parameter extrapolation:
\begin{equation}
\label{eq:FxGMVS}
\FxGX(\alpha) =
\begin{cases}
\FxgX(\alpha), & 0 \le \alpha \le 1,
\\
1 + (1-\alpha_\infty) \frac{1-\alpha}{1+\alpha}, & \alpha > 1,
\end{cases}
\end{equation}
where $\alpha_\infty$ is an adjustable parameter governing the value of $\FxGX$ when $\alpha \to \infty$.
For large $\alpha$, $\FxGX$ converges to $\alpha_\infty$ as $\alpha^{-1}$, similarly to the MVS functional \cite{MVS}.
Far from claiming that this choice is optimal, we have found that the simple functional form \eqref{eq:FxGMVS} for $\alpha > 1$ yields satisfactory results (see below).
%%% FIG 2 %%%
\begin{figure*}
\centering
\includegraphics[width=0.4\linewidth]{../Chapter3/fig/fig2a}
\includegraphics[width=0.4\linewidth]{../Chapter3/fig/fig2b}
\caption{
\label{fig:FxGLDA}
Enhancement factors $\FxGLDA(\alpha)$ or $\FxMGGA(x=0,\alpha)$ as a function of $\alpha$ for various GLDA and MGGA exchange functionals.
The TPSS functional is represented as a dot-dashed line, the MS family of functionals (MS0, MS1 and MS2) are represented as dashed lines, while the MVS and SCAN functionals are depicted with solid lines.
The new functionals \gX~and \PBEGX~are represented with thick black lines.
Note that $\FxgX(\alpha) = \FxPBEGX(0,\alpha)$ for $ 0 \le \alpha \le 1$.
For $\FxPBEGX$, $\alpha_\infty = +0.852$.}
\end{figure*}
%%% %%%
Following the seminal work of Sham \cite{Sham71} and Kleinman \cite{Kleinman84, Antoniewicz85, Kleinman88} (see also Ref.~\cite{Svendsen96}), it is also possible, using linear response theory, to derive a second-order gradient-corrected functional.
However, it does not provide any information for $\alpha >1$.
The performance of the \GX~functional is illustrated in Table \ref{tab:atoms}.
Although \GX~is an improvement compared to LDA, even for one- and two-electron systems, we observe that the \GX~functional cannot compete with GGAs and MGGAs in terms of accuracy.
%%% TABLE 1 %%%
\begin{table*}
\centering
\caption{
\label{tab:atoms}
Reduced (i.e.~per electron) mean error (ME) and mean absolute error (MAE) (in kcal/mol) of the error (compared to UHF) in the exchange energy of the hydrogen-like ions, helium-like ions and first 18 neutral atoms for various LDA, GGA, GLDA, FMGGA and MGGA functionals.
For the hydrogen-like ions, the exact density has been used for all calculations.}
\begin{tabular}{llcccccc}
\hline
& & \mc{2}{c}{hydrogen-like ions} & \mc{2}{c}{helium-like ions} & \mc{2}{c}{neutral atoms} \\
\cline{3-4} \cline{5-6} \cline{7-8}
& & ME & MAE & ME & MAE & ME & MAE \\
\hline
LDA & D30 & $153.5$ & $69.7$ & $150.6$ & $69.5$ & $70.3$ & $9.1$ \\
GGA & B88 & $9.5$ & $4.3$ & $9.3$ & $4.7$ & $2.8$ & $0.5$ \\
& G96 & $4.4$ & $2.0$ & $4.4$ & $2.2$ & $2.1$ & $0.5$ \\
& PW91 & $19.4$ & $8.8$ & $19.1$ & $9.3$ & $4.5$ & $0.8$ \\
& PBE & $22.6$ & $10.3$ & $22.3$ & $10.7$ & $7.4$ & $0.6$ \\
GLDA & \GX & $61.8$ & $123.5$ & $61.0$ & $122.0$ & --- & --- \\
FMGGA & MVS & $0.0$ & $0.0$ & $0.3$ & $0.2$ & $2.7$ & $0.9$ \\
& \PBEGX & $0.0$ & $0.0$ & $0.7$ & $0.4$ & $1.0$ & $1.1$ \\
MGGA & M06-L & $44.4$ & $88.8$ & $12.0$ & $24.0$ & $4.2$ & $2.9$ \\
& TPSS & $0.0$ & $0.0$ & $0.7$ & $0.4$ & $0.7$ & $1.1$ \\
& revTPSS & $0.0$ & $0.0$ & $0.5$ & $0.3$ & $3.5$ & $2.5$ \\
& MS0 & $0.0$ & $0.0$ & $0.4$ & $0.2$ & $1.3$ & $2.4$ \\
& SCAN & $0.0$ & $0.0$ & $0.3$ & $0.2$ & $1.2$ & $1.6$ \\
\hline
\end{tabular}
\end{table*}
%%%
%****************************************************************
\subsection{FMGGA exchange functionals}
%****************************************************************
One of the problem of GLDA functionals is that they cannot discriminate between homogeneous and inhomogeneous one-electron systems, for which we have $\alpha = 0$ independently of the value of the reduced gradient $x$.
For example, the \GX~functional is exact for one-electron FUEGs, while it is inaccurate for the hydrogen-like ions.
Unfortunately, it is mathematically impossible to design a GLDA functional exact for these two types of one-electron systems.
To cure this problem, we couple the \GX~functional designed above with a GGA enhancement factor to create a FMGGA functional.
We have chosen a PBE-like GGA factor, i.e.
\begin{equation}
\FxPBEGX(x,\alpha) =\Fx^\text{PBE}(x) \FxGX(\alpha),
\end{equation}
where
\begin{equation}
\label{eq:FxPBEGX}
\Fx^\text{PBE}(x) = \frac{1}{1+\mu\,x^2}.
\end{equation}
Similarly to various MGGAs (such as TPSS \cite{TPSS}, MVS \cite{MVS}, or SCAN \cite{SCAN}), we use the hydrogen atom as a ``norm'', and determine that $\mu = +0.001 015 549$ reproduces the exact exchange energy of the ground state of the hydrogen atom.
Also, we have found that $\alpha_\infty = +0.852$ yields excellent exchange energies for the first 18 neutral atoms.
Unlike \GX, \PBEGX~is accurate for both the (inhomogeneous) hydrogen-like ions and the (homogeneous) one-electron FUEGs, and fulfils the negativity constraint and uniform density scaling \cite{SCAN, Perdew16}.
The right graph of Fig.~\ref{fig:FxGLDA} shows the behaviour of the MGGA enhancement factor for $x = 0$ as a function of $\alpha$.
Looking at the curves for $\alpha > 1$, we observe that TPSS has a peculiar enhancement factor which slowly raises as $\alpha$ increases.
All the other functionals (including \PBEGX) decay more or less rapidly with $\alpha$.
We note that \PBEGX~and MVS behave similarly for $\alpha > 1$, though their functional form is different.
%%% FIG 3 %%%
\begin{figure}
\centering
\includegraphics[width=0.6\linewidth]{../Chapter3/fig/fig3}
\caption{
\label{fig:FxGGA}
Enhancement factors $\FxGGA(x)$ or $\FxMGGA(x,\alpha=1)$ as a function of $x$ for various GGA, FMGGA and MGGA exchange functionals.
The GGA functionals are represented in solid lines, while MGGAs are depicted in dashed lines.
The new functional \PBEGX~is represented with a thick black line.}
\end{figure}
%%% %%%
Figure \ref{fig:FxGGA} evidences a fundamental difference between GGAs and MGGAs: while the enhancement factor of conventional GGAs does increase monotonically with $x$ and favour inhomogeneous electron densities, $\FxMGGA$ decays monotonically with respect to $x$.
This is a well-known fact: the $x$- and $\alpha$-dependence are strongly coupled, as suggested by the relationship \eqref{eq:eta-def}.
Therefore, the $x$-dependence can be sacrificed if the $\alpha$-dependence is enhanced \cite{MS0, MVS, SCAN}.
Similarly to $\FxPBEGX$, $\Fx^\text{MVS}$ and $\Fx^\text{SCAN}$ decay monotonically with $x$ (although not as fast as \PBEGX), while earlier MGGAs such as TPSS and MS0 have a slowly-increasing enhancement factor.
We have observed that one needs to use a bounded enhancement factor at large $x$ (as in Eq.~\eqref{eq:FxPBEGX}) in order to be able to converge self-consistent field (SCF) calculations.
Indeed, using an unbounded enhancement factor (as in B88 \cite{B88} or G96 \cite{G96}) yields divergent SCF KS calculations.
Finally, we note that, unlike TPSS, \PBEGX~does not suffer from the order of limits problem \cite{regTPSS}.
%%% TABLE 2 %%%
\begin{table}
\centering
\caption{
\label{tab:molecules}
Reduced (i.e.~per electron) mean error (ME) and mean absolute error (MAE) (in kcal/mol) of the error (compared to the experimental value) in the atomisation energy ($E_\text{atoms} - E_\text{molecule}$) of diatomic molecules at experimental geometry for various LDA, GGA and MGGA exchange-correlation functionals.
Experimental geometries are taken from Ref.~\cite{HerzbergBook}.}
\begin{tabular}{lllcc}
\hline
& \mc{2}{c}{functional} & \mc{2}{c}{diatomics} \\
\cline{2-3} \cline{4-5}
& exchange & correlation & ME & MAE \\
\hline
LDA & D30 & VWN5 & $1.8$ & $3.7$ \\
GGA & B88 & LYP & $0.6$ & $1.2$ \\
& PBE & PBE & $0.7$ & $1.2$ \\
MGGA & M06-L & M06-L & $0.4$ & $0.7$ \\
& TPSS & TPSS & $0.6$ & $1.1$ \\
& revTPSS & revTPSS & $0.6$ & $1.2$ \\
& MVS & regTPSS & $0.5$ & $0.9$ \\
& SCAN & SCAN & $0.4$ & $0.7$ \\
& \PBEGX & PBE & $0.6$ & $1.2$ \\
& \PBEGX & regTPSS & $0.6$ & $1.1$ \\
& \PBEGX & LYP & $0.6$ & $1.1$ \\
& \PBEGX & TPSS & $0.7$ & $1.3$ \\
& \PBEGX & revTPSS & $0.8$ & $1.5$ \\
& \PBEGX & SCAN & $0.6$ & $1.0$ \\
\hline
\end{tabular}
\end{table}
%%%
%%% FIG 4 %%%
\begin{figure}
\centering
\includegraphics[width=0.6\linewidth]{../Chapter3/fig/fig4}
\caption{
\label{fig:error}
Reduced (i.e.~per electron) error (in kcal/mol) in atomic exchange energies of the first 18 neutral atoms of the periodic table for the B88 (red), TPSS (blue), MVS (orange), SCAN (purple) and \PBEGX~(thick black) functionals.}
\end{figure}
%%% %%%
How good are FMGGAs?
This is the question we would like to answer here.
In other word, we would like to know whether or not our new simple FMGGA functional called \PBEGX~is competitive within MGGAs.
Unlike GGAs and some of the MGGAs (like M06-L), by construction, \PBEGX~reproduces exactly the exchange energy of the hydrogen atom and the hydrogenic ions (\ce{He^+}, \ce{Li^2+}, \ldots) due to its dimensional consistency (see Table \ref{tab:atoms}).
\PBEGX~also reduces the error for the helium-like ions (\ce{H^-}, \ce{He}, \ce{Li^+}, \ldots) by one order of magnitude compared to GGAs, and matches the accuracy of MGGAs.
For the first 18 neutral atoms (Table \ref{tab:atoms} and Fig.~\ref{fig:error}), \PBEGX~is as accurate as conventional MGGAs with a mean error (ME) and mean absolute error (MAE) of $1.0$ and $1.1$ kcal/mol.
From the more conventional MGGAs, the TPSS and SCAN functionals are the best performers for neutral atoms with MEs of $0.7$ and $1.2$ kcal/mol, and MAEs of $1.1$ and $1.6$ kcal/mol.
\PBEGX~lies just in-between these two MGGAs.
We now turn our attention to diatomic molecules for which errors in the atomisation energy ($E_\text{atoms} - E_\text{molecule}$) are reported in Table \ref{tab:molecules} for various combinations of exchange and correlation functionals.
In particular, we have coupled our new \PBEGX~exchange functional with the PBE \cite{PBE}, regTPSS \cite{regTPSS} (also called vPBEc) and LYP \cite{LYP} GGA correlation functionals, as well as the TPSS, \cite{TPSS} revTPSS \cite{revTPSS} and SCAN \cite{SCAN} MGGA correlation functionals.
Although very lightly parametrised on atoms, \PBEGX~is also accurate for molecules.
Interestingly, the results are mostly independent of the choice of the correlation functional with MEs ranging from $0.6$ and $0.8$ kcal/mol, and MAEs from $1.0$ and $1.5$ kcal/mol.
\PBEGX~is only slightly outperformed by the SCAN functional and the highly-parametrized M06-L functional, which have both a ME of $0.4$ kcal/mol and a MAE of $0.7$ kcal/mol.

Binary file not shown.

Binary file not shown.

Binary file not shown.

Binary file not shown.

Binary file not shown.

Binary file not shown.

Binary file not shown.

Binary file not shown.

Binary file not shown.

View File

@ -0,0 +1,10 @@
%****************************************************************
\section{Summary}
%****************************************************************
In the first section, we have shown that uniform electron gases (UEGs) on a $D$-sphere are an attractive generalisation of $D$-jellium.
However, although it is pleasing to know that the spherical and conventional gases become equivalent in the thermodynamic limit, we believe that it is more important to recognise that they are \emph{not} equivalent for finite number of electrons.
This has immediate chemical ramifications, suggesting that the traditional jellium paradigm is suboptimal for modelling molecular densities, even in regions of space where the density is nearly uniform.
In the second section, using \textit{finite} UEGs (FUEGs), we have created a \textit{generalized} LDA (GLDA) exchange functional which only depends on the curvature of the Fermi hole $\alpha$.
We have also combined our newly-designed GLDA functional with a PBE-type GGA functional to create a new type of MGGAs that we have called \textit{factorizable} MGGAs (FMGGAs).

View File

@ -0,0 +1,13 @@
The time-independent electronic Schr\"odinger equation \eqref{eq:time-independent-schrodinger-equation} is the starting point for a fundamental understanding of the behaviour of electrons and, thence, of chemical structure, bonding and reactivity.
Indeed, the past 80 years have provided overwhelming evidence that, as Dirac observed in the early days of the quantum mechanical revolution \cite{Dirac29},
\begin{quote}
\textit{``the underlying physical laws necessary for the mathematical theory of a large part of physics and the whole of chemistry are thus completely known, and the difficulty is only that the exact application of these laws leads to equations much too complicated to be soluble.''}
\end{quote}
Contemporary quantum chemistry has developed in two directions: wave function-based models \cite{Helgaker} and density-based models \cite{ParrYang}.
Both spring from the Schr\"odinger equation but each reformulates this second-order partial differential equation in terms of integrals.
For this reason, it is no exaggeration to say that the mathematical operation of integration lies at the heart of the field.
If integration of functions were a trivial task, quantum chemistry would be likewise trivialised.
But, it is not.

View File

@ -0,0 +1,91 @@
%****************************************************************
\section{History}
%****************************************************************
It is well known that highly-accurate wave functions require the fulfilment (or near-fulfilment) of the electron-electron cusp conditions \cite{Kato51, Kato57, Pack66, Morgan93, Myers91, Tew08, QuasiExact09, ExSpherium10, QR12, Kurokawa13, Kurokawa14, Gruneis17}.
For correlated wave functions expanded in terms of products of one-electron Gaussian basis functions, the energy converges as $\order{L^{-3}}$, where $L$ is the maximum angular momentum of the basis set \cite{Kutzelnigg85}.
This slow convergence can be tracked down to the inadequacy of these products to properly model the Coulomb correlation hole \cite{Hattig12, Kong12}.
In the late 20's, Hylleraas solved this issue for the helium atom by introducing explicitly the interelectronic distance $\ree = \abs{\br_1 - \br_2}$ as an additional two-electron basis function \cite{Hylleraas28, Hylleraas29}.
As Kutzelnigg later showed, this leads to a prominent improvement of the energy convergence from $\order{L^{-3}}$ to $\order{L^{-7}}$ \cite{Kutzelnigg85}.
Around the same time, Slater, while studying the Rydberg series of helium \cite{Slater28}, suggested a new correlation factor known nowadays as a Slater geminal:
\begin{equation}
S_{12} = \exp(-\lambda_{12}\, \ree ).
\end{equation}
Unfortunately, the increase in mathematical complexity brought by $\ree$ or $S_{12}$ has been found to be rapidly computationally overwhelming.\footnote{Note that, although Slater was the first to propose such correlation factor, he suggested to set $\lambda_{12} = -1/2$ in order to ensure that the wave function fulfils Kato's electron-electron cusp condition. However, Hartree and Ingman \cite{Hartree33} found this correlation factor physically unreasonable due to its behaviour at large $\ree$, and suggested that a correlation factor of the form $1 - c \exp(-\lambda_{12}\, \ree)$ (with $\lambda_{12} >0$) would be more appropriate. We refer the interested reader to the review of Hattig et al.~\cite{Hattig12} for a detailed historical overview.}
In 1960, Boys \cite{Boys60} and Singer \cite{Singer60} independently proposed to use the Gaussian geminal (GG) correlation factor
\begin{equation}
\label{eq:gg}
G_{12} = \exp(-\lambda_{12}\, \ree^2 ),
\end{equation}
as \cite{Boys60}
\begin{quote}
``\textit{there are explicit formulas for all of the necessary many-dimensional integrals}".
\end{quote}
Interestingly, in the same article, a visionary Boys argued that, even if GGs do not fulfil the electron-electron cusp conditions, they could be used to fit $S_{12}$.
During the following years, variational calculations involving GGs flourished, giving birth to various methods, such as the exponentially-correlated Gaussian method \cite{RychBook, Bubin2005, Bubin2009, Szalewicz2010}.
However, this method was restricted to fairly small systems as it requires the optimisation of a large number of non-linear parameters.
In the 70's, the first MP2 calculations including GGs appeared thanks to the work by Pan and King \cite{Pan70, Pan72}, Adamowicz and Sadlej \cite{Adamowicz77a, Adamowicz77b, Adamowicz78}, and later Szalewicz \textit{et al.} \cite{Szalewicz82, Szalewicz83}.
Even if these methods represented a substantial step forward in terms of computational burden, they still require the optimization of a large number of non-linear parameters.
In 1985, Kutzelnigg derived a first form of the MP2-R12 equations using $\ree$ as a correlation factor \cite{Kutzelnigg85}.
Kutzelnigg's idea, which was more formally described together with Klopper in 1987 \cite{Klopper87}, dredged up an old problem: in addition to two-electron integrals (traditional ones and new ones), three-electron and four-electron integrals were required.
At that time, the only way to evaluate them would have been via an expensive one- or two-dimensional Gauss-Legendre quadrature \cite{Preiskorn85, Clementi89}.
Additionally, citing Kutzelnigg and Klopper \cite{Kutzelnigg91},
\begin{quote}
\textit{``even if fast procedures for the evaluation of these integrals were available, one would have to face the problem of the large number of these integrals; while that of two-electron integrals is $\sim N^{4}$, there are $\sim N^{6}$ three-electron and $\sim N^{8}$ four-electron integrals.
The storing and manipulating of these integrals could be handled only for extremely small basis sets.''}
\end{quote}
Undoubtedly, in the late 80's, the two-electron integrals technology was still in development \cite{MD78, PH78, King76, Dupuis76, Rys83, OS1, HGP, Gill94b}.
Nowadays, though still challenging, these integrals could be computed much more effectively via judicious recursive schemes, designing the quadrature only to the fundamental integrals \cite{3ERI1}.
Another important remark is that the actual number of \textit{significant} (i.e.~greater than a given threshold) three- and four-electron integrals in a large system, is, at worst, $\order{N^{3}}$ or $\order{N^{4}}$.
These kinds of scaling are achievable, for example, by exploiting robust density fitting \cite{Womack14} or upper bound-based screening methods, as discussed below \cite{3ERI2}.
Nevertheless, the success of the R12 method was triggered by the decision to avoid the computation of these three- and four-electron integrals through the use of the \textit{resolution of the identity} (RI) approximation \cite{Kutzelnigg91, Hattig12, Werner07}.
In this way, three- and four-electron integrals are approximated as linear combinations of products of two-electron integrals.
Several key developments and improvements of the original MP2-R12 approach have been proposed in the last decade \cite{MOLPRO2011, Hattig12, Werner07, Kong12}.
Of course, the accuracy of the RI approximation relies entirely on the assumption that the auxiliary basis set is sufficiently large, i.e.~$N_\text{RI} \gg N$, where $N$ and $N_\text{RI}$ are the number of basis functions in the primary and auxiliary basis sets, respectively.
The use of RI as method of choice does not seem definitive to us.
In fact, eschewing the RI approximation would offer at least two advantages:
i) smaller one-electron basis as the larger auxiliary basis set would not be required anymore;
ii) the three- and four-electron integrals would be computed exactly.
Moreover, one could avoid the commutator rearrangements involved in the computation of integrals over the kinetic energy operator \cite{Rohse93}.
In 1996, Persson and Taylor killed two birds with one stone.
Using a pre-optimized GG expansion fitting $\ree$
\begin{equation}
\label{eq:r12fit}
\ree \approx \sum_{k} a_{k} \qty[1-\exp(-\lambda_{k} \ree^{2}) ],
\end{equation}
they avoided the non-linear optimisation, and eschewed the RI approximation thanks to the analytical integrability of three- and four-electron integrals over GGs \cite{Persson96}.
They were able to show that a six- or ten-term fit introduces a $0.5$ mE$_\text{h}$ or $20$ $\mu$E$_\text{h}$ error, respectively \cite{Persson96}.
Unfortunately, further improvements were unsuccessful due to the failure of $\ree$ in modelling the correct behaviour of the wave function for intermediate and large $\ree$ \cite{Tew05, Tew06}.
In fact, Ten-no showed that $S_{12}$ is near-optimal at describing the correlation hole, and that a 10-term GG fit of $S_{12}$ yields very similar results.
This suggests that, albeit not catching the cusp per se, the Coulomb correlation hole can be accurately represented by GGs \cite{Tenno04a, Tenno07, May04, May05}.
Methods for evaluating many-electron integrals involving GGs have already been developed.
As mentioned previously, Persson and Taylor \cite{Persson97} derived recurrence relations based on Hermite Gaussians, analogously to the work of McMurchie and Davidson for two-electron integrals \cite{MD78}.
These recurrence relations were implemented by Dahle \cite{DahleThesis, Dahle2007, Dahle2008}.
Saito and Suzuki \cite{Saito01} also proposed an approach based on the work by Obara and Saika \cite{OS1, OS2}.
More recently, a general formulation using Rys polynomials \cite{King76, Dupuis76, Rys83} was published by Komornicki and King \cite{Komornicki11}.
Even if limited to the three-centre case, it is worth mentioning that May has also developed recurrence relations for two types of three-electron integrals \cite{MayThesis}.
These recurrence relations were implemented by Womack using automatically-generated code \cite{WomackThesis}.
Recently, we have developed recurrence relations for three- and four-electron integrals for generic correlation factors \cite{3ERI1, 4ERI1}.
All these recursive schemes have variable computational cost depending on the degree of contraction of the integral class to be computed.
Unsurprisingly, these algorithms are, to a large extent, complementary, and none of the algorithms has proven optimal under all circumstances.
A major limitation of all these approaches is that they do not include any integral screening.
Indeed, a remarkable consequence of the short-range nature of the Slater and Gaussian correlation factors is that, even if formally scaling as $\order{N^{6}}$ and $\order{N^{8}}$, there are only $\order{N^{2}}$ \textit{significant} (i.e.~greater than a given threshold) three- and four-electron integrals in a large system \cite{3ERI1, 3ERI2}.
Therefore, it is paramount to devise rigorous upper bounds to avoid computing the large number of negligible integrals.
This chapter is organised as follows.
First, we discuss Gaussian basis functions, many-electron integrals and the structure of the three- and four-electron operators considered here.
In the next three sections, we introduce the main ingredients for the efficient computation of three- and four-electron integrals involving GGs: i) fundamental integrals (FIs), ii) upper bounds (UBs), and iii) recurrence relations (RRs).
Finally, we give an overall view of our algorithm which is an extension of the late-contraction path of PRISM, also known as the Head-Gordon-Pople (HGP) algorithm (see Refs.~\cite{HGP, Gill94b} and references therein).
Note that the HGP algorithm corresponds to the Obara-Saika scheme where one has introduced additional RRs and provides a precise description of how these RRs can be used in tandem to good effects.

View File

@ -0,0 +1,121 @@
%==================
\section{Generalities}
%==================
%==================
\subsection{
\label{sec:gaussian}
Gaussian functions}
%==================
A primitive Gaussian function (PGF) is specified by an orbital exponent $\alpha$, a center $\bA=(A_x,A_y,A_z)$, and angular momentum $\ba=(a_{x},a_{y},a_{z})$:
\begin{equation}
\label{eq:def1}
\varphi_{\ba}^{\bA}(\br)
= (x-A_{x})^{a_{x}} (y-A_{y})^{a_{y}} (z-A_{z})^{a_{z}} e^{-\alpha \abs{\br-\bA}^2}.
\end{equation}
A contracted Gaussian function (CGF) is defined as a sum of PGFs
\begin{equation}
\label{eq:def1b}
\psi_{\ba}^{\bA}(\br)
=\sum_{k=1}^{K_a} D_{ak} (x-A_{x})^{a_{x}} (y-A_{y})^{a_{y}} (z-A_{z})^{a_{z}} e^{-\alpha_k \abs{\br-\bA}^2},
\end{equation}
where $K_a$ is the degree of contraction and the $D_{ak}$ are contraction coefficients.
A CGF-pair
\begin{equation}
\label{eq:CGTO-pair}
\ket{\ba \bb} \equiv \psi_{\ba}^{\bA}(\br)\psi_{\bb}^{\bB}(\br) = \sum_{i=1}^{K_a} \sum_{j=1}^{K_b} \sket{\ba \bb}_{ij}
\end{equation}
is a two-fold sum of PGF-pairs $\sket{\ba \bb}=\varphi_{\ba}^{\bA}(\br) \varphi_{\bb}^{\bB}(\br)$.
A primitive shell $\sket{a}$ is a set of PGFs sharing the same total angular momentum $a$, exponent $\alpha$ and center $\bA$.
Similarly, a contracted shell $\ket{a}$ is a set of CGFs sharing the same PGFs and total angular momentum.
A contracted shell-pair is the set of CGF-pairs obtained by the tensor product $\ket{a b}=\ket{a} \otimes \ket{b}$.
Similarly, a primitive shell-pair $\sket{a b}=\sket{a} \otimes \sket{b}$ is the set of PGF-pairs.
Finally, primitive and contracted shell-quartets, -sextets and -octets are obtained in an analogous way.
For example, $\sket{a_1 b_1 a_2 b_2} = \sket{a_1 b_1} \otimes \sket{a_2 b_2}$ and $\ket{a_1 a_2 b_1 b_2} = \ket{a_1 b_1} \otimes \ket{a_2 b_2}$.
Note that $\sket{1}$ is a set of three $p$-type PGFs, a $\sket{11} \equiv \sket{pp}$ shell-pair is a set of nine PGF-pairs, and a $\sket{2222} \equiv \sket{dddd}$ shell-quartet is a set of $1,296$ PGF-quartets.
%==================
\subsection{
\label{sec:integrals}
Many-electron integrals}
%==================
Throughout this chapter, we use physicists notations, and we write the integral over a $n$-electron operator $f_{1 \cdots n}$ of CGFs as
%\begin{widetext}
\begin{equation}
\begin{split}
\label{eq:def2}
\braket{\ba_1 \cdots \ba_n}{\bb_1 \cdots \bb_n}
& \equiv \mel{\ba_1 \cdots \ba_n}{f_{1\cdots n}}{\bb_1 \cdots \bb_n}
\\
& = \idotsint
\psi_{\ba_1}^{\bA_1}( \br_{1}) \cdots \psi_{\ba_n}^{\bA_n}(\br_{n})
\,f_{1\cdots n}\,
\psi_{\bb_1}^{\bB_1}( \br_{1}) \cdots \psi_{\bb_n}^{\bB_n}(\br_{n})
d \br_{1} \cdots d \br_{n}.
\end{split}
\end{equation}
Additionally, square-bracketed integrals denote integrals over PGFs:
\begin{equation}
\label{eq:def2b}
\sbraket{\ba_1 \cdots \ba_n}{\bb_1 \cdots \bb_n}
= \idotsint
\varphi_{\ba_1}^{\bA_1}( \br_{1}) \cdots \varphi_{\ba_n}^{\bA_n}(\br_{n})
\,f_{1 \cdots n}\,
\varphi_{\bb_1}^{\bB_1}( \br_{1}) \cdots \varphi_{\bb_n}^{\bB_n}(\br_{n})
d \br_{1} \cdots d \br_{n}.
\end{equation}
The FIs (i.e.~the integral in which all $2n$ basis functions are $s$-type PGFs) is defined as $\sexpval{\bo} \equiv \sbraket{\bo \cdots \bo}{\bo \cdots \bo}$ with $\bo=(0,0,0)$.
The Gaussian product rule reduces it from $2n$ to $n$ centers:
\begin{equation}
\label{eq:def4}
\sexpval{\bo} =
\qty( \prod_{i=1}^n S_{i} )
\idotsint \varphi_{\bo}^{\bZ_1}(\br_{1}) \cdots \varphi_{\bo}^{\bZ_n}(\br_{n})
\,f_{1 \cdots n}\,d \br_{1} \cdots d \br_{n},
\end{equation}
%\end{widetext}
where
\begin{subequations}
\begin{align}
\zeta_i & = \alpha_i + \beta_i,
\\
\bZ_i & = \frac{\alpha_i \bA_i + \beta_i \bB_i}{\zeta_i},
\\
S_{i} & = \exp(-\frac{\alpha_i \beta_i}{\zeta_i} \abs{\bA_i\bB_i}^2),
\end{align}
\end{subequations}
and $\bA_i\bB_i = \bA_i - \bB_i$.
We also define the quantity $\bY_{ij} = \bZ_i - \bZ_j$ which will be used later on.
For conciseness, we will adopt a notation in which missing indices represent $s$-type Gaussians.
For example, $\sexpval{\ba_2\ba_3}$ is a shorthand for $\sbraket{\bo\ba_2\ba_3\bo}{\bo\bo\bo\bo}$.
We will also use unbold indices, e.g. $\sbraket{a_1a_2a_3a_4}{b_1b_2b_3b_4}$ to indicate a complete class of integrals from a shell-octet.
%==================
\subsection{
\label{sec:operators}
Three- and four-electron operators}
%==================
In this chapter, we are particularly interested in the ``master'' four-electron operator $C_{12}G_{13}G_{14}G_{23}G_{34}$ (where $C_{12} = \ree^{-1}$ is the Coulomb operator) because the three types of three-electron integrals and the three types of four-electron integrals that can be required in F12 calculations can be easily generated from it (see Fig.~\ref{fig:tree}).
These three types of three-electron integrals are composed by a single type of integrals over the cyclic operator $C_{12}G_{13}G_{23}$, and two types of integrals over the three-electron chain (or 3-chain) operators $C_{12}G_{23}$ and $G_{13}G_{23}$.
F12 calculations may also require three types of four-electron integrals: two types of integrals over the 4-chain operators $C_{12}G_{14}G_{23}$ and $C_{12}G_{13}G_{34}$, as well as one type over the trident operator $C_{12}G_{13}G_{14}$.
Explicitly-correlated methods also requires two-electron integrals.
However, their computation has been thoroughly studied in the literature \cite{Kutzelnigg91, Klopper92, Persson97, Klopper02, Manby03, Werner03, Klopper04, Tenno04a, Tenno04b, May05, Manby06, Tenno07, Komornicki11, Tenno12a, Tenno12b, Reine12, Kong12, Hattig12}.
Similarly, the nuclear attraction integrals can be easily obtained by taking the large-exponent limit of a $s$-type shell-pair.
Starting with the ``master'' operator $C_{12}G_{13}G_{14}G_{23}G_{34}$, one can easily obtain all the FIs as well as the RRs required to compute three- and four-electron integrals within F12 calculations.
This is illustrated in Fig.~\ref{fig:tree} where we have used a diagrammatic representation of the operators.
The number $N_\text{sig}$ of significant integrals in a large system with $N$ CGFs is also reported.
%%% FIGURE 1 %%%
\begin{figure}
\centering
\includegraphics[width=0.6\linewidth]{../Chapter4/fig/fig1}
\caption{
\label{fig:tree}
Diagrammatic representation of the three- and four-electron integrals required in F12 theory.
The number $N_\text{sig}$ of significant integrals in a large system with $N$ CGFs is also reported.}
\end{figure}
%%% %%%

View File

@ -0,0 +1,78 @@
%=====================
\section{
\label{sec:FI}
Fundamental integrals}
%=====================
Following Persson and Taylor \cite{Persson96}, the $\sexpval{\bo}^{\bm{m}}$ are derived starting from the momentumless integral \eqref{eq:def4} using the following Gaussian integral representation for the Coulomb operator
\begin{equation}
C_{12} = \frac{2}{\sqrt{\pi}} \int_0^\infty \exp(-u^2 \ree^2) du.
\end{equation}
After a lengthy derivation which is not presented here for the sake of simplicity, one can show that the closed-form expression of the FIs is
\begin{equation}
\label{eq:Fund0m}
\sexpval{\bo}^{m}
= \frac{2}{\sqrt{\pi}} \sexpval{\bo}_{G} \sqrt{\frac{\delta_0}{\delta_1-\delta_0}} \qty(\frac{\delta_1}{\delta_1-\delta_0} )^{m} F_m \qty[ \frac{ \delta_1 \qty( Y_1-Y_0 )}{\delta_1-\delta_0} ],
\end{equation}
where $m$ is an auxiliary index, $F_m(t)$ is the generalised Boys function, and
\begin{equation}
\label{eq:Fund0GGGG}
\sexpval{\bo}_{G}
= \qty( \prod_{i=1}^4 S_{i} ) \qty( \frac{\pi^4}{\delta_0} )^{3/2} \exp(-Y_0)
\end{equation}
is the FI of the ``pure'' GG operator $G_{13}G_{14}G_{23}G_{34}$ from which one can easily get the FI of the 3-chain operator $G_{13}G_{23}$ by setting $\la_{14} = \la_{34} = 0$.
While the FIs involving a Coulomb operator contain an auxiliary index $m$, the FIs over ``pure'' GG operators (like $G_{13}G_{23}$) do not, thanks to the factorisation properties of GGs \cite{GG16}.
This is a a major computational saving as the computation of these auxiliary integrals can take a significant fraction of the CPU time, even for two-electron integrals.
The various quantities required to compute \eqref{eq:Fund0m} are
\begin{equation}
\bm{\delta}_u
= \bm{\zeta} + \bm{\la}_u = \bm{\zeta} + \bG + u^2 \bC,
\end{equation}
where
\begin{subequations}
\begin{align}
\bm{\zeta} & =
\begin{pmatrix}
\zeta_1 & 0 & 0 & 0 \\
0 & \zeta_2 & 0 & 0 \\
0 & 0 & \zeta_3 & 0 \\
0 & 0 & 0 & \zeta_4 \\
\end{pmatrix},
\quad
\bC =
\begin{pmatrix}
1 & -1 & 0 & 0 \\
-1 & 1 & 0 & 0 \\
0 & 0 & 0 & 0 \\
0 & 0 & 0 & 0 \\
\end{pmatrix},
\\
\bG & =
\begin{pmatrix}
\la_{13}+\la_{14} & 0 & -\la_{13} & -\la_{14} \\
0 & \la_{23} & -\la_{23} & 0 \\
-\la_{13} & -\la_{23} & \la_{13}+\la_{23}+\la_{34} & -\la_{34} \\
-\la_{14} & 0 & -\la_{34} & \la_{14}+\la_{34} \\
\end{pmatrix},
\end{align}
\end{subequations}
and
\begin{subequations}
\begin{align}
\bm{\Delta}_u & = \bm{\zeta} \cdot \bm{\delta}_u^{-1} \cdot \bm{\zeta},
&
\bY^k & =
\begin{pmatrix}
0 & \bY_{12}^k & \bY_{13}^k & \bY_{14}^k \\
0 & 0 & \bY_{23}^k & \bY_{24}^k \\
0 & 0 & 0 & \bY_{34}^k \\
0 & 0 & 0 & 0 \\
\end{pmatrix},
\\
\delta_u & = \det(\bm{\delta}_u),
&
Y_u & = \Tr( \bm{\Delta}_u \cdot \bY^2).
\end{align}
\end{subequations}
The generalised Boys function $F_m(t)$ in Eq.~\eqref{eq:Fund0m} can be computed efficiently using well-established algorithms \cite{Gill91, Ishida96, Weiss15}.

View File

@ -0,0 +1,110 @@
%==============
\section{
\label{sec:UB}
Upper bounds}
%==============
In this section, instead of reporting the mathematical expressions of UBs (which can be found in Ref.~\cite{IntF12}), we present general concepts about UBs for three- and four-electron integrals.
We refer the interested reader to Refs.~\cite{Gill94a, GG16} for additional information about UBs.
As mentioned earlier in this chapter, computing $\order{N^{6}}$ or $\order{N^{8}}$ integrals in a large system would be extremely challenging, but it turns out that the number of \emph{significant} three- and four-electron integrals is, at worst, $\order{N^{3}}$ and $\order{N^{4}}$, respectively.
Moreover, if the correlation factor is a short-range operator (as in modern F12 methods \cite{Persson96, Persson97, May04, Tenno04a, Tenno04b, Tew05, May05}), it can be shown that the number drops to only $\order{N^{2}}$.
However, to exploit this fully, one must devise rigorous UBs and then use these to avoid computing vast numbers of negligible integrals.
If this can be achieved, it may enable large-scale F12 calculations without the need to introduce RI approximations.
From a general point of view, an effective UB should be:
\begin{itemize}
\item simple, i.e.~much cheaper than the true integral;
\item strong, i.e.~as close as possible to the true integral;
\item scaling-consistent, i.e.~$N_\text{sig} = \order{N_\text{UB}}$, where $N_\text{UB}$ is the number estimated by the UB.
\end{itemize}
Many two-electron integral UBs are known \cite{Power74, Ahlrichs74, Haser89, Horn91, Gill94a} but few satisfy all three requirements.
Moreover, to the best of our knowledge, the only three-electron integral UB that has been proposed is a simple application of the Cauchy-Schwartz inequality \cite{DahleThesis}.
To construct UBs, we will depend heavily on the absolute value inequality
\begin{equation}
\abs{ \int \phi(\br) d\br } \le \int \abs{\phi(\br)} d\br,
\end{equation}
and the H\"{o}lder inequality \cite{NISTbook}
\begin{equation}
\abs{ \int \phi_{1}(\br)\phi_{2}(\br) d\br } \le \qty[ \int \abs{\phi_{1}(\br)}^{p} d\br ]^{1/p} \qty[ \int \abs{\phi_{2}(\br)}^{q} d\br ]^{1/q} ,
\end{equation}
where $p^{-1}+q^{-1}=1$ and $p,q > 1$. H\"older yields the Cauchy-Schwartz inequality \cite{NISTbook} if one chooses $p=q=2$.
Note, however, that we eschewed bounds descending from the Cauchy-Schwartz inequality because they are usually weaker than ours \cite{Gill94a} and, for three-electron integrals, they are usually not simple.
%-----------------------------------------------------
\subsection{\label{sec:ib} Integral bounds}
%-----------------------------------------------------
An integral bound is a number that bounds \emph{a particular integral}. For example, the Cauchy-Schwartz inequality yields the well-known \cite{Ahlrichs74} two-electron integral bound
\begin{equation}
\abs{\sbraket{\ba_1\ba_2}{\bb_1\bb_2}} \le \sbraket{\ba_1\ba_1}{\bb_1\bb_1}^{1/2} \sbraket{\ba_2\ba_2}{\bb_2\bb_2}^{1/2} .
\end{equation}
If one has pre-computed and stored $\order{N^{2}}$ Cauchy-Schwartz factors $\sbraket{\ba_1\ba_1}{\bb_1\bb_1}$, these yield cheap upper bounds on $\order{N^{4}}$ two-electron integrals.
However, despite their attractive features, integral bounds are poorly suited to modern hardware and software.
Bounding every integral before deciding whether or not to compute its exact value places logical branches within inner loops and leads to slow code.
Moreover, using bounds to eliminate a few integrals from a class is incompatible with recursive methods for integral generation.
This leads naturally to a class strategy.
%----------------------------------------------------
\subsection{\label{sec:cb} Class bounds}
%----------------------------------------------------
A class bound is a number that bounds \emph{all the integrals in a class}.
These are particularly effective for large classes because, if the class bound is below $\tau$, a large number of integrals can be skipped on the basis of one test.
Spherical bounding Gaussians (SBGs) $\sba$, as introduced in Ref.~\cite{GG16, IntF12}, lead naturally to class bounds, for example,
\begin{equation} \label{eq:cb1}
\abs{\sbraket{a_1a_2}{b_1b_2}} \le \sbraket{\sba_{1} \sba_{2}}{\sbb_{1} \sbb_{2}}.
\end{equation}
Non-separable class bounds, such as \eqref{eq:cb1}, involve quantities that have the same asymptotic scaling as the integrals.
Such bounds are therefore always scaling-consistent.
Separable class bounds, such as the Cauchy-Schwartz bound derived from \eqref{eq:cb1}
\begin{equation} \label{eq:hb1}
\left| \sbraket{a_1a_2}{b_1b_2} \right| \le \sbraket{\sba_1\sba_1}{\sbb_1\sbb_1}^{1/2} \sbraket{\sba_2\sba_2}{\sbb_2\sbb_2}^{1/2}
\end{equation}
involve factors that may scale differently from the integrals themselves.
Such bounds may not be scaling-consistent.
A specific example may be helpful. The number of significant two-electron integrals over long-range and short-range operators is $\order{N^{2}}$ and $\order{N}$, respectively.
However, the separable bound \eqref{eq:hb1} predicts $\order{N^{2}}$ in both cases and is therefore scaling-inconsistent for short-range operators.
In situations when one cannot find a scaling-consistent separable bound, one should use a non-separable bound.
Note that bounding an entire class of integrals with a single UB is a particularly desirable feature, especially when dealing with three- or four-electron integrals where the size of a class can be extremely large.
For example, the simple $\sbraket{ppp}{ppp}$ and $\sbraket{pppp}{pppp}$ classes are made of 729 and 4,096 integrals!
%-----------------------------------------------------------------
\subsection{\label{sec:sb} Shell-$m$tuplet bounds}
%-----------------------------------------------------------------
A shell-$m$tuplet bound $B_m$ relies only on shell-$m$tuplet information, where $m$ is the shell multiplicity: shell-pair ($m=2$), shell-quartet ($m=4$), shell-sextet ($m=6$), etc.
If $B_m > \tau$, it indicates that the shell-$m$tuplet is significant, i.e.~it could yield significant integrals.
A shell-$m$tuplet bound is a class bound that depends only on the operator, the basis set and the shell multiplicity $m$, independent of the maximum shell multiplicity $n$ of the integrals.
It is also scaling-consistent at its specific shell-multiplet level.
%-----------------------------------------------------------------
\subsection{Screening algorithm}
%-----------------------------------------------------------------
Our screening algorithms are based on primitive, $[B_{m}]$, and contracted, $\expval{B_{m}}$, shell-$m$tuplet bounds.
Figure \ref{fig:scheme1} is a schematic representation of the overall screening scheme for contracted four-electron integrals.
First, we use a primitive shell-pair bound $\sexpval{B_2}$ to create a list of significant primitive shell-pairs.
For a given contracted shell-pair, if at least one of its primitive shell-pairs has survived, a contracted shell-pair bound $\expval{B_2}$ is used to decide whether or not this contracted shell-pair is worth keeping.
The second step consists in using a shell-quartet bound $\expval{B_4}$ to create a list of significant contracted shell-quartets by pairing the contracted shell-pairs with themselves.
Then, we combine the significant shell-quartets and shell-pairs, and a shell-sextet bound $\expval{B_6}$ identifies the significant contracted shell-sextets.
Finally, the shell-sextets are paired with the shell-pairs.
If the resulting shell-octet quantity is found to be significant, the contracted integral class $\braket{a_1a_2a_3a_4}{b_1b_2b_3b_4}$ must be computed via RRs, as discussed in the next section.
Following this strategy, the size of any shell-$m$tuplet list is, at worst, quadratic in a large system.
During the shell-pair screening, either a contracted or a primitive path is followed depending on the degree of contraction of the integral class $K_\text{tot}=\prod_{i=1}^{n} K_{a_{i}}K_{b_{i}}$.
If $K_\text{tot}>1$, the contracted path is enforced, otherwise the primitive path is followed.
This enables to adopt the more effective primitive bounds for primitive integral classes which are usually associated with medium and high angular momentum PGFs and, therefore, are more expensive to evaluate via RRs \cite{IntF12}.
The scheme for primitive four-electron integrals differs only by the use of primitive bounds instead of contracted ones.
The three-electron integrals screening scheme can be easily deduced from Fig.~\ref{fig:scheme1}.
%%% FIGURE 2 %%%
\begin{figure*}
\centering
\includegraphics[width=\linewidth]{../Chapter4/fig/fig2}
\caption{
\label{fig:scheme1}
Schematic representation of the screening algorithm used to compute contracted four-electron integrals.}
\end{figure*}
%%% %%%

View File

@ -0,0 +1,159 @@
%%%%%%%%%%%%%%%%%%%%%%%%%
\section{
\label{sec:RR}
Recurrence relations}
%%%%%%%%%%%%%%%%%%%%%%%%%
%%%%%%%%%%%%%%%%%%%%%%%%%
\subsection{
\label{sec:VRR}
Vertical recurrence relations}
%%%%%%%%%%%%%%%%%%%%%%%%%
Following Obara and Saika \cite{OS1, OS2}, vertical RRs (VRRs) are obtained by differentiation of Eq.~\eqref{eq:Fund0m} with respect to the centers coordinates \cite{Ahlrichs06, 3ERI1}.
For the integrals considered in this chapter, one can show that
\begin{equation}
\begin{split}
\label{eq:VRR}
\sexpval{\cdots \ba_i^+ \cdots}^{m}
& =
\qty( \bZ_i\bA_i - \DOp_i Y_0 ) \sexpval{\cdots \ba_i \cdots}^{m}
% \\
% &
- \qty( \DOp_i Y_1 - \DOp_i Y_0 ) \sexpval{\cdots \ba_i \cdots}^{m+1}
\\
& + \sum_{j=1}^n \ba_j \Bigg\{ \qty( \frac{\delta_{ij}}{2\zeta_i} - \DOp_{ij} Y_0 ) \sexpval{\cdots \ba_j^- \cdots}^{m}
% \\
% &
- \qty( \DOp_{ij} Y_1 - \DOp_{ij} Y_0 ) \sexpval{\cdots \ba_j^- \cdots}^{m+1} \Bigg\},
\end{split}
\end{equation}
where $\delta_{ij}$ is the Kronecker delta \cite{NISTbook},
\begin{align}
\DOp_i & = \frac{\nabla_{A_i}}{2\alpha_i},
&
\DOp_{ij} & = \DOp_i \DOp_j,
\end{align}
and
\begin{subequations}
\begin{align}
\DOp_i Y_u & = \Tr(\bm{\Delta}_u \cdot \DOp_i \bY^2),
&
(\DOp_i \bY^2)_{kl} & = \kappa_{ikl} (\bY)_{kl},
\\
\DOp_{ij} Y_u & = \Tr(\bm{\Delta}_u \cdot \DOp_{ij} \bY^2),
&
(\DOp_{ij} \bY^2)_{kl} & = \frac{\kappa_{ikl}\kappa_{jkl}}{2},
\end{align}
\end{subequations}
with
\begin{align}
\eps_{ij} & =
\begin{cases}
1, & \text{if $i \le j$},
\\
0, & \text{otherwise},
\end{cases}
&
\kappa_{ijk} & = \frac{\eps_{ij} \delta_{ki} - \delta_{ij} \eps_{ki} }{\zeta_i}.
\end{align}
One can easily derive VRRs for other three- and four-electron operators following the simple rules given in Fig.~\ref{fig:tree}.
The number of terms for each of these VRRs is reported in Table \ref{tab:RRcount} for various two-, three- and four-electron operators.
Note that for a pure GG operator, we have $m = 0$ and $Y_1 = Y_0$.
Therefore, Eq.~\eqref{eq:VRR} reduces to a simpler expression:
\begin{equation}
\label{eq:VRR-pure}
%\begin{split}
\sexpval{\cdots \ba_i^+ \cdots}
% &
= \qty( \bZ_i\bA_i - \DOp_i Y_0 ) \sexpval{\cdots \ba_i \cdots}
% \\
% &
+ \sum_{j=1}^n \ba_j \qty( \frac{\delta_{ij}}{2\zeta_i} - \DOp_{ij} Y_0 ) \sexpval{\cdots \ba_j^- \cdots}.
%\end{split}
\end{equation}
%%%%%%%%%%%%%%%%%%%%%%%%%
\subsection{
\label{sec:TRR}
Transfer recurrence relations}
%%%%%%%%%%%%%%%%%%%%%%%%%
Transfer RRs (TRRs) redistribute angular momentum between centres referring to different electrons \cite{3ERI1}.
Using the translational invariance, one can derive
\begin{equation}
\label{eq:TRR}
%\begin{split}
\sexpval{\cdots \ba_i^+ \cdots}
% &
= \sum_{j=1}^n \frac{\ba_j}{2\zeta_i } \sexpval{\cdots \ba_j^- \cdots}
- \sum_{j \neq i}^n \frac{\zeta_j}{\zeta_i } \sexpval{\cdots \ba_j^+ \cdots}
% \\
% &
- \frac{\sum_{j=1}^n \beta_j \bA_j \bB_j}{\zeta_i } \sexpval{\cdots \ba_j \cdots}.
%\end{split}
\end{equation}
Note that Eq.~\eqref{eq:TRR} can only be used to build up angular momentum on the last center.
Moreover, to increase the momentum by one unit on this last center, one must increase the momentum by the same amount on all the other centres (as evidenced by the second term in the right-hand side of \eqref{eq:TRR}).
Therefore, the TRR is computationally expensive for three- and four-electron integrals due to the large number of centres (see below).
As mentioned by Ahlrichs \cite{Ahlrichs06}, the TRR can be beneficial for very high angular momentum two-electron integral classes.
%===========================
\subsection{
\label{sec:HRR}
Horizontal recurrence relations}
%===========================
The so-called horizontal RRs (HRRs) enable to shift momentum between centres over the same electronic coordinate \cite{3ERI1}:
\begin{equation}
\label{eq:HRR}
%\begin{split}
\braket{\cdots \ba_i \cdots}{\cdots \bb_i^+ \cdots}
% &
= \braket{\cdots \ba_i^+ \cdots}{\cdots \bb_i \cdots}
% \\
% &
+ \bA_i \bB_i \braket{\cdots \ba_i \cdots}{\cdots \bb_i \cdots}.
%\end{split}
\end{equation}
Note that HRRs can be applied to contracted integrals because they are independent of the contraction coefficients and exponents.
%%% TABLE 1 %%%
\begin{table*}
\footnotesize
\centering
\caption{
\label{tab:RRcount}
Number of intermediates required to compute various integral classes for two-, three- and four-electron operators.
The path generating the minimum number of intermediates is highlighted in bold.
The number of terms in the RRs and the associated incremental center are also reported.}
\begin{tabular}{llllllcccc}
\hline
Integral & type & operator & path & number & centers & \mc{4}{c}{integral class} \\
\cline{7-10}
& & & & of terms & & $\sexpval{p \ldots p}$ & $\sexpval{d \ldots d}$ & $\sexpval{f \ldots f}$ & $\sexpval{g \ldots g}$ \\
\hline
two-electron & chain & $G_{12}$ & \bf VV & \bf (2,3) & ($\bA_2$,$\bA_1$) & \bf 3 & \bf 6 & \bf 10 & \bf 15 \\
& & & VT & (2,4) & ($\bA_2$,$\bA_1$) & 4 & 9 & 16 & 25 \\
& & $C_{12}$ & \bf VV & \bf (4,6) & ($\bA_2$,$\bA_1$) & \bf 4 & \bf 13 & \bf 25 & \bf 48 \\
& & & VT & (4,4) & ($\bA_2$,$\bA_1$) & 7 & 19 & 37 & 61 \\
three-electron & chain & $G_{13}G_{23}$ & \bf VVV & \bf (2,3,4) & ($\bA_3$,$\bA_2$,$\bA_1$) & \bf 5 & \bf 13 & \bf 26 & \bf 45 \\
& & & VVT & (2,3,6) & ($\bA_3$,$\bA_1$,$\bA_2$) & 8 & 25 & 56 & 105 \\
& & $C_{12}G_{23}$ & VVV & (4,5,7) & ($\bA_3$,$\bA_1$,$\bA_2$) & 11 & 39 & 96 & 195 \\
& & & \bf VVV & \bf (4,6,6) & ($\bA_3$,$\bA_2$,$\bA_1$) & \bf 10 & \bf 39 & \bf 96 & \bf 196 \\
& & & VVT & (4,5,6) & ($\bA_3$,$\bA_1$,$\bA_2$) & 16 & 66 & 173 & 359 \\
& & & VVT & (4,6,6) & ($\bA_3$,$\bA_2$,$\bA_1$) & 15 & 65 & 171 & 357 \\
& cyclic & $C_{12}G_{13}G_{23}$ & \bf VVV & \bf (4,6,8) & ($\bA_3$,$\bA_2$,$\bA_1$) & \bf 12 & \bf 46 & \bf 119 & \bf 250 \\
& & & VVT & (4,6,6) & ($\bA_3$,$\bA_2$,$\bA_1$) & 16 & 66 & 173 & 359 \\
four-electron & chain & $C_{12}G_{14}G_{23}$ & VVVV & (4,5,7,8) & ($\bA_4$,$\bA_3$,$\bA_2$,$\bA_1$) & 21 & 108 & 344 & 847 \\ & & & \bf VVVV & \bf (4,6,6,8) & ($\bA_4$,$\bA_1$,$\bA_3$,$\bA_2$) & \bf 19 & \bf 88 & \bf 260 & \bf 607 \\
& & & VVVT & (4,5,7,8) & ($\bA_4$,$\bA_3$,$\bA_2$,$\bA_1$) & 33 & 208 & 736 & 1,926 \\
& & & VVVT & (4,6,6,8) & ($\bA_4$,$\bA_1$,$\bA_3$,$\bA_2$) & 33 & 204 & 716 & 1,866 \\
& & $C_{12}G_{13}G_{34}$ & VVVV & (4,6,6,9) & ($\bA_4$,$\bA_3$,$\bA_2$,$\bA_1$) & 22 & 113 & 360 & 888 \\
& & & \bf VVVV & \bf (4,6,8,7) & ($\bA_4$,$\bA_3$,$\bA_1$,$\bA_2$) & \bf 20 & \bf 98 & \bf 302 & \bf 726 \\
& & & VVVT & (4,6,6,8) & ($\bA_4$,$\bA_3$,$\bA_2$,$\bA_1$) & 33 & 204 & 716 & 1,866 \\
& & & VVVT & (4,6,8,8) & ($\bA_4$,$\bA_3$,$\bA_1$,$\bA_2$) & 34 & 214 & 756 & 1,976 \\
& trident & $C_{12}G_{13} G_{14}$ & VVVV & (4,6,6,9) & ($\bA_4$,$\bA_3$,$\bA_2$,$\bA_1$) & 22 & 113 & 360 & 888 \\
& & & \bf VVVV & \bf (4,6,8,7) & ($\bA_4$,$\bA_3$,$\bA_1$,$\bA_2$) & \bf 20 & \bf 98 & \bf 302 & \bf 726 \\
& & & VVVT & (4,6,6,8) & ($\bA_4$,$\bA_3$,$\bA_2$,$\bA_1$) & 33 & 204 & 716 & 1,866 \\
& & & VVVT & (4,6,8,8) & ($\bA_4$,$\bA_3$,$\bA_1$,$\bA_2$) & 34 & 214 & 756 & 1,976 \\
\hline
\end{tabular}
\end{table*}
%%%

View File

@ -0,0 +1,68 @@
%==================
\section{
\label{sec:algorithm}
Algorithm}
%==================
In this section, we present our recursive algorithm for the computation of a class of three- or four-electron integrals of arbitrary angular momentum.
The present recursive algorithm is based on a late-contraction scheme inspired by the HGP algorithm \cite{HGP} following a BOVVVVCCCCHHHH path.
The general skeleton of the algorithm is shown in Fig.~\ref{fig:algo} for the trident operator $C_{12}G_{13}G_{14}$.
We will use this example to illustrate each step.
Based on the shell data, the first step of the algorithm (step B) is to decide whether or not a given class of integrals is significant or negligible.
If the integral class is found to be significant by the screening algorithm depicted in Fig.~\ref{fig:scheme1}, an initial set of FIs is computed (step O).
Starting with these FIs, angular momentum is then built up over the different bra centres $\bA_1$, $\bA_2$, $\bA_3$ and $\bA_4$ using the VRRs derived in the previous section.
To minimise the computational cost, one has to think carefully how to perform this step.
Indeed, the cost depends on the order in which this increase in angular momentum is performed.
This is illustrated in Fig.~\ref{fig:graph}, where we have represented the various possible pathways for the 3-chain operator $C_{12}G_{23}$ (left) and the trident operator $C_{12}G_{13}G_{14}$ (right).
The red path corresponds to the path generating the least intermediates (i.e.~requiring the smallest number of classes in order to compute a given class).
Different paths are compared in Table \ref{tab:RRcount} for various two-, three- and four-electron operators, where we have reported the number of intermediates generated by each path for various integral classes.
Taking the 3-chain operator $C_{12}G_{23}$ as an example, one can see that, to compute a $\sexpval{ppp}$ class, it is more advantageous to build momentum over center $\bA_3$, then over centres $\bA_2$, and finally over center $\bA_1$ using VRRs with 4, 6 and 6 terms, respectively.
The alternative path corresponding to building momentum over $\bA_3$, $\bA_1$, and then $\bA_2$ with 4-, 5- and 7-term VRRs is slightly more expensive for a $\sexpval{ppp}$ class but becomes affordable for high angular momentum classes.
For both paths, using the TRR instead of the last VRR implies a large increase in the number of intermediates.
For the trident operator, we successively build angular momentum over $\bA_4$, $\bA_3$, $\bA_1$ and $\bA_2$ using VRRs with 4, 6, 8 and 7 terms.
The pathway using VRRs with 4, 6, 6, and 9 terms is more expensive due to the large number of terms of the VRR building up momentum over the last center.
Again, using the TRR instead of the last VRR significantly increases the number of intermediates.
The path involving the minimal number of intermediates is given in Table \ref{tab:RRcount} for various two-, three- and four-electron operators.
It is interesting to point out that it is never beneficial to use the TRR derived in Eq.~\eqref{eq:TRR}.
One can easily show that, for operators involving the Coulomb operator, the number of intermediates required to compute a $n$-electron integral class $\sexpval{a \ldots a}$ increases as $\order{a^{n+1}}$ for the VRR-only paths (see Table \ref{tab:RRcount}).
This number is reduced to $\order{a^{n}}$ if one uses the TRR to build up angular momentum on the last center.
However, the prefactor is much larger and the crossover happens for extremely high angular momentum for three- and four-electron integrals.
For ``pure'' GG operators, such as $G_{12}$ or $G_{13}G_{23}$, the number of intermediates required to compute a class $\sexpval{a \ldots a}$ increases as $\order{a^n}$ for any type of paths.
Finally, we note that the optimal path for the trident $C_{12}G_{13}G_{14}$ and the 4-chain $C_{12}G_{13}G_{34}$ is similar, thanks to their similar structure.
Indeed, these two operators can be seen as two ``linked'' GGs ($G_{13}G_{14}$ or $G_{13}G_{34}$) interacting with the Coulomb operator $C_{12}$ (see Fig.~\ref{fig:tree}), while the other 4-chain operator $C_{12}G_{14}G_{23}$ can be seen as two ``unlinked'' GGs ($G_{14}$ and $G_{23}$) interacting with the Coulomb operator.
When angular momentum has been built over all the bra centres, following the HGP algorithm \cite{HGP}, we contract $\sbraket{\ba_1 \ba_2 \ba_3 \ba_4}{\bo \bo \bo \bo}$ to form $\braket{\ba_1 \ba_2 \ba_3 \ba_4}{\bo \bo \bo \bo}$ (step CCCC).
We can perform the contraction at this point because all of the subsequent RRs are independent of the contraction coefficients and exponents.
More details about this contraction step can be found in Ref.~\cite{Gill94b}.
The last step of the algorithm (step HHHH) shifts momentum from the bra center $\bA_1$, $\bA_2$, $\bA_3$ and $\bA_4$ to the ket centres $\bB_1$, $\bB_2$, $\bB_3$ and $\bB_4$ using the two-term HRRs given by Eq.~\eqref{eq:HRR}.
%%% FIGURE 3 %%%
\begin{figure}
\centering
\includegraphics[width=0.6\linewidth]{../Chapter4/fig/fig3}
\caption{
\label{fig:algo}
PRISM representation \cite{PRISM91} of the recursive algorithm used to compute a four-electron integral class $\braket{a_1 a_2 a_3 a_4}{b_1 b_2 b_3 b_4}$ over the trident operator $C_{12}G_{13}G_{14}$.
In our algorithm, we consider the (orange) BOVVVVCCCCHHHH path.}
\end{figure}
%%%
%%% FIGURE 4 %%%
\begin{figure*}
\centering
\includegraphics[height=0.38\textheight]{../Chapter4/fig/fig4a}
\includegraphics[height=0.38\textheight]{../Chapter4/fig/fig4b}
\caption{
\label{fig:graph}
Graph representation of the VRRs for the 3-chain operator $C_{12}G_{23}$ (left) and trident operator $C_{12}G_{13} G_{14}$ (right).
The edge label gives the number of terms in the corresponding VRR.
The red path corresponds to the algorithm generating the smallest number of intermediates.}
\end{figure*}
%%%

Binary file not shown.

Binary file not shown.

Binary file not shown.

Binary file not shown.

Binary file not shown.

View File

@ -0,0 +1,11 @@
%======================
\section{Summary}
%======================
We have presented the three main ingredients to compute three- and four-electron integrals involving GGs.
Firstly, a straightforward method to compute the FIs is given.
Secondly, our UBs strategy is briefly discussed.
Finally, the significant integrals are computed via a recursive scheme based on vertical and horizontal RRs, which can be viewed as an extension of the PRISM late-contraction path to three- and four-electron integrals.
We believe our approach represents a major step towards an accurate and efficient computational scheme for three- and four-electron integrals.
It also paves the way to contraction-effective methods for these types of integrals.
In particular, an early-contraction scheme (including the contraction of both basis functions and Gaussian geminals) would have significant computational benefits.

View File

@ -0,0 +1,35 @@
%****************************************************************
\section{Motivations}
%****************************************************************
In the last decade, the advent of massively parallel computational platforms and their ever-growing capabilities in terms of number of computing nodes (exceeding now one million!) has unveiled new horizons for studying large quantum systems with genuine physical and/or chemical relevance (see Fig.~\ref{fig:supercomputer}).
It is now widely recognised that there is an imperative need to revisit most of the standard algorithms (or design totally new ones!) to make sure that they take full advantage of these new supercomputer architectures and scale up to an arbitrary number of cores.
Unfortunately, because most of the computational chemistry methods developed so far are mainly based on iterative schemes for solving very large linear systems with stringent I/O and memory constraints, they intrinsically do not scale up, i.e.~they are not able to deliver the result in an elapsed time (restitution time) inversely proportional to the number of cores (in the very large number of cores regime).
A class of methods known to scale up nicely are stochastic approaches.
Taking advantage of this attractive feature, a number of authors has recently proposed to systematically revisit the traditional quantum chemistry methods to make them stochastic in nature.
Note that the fundamental equations are identical, only the way of solving them is different.
Let us mention the stochastic MP2 method of Hirata \cite{Willow12, Willow14}, the FCI-QMC approach of Alavi and coworkers \cite{Booth09, Cleland11}, the stochastic coupled-cluster theory \cite{Thom10}, and the stochastic CASSCF method \cite{Thomas15}.
Quite remarkably, in each case, it is found that the stochastic version is able to surpass the limits of the corresponding deterministic one.
To give a concrete example, the authors of Ref.~\cite{Thomas15} have been able to perform a CASSCF calculation for the coronene molecule in a complete active space of 24 $\pi$ electrons in 24 orbitals, a calculation impossible to perform using standard deterministic CASSCF implementations.
Despite these impressive improvements, major limitations remain...
\begin{figure}
\centering
\includegraphics[width=0.6\textwidth]{../Chapter5/fig/supercomputer}
\caption{
\label{fig:supercomputer}
Concrete applications made possible thanks to the massively parallel nature of the hybrid deterministic/stochastic methods.
Biology: study of the rhodopsin protein \cite{Valsson13};
Physics: phase diagram of solid molecular hydrogen at extreme pressures \cite{Drummond15};
Chemistry: absorption spectra in solution \cite{Daday15}.}
\end{figure}
In this final chapter, we present two (unfinished) ideas.
First, we present an explicitly-correlated version of the CI method.
The key idea here is to combine QMC methods and traditional CI-type approaches.
More precisely, we propose to exploit the extremely fast convergence properties of explicitly-correlated methods, and the multi-decade experience of quantum chemistry in building compact albeit accurate wave functions.
The ultimate goal is to design a new highly accurate, black-box QMC method applicable to a wide range of chemical systems and able to run efficiently on current and future massively parallel computers (exascale horizon).
Second, we describe a method for imposing the correct electron-nucleus (e-n) cusp in MOs expanded as a linear combination of (cuspless) Gaussian basis functions.
Enforcing the e-n cusp in trial wave functions is a important asset in QMC calculations as it significantly reduces the variance of the local energy during the Monte Carlo sampling.

View File

@ -0,0 +1,198 @@
%****************************************************************
\section{Explicitly-correlated FCI methods}
%****************************************************************
One of the most fundamental problem of conventional electronic structure methods is their slow energy convergence with respect to the size of the one-electron basis set.
This problem was already spotted thirty years ago by Kutzelnigg \cite{Kutzelnigg85} who stated that
\begin{quote}
\textit{``traditional CI is not really bad, it only has difficulties to represent the wave function at those regions of configuration space where one interelectronic distance $r_{ij}$ approaches zero.''}
\end{quote}
To address this problem he proposed to introduce explicitly the correlation between electrons via the introduction of the interelectronic distance $\ree$ as a basis function \cite{Kutzelnigg91, Termath91, Klopper91a, Klopper91b, Noga94}.
As mentioned in the previous chapter, this yields a prominent improvement of the energy convergence from $O(L^{-3})$ to $O(L^{-7})$ (where $L$ is the maximum angular momentum of the one-electron basis).
This idea was later generalised to more accurate correlation factors $f_{12} \equiv f(\ree)$ \cite{Persson96, Persson97, May04, Tenno04b, Tew05, May05}.
The resulting F12 methods achieve chemical accuracy for small organic molecules with relatively small Gaussian basis sets \cite{Tenno12a, Tenno12b, Hattig12, Kong12}.
For example, as illustrated by Tew and coworkers, one can obtain, at the CCSD(T) level, quintuple-zeta quality correlation energies with a triple-zeta basis \cite{Tew07b}.
Here, following Kutzelnigg's idea, we propose to introduce the explicit correlation between electrons within the CI method via a dressing of the CI matrix \cite{Huron73, Evangelisti83}.
This method, involving effective Hamiltonian theory, has been shown to be successful in other scenarios \cite{Heully92}.
Compared to other explicitly-correlated methods, this dressing strategy has the advantage of introducing the explicit correlation at a low computational cost.
The present explicitly-correlated dressed CI method is completely general and can be applied to any type of truncated, full, or even selected CI methods \cite{Giner13, Scemama13a, Scemama13b, Scemama14, Giner15, Caffarel16}.
However, for the sake of generality, we will discuss here the dressing of the FCI matrix.
%----------------------------------------------------------------
\subsection{Ansatz}
%----------------------------------------------------------------
Inspired by a number of previous research \cite{Shiozaki11}, our electronic wave function ansatz $\ket{\Psi} = \kD + \kF$ is simply written as the sum of a ``conventional'' part
\begin{equation}
\label{eq:D}
\kD = \sum_{I} c_I \kI
\end{equation}
composed by a linear combination of determinants $\kI$ of coefficients $c_I$ and an ``explicitly-correlated'' part
\begin{equation}
\label{eq:WF-F12-CIPSI}
\kF = \sum_{I} t_I \QOp f \kI
\end{equation}
with coefficients $t_I$.
The projector
\begin{equation}
\QOp = \IdOp - \sum_{I} \dyad{I}
\end{equation}
ensures the orthogonality between $\kD$ and $\kF$, and
\begin{equation}
\label{eq:Ja}
f = \sum_{i < j} \gamma_{ij} f_{ij}
\end{equation}
is a correlation factor, and
\begin{equation}
\gamma_{ij} =
\begin{cases}
1/2, & \text{for opposite-spin electrons},
\\
1/4, & \text{for same-spin electrons}.
\end{cases}
\end{equation}
As first shown by Kato \cite{Kato51, Kato57} (and further elaborated by various authors \cite{Pack66, Morgan93}), for small $\ree$, the two-electron correlation factor $f_{12}$ in Eq.~\eqref{eq:Ja} must behave as
\begin{equation}
f_{12} = \gamma_{12}\,\ree + \order{\ree^2}.
\end{equation}
%----------------------------------------------------------------
\subsection{Dressing}
%----------------------------------------------------------------
Our primary goal is to introduce the explicit correlation between electrons at low computational cost.
Therefore, assuming that $\HOp \ket{\Psi} = E \ket{\Psi}$, one can write, by projection over $\bra{I}$,
\begin{equation}
c_I \qty[ H_{II} + c_I^{-1} \mel*{I}{\HOp}{F} - E] + \sum_{J \ne I} c_J H_{IJ} = 0,
\end{equation}
where $H_{IJ} = \mel{I}{\HOp}{J}$.
Hence, we obtain the desired energy by diagonalising the dressed Hamiltonian:
\begin{equation}
\label{eq:DrH}
\oH_{IJ} =
\begin{cases}
H_{II} + c_I^{-1}\mel*{I}{\HOp}{F}, & \text{if $I = J$},
\\
H_{IJ}, & \text{otherwise},
\end{cases}
\end{equation}
with
\begin{equation}
\label{eq:IHF}
\mel{I}{\HOp}{F} = \sum_J t_J \qty[ \mel{I}{\HOp f}{J} - \sum_{K} H_{IK} f_{KJ} ],
\end{equation}
and $f_{IJ} = \mel{I}{f}{J}$.
It is interesting to note that, in an infinite basis, we have $\mel{I}{\HOp}{F} = 0$, which demonstrates that our dressed CI method becomes exact in the limit of a complete one-electron basis.
At this stage, two key comments are in order.
First, as one may have realised, the coefficients $t_I$ are unknown.
However, they can be set to ensure the correct electron-electron cusp conditions \cite{Tenno04a}.
This yields the following linear system of equations
\begin{equation}
\label{eq:tI}
\sum_J (\delta_{IJ} + f_{IJ}) t_J = c_I,
\end{equation}
which can be easily solved using standard linear algebra packages.
Second, because Eq.~\eqref{eq:DrH} depends on the CI coefficient $c_I$, one must iterate the diagonalisation process self-consistently until convergence of the desired eigenvalues of the dressed Hamiltonian $\oH$.
At each iteration, we solve Eq.~\eqref{eq:tI} to obtain the coefficients $t_I$ and dress the Hamiltonian [see Eq.~\eqref{eq:DrH}].
In practice, we initially start with a CI vector obtained by the diagonalisation of the undressed Hamiltonian, and convergence is usually reached within few cycles.
This iteration process can be also embedded in the Davidson diagonalisation process, which is also an iterative process.
For pathological cases, a DIIS-like procedure may be employed \cite{Pulay80, Pulay82}.
%%% FIG 1 %%%
\begin{figure}
\centering
\includegraphics[width=0.6\linewidth]{../Chapter5/fig/fig1}
\caption{
\label{fig:CBS}
Schematic representation of the various orbital spaces and their notation.
The arrows represent the three types of excited determinants contributing to the dressing: the pure doubles $\ket*{_{ij}^{\alpha \beta}}$ (green), the mixed doubles $\ket*{_{ij}^{a \beta}}$ (magenta) and the pure singles $\ket*{_{i}^{\alpha}}$ (orange).}
\end{figure}
%%% %%%
%----------------------------------------------------------------
\subsection{Matrix elements}
%----------------------------------------------------------------
Compared to a conventional CI calculation, new matrix elements are required.
The simplest of them $f_{IJ}$ --- required in Eqs.~\eqref{eq:IHF} and \eqref{eq:tI} --- can be easily computed by applying Slater-Condon rules \cite{Szabo}.
They involve two-electron integrals over the geminal factor $f_{12}$.
Their computation has been thoroughly studied in the literature in the last thirty years \cite{Kutzelnigg91, Klopper92, Persson97, Klopper02, Manby03, Werner03, Klopper04, Tenno04a, Tenno04b, May05, Manby06, Tenno07, Komornicki11, Reine12, GG16}.
These can be more or less expensive to compute depending on the choice of the correlation factor.
As shown in Eq.~\eqref{eq:IHF}, the present explicitly-correlated CI method also requires matrix elements of the form $\mel{I}{\HOp f}{ J}$.
These are more problematic, as they involve the computation of numerous three-electron integrals over the operator $\ree^{-1}f_{13}$, as well as new two-electron integrals \cite{Kutzelnigg91, Klopper92}.
We have recently developed recurrence relations and efficient upper bounds in order to compute these types of integrals \cite{3ERI1, 3ERI2, 4eRR, IntF12}.
However, we will also explore a different route here.
We propose to compute them using the RI approximation \cite{Kutzelnigg91, Klopper02, Valeev04, Werner07, Hattig12}, which requires a complete basis set (CBS).
This CBS is built as the union of the orbital basis set (OBS) $\qty{p}$ (divided as occupied $\qty{i}$ and virtual $\qty{a}$ subspaces) augmented by a complementary auxiliary basis set (CABS) $\qty{\alpha}$, such as $ \qty{p} \cap \qty{\alpha} = \varnothing$ and $\braket{p}{\alpha} = 0$ \cite{Klopper02, Valeev04} (see Fig.~\ref{fig:CBS}).
In the CBS, one can write
\begin{equation}
\label{eq:RI}
\IdOp = \sum_{A \in \mA} \dyad{A}{A}
\end{equation}
where $\mA$ is the set of all the determinants $\kA$ corresponding to electronic excitations from occupied orbitals $\qty{i}$ to the extended virtual orbital space $\qty{a} \cup \qty{\alpha}$.
Substituting \eqref{eq:RI} into the first term of the right-hand side of Eq.~\eqref{eq:IHF}, one gets
\begin{equation}
\label{eq:IHF-RI}
\begin{split}
\mel{I}{\HOp}{F}
& = \sum_J t_J \qty[ \sum_{A \in \mA} H_{IA} f_{AJ} - \sum_{K \in \mD} H_{IK} f_{KJ} ]
\\
& = \sum_J t_J \sum_{A \in \mC} H_{IA} f_{AJ},
\end{split}
\end{equation}
where $\mD$ is the set of ``conventional'' determinants obtained by excitations from the occupied space $\qty{i}$ to the virtual one $\qty{a}$, and $\mC = \mA \setminus \mD$.
Because $f$ is a two-electron operator, the way to compute efficiently Eq.~\eqref{eq:IHF-RI} is actually very similar to what is done within second-order multireference perturbation theory \cite{PT2}.
Although $\mel{0}{\HOp}{_{i}^{a}} = 0$, note that the Brillouin theorem does not hold in the CABS, i.e.~$\mel{0}{\HOp}{_{i}^{\alpha}} \neq 0$.
Here, we will eschew the generalized Brillouin condition (GBC) which set these to zero \cite{Kutzelnigg91}.
%----------------------------------------------------------------
\subsection{An illustrative example}
%----------------------------------------------------------------
%%% FIG 1 %%%
\begin{figure}
\centering
\includegraphics[width=0.45\linewidth]{../Chapter5/fig/glo1}
\includegraphics[width=0.45\linewidth]{../Chapter5/fig/glo2}
\caption{
\label{fig:Glo}
$\Ec$ for two electrons on a surface of a glome of unit radius as a function of the maximum angular momentum of the basis set $L$.
For each calculation, the maximum angular momentum of the auxiliary basis is set to $L_\text{RI} = 3 L$.}
\end{figure}
%%% %%%
To illustrate this method, we have computed the correlation energy of two electrons on a surface of a unit glome --- system we have presented earlier in the memoir --- as a function of the maximum angular momentum of the basis set $L$.
For each calculation, the maximum angular momentum of the auxiliary (or RI) basis is set to $L_\text{RI} = 3 L$.
Note that here, because of the form of the exact wave function presented earlier, we used a correlation factor $f_{12} = r_{12}$.
Various methods have been considered:
\begin{enumerate}
\item the conventional FCI method which obviously corresponds to CISD here.
\item FCI-PT2 in which we compute a second-order Epstein-Nesbet perturbative correction using the auxiliary basis.
\item the FCI-F12 method where the explicitly-correlated basis function is treated variationally (i.e.~no dressing).
\item the dressed FCI-F12 method presented here in which the energy is computed by projection and the dressing term is computed explicitly.
\item the same dressed FCI-F12 method where the dressing term is computed with the help of the auxiliary basis.
\end{enumerate}
The results are depicted in Fig.~\ref{fig:Glo}.
Few comments are in order:
\begin{itemize}
\item As expected, the convergence of the conventional FCI method is miserable.
\item Treating the explicitly-correlated basis function variationally yields the fastest convergence but it requires the computation of expensive and numerous three- and four-electron integrals.
\item the dressed FCI-F12 method significantly improves the convergence of the energy.
With a relative small number of basis functions, one can reach sub-millihartree accuracy.
However, the energy is not variational as it is calculated via projection.
\item the PT2 correction allows to recover a significant fraction of the missing correlation energy.
However, it does not produce a wave function one can use as a trial wave function for QMC calculations.
\item the RI approximation induces a large error but still improve upon the conventional FCI method.
Therefore, we believe that one should try to compute explicitly the three-electron integrals required in the dressed FCI-F12 method.
\end{itemize}
In regards to these results, we believe that the present dressed FCI-F12 method may be an interesting alternative for producing accurate and compact trial wave functions for DMC calculations.
We hope to be able to consider more realistic systems in the near future as well as studying the nodal surfaces of these explicitly-correlated wave functions.

View File

@ -0,0 +1,223 @@
%****************************************************************
\section{Self-consistent electron-nucleus cusp correction for molecular orbitals}
%****************************************************************
At short interparticle distances, the Coulombic singularity dominates all other terms and, near the two-particle coalescence point, the behaviour of the exact wave function $\Psi$ becomes independent of other details of the system \cite{eee15}.
In particular, early work by Kato \cite{Kato51, Kato57}, and elaborations by Pack and Byers Brown \cite{Pack66}, showed that, as one electron at $\bri$ approaches a nucleus of charge $Z_A$ at $\brA$, we have
\begin{equation}
\label{eq:eNcusp}
\eval{\pdv{\expval{\Psi(\bR)}}{\ri}}_{\ri = \rA} = -Z_A \left.\expval{\Psi(\bR)}\right|_{\ri = \rA},
\end{equation}
where $\left.\expval{\Psi(\bR)}\right|_{\ri = \rA}$ is the spherical average of $\Psi(\bR)$ about $\bri = \brA$.
To remove divergences in the local energy at the electron-nucleus (e-n) coalescence points, cusp conditions such as \eqref{eq:eNcusp} must be satisfied.\footnote{Note that the use of pseudopotentials would also remove the divergence at the e-n coalescence points as routinely done in QMC calculations.}
These divergences are especially harmful in DMC calculations, where they can lead to a large increase of the statistical variance, population-control problems and significant biases \cite{Drummond04}.
There are two possible ways to enforce the correct e-n cusp.
One way to do it is to enforce the e-n cusp within the Jastrow factor in Eq.~\eqref{eq:Psi-trial}.
This has the disadvantage of increasing the number of parameters in $\Js(\bR)$, and their interdependence can be tricky as one must optimise the large number of linear and non-linear parameters contained in $\Js(\bR)$ via a stochastic (noisy) optimization of the energy and/or its variance.
However, it is frequently done in the literature thanks to some recent progress \cite{Toulouse07, Umrigar07, Toulouse08}.
Here, we will follow an alternative path which consists in imposing the e-n cusp within the multideterminant expansion of Eq.~\eqref{eq:Psi-trial}.
However, because one usually employs Gaussian basis functions \cite{Boys69} (as in standard quantum chemistry packages), the MOs $\MO{i}(\br)$ are cuspless, i.e.~
\begin{equation}
\eval{\pdv{\expval{\MO{i}(\br)}}{r}}_{r = \rA} = 0.
\end{equation}
One solution would be to use a different set of basis functions \cite{McKemmish14} as, for instance, Slater basis functions \cite{Slater30, Bouferguene96}.
However, they are known to be troublesome, mainly due to the difficulty of calculating multicentric two-electron integrals which require expensive numerical expansions or quadratures.
Nevertheless, some authors \cite{Nemec10} have explored using wave functions built with Slater basis functions \cite{Lenthe03} while imposing the right e-n cusp afterwards.\footnote{It is also possible to enforce the correct e-n cusp during the SCF process although it is rarely done \cite{Galek05}.}
These types of calculations can be performed with an electronic structure package such as ADF \cite{ADF}.
However, as far as we know, it is hard to perform large-scale calculations with Slater basis functions and the virtual space is usually poorly described.
Moreover, Gaussian basis are usually of better quality than Slater-based ones due to the extensive knowledge and experience gathered by quantum chemists over the last fifty years while building robust, compact and effective Gaussian basis sets \cite{Huzinaga65, Hehre69, Hehre72, Schmidt79, Feller79, Almlof87, Almlof90, Bauschlicher93, Dunning89, Woon93, Peterson93, Jensen01, Jensen07, Jensen12}.
Conventional cusp correction methods usually replace the part of $\GTO{\mu}(\br)$ or $\MO{i}(\br)$ close to the nuclei within a cusp-correction radius by a polynomial or a spline function which fulfils Kato cusp conditions and ensures a well-behaved local energy \cite{Manten01, Ma05, Kussmann07, Per08}.
For atoms, one can also substitute Gaussian core orbitals by tabulated Slater-based ones \cite{Bunge93, Scemama14}.
In the same vein, Toulouse and Umrigar have fitted Slater basis functions with a large number of Gaussian functions and replaced them within the QMC calculation \cite{Toulouse08}.
However, it is hardly scalable for large systems due to its lack of transferability and the ever-growing number of primitive two-electron integrals to compute.
Here, we propose to follow a different, alternative route by augmenting conventional Gaussian basis sets with cusp-correcting Slater basis functions.
Mixed Gaussian-Slater basis sets have been already considered in the past with limited success due to the difficultly of computing efficiently mixed electron repulsion integrals \cite{Allen59, Silver70, Bacskay72a, Bacskay72b, Bacskay72c, Bacskay72d, Bugaets76}.
However, we will show that, because of the way we introduce the cusp correction, the integrals required here are not that scary.
For the sake of simplicity, we will focus on the HF formalism in the present study, although our scheme can also be applied to KS calculations.
%----------------------------------------------------------------
\subsection{Cusp-corrected orbitals}
%----------------------------------------------------------------
Assuming that the Jastrow factor does not contribute, a sufficient condition to ensure that $\PsiT$ (cf Eq.~\eqref{eq:Psi-trial}) fulfils the e-n cusp \eqref{eq:eNcusp} is that each (occupied and virtual) MO $\ccedMO{i}(\br)$ satisfies the e-n cusp at each nuclear position $\brA$:
\begin{equation}
\label{eq:eNcusp-orb}
\eval{\pdv{\expval*{\ccedMO{i}(\br)}}{r}}_{r = \rA} = -Z_A \expval*{\ccedMO{i}(\br)}\big|_{r = \rA}.
\end{equation}
We also assume that the basis functions have been already orthogonalised via the standard procedure \cite{Szabo}, i.e.~$\braket{\GTO{\mu}}{\GTO{\nu}} = \delta_{\mu \nu}$, where $\delta_{\mu \nu}$ is the Kronecker delta \cite{NISTbook}.
Here, we enforce the correct value of the e-n cusp by adding a cusp-correcting orbital to each MO:
\begin{equation}
\label{eq:tphi}
\ccedMO{i}(\br) = \phi_i(\br) + \POp \ccingMO{i}(\br),
\end{equation}
with
\begin{equation}
\ccingMO{i}(\br) = \sum_A^M \cSTO{A}{i} \, \STO{A}{i}(\br),
\end{equation}
where $M$ is the number of nuclear centres and
\begin{equation}
\label{eq:Slater}
\STO{A}{i}(\br) = \sqrt{\frac{\expSTOa_{i}^3}{\pi}} \exp[-\expSTOa_{i} \abs{\br - \brA}]
\end{equation}
is a $s$-type Slater function centred on nucleus $A$ with an orbital-dependent exponent $\expSTOa_{i}$.
In Eq.~\eqref{eq:tphi}, the projector
\begin{equation}
\POp = \IdOp - \sum_\mu \dyad{\GTO{\mu}}
\end{equation}
(where $\IdOp$ is the identity operator) ensures orthogonality between $\MO{i}(\br)$ and the cusp-correcting orbital $\ccingMO{i}(\br)$.
It is easy to show that ensuring the right e-n cusp yields the following linear system of equations for the coefficients $c_{Ai}$:
\begin{equation}
\label{eq:cAi-lineq}
\sum_B \Bigg[ - \frac{\delta_{AB}}{Z_A} \partial_r \STO{A}{i}(\brA) - \STO{B}{i}(\brA)
\\
+ \sum_\mu \DrOvEl{B}{\mu}{i} \GTO{\mu} (\brA) \Bigg] \cSTO{B}{i} = \MO{i}(\brA),
\end{equation}
where the explicit expression of the matrix elements $\DrOvEl{\mu}{A}{i} = \braket{\GTO{\mu}}{\STO{A}{i}}$ can be easily found using standard procedures and
\begin{equation}
\partial_r \STO{A}{i}(\brA) \equiv \eval{\pdv{\STO{A}{i}(\br)}{r}}_{r = \rA}.
\end{equation}
Equation \eqref{eq:cAi-lineq} can be easily solved using standard linear algebra packages, and provides a way to obtain a cusp-corrected orbital $\ccedMO{i}(\br)$ from a given MO $\MO{i}(\br)$.
For reasons that will later become apparent, we will refer to this procedure as a one-shot (OS) calculation.
Next, we are going to explain how one can optimise self-consistently the coefficients $\cSTO{A}{i}$.
%----------------------------------------------------------------
\subsection{Self-consistent dressing of the Fock matrix}
%----------------------------------------------------------------
So far, the coefficient $\cSTO{A}{i}$ have been set via Eq.~\eqref{eq:cAi-lineq}.
Therefore, they have not been obtained via a variational procedure as their only purpose is to enforce the e-n cusp.
However, they do depend on $\phi_i(\brA)$, hence on the MO coefficients $\cGTO{\mu}{i}$.
We will show below that one can optimise simultaneously the coefficients $\cSTO{A}{i}$ and $\cGTO{\mu}{i}$ by constructing an orbital-dependent effective Fock matrix.
As it is ultimately what we wish for, the key point is to assume that $\ccedMO{i}(\br)$ is an eigenfunction of the Fock operator $\FkOp$, i.e.
\begin{equation}
\label{eq:Jia}
\FkOp \ket*{\ccedMO{i}} = \DrMOeigval{i} \ket*{\ccedMO{i}}.
\end{equation}
Note that, even at convergence of a conventional HF or KS calculation, the equality \eqref{eq:Jia} is never fulfilled (unless the basis happens to span the exact orbital).
This under-appreciated fact has been used by Deng et al.~to design a measure of the quality of a MO \cite{Deng10}.
Next, we project out Eq.~\eqref{eq:Jia} over $\bra*{\chi_\mu}$ yielding
\begin{equation}
\label{eq:HFeq}
\sum_\nu F_{\mu \nu} \cGTO{\nu}{i} + \sum_A \cSTO{A}{i} \qty( \DrFkEl{\mu}{A}{i} - \sum_\lambda \FkEl{\mu}{\lambda} \DrOvEl{\lambda}{A}{i} )
= \DrMOeigval{i} \cGTO{\mu}{i},
\end{equation}
where
\begin{align}
\FkEl{\mu}{\nu} & = \mel{\GTO{\mu}}{\FkOp}{\GTO{\nu}},
&
\DrFkEl{\mu}{A}{i} & = \mel{\GTO{\mu}}{\FkOp}{\STO{A}{i}}.
\end{align}
In the general case, because we must use basis functions with non-zero derivatives at the nucleus, finding the matrix elements $\DrFkEl{\mu}{A}{i}$ is challenging and costly.
However, because we are interested in the e-n cusp, we have found that a satisfactory approximation is
\begin{equation}
\label{eq:approx}
\DrFkEl{\mu}{A}{i} - \sum_\lambda \FkEl{\mu}{\lambda} \DrOvEl{\lambda}{A}{i} \approx \DrHcEl{\mu}{A}{i} - \sum_\lambda \HcEl{\mu}{\lambda} \DrOvEl{\lambda}{A}{i}
\end{equation}
where
\begin{align}
\HcEl{\mu}{\nu} & = \mel{\GTO{\mu}}{\HcOp}{\GTO{\nu}},
&
\DrHcEl{\mu}{A}{i} & = \mel{\GTO{\mu}}{\HcOp}{\STO{A}{i}},
\end{align}
and $\HcOp$ is the core Hamiltonian.
Note that, in Eq.~\eqref{eq:approx}, it is important to use the same approximation for both terms ($\DrFkEl{\mu}{A}{i} \approx \DrHcEl{\mu}{A}{i}$ and $\FkEl{\mu}{\nu} \approx \HcEl{\mu}{\nu}$) in order to preserve the subtle balance between the two terms.
For the sake of clarity, the expression of the matrix elements $\DrHcEl{\mu}{A}{i}$ will not be reported here, but they can be obtained easily realising that these integrals only involve $s$-type Slater functions.
The eigenvalue problem given by Eq.~\eqref{eq:HFeq} can be recast as
\begin{equation}
\sum_\nu \DrFkOpEl{\mu}{\nu}{i} \cGTO{\nu}{i} = \DrMOeigval{i} \cGTO{\mu}{i},
\end{equation}
where we have ``dressed'' the diagonal of the Fock matrix
\begin{equation}
\label{eq:DressedFock}
\DrFkOpEl{\mu}{\nu}{i} =
\begin{cases}
\FkEl{\mu}{\mu} + \DrEl{\mu}{i},
&
\text{if $\mu = \nu$},
\\
\FkEl{\mu}{\nu},
&
\text{otherwise},
\end{cases}
\end{equation}
with
\begin{equation}
\label{eq:dressing}
\DrEl{\mu}{i} = \cGTO{\mu}{i}^{-1} \sum_A \cSTO{A}{i} \qty( \DrHcEl{\mu}{A}{i} - \sum_\lambda \HcEl{\mu}{\lambda} \DrOvEl{\lambda}{A}{i} ).
\end{equation}
The process is repeated until our convergence criteria is met, i.e.~the largest absolute value of the elements of the commutator $\bDrFkOp{i} \bP - \bP \bDrFkOp{i}$ is lower than a given threshold, where $\bDrFkOp{i}$ is the dressed Fock matrix (Eq.~\eqref{eq:DressedFock}) and $\bP$ is the density matrix with
\begin{equation}
P_{\mu \nu} = \sum_i^\occ \cGTO{\mu}{i} \cGTO{\nu}{i}.
\end{equation}
We will refer to this procedure as self-consistent dressing (SCD).
Similarly to the Perdew-Zunger self-interaction correction \cite{PZ81}, the orbitals $\ccedMO{i}(\br)$ are eigenfunctions of different Fock operators and therefore no longer necessarily orthogonal.
Practically, we have found that the e-n cusp correction makes the cusp-corrected MOs $\ccedMO{i}$ slightly non-orthogonal.
However, this is not an issue as, within QMC, one evaluates the energy via MC sampling which only requires the evaluation of the MOs and their first and second derivatives.
Obviously, as evidenced by Eq.~\eqref{eq:DressedFock}, when $\cGTO{\mu}{i}$ is small, the dressing of the Fock matrix is numerically unstable.
Therefore, we have chosen not to dress the Fock matrix if $\cGTO{\mu}{i}$ is smaller than a user-defined threshold $\tau$.
We have found that a value of $10^{-5}$ is suitable for our purposes, and we use the same value for the convergence threshold.
Moreover, we have found that setting \cite{Ma05}
\begin{equation}
\label{eq:Zeff}
\expSTOa_i = \frac{\MO{i}(\brA)}{\MOsA{i}(\brA)} Z_A
\end{equation}
(where $\MOsA{i}(\br)$ corresponds to the $s$-type components of $\MO{i}(\br)$ centred at $\brA$) yields excellent results for molecular systems.
In the case where $\MOsA{i}(\brA) = 0$, the MO is effectively zero at $\br = \brA$ and, therefore, does not need to be cusp corrected.
%----------------------------------------------------------------
\subsection{An illustrative example}
%----------------------------------------------------------------
%%% FIGURE 1 %%%
\begin{figure}
\centering
\includegraphics[width=0.6\linewidth]{../Chapter5/fig/fig1-en}
\caption{
\label{fig:H-EL}
Local energy $E_\text{L}(r)$ for various wave functions of the \ce{H} atom.
The cuspless wave function is obtained with the decontracted STO-3G Gaussian basis set (red curve), and the OS and SCD cusp-corrected wave functions (blue and orange curves respectively) are obtained using $\expSTOa_\text{H} = 1$.}
\end{figure}
%%% %%%
%%% TABLE 1 %%%
\begin{table}
\centering
\caption{
\label{tab:H}
Variational energy and its variance for various wave functions of the \ce{H} atom.
The energy is obtained with the decontraced STO-3G Gaussian basis set.
The OS and SCD cusp-corrected energies are obtained by adding a Slater basis function of unit exponent ($\expSTOa_\text{H} = 1$) to the Gaussian basis set.
The energy and variance at each iteration of the SCD process is also reported.}
\begin{tabular}{cccccc}
\hline
Basis & Cusp correction & Iteration & Energy & Variance \\
\hline
Gaussian & \cdash & & $-0.495741$ & $2.23 \times 10^{-1}$ \\
Mixed & OS & & $-0.499270$ & $4.49 \times 10^{-2}$ \\
Mixed & SCD & \#1 & $-0.499270$ & $4.49 \times 10^{-2}$ \\
& & \#2 & $-0.499970$ & $3.07 \times 10^{-6}$ \\
& & \#3 & $-0.500000$ & $4.88 \times 10^{-9}$ \\
\hline
\end{tabular}
\end{table}
%%% %%%
Let us illustrate the present method with a simple example!
For pedagogical purposes, we have computed the wave function of the hydrogen atom within a small Gaussian basis (decontracted STO-3G basis).
In Fig.~\ref{fig:H-EL}, we have plotted the local energy associated with this wave function as well as its OS and SCD cusp-corrected versions.
The numerical results are reported in Table \ref{tab:H}.
As expected, the ``cuspless'' local energy (red curve) diverges for small $r$ with a variational energy off by $4.3$ millihartree compared to the exact value of $-1/2$.
The OS cusp-correcting procedure which introduces a Slater basis function of unit exponent (but does not re-optimise any coefficients) cures the divergence at $r = 0$ and significantly improves (by roughly one order of magnitude) both the variational energy and the variance.
Moreover, we observe that the long-range part of the wave function is also improved compared to the Gaussian basis set due to the presence of the Slater basis function which has the correct asymptotic decay.
The SCD cusp-correcting procedure further improve upon the OS scheme, and we reach a variance lower than $10^{-8}$ after only 3 iterations.
Obviously, more tests are required to ensure the validity of the method but we believe that the present results are encouraging and we hope to pursuit this study in the near future.

Binary file not shown.

Binary file not shown.

Binary file not shown.

Binary file not shown.

Binary file not shown.

After

Width:  |  Height:  |  Size: 256 KiB

View File

@ -0,0 +1,15 @@
%----------------------------------------------------------------
\section{Summary}
%----------------------------------------------------------------
In the last chapter of this memoir, we have presented two lines of our current research.
First, we have introduced a dressed version of the well-established CI method to incorporate explicitly the correlation between electrons.
We have shown that the new CI-F12 method allows to fix one of the main issue of conventional CI methods, i.e.~the slow convergence of the electronic energy with respect to the size of the one-electron basis set.
Albeit not variational, our method is able to catch a large fraction of the basis set incompleteness error at a low computational cost compared to other variants.
In particular, one eschews the computation of four-electron integrals as well as some types of three-electron integrals.
We believe that the present approach could be a significant step towards the development of an accurate and efficient explicitly-correlated FCI methods.
Second, we have proposed a procedure to enforce the e-n cusp by augmenting conventional (cuspless) Gaussian basis sets with cusp-correcting Slater basis functions.
Two types of procedure has been presented.
In the one-shot procedure, the coefficients of the Slater functions are obtained by ensuring the correct e-n cusp at each nucleus.
We have also designed a self-consistent procedure to optimise simultaneously the coefficients of the Gaussian and Slater basis functions by diagonalisation of an orbital-dependent effective Fock operator.
The same procedure could potentially be employed to correct the long-range part of the electronic density with obvious application within DFT.

View File

@ -0,0 +1,180 @@
In this memoir, I have presented succinctly some of the research projects we have been pursuing in the last ten years.
Moreover, I have discussed two of our current research topics in the final chapter.
As concluding remarks, I would like to talk further about various research projects we would like to work on in the years to come.
This is a non-exhaustive list in no particular order but I hope it will give to the reader a feeling about what we are trying to achieve.
%************************************************************************
\paragraph{What is the exact Green function?}
%************************************************************************
As mentioned earlier in the memoir, exactly solvable models are particularly valuable for testing theoretical approaches.
Here, we would like to use the electrons-on-a-sphere model presented above to unveil the form of the exact Green function \cite{Berger14}.
Green function-based methods allows an explicit incorporation of the electronic correlation effects through a summation of Feynman diagrams.
Important properties such as total energies, ionisation potentials, electron affinities as well as photo-emission spectra can be obtained directly from the Green function.
A particularly successful variant of these methods in electronic-structure calculations is the so-called GW approximation, which consists in evaluating the self-energy $\Sigma$ starting from the Green function $G$ using a sequence of self-consistent steps (see Fig.~\ref{fig:pentagon}).
Thanks to this toy system, our preliminary results show that we might be able to compute self-consistently $\Sigma$.
This will help us understand approximation such as G$_0$W$_0$ where one eschews the iterative process.
More importantly, we might be able to obtain the closed-form expression of the vertex correction $\Gamma$ --- a quantity hardly accessible in real systems --- and complete the entire five-step self-consistent process (see Fig.~\ref{fig:pentagon}).
This could shed lights on how to approximate wisely the vertex function in real systems.
\begin{figure}
\centering
\includegraphics[width=0.4\linewidth]{../Conclusion/fig/pentagon}
\caption{
\label{fig:pentagon}
Hedin's pentagon \cite{Hedin65}.}
\end{figure}
%************************************************************************
\paragraph{GLDA correlation functional}
%************************************************************************
In Sec.~\ref{sec:ExGLDA}, we have presented an exchange functional based on FUEGs.
In order to create the associated correlation functional, one would need to compute accurate energies of FUEGs for various number of electrons and densities.
One of the method of choice to achieve this would probably be DMC.
Sadly, DMC on a curved manifold (like a $D$-sphere) is not as easy as one would have thought.
What are the modifications required to the VMC and DMC algorithms to perform calculations of electrons in curved manifolds?
While the modifications required for the VMC algorithm are fairly straightforward \cite{SGF14, Nodes15, LowGlo15}, the modifications one has to do in the DMC algorithm are much more subtle.
DMC on a curved manifold has received very little attention in the past.
To the best of our knowledge, the only work related to this has been done by Ortiz and coworkers to calculate the energy of composite fermions on the Haldane sphere \cite{Melik97}.
On a curved manifold, when moving the electrons, one has to make sure that the move keeps the electrons on the surface of the sphere.
In VMC, the only required modification is the Metropolis acceptance probability \cite{Nodes15, LowGlo15}.
On a curved manifold, the DMC algorithm requires modifications in the diffusion and drift processes.
The branching process is not affected by the curved nature of the manifold.
The major difference appears in the calculation of the short-time approximation of the Green function
This ``curved'' DMC method could be efficiently implemented in the local QMC software package (QMC=Chem) developed by Scemama, Caffarel and coworkers \cite{Scemama13b}.
This would allow to perform DMC calculations and obtain the near-exact energies of FUEGs required to build the three-dimensional version of the GLDA correlation functional, similarly to what we have done in the one-dimensional case \cite{gLDA14, Wirium14}.
%************************************************************************
\paragraph{Symmetry-broken LDA}
%************************************************************************
Within DFT, the LDA correlation functional is typically built by fitting the difference between the near-exact and HF energies of the UEG, together with analytic perturbative results from the high- and low-density regimes.
Near-exact energies are obtained by performing accurate DMC calculations, while HF energies are usually assumed to be the Fermi fluid HF energy.
However, it has been known since the seminal work of Overhauser \cite{Overhauser59, Overhauser62} that one can obtain lower, symmetry-broken (SB) HF energies at any density \cite{Trail03, Delyon08, Bernu08, Bernu11, Baguet13, Baguet14, Delyon15}.
Recently, we have computed the SBHF energies of the one-dimensional UEG \cite{1DEG13, ESWC17} and constructed a SB version of the LDA (SBLDA) from these results \cite{SBLDA16}.
The newly designed functional, which we have named SBLDA, has shown to surpass the performance of its LDA parent in providing better estimates of the correlation energy in one-dimensional systems \cite{gLDA14, Wirium14, 1DChem15, Ball15, Leglag17}.
Based on the same methodology, we would like to design of new exchange and correlation functionals for two- and three-dimensional systems for which SBHF calculations have already been performed \cite{Trail03, Bernu11, Baguet13, Baguet14}.
%************************************************************************
\paragraph{Resolution of geminals}
%************************************************************************
The main idea behind the ``resolution of geminals'' (RG) is a generalisation of the resolution of the identity (RI).
To explain what we mean by this, let us state the RI identity in its two-electron version, i.e.
\begin{equation}
\label{eq:2eRI}
\delta(\ree) = \sum_{\mu}^\infty \dyad{\chi_\mu(\br_1)}{\chi_\mu(\br_2)},
\end{equation}
where $\delta(r)$ is the Dirac delta function and the one-electron basis set $\chi_\mu(\br)$ is formally complete.
In other words, we have just ``resolved'' the Dirac delta function, i.e. we wrote a two-electron function as a sum of products of one-electron functions.
One can show that most of the usual two-electron operators used in quantum chemistry can be written in a similar form.
For example, one can write a Gaussian geminal, using a Gauss-Hermite quadrature, as \cite{Limpanuparb11b}
\begin{equation}
G_{12} = \sum_{n \ell m} \dyad{\phi_{n \ell m}(\br_1)}{\phi_{n \ell m}(\br_2)},
\end{equation}
with
\begin{equation}
\phi_{n \ell m}(\br) = \sqrt{8 \pi^{1/2}b_n}\,\beta_n\,j_{\ell} (2\sqrt{\lambda}\,\beta_n\,r) Y_{\ell m}(\bm{r}),
\end{equation}
where $\beta_n$ and $b_n$ are the (positive) Hermite roots and weights, and $j_n(r)$ is a spherical Bessel function of the first kind \cite{NISTbook}.
A similar expression can be found for the long-range Coulomb operator, the Slater geminal and many others.
In this way, as one inserts the RI ``in-between'' two operators, one can now resolve operators!
This is illustrated diagrammatically in Fig.~\ref{fig:RIvsRG} for some of the three-electron integrals involved in explicitly-correlated methods.
This procedure generates new integrals as one has to deal with spherical Bessel functions now.
However, these are only one- and two-electron integrals.
%%% FIGURE 1 %%%
\begin{figure*}
\centering
\begin{minipage}[b]{0.3\textwidth}
\includegraphics[width=0.8\textwidth]{../Conclusion/fig/fig1a}
\scriptsize $I_{ijk}^{lmn} \overset{\text{RI}} \approx \sum_{\mu} G_{i\mu}^{jm} F_{\mu l}^{kn}$
\end{minipage}
\begin{minipage}[b]{0.3\textwidth}
\includegraphics[width=0.8\textwidth]{../Conclusion/fig/fig1b}
\scriptsize $I_{ijk}^{lmn} = \left< ijk \left| r_{12}^{-1}\,f_{13} \right| lmn \right>$
\end{minipage}
\begin{minipage}[b]{0.3\textwidth}
\includegraphics[width=0.8\textwidth]{../Conclusion/fig/fig1c}
\scriptsize $I_{ijk}^{lmn} \overset{\text{RG}} \approx \sum_{\mu}G_{il,\mu}^{jm} S_{kn,\mu} $
\end{minipage}
%
\begin{minipage}[b]{0.3\textwidth}
\includegraphics[width=0.8\textwidth]{../Conclusion/fig/fig2a}
\scriptsize $J_{ijk}^{lmn} \overset{\text{RI}} \approx \sum_{\mu} F_{i\mu}^{jm} F_{\mu l}^{kn}$
\end{minipage}
\begin{minipage}[b]{0.3\textwidth}
\includegraphics[width=0.8\textwidth]{../Conclusion/fig/fig2b}
\scriptsize $J_{ijk}^{lmn} = \left< ijk \left| f_{12}\,f_{13} \right| lmn \right>$
\end{minipage}
\begin{minipage}[b]{0.3\textwidth}
\includegraphics[width=0.8\textwidth]{../Conclusion/fig/fig2c}
\scriptsize $J_{ijk}^{lmn} \overset{\text{RG}} \approx \sum_{\mu\nu} S_{il,\mu\nu} S_{jm,\mu} S_{kn,\nu}$
\end{minipage}
%
\begin{minipage}[b]{0.3\textwidth}
\includegraphics[width=0.8\textwidth]{../Conclusion/fig/fig4a}
\scriptsize $L_{ijk}^{lmn} \overset{\text{RI}} \approx \sum_{\mu \nu \lambda} F_{i\mu}^{j\nu} G_{\nu m}^{k \lambda} F_{\mu l}^{\lambda n}$
\end{minipage}
\begin{minipage}[b]{0.3\textwidth}
\includegraphics[width=0.8\textwidth]{../Conclusion/fig/fig4b}
\scriptsize $L_{ijk}^{lmn} = \left<ijk \left| f_{12}\,r_{23}^{-1}\,f_{13} \right| lmn \right>$
\end{minipage}
\begin{minipage}[b]{0.3\textwidth}
\includegraphics[width=0.8\textwidth]{../Conclusion/fig/fig4c}
\scriptsize $L_{ijk}^{lmn} \overset{\text{RG}} \approx \sum_{\mu \nu} S_{il,\mu\nu} G_{jm,\mu}^{kn,\nu}$
\end{minipage}
\caption{RI (left) vs RG (right) for the three-electron integrals $I_{ijk}^{lmn}$, $J_{ijk}^{lmn}$ and $L_{ijk}^{lmn} $.}
\label{fig:RIvsRG}
\end{figure*}
%************************************************************************
\paragraph{A zero-variance hybrid MP2 method}
%************************************************************************
The stochastic MP2 algorithm developed by Hirata and coworkers \cite{Willow12, Willow14, Johnson16, Gruneis17} has been shown to be particularly promising due to its low computational scaling and its independence towards the correlation factor \cite{Johnson17}.
We propose to investigate two potential improvements of So Hirata's stochastic MP2 algorithm.
First, following the philosophy of the multireference perturbation theory algorithm we have published recently \cite{PT2}, we would like to introduce a small deterministic orbital window.
It would allow to catch the largest fraction of the MP2 correlation energy using a small number of MOs around the Fermi level.\footnote{This idea is somewhat related to the semi-stochastic FCIQMC algorithm developed by Umrigar and coworkers \cite{Petruzielo12b}.}
This would significantly reduce the statistical error of the stochastic part because the magnitude of the statistical error in a Monte Carlo calculation is proportional to the magnitude of the actual expectation value one is actually computing.
Second, we would like to propose a zero-variance version of Hirata's stochastic algorithm \cite{Assaraf99}.
Indeed, one of the weak point of his algorithm comes from the choice of the probability distribution function.
Surely, a zero-variance algorithm would significantly decrease the statistical error on the MP2 correlation energy.
%************************************************************************
\paragraph{Chemistry without Coulomb singularity}
%************************************************************************
One of the most annoying feature of the Coulomb operator is its divergence as $\ree \to 0$.
Indeed, the exact wave function must have a well-defined cusp at electron coalescences so that the infinite Coulomb interaction is exactly cancelled by an opposite divergence in the kinetic term.
Removing such a divergence would have one very important consequence: accelerating the rate of convergence of the energy with respect to the one-electron basis set (see, for example, Ref.~\cite{Franck15}).
A well-known procedure to remove the Coulomb singularity is to use a range-separated operator \cite{Savin96}:
\begin{equation}
\frac{1}{\ree} = \frac{\erfc(\omega \ree)}{\ree} + \frac{\erf(\omega \ree)}{\ree},
\end{equation}
where $\erf(x)$ is the error function and $\erfc(x) = 1 - \erf(x)$ its complementary version.
The parameter $\omega$ controls the separation range.
For $\omega = 0$, the long-range interaction vanishes while, for $\omega \to \infty$, the short range disappears
In range-separated methods, two different methods are usually used for the short-range and long-range parts.
For example, in range-separated DFT, one usually used DFT for the short-range interaction and a wave function method (such as MP2) to model the long-range part \cite{Toulouse04}.
Here, we propose something slightly different.
What if we approximate the Coulomb operator by its long-range component only, i.e.
\begin{equation}
\frac{1}{\ree} \approx \frac{\erf(\omega \ree)}{\ree},
\end{equation}
with $\omega$ large enough to be chemically meaningful?
The variational energy would definitely be altered by such a choice \cite{Prendergast01}.
But what about the nodes? At the end of the day, the nodes are the only things which matters in DMC!
Are the nodes obtained with this attenuated Coulomb operator worse than the ones obtained with the genuine, singular Coulomb operator?
As stated above, the singularity of the Coulomb operator gives birth to Kato's cusp.
However, for a same-spin electron pair, the node in the wave function at $\ree = 0$ is produced by the antisymmetry of the wave function (Pauli exclusion principle).
For an opposite-spin electron pair, Kato taught us that the wave function is non-zero at $\ree = 0$.
In other words, there can't be a node!
Therefore, one could argue that removing the Coulomb singulary would have a marginal effect on the nodal surface of the electronic wave function.
This is what we would like to investigate in the future.
Amother possiblity would be to create a local or non-local pseudopotential for the electron-electron interaction.

Binary file not shown.

Binary file not shown.

Binary file not shown.

Binary file not shown.

Binary file not shown.

Binary file not shown.

Binary file not shown.

Binary file not shown.

Binary file not shown.

Binary file not shown.

Binary file not shown.

Binary file not shown.

Binary file not shown.

View File

@ -0,0 +1,43 @@
This memoir concerns the research activities I have been involved in after the end of my PhD.
In a nutshell, my PhD work deals with excited electronic states of macromolecules, such as proteins, enzymes and DNA fragments, as well as the development of QM/MM methods which combine quantum mechanics and molecular mechanics methods.
Martin Karplus, Micheal Levitt and Arieh Warshel have been awarded the 2013 Nobel Prize in Chemistry for the seminal development of these methods.
During the three years of my PhD, I worked on the development of a new efficient hybrid QM/MM method, as well as its implementation in a quantum chemistry package \cite{Fornili06, SLBO07}.
Part of my research project aimed at investigating spectroscopic properties and solvation effects on large systems (core ionisations, UV/Vis and IR spectra of chromophoric units) with the help of density-functional theory (DFT) and its time-dependent version (TD-DFT) \cite{CI07, AB08}.
I have also made a series of more technical contributions, including:
\begin{itemize}
\item combination of orthogonalisation procedures \cite{CI07};
\item non-orthogonal molecular orbitals (biorthogonal basis sets) \cite{SLBO07};
\item variationally-optimised strictly localized orbitals \cite{SLBO07};
\item coupled-perturbated Hartree-Fock equations with non-variational orbitals;
\item TD-DFT/MM coupling \cite{AB08}.
\end{itemize}
Towards the end of my PhD, I turned to new chemical situations (DNA damage, Ru@DNA complexes, reducible disulfide bonds) for which one has to ensure a proper treatment of electronic attachment \cite{SS08a, SS08b, SS08c, SS09, DNA09, RuDNA10}.
After completing my PhD, I worked for four years as a postdoctoral fellow at the Research School of Chemistry (RSC) at the Australian National University (ANU) under the supervision of Prof.~Peter Gill.
During these years, I worked extensively on two-electron systems \cite{TEOAS09, EcLimit09, Frontiers10, Concentric10, Ballium10, EcProof10, QuasiExact09, Hook10, ExSpherium10, QR12, Exciton12}.
I also co-supervised one third-year undergraduate student (Yan Zhao) \cite{Yanium11} and one exchange student from Switzerland (Julian Strauss).
Some of this work is summarised in Chapter \ref{chap:two-electron}.
From 2013 to 2017, I was a DECRA recipient (roughly equivalent to a \textit{``ANR JCJC''}), which allowed me to concentrate on my research and steadily build my research group.
During that time, I was the group leader of the Mathematical and Theoretical Chemistry group at the RSC.
In 2014, I was awarded a Discovery Project (equivalent to a \textit{``Projet ANR''}), and I was promoted to senior lecturer.
Thanks to this Discovery Project grant, I hired a postdoctoral fellow (Dr Davids Agboola) on a one-year contract, followed by Dr Marat Sibaev on a two-year contract.
In 2016, I was a full-time lecturer at the ANU and a visiting Erskine fellow at the University of Canterbury.
I also organise with Deborah Crittenden (University of Canterbury, New Zealand) the \textit{2nd Quantum and Computational Chemistry Student Conference} in Christchurch NZ.
During my time at the ANU, I supervised three Master students (Anneke Knol, Sam Backwell and Fergus Rogers).
I also co-supervised two PhD students (Caleb Ball and Giuseppe Barca), who have both recently successfully completed their PhD.
In addition, I also supervised a dozen of undergraduate students: Dominic Weiller, Amy Kendrick, Ee-Faye Chong, Stuart Ferrie, Matt Plowman, Nathaniel Bloomfield, Anneke Knol, Daniel Hills, Nilupuli Senadhira, Wenqi Zhang, Harrison Barnett and Fergus Rogers.
During these years, I made several contributions on the uniform electron gas (UEG) models.
In particular, we introduced a new paradigm to study the UEG based on spherical geometry \cite{Glomium11}.
We showed that this new model is mathematically simple and well-suited to address some unsolved problems in the field.
I also worked on more conventional UEG models, and we published three papers reporting the derivation of the closed-form expression of energy expansion coefficients \cite{2DEG11, 3DEG11, 1DEG13}.
Some of the work we performed during that time is summarised in Chapter \ref{chap:DFT-UEG}.
More recently, I have devoted part of my time to the construction of accurate trial wave functions incorporating explicit electronic correlation.
Some of this work is discussed in Chapter \ref{chap:ManyElectronIntegrals}.
Since February 2017, I have been a CNRS researcher at the \textit{Laboratoire de Chimie et Physique Quantiques} at the Universit\'e Paul Sabatier in Toulouse.
The research projects we are currently pursuing are summarised in Chapter \ref{chap:future}.

View File

@ -0,0 +1,120 @@
\section*{Publications}
\begin{enumerate}
\item Garniron, Y.; Scemama, A.; \underline{Loos, P. F.}; Caffarel, M. Hybrid stochastic-deterministic calculation of the second-order perturbative contribution of multireference perturbation theory, \textit{J. Chem. Phys.}, \textbf{2017}, \textit{147}, 034101.
\item Barca, G. M. J.; \underline{Loos, P. F.} Three-electron and four-electron integrals involving Gaussian geminals: fundamental integrals, upper bounds and recurrence relations, \textit{J. Chem. Phys.}, \textbf{2017}, \textit{147}, 024103.
\item Barca, G. M. J.; \underline{Loos, P. F.} Recurrence relations for four-electron integrals over Gaussian basis functions, \textit{Adv. Quantum Chem.}, \textbf{2017}, (in press).
\item \underline{Loos, P. F.}; Rivail, J.-L.; Assfeld, X. Iterative stochastic subspace self-consistent field method, \textit{J. Mod. Mol.}, \textbf{2017}, \textit{23}, 173.
\item \underline{Loos, P. F.} Exchange functionals based on finite uniform electron gases, \textit{J. Chem. Phys.}, \textbf{2017}, \textit{146}, 114108.
\item Rogers, F. J. M.; \underline{Loos, P. F.} Excited-state Wigner crystals, \textit{J. Chem. Phys.}, \textbf{2017}, \textit{146}, 044114.
\item Ball, C. J.; \underline{Loos, P. F.}; Gill, P. M. W. Electronic structure calculations in one dimension, \textit{Phys. Chem. Chem. Phys.}, \textbf{2017}, \textit{19}, 3987.
\item Rogers, F. J. M.; Ball, C. J.; \underline{Loos, P. F.} Symmetry-broken local-density approximation for one-dimensional systems, \textit{Phys. Rev. B}, \textbf{2016}, \textit{93}, 235114.
\item \underline{Loos, P. F.}; Gill, P. M. W. The uniform electron gas, \textit{WIREs Comput. Mol. Sci.}, \textbf{2016}, \textit{6}, 410.
\item Barca, G. M. J.; \underline{Loos, P. F.}; Gill, P. M. W. Many-electron integrals over Gaussian basis functions. I. Recurrence relations for three-electron integrals, \textit{J. Chem. Theory Comput.}, \textbf{2016}, \textit{12}, 1735.
\item Tognetti, V; \underline{Loos, P. F.} Natural occupation numbers in two-electron quantum rings, \textit{J. Chem. Phys.}, \textbf{2016}, \textit{144}, 054108.
\item \underline{Loos, P. F.}; Bloomfield. N. J.; Gill, P. M. W. Three-electron coalescence points in two and three dimensions, \textit{J. Chem. Phys.}, \textbf{2015}, \textit{143}, 181101.
\item Agboola, D.; Knol. A. L.; Gill, P. M. W.; \underline{Loos, P. F.} Uniform electron gases: III. Low-density gases on three-dimensional spheres, \textit{J. Chem. Phys.}, \textbf{2015}, \textit{143}, 084114.
\item \underline{Loos, P. F.}; Bressanini, D. Nodal surfaces and interdimensional degeneracies, \textit{J. Chem. Phys.}, \textbf{2015}, \textit{142}, 214112.
\item \underline{Loos, P. F.}; Ball, C. J.; Gill, P. M. W. Chemistry in one dimension, \textit{Phys. Chem. Chem. Phys.}, \textbf{2015}, \textit{17}, 3196.
\item Gill, P. M. W.; \underline{Loos, P. F.}; Agboola, D. Basis functions for electronic structure calculations on spheres, \textit{J. Chem. Phys.}, \textbf{2014}, \textit{141}, 244102.
\item \underline{Loos, P. F.} Generalized local-density approximation and one-dimensional uniform electron gases, \textit{Phys. Rev. A}, \textbf{2014}, \textit{89}, 052523.
\item \underline{Loos, P. F.}; Ball, C. J.; Gill, P. M. W. Uniform electron gases. II. The generalized local density approximation in one dimension, \textit{J. Chem. Phys.}, \textbf{2014}, \textit{140}, 18A524.
\item \underline{Loos, P. F.}; Gill, P. M. W. Exact wave functions for concentric two-electron systems, \textit{Phys. Lett. A}, \textbf{2014}, \textit{378}, 329.
\item Bernard, Y. A.; \underline{Loos, P. F.}; Gill, P. M. W. Distribution of $r_{12} \cdot p_{12}$ in quantum systems, \textit{Mol. Phys.}, \textbf{2013}, \textit{111}, 2414.
\item \underline{Loos, P. F.}; Gill, P. M. W. Uniform electron gases. II. Electrons on a ring, \textit{J. Chem. Phys.}, \textbf{2013}, \textit{138}, 164124.
\item \underline{Loos, P. F.} High-density correlation energy expansion of the one-dimensional uniform electron gas, \textit{J. Chem. Phys.}, \textbf{2013}, \textit{138}, 064108.
\item \underline{Loos, P. F.} Understanding excitons using spherical geometry, \textit{Phys. Lett. A}, \textbf{2012}, \textit{376}, 1997.
\item \underline{Loos, P. F.}; Gill, P. M. W. Harmonically trapped jellium model, \textit{Mol. Phys.}, \textbf{2012}, \textit{108}, 083002.
\item \underline{Loos, P. F.}; Gill, P. M. W. Exact wave functions of two-electron quantum rings, \textit{Phys. Rev. Lett.}, \textbf{2012}, \textit{110}, 2337.
\item \underline{Loos, P. F.}; Gill, P. M. W. Leading-order behavior of the correlation energy in the uniform electron gas, \textit{Int. J. Quantum Chem.}, \textbf{2012}, \textit{112}, 1712.
\item Gill, P. M. W.; \underline{Loos, P. F.} Uniform electron gases, \textit{Theor. Chem. Acc.}, \textbf{2012}, \textit{131}, 1069.
\item \underline{Loos, P. F.}; Gill, P. M. W. Thinking outside the box: the uniform electron gas on a hypersphere, \textit{J. Chem. Phys.}, \textbf{2011}, \textit{135}, 214111.
\item Zhao, Y.; \underline{Loos, P. F.}; Gill, P. M. W. Correlation energy of anisotropic quantum dots, \textit{Phys. Rev. A}, \textbf{2011}, \textit{84}, 032513.
\item \underline{Loos, P. F.}; Gill, P. M. W. Correlation energy of the spin-polarized uniform electron gas at high density, \textit{Phys. Rev. B}, \textbf{2011}, \textit{84}, 033103.
\item \underline{Loos, P. F.}; Gill, P. M. W. Exact energy of the spin-polarized two-dimensional electron gas at high density, \textit{Phys. Rev. B}, \textbf{2011}, \textit{83}, 233102.
\item \underline{Loos, P. F.}; Gill, P. M. W. A tale of two electrons: correlation at high density, \textit{Chem. Phys. Lett.}, \textbf{2010}, \textit{500}, 1.
\item \underline{Loos, P. F.}; Gill, P. M. W. Invariance of the correlation energy at high density and large dimension for two-electron systems, \textit{Phys. Rev. Lett.}, \textbf{2010}, \textit{105}, 113001.
\item \underline{Loos, P. F.}; Gill, P. M. W. Excited states of spherium, \textit{Mol. Phys.}, \textbf{2010}, \textit{108}, 2527.
\item \underline{Loos, P. F.}; Gill, P. M. W. Correlation energy of two electrons in a ball, \textit{J. Chem. Phys.}, \textbf{2010}, \textit{132}, 234111.
\item \underline{Loos, P. F.}; Gill, P. M. W. Ground state of two electrons on concentric spheres, \textit{Phys. Rev. A}, \textbf{2010}, \textit{81}, 052510.
\item Ambrosek, D. \underline{Loos, P. F.}; Assfeld, X.; Daniel, C. Electronic absorption spectroscopy of Ru(II) polypyridyl DNA intercalators: a theoretical study, \textit{J. Inorg. Biochem.}, \textbf{2010}, \textit{104}, 893.
\item \underline{Loos, P. F.} Hooke's law correlation in two-electron systems, \textit{Phys. Rev. A}, \textbf{2010}, \textit{81}, 032510.
\item Dumont, E.; \underline{Loos, P. F.}; Laurent, A.; Assfeld, X. Electronic effects and ring strain influences on the electron uptake by selenium-containing bonds, \textit{Int. J. Quantum Chem.}, \textbf{2010}, \textit{110}, 513.
\item \underline{Loos, P. F.}; Gill, P. M. W. Correlation energy of two electrons in the high-density limit, \textit{J. Chem. Phys.}, \textbf{2009}, \textit{131}, 241101.
\item \underline{Loos, P. F.}; Gill, P. M. W. Two electrons on a hypersphere: a quasi-exactly solvable model, \textit{Phys. Rev. Lett.}, \textbf{2009}, \textit{103}, 123008.
\item \underline{Loos, P. F.}; Gill, P. M. W. Ground state of two electrons on a sphere, \textit{Phys. Rev. A}, \textbf{2009}, \textit{79}, 062517.
\item \underline{Loos, P. F.}; Dumont, E.; Laurent, A.; Assfeld, X. Important effects of neighboring nucleotides on electron induced DNA single-strand breaks, \textit{Chem. Phys. Lett.}, \textbf{2009}, \textit{475}, 120.
\item Dumont, E.; Laurent, A.; \underline{Loos, P. F.}; Assfeld, X. Analyzing the selectivity and successiveness of a two-electron capture on a multiply disulfide-linked protein, \textit{J. Chem. Theor. Comput.}, \textbf{2009}, \textit{5}, 1700.
\item Dumont, E.; \underline{Loos, P. F.}; Assfeld, X. Factors governing electron capture by small disulfide loops in two-cysteines peptides, \textit{J. Phys. Chem. B}, \textbf{2008}, \textit{112}, 13661.
\item Dumont, E.; \underline{Loos, P. F.}; Laurent, A.; Assfeld, X. Huge disulfide-linkage's reducible potential variation induced by $\alpha$-helix orientation, \textit{J. Chem. Theor. Comput.}, \textbf{2008}, \textit{4}, 1171.
\item Dumont, E.; \underline{Loos, P. F.}; Assfeld, X. Effect of ring strain on disulfide electron attachment, \textit{Chem. Phys. Lett.}, \textbf{2008}, \textit{458}, 276.
\item \underline{Loos, P. F.}; Preat, J.; Laurent, A.; Michaux, C.; Jacquemin, D.; Perp\`ete, E. A.; Assfeld, X. Theoretical investigation of the geometries and UV/Vis spectra of Poly(L-glutamic acid) featuring photochromic azobenzene side chain, \textit{J. Chem. Theor. Comput.}, \textbf{2008}, \textit{4}, 637.
\item \underline{Loos, P. F.}; Assfeld, X. On the frontier bond location in the QM/MM description of the peptides and proteins, \textit{AIP Conf. Proc.}, \textbf{2007}, \textit{963}, 308.
\item \underline{Loos, P. F.}; Fornili, A.; Sironi, M.; Assfeld, X. Removing the extra frontier parameters in QM/MM methods: a tentative with the Local Self-Consistent Field approach, \textit{Comput. Lett.} \textbf{2007}, \textit{4}, 473.
\item \underline{Loos, P. F.}; Assfeld, X. Core-ionized and core-excited states of macromolecules, \textit{Int. J. Quantum Chem.}, \textbf{2007}, \textit{107}, 2343.
\item Preat, J.; \underline{Loos, P. F.}; Assfeld, X.; Jacquemin, D.; Perp\`ete, E. A. A TD-DFT investigation of UV spectra of pyrano\"idic dyes: a NCM vs. PCM comparison, \textit{J. Mol. Struct. (THEOCHEM)}, \textbf{2007}, \textit{808}, 85.
\item \underline{Loos, P. F.}; Assfeld, X. Self-Consistent Strictly Localized Orbitals, \textit{J. Chem. Theor. Comput.}, \textbf{2007}, \textit{3}, 1047.
\item \underline{Loos, P. F.}; Assfeld, X.; Rivail, J.-L. Intramolecular interactions and cis peptidic bonds, \textit{Theor. Chem. Acc.}, \textbf{2007}, \textit{118}, 165.
\item Preat, J.; \underline{Loos, P. F.}; Assfeld, X.; Jacquemin, D.; Perp\`ete, E. A. DFT and TD-DFT investigation of IR and UV spectra of solvated molecules: comparison of two SCRF continuum models, \textit{Int. J. Quantum Chem.}, \textbf{2007}, \textit{107}, 574.
\item Rivail, J.-L.; Bouchy, A.; \underline{Loos, P. F.}, Electronic factors favouring the cis conformation in proline peptidic bonds, \textit{J. Argentine Chem. Soc.}, \textbf{2006}, \textit{94}, 19.
\item Fornili, A.; \underline{Loos, P. F.}; Sironi, M.; Assfeld, X. Frozen core orbitals as an alternative to specific frontier bond potential in hybrid Quantum Mechanics/Molecular Mechanics methods, \textit{Chem. Phys. Lett.}, \textbf{2006}, \textit{427}, 236.
\item Moreau, Y.; \underline{Loos, P. F.}; Assfeld, X. Solvent effects on the asymmetric Diels-Alder reaction between cyclopentadiene and (-)-menthyl acrylate revisited with the three-layer hybrid local self-consistent field/molecular mechanics/self-consistent reaction field method, \textit{Theor. Chem. Acc.}, \textbf{2004}, \textit{112}, 228.
\end{enumerate}

7838
Manuscript/main/HDR.bib Normal file

File diff suppressed because it is too large Load Diff

679
Manuscript/main/HDR.tex Normal file
View File

@ -0,0 +1,679 @@
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
% Masters/Doctoral Thesis
% LaTeX Template
% Version 2.5 (27/8/17)
%
% This template was downloaded from:
% http://www.LaTeXTemplates.com
%
% Version 2.x major modifications by:
% Vel (vel@latextemplates.com)
%
% This template is based on a template by:
% Steve Gunn (http://users.ecs.soton.ac.uk/srg/softwaretools/document/templates/)
% Sunil Patel (http://www.sunilpatel.co.uk/thesis-template/)
%
% Template license:
% CC BY-NC-SA 3.0 (http://creativecommons.org/licenses/by-nc-sa/3.0/)
%
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
%----------------------------------------------------------------------------------------
% PACKAGES AND OTHER DOCUMENT CONFIGURATIONS
%----------------------------------------------------------------------------------------
\documentclass[
11pt, % The default document font size, options: 10pt, 11pt, 12pt
%oneside, % Two side (alternating margins) for binding by default, uncomment to switch to one side
english, % ngerman for German
singlespacing, % Single line spacing, alternatives: onehalfspacing or doublespacing
%draft, % Uncomment to enable draft mode (no pictures, no links, overfull hboxes indicated)
%nolistspacing, % If the document is onehalfspacing or doublespacing, uncomment this to set spacing in lists to single
%liststotoc, % Uncomment to add the list of figures/tables/etc to the table of contents
%toctotoc, % Uncomment to add the main table of contents to the table of contents
%parskip, % Uncomment to add space between paragraphs
%nohyperref, % Uncomment to not load the hyperref package
headsepline, % Uncomment to get a line under the header
%chapterinoneline, % Uncomment to place the chapter title next to the number on one line
%consistentlayout, % Uncomment to change the layout of the declaration, abstract and acknowledgements pages to match the default layout
]{MastersDoctoralThesis} % The class file specifying the document structure
%\usepackage[utf8]{inputenc} % Required for inputting international characters
%\usepackage[T1]{fontenc} % Output font encoding for international characters
\usepackage{mathpazo} % Use the Palatino font by default
\usepackage[backend=bibtex,style=phys,natbib=true]{biblatex} % Use the bibtex backend with the authoryear citation style (which resembles APA)
\addbibresource{HDR.bib} % The filename of the bibliography
\usepackage[autostyle=true]{csquotes} % Required to generate language-dependent quotes in the bibliography
\usepackage{graphicx,dcolumn,bm,xcolor,microtype,hyperref,multirow,amscd,amsmath,amssymb,amsfonts,physics}
\usepackage[version=4]{mhchem}
\usepackage{algorithmicx,algorithm,algpseudocode}
\newcommand{\alert}[1]{\textcolor{red}{#1}}
\newcommand{\cdash}{\multicolumn{1}{c}{---}}
\newcommand{\mc}{\multicolumn}
\newcommand{\mcc}[1]{\multicolumn{1}{c}{#1}}
\newcommand{\mr}{\multirow}
\DeclareMathOperator{\erfc}{erfc}
%algorithm
\algnewcommand\algorithmicswitch{\textbf{switch}}
\algnewcommand\algorithmiccase{\textbf{case}}
\algnewcommand\algorithmicassert{\texttt{assert}}
\algnewcommand\Assert[1]{\State \algorithmicassert(#1)}
\algdef{SE}[SWITCH]{Switch}{EndSwitch}[1]{\algorithmicswitch\ #1\ \algorithmicdo} {\algorithmicend\ \algorithmicswitch}
\algdef{SE}[CASE]{Case}{EndCase}[1]{\algorithmiccase\ #1}{\algorithmicend\ \algorithmiccase}
\algtext*{EndSwitch}
\algtext*{EndCase}
\algrenewcommand{\algorithmiccomment}[1]{$\triangleright$ \textit{#1}}
\algnewcommand{\algorithmicgoto}{\textbf{go to}}%
\algnewcommand{\Goto}[1]{\algorithmicgoto~\ref{#1}}%
% wave functions
\newcommand{\PsiT}{\Psi_\text{T}}
\newcommand{\PsiEx}{\Psi_\text{ex}}
\newcommand{\PsiHF}{\Psi_\text{HF}}
\newcommand{\PsiCI}{\Psi_\text{CI}}
\newcommand{\PsiCC}{\Psi_\text{CC}}
\newcommand{\Js}{J}
\newcommand{\sdet}{D}
% orbitals
\newcommand{\sMO}[1]{\psi_{#1}}
\newcommand{\MO}[1]{\phi_{#1}}
\newcommand{\GTO}[1]{\chi_{#1}}
\newcommand{\AO}[1]{\chi_{#1}}
% Operators
\newcommand{\IdOp}{\Hat{I}}
\newcommand{\HOp}{\Hat{H}}
\newcommand{\POp}{\Hat{P}}
\newcommand{\QOp}{\Hat{Q}}
\newcommand{\TOp}{\Hat{T}}
\newcommand{\VOp}{\Hat{V}}
\newcommand{\DOp}{\Hat{D}}
\newcommand{\FkOp}{\Hat{F}}
\newcommand{\FOp}{\Hat{F}}
\newcommand{\HcOp}{\Hat{H}^\text{c}}
\newcommand{\JOp}{\Hat{J}}
\newcommand{\KOp}{\Hat{K}}
\newcommand{\TeOp}{\Hat{T}_\text{e}}
\newcommand{\VenOp}{\Hat{V}_\text{en}}
\newcommand{\VeeOp}{\Hat{V}_\text{ee}}
\newcommand{\VnnOp}{\Hat{V}_\text{nn}}
% Matrices
\newcommand{\IdMat}{\bm{I}}
\newcommand{\FkMat}{\bm{F}}
\newcommand{\PMat}{\bm{P}}
\newcommand{\HcMat}{\bm{H}^\text{c}}
\newcommand{\HMat}{\bm{H}}
\newcommand{\FMat}{\bm{F}}
\newcommand{\SMat}{\bm{S}}
\newcommand{\CMat}{\bm{C}}
\newcommand{\GMat}{\bm{G}}
\newcommand{\XMat}{\bm{X}}
\newcommand{\UMat}{\bm{U}}
\newcommand{\sMat}{\bm{s}}
\newcommand{\MOevMat}{\bm{\varepsilon}}
% matrix elements
\newcommand{\FkEl}[2]{F_{#1 #2}}
\newcommand{\PEl}[2]{P_{#1 #2}}
\newcommand{\HcEl}[2]{H^\text{c}_{#1 #2}}
\newcommand{\HEl}[2]{H_{#1 #2}}
\newcommand{\FEl}[2]{F_{#1 #2}}
\newcommand{\GEl}[2]{G_{#1 #2}}
\newcommand{\SEl}[2]{S_{#1 #2}}
\newcommand{\XEl}[2]{X_{#1 #2}}
% bold symbols
\newcommand{\br}{\bm{r}}
\newcommand{\bx}{\bm{x}}
\newcommand{\bs}{\bm{s}}
\newcommand{\bR}{\bm{R}}
\newcommand{\bN}{\bm{N}}
\newcommand{\bX}{\bm{X}}
\newcommand{\rA}{r_A}
\newcommand{\rB}{r_B}
\newcommand{\brA}{\br_A}
\newcommand{\brB}{\br_B}
\newcommand{\ri}{r_i}
\newcommand{\rj}{r_j}
\newcommand{\rij}{r_{ij}}
\newcommand{\ree}{r_{12}}
\newcommand{\bri}{\br_i}
\newcommand{\brj}{\br_j}
\newcommand{\bA}{\mathbf{A}}
\newcommand{\bB}{\mathbf{B}}
\newcommand{\bC}{\mathbf{C}}
\newcommand{\bO}{\mathbf{0}}
% coefficients
\newcommand{\cCI}[2]{c_{#1}^{#2}}
\newcommand{\cMO}[2]{c_{#1 #2}}
% energies
\newcommand{\EHF}{E_\text{HF}}
\newcommand{\EKS}{E_\text{KS}}
\newcommand{\ECI}{E_\text{CI}}
\newcommand{\ECC}{E_\text{CC}}
\newcommand{\Ec}{E_\text{c}}
\newcommand{\Eee}{E_\text{ee}}
\newcommand{\Ts}{T_\text{s}}
\newcommand{\J}{J}
\newcommand{\Ex}{E_\text{x}}
\newcommand{\Exc}{E_\text{xc}}
\newcommand{\Ene}{E_\text{ne}}
\newcommand{\EVMC}{E_\text{VMC}}
\newcommand{\EDMC}{E_\text{DMC}}
\newcommand{\MOev}[1]{\varepsilon_{#1}}
% potentials
\newcommand{\vxc}{v_\text{xc}}
% Determinants
\newcommand{\ExDet}[2]{\Psi_{#1}^{#2}}
% others
\newcommand{\nuc}{\text{nuc}}
\newcommand{\occ}{\text{occ}}
\newcommand{\virt}{\text{virt}}
% DFT
\newcommand{\Fx}{F_{\text{x}}}
%
\newcommand{\gX}{gX}
\newcommand{\HgX}{HgX}
\newcommand{\GX}{GX}
\newcommand{\HGX}{HGX}
\newcommand{\PBEGX}{PBE-GX}
%
\newcommand{\FxgX}{F_{\text{x}}^\text{\gX}}
\newcommand{\FxHgX}{F_{\text{x}}^\text{\HgX}}
\newcommand{\FxGX}{F_{\text{x}}^\text{\GX}}
\newcommand{\FxHGX}{F_{\text{x}}^\text{\HGX}}
\newcommand{\FxPBEGX}{F_{\text{x}}^\text{\PBEGX}}
%
\newcommand{\ExLDA}{E_{\text{x}}^\text{LDA}}
\newcommand{\FxGGA}{F_{\text{x}}^\text{GGA}}
\newcommand{\FxGLDA}{F_{\text{x}}^\text{GLDA}}
\newcommand{\FxMGGA}{F_{\text{x}}^\text{MGGA}}
\newcommand{\FxFMGGA}{F_{\text{x}}^\text{FMGGA}}
\newcommand{\ExsLDA}{E_{\text{x},\sigma}^\text{LDA}}
\newcommand{\ExsGGA}{E_{\text{x},\sigma}^\text{GGA}}
\newcommand{\ExsGLDA}{E_{\text{x},\sigma}^\text{GLDA}}
\newcommand{\exsLDA}{e_{\text{x},\sigma}^\text{LDA}}
\newcommand{\exsGGA}{e_{\text{x},\sigma}^\text{GGA}}
\newcommand{\exsGLDA}{e_{\text{x},\sigma}^\text{GLDA}}
\newcommand{\exsMGGA}{e_{\text{x},\sigma}^\text{MGGA}}
\newcommand{\exsFMGGA}{e_{\text{x},\sigma}^\text{FMGGA}}
\newcommand{\CxLDA}{C_\text{x}^\text{LDA}}
\newcommand{\CxGLDA}{C_\text{x}^\text{GLDA}}
\newcommand{\Cx}{C_\text{x}}
\newcommand{\Cf}{C_\text{F}}
\newcommand{\rs}{\rho_\sigma}
\newcommand{\xs}{x_\sigma}
\newcommand{\ts}{\tau_\sigma}
\newcommand{\as}{\alpha_\sigma}
\newcommand{\ns}{n_\sigma}
\newcommand{\Ls}{L_\sigma}
\newcommand\upa{\uparrow}
\newcommand\dwa{\downarrow}
% integrals
\usepackage[version=4]{mhchem}
\newcommand{\sba}{\mathring{a}}
\newcommand{\sbb}{\mathring{b}}
\newcommand{\sbp}{\mathring{p}}
\newcommand{\sbz}{\mathring{z}}
\newcommand{\sbd}{\mathring{\delta}}
\newcommand{\sbD}{\mathring{\Delta}}
\newcommand{\sbzeta}{\mathring{\zeta}}
\newcommand*\elide{\textup{[\,\dots]}}
\newcommand{\Db}{\check{\Delta}}
\newcommand{\sbR}{\mathring{R}}
\newcommand{\sbY}{\mathring{Y}}
\newcommand{\sbZ}{\mathring{Z}}
\newcommand{\bAB}{\mathbf{AB}}
\newcommand{\bG}{\mathbf{G}}
\newcommand{\bY}{\mathbf{Y}}
\newcommand{\bZ}{\mathbf{Z}}
\newcommand{\la}{\lambda}
\newcommand{\eps}{\varepsilon}
\newcommand{\Lo}{L}
\newcommand{\bo}{\mathbf{0}}
\newcommand{\barS}{\Bar{S}}
\newcommand{\ba}{\bm{a}}
\newcommand{\bb}{\bm{b}}
\newcommand{\Po}{\mathcal{P}}
\newcommand{\ssc}{\scriptscriptstyle}
\newcommand{\Rb}{\mathcal{R}}
\newcommand{\purple}[1]{\textcolor{purple}{#1}}
\newcommand{\orange}[1]{\textcolor{orange}{#1}}
\newcommand{\green}[1]{\textcolor{green}{#1}}
\newcommand{\blue}[1]{\textcolor{blue}{#1}}
\newcommand{\alphaup}{\hat{\alpha}}
\newcommand{\Lup}{\hat{a}}
\newcommand{\hztup}{\hat{\hzt}}
\newcommand{\hztdw}{\check{\hzt}}
\newcommand{\Deltaup}{\hat{\Delta}}
\newcommand{\Deltadw}{\check{\Delta}}
\newcommand{\deltadw}{\check{\delta}}
\newcommand{\Lambdaup}{\hat{\Lambda}}
\newcommand{\Lambdadw}{\check{\Lambda}}
\newcommand{\hzt}{\xi}
\newcommand{\sbra}[1]{[ #1 |}
\newcommand{\sket}[1]{| #1 ]}
\newcommand{\sexpval}[1]{[ #1 ]}
\newcommand{\sbraket}[2]{[ #1 | #2 ]}
\newcommand{\smel}[3]{[ #1 | #2 | #3 ]}
\newcommand{\shield}{\sigma}
\newcommand{\mfac}{\sexpval{\widehat{1}}}
\newcommand{\cfac}{\sexpval{\widetilde{1}}}
\newcommand{\shopt}{\mathring{\sigma}}
\newcommand{\shO}{\mathring{\omega}_{1}}
\newcommand{\shOij}{\mathring{\omega}_{1ij}}
\newcommand{\cmax}[1]{\langle\widehat{#1}\rangle}
% Dressed CI
\newcommand{\oH}{\mathring{H}}
\newcommand{\EPT}{E_\text{PT2}}
\newcommand{\NGG}{N_\text{GG}}
\newcommand{\mA}{\mathcal{A}}
\newcommand{\mC}{\mathcal{C}}
\newcommand{\mD}{\mathcal{D}}
\newcommand{\mE}{\mathcal{E}}
\newcommand{\mK}{\mathcal{K}}
\newcommand{\mF}{\mathcal{F}}
\newcommand{\mL}{\mathcal{L}}
\newcommand{\kA}{\ket{A}}
\newcommand{\kD}{\ket{D}}
\newcommand{\kI}{\ket{I}}
\newcommand{\kJ}{\ket{J}}
\newcommand{\kE}{\ket{E}}
\newcommand{\kK}{\ket{K}}
\newcommand{\kL}{\ket{L}}
\newcommand{\kF}{\ket{F}}
\newcommand{\kO}{\ket{0}}
% Dressed e-n cusp
\newcommand{\DrSym}[1]{\Tilde{#1}}
% wave functions and orbitals
\newcommand{\ExactPsi}{\Phi}
\newcommand{\MOsA}[1]{\mathring{\MO{#1}}}
\newcommand{\STO}[2]{{\DrSym{\chi}_{#1}}^{#2}}
\newcommand{\ccedMO}[1]{\DrSym{\MO{#1}}}
\newcommand{\ccingMO}[1]{\varphi_{#1}}
% coefficients
\newcommand{\cGTO}[2]{c_{#1 #2}}
\newcommand{\cSTO}[2]{\DrSym{c}_{#1 #2}}
\newcommand{\bcGTO}{\bm{c}}
\newcommand{\bcSTO}{\DrSym{\bm{c}}}
% exponents
\newcommand{\expSTOa}{\DrSym{\alpha}}
\newcommand{\expSTOb}{\DrSym{\beta}}
% hat operators
\newcommand{\hFk}{\Hat{f}}
\newcommand{\hHc}{\Hat{h}}
% matrices
\newcommand{\bFk}{\bm{F}}
\newcommand{\bHc}{\bm{h}}
\newcommand{\bP}{\bm{P}}
\newcommand{\bDrFkOp}[1]{\DrSym{\bm{F}}^{#1}}
\newcommand{\bDr}[1]{\bm{D}^{#1}}
\newcommand{\bDrFk}[1]{\DrSym{\bm{F}}^{#1}}
\newcommand{\bDrHc}[1]{\DrSym{\bm{h}}^{#1}}
\newcommand{\bDrKi}[1]{\DrSym{\bm{T}}^{#1}}
\newcommand{\bDrPo}[1]{\DrSym{\bm{V}}^{#1}}
\newcommand{\bDrOv}[1]{\DrSym{\bm{S}}^{#1}}
\newcommand{\bMOeigval}{\bm{\varepsilon}}
\newcommand{\bDrMOeigval}{\DrSym{\bm{\varepsilon}}}
% matrix elements
\newcommand{\DrFkEl}[3]{\DrSym{F}_{#1 #2}^{#3}}
\newcommand{\DrFkOpEl}[3]{\DrSym{F}_{#1 #2}^{#3}}
\newcommand{\DrHcEl}[3]{\DrSym{h}_{#1 #2}^{#3}}
\newcommand{\DrKiEl}[3]{\DrSym{T}_{#1 #2}^{#3}}
\newcommand{\DrPoEl}[3]{\DrSym{V}_{#1 #2}^{#3}}
\newcommand{\DrOvEl}[3]{\DrSym{S}_{#1 #2}^{#3}}
\newcommand{\DrEl}[2]{\DrSym{D}_{#1}^{#2}}
\newcommand{\MOeigval}[1]{\varepsilon_{#1}}
\newcommand{\DrMOeigval}[1]{\DrSym{\varepsilon}_{#1}}
%----------------------------------------------------------------------------------------
% MARGIN SETTINGS
%----------------------------------------------------------------------------------------
\geometry{
paper=a4paper, % Change to letterpaper for US letter
inner=2.5cm, % Inner margin
outer=3.8cm, % Outer margin
bindingoffset=.5cm, % Binding offset
top=1.5cm, % Top margin
bottom=1.5cm, % Bottom margin
%showframe, % Uncomment to show how the type block is set on the page
}
%----------------------------------------------------------------------------------------
% THESIS INFORMATION
%----------------------------------------------------------------------------------------
\thesistitle{Functionals, Integrals, Spheres \& Cusps} % Your thesis title, this is used in the title and abstract, print it elsewhere with \ttitle
\supervisor{} % Your supervisor's name, this is used in the title page, print it elsewhere with \supname
\examiner{} % Your examiner's name, this is not currently used anywhere in the template, print it elsewhere with \examname
\degree{Habilitation \`a diriger les recherches} % Your degree name, this is used in the title page and abstract, print it elsewhere with \degreename
\author{Pierre-Fran{\c c}ois Loos} % Your name, this is used in the title page and abstract, print it elsewhere with \authorname
\addresses{} % Your address, this is not currently used anywhere in the template, print it elsewhere with \addressname
\subject{Theoretical Chemistry} % Your subject area, this is not currently used anywhere in the template, print it elsewhere with \subjectname
\keywords{correlation energy; quasi-exactly solvable models; uniform electron gas; many-electron integrals, density-functional theory; explicitly-correlated methods; quantum Monte Carlo methods} % Keywords for your thesis, this is not currently used anywhere in the template, print it elsewhere with \keywordnames
\university{\href{http://www.university.com}{Universit\'e Toulouse III, Paul Sabatier}} % Your university's name and URL, this is used in the title page and abstract, print it elsewhere with \univname
\department{\href{http://www.lcpq.ups-tlse.fr}{Laboratoire de Chimie et Physique Quantiques}} % Your department's name and URL, this is used in the title page and abstract, print it elsewhere with \deptname
\group{\href{http://researchgroup.university.com}{Universit\'e de Toulouse, CNRS, UPS, France}} % Your research group's name and URL, this is used in the title page, print it elsewhere with \groupname
\faculty{\href{http://faculty.university.com}{}} % Your faculty's name and URL, this is used in the title page and abstract, print it elsewhere with \facname
\AtBeginDocument{
\hypersetup{pdftitle=\ttitle} % Set the PDF's title to your title
\hypersetup{pdfauthor=\authorname} % Set the PDF's author to your name
\hypersetup{pdfkeywords=\keywordnames} % Set the PDF's keywords to your keywords
}
\begin{document}
\frontmatter % Use roman page numbering style (i, ii, iii, iv...) for the pre-content pages
\pagestyle{plain} % Default to the plain heading style until the thesis style is called for the body content
%----------------------------------------------------------------------------------------
% TITLE PAGE
%----------------------------------------------------------------------------------------
\begin{titlepage}
\begin{center}
\vspace*{.06\textheight}
{\scshape\LARGE \univname\par}\vspace{1.5cm} % University name
\textsc{\Large Habilitation \`a diriger les recherches}\\[0.5cm] % Thesis type
\HRule \\[0.4cm] % Horizontal line
{\huge \bfseries \ttitle\par}\vspace{0.4cm} % Thesis title
\HRule \\[1.5cm] % Horizontal line
\begin{minipage}[t]{0.4\textwidth}
\begin{flushleft} \large
\emph{Author:}\\
\href{http://www.irsamc.ups-tlse.fr/loos/}{\authorname} % Author name - remove the \href bracket to remove the link
\end{flushleft}
\end{minipage}
\begin{minipage}[t]{0.5\textwidth}
\begin{flushright} \large
\emph{Panel:} \\
\href{http://www.lpt.ups-tlse.fr/spip.php?article49&lang=en}{Pierre Pujol} (president) \\
\href{https://www.quantummatter.eu}{Paola Gori-Giorgi} (reviewer) \\
\href{https://quantique.u-strasbg.fr/doku.php?id=en:pageperso:ef:welcome}{Emmanuel Fromager} (reviewer) \\
\href{http://www.lct.jussieu.fr/pagesperso/toulouse/}{Julien Toulouse} (reviewer) \\
\href{http://qmcchem.ups-tlse.fr/index.php?title=Michel_Caffarel}{Michel Caffarel} (supervisor)
\end{flushright}
\end{minipage}\\[1cm]
\vfill
\large \textit{A thesis submitted in fulfillment of the requirements\\ for the degree of \degreename}\\[0.3cm] % University requirement text
\textit{in the}\\[0.4cm]
\groupname\\\deptname\\[2cm] % Research group name and department name
\vfill
{\large January 25, 2018}\\[4cm] % Date
%\includegraphics{Logo} % University/department logo - uncomment to place it
\vfill
\end{center}
\end{titlepage}
%----------------------------------------------------------------------------------------
% DECLARATION PAGE
%----------------------------------------------------------------------------------------
%\begin{declaration}
%\addchaptertocentry{\authorshipname} % Add the declaration to the table of contents
%\noindent I, \authorname, declare that this thesis titled, \enquote{\ttitle} and the work presented in it are my own. I confirm that:
%\begin{itemize}
%\item This work was done wholly or mainly while in candidature for a research degree at this University.
%\item Where any part of this thesis has previously been submitted for a degree or any other qualification at this University or any other institution, this has been clearly stated.
%\item Where I have consulted the published work of others, this is always clearly attributed.
%\item Where I have quoted from the work of others, the source is always given. With the exception of such quotations, this thesis is entirely my own work.
%\item I have acknowledged all main sources of help.
%\item Where the thesis is based on work done by myself jointly with others, I have made clear exactly what was done by others and what I have contributed myself.\\
%\end{itemize}
%\noindent Signed:\\
%\rule[0.5em]{25em}{0.5pt} % This prints a line for the signature
%\noindent Date:\\
%\rule[0.5em]{25em}{0.5pt} % This prints a line to write the date
%\end{declaration}
%\cleardoublepage
%----------------------------------------------------------------------------------------
% QUOTATION PAGE
%----------------------------------------------------------------------------------------
%\vspace*{0.2\textheight}
%
%\noindent\enquote{\itshape Dans la poudreuse, on est tous champion du monde. [...] Y'en pas pu un d\`es que c'est raide et un peu gel\'e.}\bigbreak
%
%\hfill Marco Siffredi
%----------------------------------------------------------------------------------------
% ABSTRACT PAGE
%----------------------------------------------------------------------------------------
\begin{abstract}
%\addchaptertocentry{\abstractname} % Add the abstract to the table of contents
In this memoir, after a brief introduction of the various quantum chemistry methods considered here, I summarise some of the projects we have been working on in the last ten years.
First, I describe succinctly several studies we have been doing on model two-electron systems.
In particular, we introduced a novel class a quasi-exactly solvable systems that we have been studying exhaustively in several papers.
Following this work, we shed new lights on the universality of correlation effects in two-electrons systems.
The discovery we have made are discussed.
Second, I present the work we performed on the mathematical properties of a new family of uniform electron gases as well as the development of a new class of density functionals based on this new paradigm.
Third, new recurrence relations for three- and four-electron integrals as well as their fundamental integrals and upper bounds are discussed.
In particular, our strategy to bound rigorously and efficiently these many-electron integrals is presented.
This new way of calculating many-electron integrals represents an interesting alternative to what is currently done in explicitly-correlated methods.
Finally, I present two lines of research we have been pursuing recently, namely the development of explicitly-correlated configuration interaction methods and a self-consistent correction to enforce the electron-nucleus cusp in molecular orbitals.
\end{abstract}
%----------------------------------------------------------------------------------------
% ACKNOWLEDGEMENTS
%----------------------------------------------------------------------------------------
%\begin{acknowledgements}
%\addchaptertocentry{\acknowledgementname} % Add the acknowledgements to the table of contents
%I would like to thank... absolutely nobody!
%\end{acknowledgements}
%----------------------------------------------------------------------------------------
% LIST OF CONTENTS/FIGURES/TABLES PAGES
%----------------------------------------------------------------------------------------
\tableofcontents % Prints the main table of contents
%\listoffigures % Prints the list of figures
%\listoftables % Prints the list of tables
%----------------------------------------------------------------------------------------
% ABBREVIATIONS
%----------------------------------------------------------------------------------------
%\begin{abbreviations}{ll} % Include a list of abbreviations (a table of two columns)
%
%\textbf{LAH} & \textbf{L}ist \textbf{A}bbreviations \textbf{H}ere\\
%\textbf{WSF} & \textbf{W}hat (it) \textbf{S}tands \textbf{F}or\\
%
%\end{abbreviations}
%----------------------------------------------------------------------------------------
% PHYSICAL CONSTANTS/OTHER DEFINITIONS
%----------------------------------------------------------------------------------------
%\begin{constants}{lr@{${}={}$}l} % The list of physical constants is a three column table
% The \SI{}{} command is provided by the siunitx package, see its documentation for instructions on how to use it
%Speed of Light & $c_{0}$ & \SI{2.99792458e8}{\meter\per\second} (exact)\\
%Constant Name & $Symbol$ & $Constant Value$ with units\\
%\end{constants}
%----------------------------------------------------------------------------------------
% SYMBOLS
%----------------------------------------------------------------------------------------
%\begin{symbols}{lll} % Include a list of Symbols (a three column table)
%$a$ & distance & \si{\meter} \\
%$P$ & power & \si{\watt} (\si{\joule\per\second}) \\
%Symbol & Name & Unit \\
%\addlinespace % Gap to separate the Roman symbols from the Greek
%$\omega$ & angular frequency & \si{\radian} \\
%\end{symbols}
%----------------------------------------------------------------------------------------
% DEDICATION
%----------------------------------------------------------------------------------------
%\dedicatory{A mon v\'elo \dots}
%----------------------------------------------------------------------------------------
% THESIS CONTENT - CHAPTERS
%----------------------------------------------------------------------------------------
\mainmatter % Begin numeric (1,2,3...) page numbering
\pagestyle{thesis} % Return the page headers back to the "thesis" style
% Include the chapters of the thesis as separate files from the Chapters folder
% Uncomment the lines as you write the chapters
%----------------------------------------------------------------
% INTRODUCTION
%----------------------------------------------------------------
\chapter*{
\label{chap:intro}
Introduction}
\addchaptertocentry{Introduction}
%----------------------------------------------------------------
\input{../Intro/intro.tex}
\input{../Intro/publications.tex}
%----------------------------------------------------------------
% CHAPTER 1
%----------------------------------------------------------------
\chapter{
\label{chap:method}
Methods}
%----------------------------------------------------------------
\input{../Chapter1/chapter1.tex}
%----------------------------------------------------------------
% CHAPTER 2
%----------------------------------------------------------------
\chapter{
\label{chap:two-electron}
Correlation in two-electron systems}
%----------------------------------------------------------------
\input{../Chapter2/chapter2.0.tex}
\input{../Chapter2/chapter2.1.tex}
\input{../Chapter2/chapter2.2.tex}
\input{../Chapter2/summary.tex}
%----------------------------------------------------------------
% CHAPTER 3
%----------------------------------------------------------------
\chapter{
\label{chap:DFT-UEG}
DFT using finite uniform electron gases}
%----------------------------------------------------------------
\input{../Chapter3/chapter3.0.tex}
\input{../Chapter3/chapter3.1.tex}
\input{../Chapter3/chapter3.2.tex}
\input{../Chapter3/summary.tex}
%----------------------------------------------------------------
% CHAPTER 4
%----------------------------------------------------------------
\chapter{
\label{chap:ManyElectronIntegrals}
Many-electron integrals involving Gaussian geminals}
%----------------------------------------------------------------
\input{../Chapter4/chapter4.0.tex}
\input{../Chapter4/chapter4.1.tex}
\input{../Chapter4/chapter4.2.tex}
\input{../Chapter4/chapter4.3.tex}
\input{../Chapter4/chapter4.4.tex}
\input{../Chapter4/chapter4.5.tex}
\input{../Chapter4/chapter4.6.tex}
\input{../Chapter4/summary.tex}
%----------------------------------------------------------------
% CHAPTER 5
%----------------------------------------------------------------
\chapter{
\label{chap:future}
Future directions}
%----------------------------------------------------------------
\input{../Chapter5/chapter5.0.tex}
\input{../Chapter5/chapter5.1.tex}
\input{../Chapter5/chapter5.2.tex}
\input{../Chapter5/summary.tex}
%----------------------------------------------------------------
% CONCLUSION
%----------------------------------------------------------------
\chapter*{
\label{chap:conclusion}
Conclusion}
\addchaptertocentry{Conclusion}
%----------------------------------------------------------------
\input{../Conclusion/conclusion.tex}
%----------------------------------------------------------------------------------------
% THESIS CONTENT - APPENDICES
%----------------------------------------------------------------------------------------
%\appendix % Cue to tell LaTeX that the following "chapters" are Appendices
% Include the appendices of the thesis as separate files from the Appendices folder
% Uncomment the lines as you write the Appendices
%\include{Appendices/AppendixA}
%----------------------------------------------------------------------------------------
% BIBLIOGRAPHY
%----------------------------------------------------------------------------------------
\printbibliography[heading=bibintoc]
%----------------------------------------------------------------------------------------
\end{document}

View File

@ -0,0 +1,544 @@
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
% Masters/Doctoral Thesis
% Class File
% Version 1.6 (27/8/17)
%
% This class was downloaded from:
% http://www.LaTeXTemplates.com
%
% Authors:
% Vel (vel@latextemplates.com)
% Johannes Böttcher
%
% Notes:
% 1) This class file defines the structure and layout of the template file (main.tex).
% 2) It has been written in such a way that under most circumstances you should not need
% to edit it; updating it to a newer version will be harder. If you do make changes, please change the name of
% the file and add comments to make your changes more visible.
%
% Class license:
% LPPL v1.3c (http://www.latex-project.org/lppl)
%
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
%----------------------------------------------------------------------------------------
% CLASS DEFINITION AND PARAMETERS
%----------------------------------------------------------------------------------------
\NeedsTeXFormat{LaTeX2e}[1996/12/01]
\newcommand{\classname}{MastersDoctoralThesis}
\ProvidesClass{\classname}[2016/11/22 v1.5 LaTeXTemplates.com]
\providecommand{\baseclass}{book}
\RequirePackage{etoolbox}
\RequirePackage{xparse}
\newbool{nolistspace}
\newbool{chapteroneline}
\newbool{listtoc}
\newbool{toctoc}
\newbool{parskip}
\newbool{hyperrefsupport}
\booltrue{hyperrefsupport}
\newbool{headsepline}
\newbool{consistentlayout}
\DeclareOption{nohyperref}{\boolfalse{hyperrefsupport}}
\DeclareOption{nolistspacing}{\booltrue{nolistspace}}
\DeclareOption{liststotoc}{\booltrue{listtoc}}
\DeclareOption{chapterinoneline}{\booltrue{chapteroneline}}
\DeclareOption{toctotoc}{\booltrue{toctoc}}
\DeclareOption{parskip}{\booltrue{parskip}}
\DeclareOption{headsepline}{\booltrue{headsepline}}
\DeclareOption{consistentlayout}{\booltrue{consistentlayout}}
\DeclareOption*{\PassOptionsToClass{\CurrentOption}{\baseclass}}
\ProcessOptions\relax
\LoadClass{\baseclass}
% Simple interface for the user to customize the chapter titles
\ProvideDocumentCommand{\abovechapterskip}{}{\vspace*{20pt}}
\ProvideDocumentCommand{\chapterbelowskip}{}{\vspace*{40pt}}
\ProvideDocumentCommand{\chapterinbetweenskip}{}{\vspace*{20pt}}
\ProvideDocumentCommand{\autodot}{}{}
\ProvideDocumentCommand{\mdtChapapp}{}{}
\ProvideDocumentCommand{\chapteralign}{}{\raggedright}
\ProvideDocumentCommand{\chapterfont}{}{\Huge\bfseries}
\ProvideDocumentCommand{\chapterprefixfont}{}{\LARGE\bfseries}
\DeclareDocumentCommand{\@makechapterhead}{ m }{%
\abovechapterskip
{\parindent \z@ \chapteralign \normalfont
\ifnum \c@secnumdepth >\m@ne
\if@mainmatter
\ifbool{chapteroneline}{%
\chapterfont \mdtChapapp\thechapter\autodot\enspace
}{%
\chapterprefixfont \@chapapp\space \thechapter
\par\nobreak
\chapterinbetweenskip
}%
\fi
\fi
\interlinepenalty\@M%
\chapterfont #1\par\nobreak
\chapterbelowskip
}
\thispagestyle{\chapter@p@gestyle}
}
\def\@makeschapterhead#1{%
\abovechapterskip
{\parindent \z@ \chapteralign
\normalfont
\interlinepenalty\@M
\chapterfont #1\par\nobreak
\chapterbelowskip
}
\thispagestyle{\chapter@p@gestyle}
}
% Addchap provides unnumbered chapters with an entry in the table of contents as well as an updated header
\ProvideDocumentCommand{\addchap}{ s o m }{%
\chapter*{#3}%
\markboth{}{}%
\IfBooleanTF{#1}{%
}{%
\IfNoValueTF{#2}{%
\addchaptertocentry{#3}%
\markboth{\MakeMarkcase{#3}}{\MakeMarkcase{#3}}%
}{%
\addchaptertocentry{#2}%
\markboth{\MakeMarkcase{#2}}{\MakeMarkcase{#2}}%
}%
}%
}%
\ProvideDocumentCommand{\addsec}{ s o m }{%
\section*{#3}%
\markright{}%
\IfBooleanTF{#1}{%
}{%
\IfNoValueTF{#2}{%
\addcontentsline{toc}{section}{#3}%
\markright{\MakeMarkcase{#3}}%%
}{%
\addcontentsline{toc}{section}{#2}%
\markright{\MakeMarkcase{#2}}%
}%
}%
}%
%----------------------------------------------------------------------------------------
% CLASS OPTIONS
%----------------------------------------------------------------------------------------
\ifbool{parskip}{\RequirePackage{parskip}} % If the parskip option is passed to the class, require the parskip package
\ifbool{listtoc}{% If the liststotoc option has been passed to the class, add the lists to the table of contents
\patchcmd{\listoftables}{\@starttoc{lot}}{%
\addchaptertocentry{\listtablename}\@starttoc{lot}%
}{}{}%
\patchcmd{\listoffigures}{\@starttoc{lof}}{%
\addchaptertocentry{\listfigurename}\@starttoc{lof}%
}{}{}%
}
\ifbool{toctoc}{% If the toctotoc options has been passed to the class, add the table of contents to the table of contents
\patchcmd{\tableofcontents}{\@starttoc{toc}%
}{%
\addchaptertocentry{\contentsname}\@starttoc{toc}}{}{}%
}
\patchcmd{\tableofcontents}{\MakeUppercase}{\MakeMarkcase}{}{}
\patchcmd{\tableofcontents}{\MakeUppercase}{\MakeMarkcase}{}{}
\patchcmd{\listoffigures}{\MakeUppercase}{\MakeMarkcase}{}{}
\patchcmd{\listoffigures}{\MakeUppercase}{\MakeMarkcase}{}{}
\patchcmd{\listoftables}{\MakeUppercase}{\MakeMarkcase}{}{}
\patchcmd{\listoftables}{\MakeUppercase}{\MakeMarkcase}{}{}
% If the option `nolistspacing' is given, the spacing in the different lists is reduced to single spacing. This option is only useful, if the spacing of the document has been changed to onehalfspacing or doublespacing.
\ifbool{nolistspace}{
\patchcmd{\listoffigures}{%
\@starttoc{lof}
}{%
\begingroup%
\singlespace\@starttoc{lof}\endgroup%
}{}{}%
\patchcmd{\listoftables}{%
\@starttoc{lot}
}{%
\begingroup%
\singlespace\@starttoc{lot}\endgroup%
}{}{}%
\patchcmd{\tableofcontents}{%
\@starttoc{toc}
}{%
\begingroup%
\singlespace\@starttoc{toc}\endgroup%
}{}{}%
}{}
%----------------------------------------------------------------------------------------
% REQUIRED PACKAGES
%----------------------------------------------------------------------------------------
\RequirePackage{babel} % Required for automatically changing names of document elements to languages besides english
\RequirePackage{scrbase} % Required for handling language-dependent names of sections/document elements
\RequirePackage{scrhack} % Loads fixes for various packages
\RequirePackage{setspace} % Required for changing line spacing
\RequirePackage{longtable} % Required for tables that span multiple pages (used in the symbols, abbreviations and physical constants pages)
\RequirePackage{siunitx} % Required for \SI commands
\RequirePackage{graphicx} % Required to include images
\graphicspath{{Figures/}{./}} % Specifies where to look for included images
\RequirePackage{booktabs} % Required for better table rules
\RequirePackage{caption} % Required for customising the captions
\captionsetup{justification=centerlast,font=small,labelfont=sc,margin=50pt}
%----------------------------------------------------------------------------------------
% DEFINE CUSTOM THESIS INFORMATION COMMANDS
%----------------------------------------------------------------------------------------
\NewDocumentCommand{\thesistitle} { o m }{%
\IfValueTF{#1}{\def\shorttitle{#1}}{\def\shorttitle{#2}}%
\def\@title{#2}%
\def\ttitle{#2}%
}
\DeclareDocumentCommand{\author}{m}{\newcommand{\authorname}{#1}\renewcommand{\@author}{#1}}
\NewDocumentCommand{\supervisor}{m}{\newcommand{\supname}{#1}}
\NewDocumentCommand{\examiner}{m}{\newcommand{\examname}{#1}}
\NewDocumentCommand{\degree}{m}{\newcommand{\degreename}{#1}}
\NewDocumentCommand{\addresses}{m}{\newcommand{\addressname}{#1}}
\NewDocumentCommand{\university}{m}{\newcommand{\univname}{#1}}
\NewDocumentCommand{\department}{m}{\newcommand{\deptname}{#1}}
\NewDocumentCommand{\group}{m}{\newcommand{\groupname}{#1}}
\NewDocumentCommand{\faculty}{m}{\newcommand{\facname}{#1}}
\NewDocumentCommand{\subject}{m}{\newcommand{\subjectname}{#1}}
\NewDocumentCommand{\keywords}{m}{\newcommand{\keywordnames}{#1}}
\newcommand{\checktoopen}{% New command to move content to the next page which prints to the next odd page if twosided mode is active
\if@openright\cleardoublepage\else\clearpage\fi
\ifdef{\phantomsection}{\phantomsection}{}% The \phantomsection command is necessary for hyperref to jump to the correct page
}
\NewDocumentCommand{\bhrule}{}{\typeout{--------------------}}
\NewDocumentCommand{\tttypeout}{m}{\bhrule\typeout{\space #1}\bhrule}
\newcommand{\HRule}{\rule{.9\linewidth}{.6pt}} % New command to make the lines in the title page
\newcommand{\decoRule}{\rule{.8\textwidth}{.4pt}} % New command for a rule to be used under figures
\setcounter{tocdepth}{3} % The depth to which the document sections are printed to the table of contents
\ProvideDocumentCommand{\addchaptertocentry}{ m }{%
\addcontentsline{toc}{chapter}{#1}%
}
%----------------------------------------------------------------------------------------
% COLOURS
%----------------------------------------------------------------------------------------
\usepackage{xcolor} % Required for specifying custom colours
\colorlet{mdtRed}{red!50!black}
%----------------------------------------------------------------------------------------
% MARGINS
%----------------------------------------------------------------------------------------
\RequirePackage{geometry}
\geometry{
headheight=4ex,
includehead,
includefoot
}
\raggedbottom
%----------------------------------------------------------------------------------------
% PENALTIES
%----------------------------------------------------------------------------------------
\doublehyphendemerits=10000 % No consecutive line hyphens
\brokenpenalty=10000 % No broken words across columns/pages
\widowpenalty=9999 % Almost no widows at bottom of page
\clubpenalty=9999 % Almost no orphans at top of page
\interfootnotelinepenalty=9999 % Almost never break footnotes
%----------------------------------------------------------------------------------------
% HEADERS AND FOOTERS
%----------------------------------------------------------------------------------------
\RequirePackage[markcase=used]{scrlayer-scrpage}
\providepairofpagestyles{thesisSimple}{%
\clearpairofpagestyles%
\automark[chapter]{chapter}
\ihead{\headmark}% Inner header
\ohead[\pagemark]{\pagemark}% Outer header
}
\ifoot{}% Inner footer
\ofoot{}% Outer footer
\pagestyle{thesisSimple}
\providepairofpagestyles[thesisSimple]{thesis}{%
\automark*[section]{}%
}
\providepairofpagestyles[thesisSimple]{review}{%
\ofoot[\shorttitle/\authorname]{\shorttitle/\authorname}
\ifoot[\today]{\today}
}
\pagestyle{thesis}
\ifbool{headsepline}{\KOMAoption{headsepline}{true}}{}
\PreventPackageFromLoading[\ClassError{\classname}{Package `fancyhdr' is
incompatible\MessageBreak with this class}{The pagesyles are defined
using package `scrlayer-scrpage', please consult the\MessageBreak
KOMA-script documentation for details.}]{fancyhdr}
\newcommand{\blank@p@gestyle}{empty}
\newcommand{\chapter@p@gestyle}{plain}
\NewDocumentCommand{\blankpagestyle}{ m }{%
\ClassWarning{\classname}{\string\blankpagestyle\space is
obsolete,\MessageBreak use \string\setblankpagestyle \space instead}\renewcommand{\blank@p@gestyle}{}{#1}
}
\NewDocumentCommand{\setblankpagestyle}{ m }{\renewcommand{\blank@p@gestyle}{#1}}
\NewDocumentCommand{\setchapterpagestyle}{ m }{\renewcommand{\chapter@p@gestyle}{#1}}
\DeclareDocumentCommand\cleardoublepage{}{\clearpage\if@twoside \ifodd\c@page\else
\hbox{}
\thispagestyle{\blank@p@gestyle}
\newpage
\if@twocolumn\hbox{}\newpage\fi\fi\fi%
}
%----------------------------------------------------------------------------------------
% ABBREVIATIONS PAGE DESIGN
%----------------------------------------------------------------------------------------
\newcommand{\abbrevname}{List of Abbreviations}
\providecaptionname{english,british,american}{\abbrevname}{List of Abbreviations}
\providecaptionname{ngerman,german,austrian,naustrian}{\abbrevname}{Abk\"urzungsverzeichnis}
\NewDocumentEnvironment{abbreviations}{ m }{%
\ifbool{nolistspace}{\begingroup\singlespacing}{}
\ifbool{listtoc}{\addchap{\abbrevname}}{\addchap*{\abbrevname}}
\begin{longtable}{#1}
}{%
\end{longtable}
\addtocounter{table}{-1}% Don't count this table as one of the document tables
\ifbool{nolistspace}{\endgroup}{}
}
%----------------------------------------------------------------------------------------
% ABSTRACT PAGE DESIGN
%----------------------------------------------------------------------------------------
\DeclareDocumentCommand{\abstractauthorfont}{}{}
\DeclareDocumentCommand{\abstracttitlefont}{}{}
\newcommand{\byname}{by}
\newcommand{\abstractname}{Abstract}
\providecaptionname{german,ngerman,austrian,naustrian}{\byname}{von}
\providecaptionname{american,australian,british,canadian,english,newzealand,UKenglish,USenglish}{\byname}{by}
\ifbool{consistentlayout}{
\DeclareDocumentEnvironment{abstract}{ O{} }{%
\addchap*{\abstractname}%
{\chapteralign\normalsize\abstractauthorfont \authorname \par}% Author name
\vspace{\baselineskip}
{\chapteralign\parbox{.7\linewidth}{\chapteralign\normalsize\itshape\abstracttitlefont\@title}\par}% Thesis title
\bigskip\noindent\ignorespaces
}%
{}%end alt-abstract
}{%
\DeclareDocumentEnvironment{abstract}{ O{\null\vfill} }{
\checktoopen
\tttypeout{\abstractname}
#1%added to be able to have abstract more than one page long
\thispagestyle{plain}
\begin{center}
{\normalsize \MakeUppercase{\univname} \par}% University name in capitals
\bigskip
{\huge\textit{\abstractname} \par}
\bigskip
{\normalsize \facname \par}% Faculty name
{\normalsize \deptname \par}% Department name
\bigskip
{\normalsize \degreename\par}% Degree name
\bigskip
{\normalsize\bfseries \@title \par}% Thesis title
\medskip
{\normalsize \byname{} \authorname \par}% Author name
\bigskip
\end{center}
}
{
\vfill\null
}
}
\DeclareDocumentEnvironment{extraAbstract}{ O{\null\vfill} }{
\checktoopen
\tttypeout{\abstractname}
#1%added to be able to have abstract more than one page long
\thispagestyle{empty}
\begin{center}
{\normalsize \MakeUppercase{\univname} \par}% University name in capitals
\bigskip
{\huge\textit{\abstractname} \par}
\bigskip
{\normalsize \facname \par}% Faculty name
{\normalsize \deptname \par}% Department name
\bigskip
{\normalsize \degreename\par}% Degree name
\bigskip
{\normalsize\bfseries \@title \par}% Thesis title
\medskip
{\normalsize \byname{} \authorname \par}% Author name
\bigskip
\end{center}
}
{
\vfill\null
}
%----------------------------------------------------------------------------------------
% ACKNOWLEDGEMENTS PAGE DESIGN
%----------------------------------------------------------------------------------------
\usepackage{xcolor}
\colorlet{mdtRed}{red!50!black}
\newcommand{\acknowledgementname}{Acknowledgements}
\providecaptionname{american,australian,british,canadian,english,newzealand,UKenglish,USenglish} {\acknowledgementname}{Acknowledgements} % Acknowledgement text for English countries
\providecaptionname{german,ngerman,austrian,naustrian}{\acknowledgementname}{Danksagung} % Acknowledgement text for Germanic countries
\ifbool{consistentlayout}{
\DeclareDocumentEnvironment{acknowledgements}{}{%
\tttypeout{\acknowledgementname}
\addchap*{\acknowledgementname}
}
}
{
\DeclareDocumentEnvironment{acknowledgements}{}{%
\checktoopen
\tttypeout{\acknowledgementname}
\thispagestyle{plain}
\begin{center}{\huge\textit{\acknowledgementname}\par}\end{center}
}
{
\vfil\vfil\null
}
}
%----------------------------------------------------------------------------------------
% DECLARATION PAGE DESIGN
%----------------------------------------------------------------------------------------
\newcommand{\authorshipname}{Declaration of Authorship}
\providecaptionname{american,australian,british,canadian,english,newzealand,UKenglish,USenglish}{\authorshipname}{Declaration of Authorship} % Declaration of Authorship text for English countries
\providecaptionname{german,ngerman,austrian,naustrian}{\authorshipname}{Eidesstattliche Erkl\"arung} % Declaration of Authorship text for Germanic countries
\ifbool{consistentlayout}{
\DeclareDocumentEnvironment{declaration}{}{
\addchap*{\authorshipname}
}{}%
}{
\DeclareDocumentEnvironment{declaration}{}{
\checktoopen
\tttypeout{\authorshipname}
\thispagestyle{plain}
\null\vfil
{\noindent\huge\bfseries\authorshipname\par\vspace{10pt}}
}{}
}
%----------------------------------------------------------------------------------------
% DEDICATION PAGE DESIGN
%----------------------------------------------------------------------------------------
\ifbool{consistentlayout}{
\DeclareDocumentCommand{\dedicatory}{
m O{\vspace*{.7\textheight} } }{
\checktoopen\tttypeout{Dedicatory}
\markboth{}{}
#2
{\hfill\parbox{.4\textwidth}{\flushright#1\par}}
}
}{
\newcommand\dedicatory[1]{
\checktoopen
\tttypeout{Dedicatory}
\null\vfil
\thispagestyle{plain}
\begin{center}{\Large\slshape #1}\end{center}
\vfil\null
}
}
%----------------------------------------------------------------------------------------
% PHYSICAL CONSTANTS PAGE DESIGN
%----------------------------------------------------------------------------------------
\newcommand{\constantsname}{Physical Constants}
\providecaptionname{english,british,american}{\constantsname}{Physical Constants}
\providecaptionname{ngerman,german,austrian,naustrian}{\constantsname}{Physikalische Konstanten}
\NewDocumentEnvironment{constants}{ m }{%
\ifbool{nolistspace}{\begingroup\singlespacing}{}
\ifbool{listtoc}{\addchap{\constantsname}}{\addchap*{\constantsname}}
\begin{longtable}{#1}
}{%
\end{longtable}
\addtocounter{table}{-1}% Don't count this table as one of the document tables
\ifbool{nolistspace}{\endgroup}{}
}
%----------------------------------------------------------------------------------------
% SYMBOLS PAGE DESIGN
%----------------------------------------------------------------------------------------
\newcommand{\symbolsname}{List of Symbols}
\providecaptionname{english,british,american}{\symbolsname}{List of Symbols}
\providecaptionname{ngerman,german,austrian,naustrian}{\symbolsname}{Symbolverzeichnis}
\NewDocumentEnvironment{symbols}{ m }{%
\ifbool{nolistspace}{\begingroup\singlespacing}{}
\ifbool{listtoc}{\addchap{\symbolsname}}{\addchap*{\symbolsname}}
\begin{longtable}{#1}
}{%
\end{longtable}
\addtocounter{table}{-1}% Don't count this table as one of the document tables
\ifbool{nolistspace}{\endgroup}{}
}
%----------------------------------------------------------------------------------------
\ifbool{hyperrefsupport}{% If the nohyperref class option has not been specified
\AtEndPreamble{\RequirePackage{hyperref}
\hypersetup{pdfpagemode={UseOutlines},
bookmarksopen=true,
bookmarksopenlevel=0,
hypertexnames=false,
colorlinks=true,% Set to false to disable coloring links
citecolor=magenta,% The color of citations
linkcolor=red,% The color of references to document elements (sections, figures, etc)
urlcolor=mdtRed,% The color of hyperlinks (URLs)
pdfstartview={FitV},
unicode,
breaklinks=true,
}
\pdfstringdefDisableCommands{% If there is an explicit linebreak in a section heading (or anything printed to the pdf-bookmarks), it is replaced by a space
\let\\\space%
}
}
}{%nothing
}
%----------------------------------------------------------------------------------------
\endinput
% lazyLizardTracer

4
Manuscript/main/makeHDR Executable file
View File

@ -0,0 +1,4 @@
pdflatex HDR
bibtex HDR
pdflatex HDR
open -F HDR.pdf

BIN
References/hdr_Berger.pdf Normal file

Binary file not shown.

Binary file not shown.

BIN
References/hdr_scemama.pdf Normal file

Binary file not shown.

BIN
References/hdr_toulouse.pdf Normal file

Binary file not shown.