A fairly old idea for describing the (potentially delocalized) excited states of molecular crystals, or more generally noncovalent assemblies or aggregates of (weakly) electronically-coupled chromophores, is the so called Frenkel-Davydov Exciton model. In such a model, a collective excitation of the entire aggregate is expressed as a linear combination of excitations that are localized on molecular sites. The th excited state, , is thus written
(13.42) |
where is the th excited state of the th molecular fragment and is the ground-state wave function of the th fragment. Eigenstates and energies are found by constructing and diagonalizing the electronic Hamiltonian matrix in this direct product, “exciton-site basis”.
In the ab initio Frenkel-Davydov exciton model (AIFDEM) developed by Morrison and Herbert,[Morrison et al.(2014)Morrison, You, and Herbert, Morrison and Herbert(2015)] the ground-state wave functions in Eq. eq:AIFDEM_direct_pdt are single Slater determinants (obtained from SCF calculations on isolated fragments), and the fragment excited-state wave functions are linear combinations of singly-excited determinants:
(13.43) |
The AIFDEM approach computes elements of the exact Hamiltonian,
(13.44) |
In particular, no dipole-coupling approximation is made (as is often invoked in simple exciton models). Such an approximation may be valid for well-separated chromophores but likely less so for tightly-packed chromophores in a molecular crystal. Overlap matrices
(13.45) |
are also required because molecular orbitals located on different fragments are not orthogonal to one another. In order to reduce the number of terms in Eqs. eq:AIFDEM_H and eq:AIFDEM_S, the fragment excited states are transformed into the natural transition orbital (NTO) basis (see Section 7.12.2) and then the corresponding orbitals transformation (Section 11.16.2.2) is used to compute matrix elements between non-orthogonal Slater determinants. The size of the exciton-site basis is sufficiently small such that eigenvectors and energies of the exciton Hamiltonian can be printed and saved to scratch files. Transition dipole moments between the ground state and the first ten excited states of the exciton Hamiltonian are also computed.
The cost to compute each matrix element scales with the size of the supersystem (somewhere between quadratic and quartic with monomer size), since all fragments must be included in the direct products. To reduce this scaling, a physically-motivated charge embedding scheme was introduced[Morrison and Herbert(2015)] that only treats the excited fragments, and neighbors within a user-specified distance threshold, with full QM calculation, while the other ground state fragment interactions are approximated by point charges. (The nature of the point charges is controlled by the $rem variable XPOL_CHARGE_TYPE.) In general, inclusion of neighboring fragments in the QM part of the matrix element evaluation does not seem to significantly improve the accuracy and diminishes the cost savings of the charge-embedding procedure. Therefore, the minimal “ 0 Å” threshold, where only the excited fragments are described at a QM level, can be considered optimal. Charge embedding with the minimal threshold affords an algorithm that scales as , where is the number of fragments and is the size of a pair of fragments.
The exciton-site basis can be expanded to include higher-lying fragment excited states which affords the wave function increased variational flexibility, and can significantly improve the accuracy for polar systems and delocalized excited states. The number of fragment excited states included in the basis is specified by the CIS_N_ROOTS keyword, which must be . A cost effective means of including polarization effects is to use the XPol method to compute fragment ground states, see Section 13.10 and associated job controls. Fragment excited states are then computed using the XPol-polarized MOs. Charge transfer-type states of the form , where are cationic or anionic determinants from unrestricted SCF calculations on the isolated fragments, can also be included in the basis.
The exciton-site basis states are spin-adapted to form proper eigenstates. Their multiplicity determines that of the target excited state and this must be specified by setting CIS_SINGLETS or CIS_TRIPLETS to TRUE. The number of terms included in Eqs. eq:AIFDEM_H and eq:AIFDEM_S can be rationally truncated at some fraction of the norm of the fragment NTO amplitudes, in order to reduce cost at the expense of accuracy, although the approximation is controllable by means of the truncation threshold. Computation time scales approximately quadratically with the number of terms and a threshold of about 85% has been found to maintain acceptable accuracy for organic molecules with reasonable cost. The fragment orbitals and excited states may be computed with any SCF and single-excitation theory, including DFT and TDDFT, however the coupling matrix elements are always computed with a CIS-like Hamiltonian with no DFT exchange-correlation. Both OpenMP and MPI parallel implementations are available; the former distributes two-electron integral computation across cores in a node as in a traditional excited-state calculation, the latter can distribute matrix element evaluations across hundreds of cores with minimal overhead.
Note: Symmetry should be turned off for AIFDEM calculations.
AIFDEM
Perform an AIFDEM calculation.
TYPE:
LOGICAL
DEFAULT:
FALSE
OPTIONS:
FALSE
Do not perform an AIFDEM calculation.
TRUE
Perform an AIFDEM calculation.
RECOMMENDATION:
False
AIFDEM_NTOTHRESH
Controls the number of NTOs that are retained in the exciton-site basis states.
TYPE:
INTEGER
DEFAULT:
99
OPTIONS:
Threshold percentage of the norm of fragment NTO amplitudes.
RECOMMENDATION:
A threshold of gives a good trade-off of computational time and accuracy for organic molecules.
AIFDEM_EMBED_RANGE
Specifies the size of the QM region for charge embedding
TYPE:
INTEGER
DEFAULT:
FULL_QM
OPTIONS:
FULL_QM
No charge embedding.
0
Treat only excited fragments with QM.
Range (Å) from excited fragments within which to treat other fragments with QM.
RECOMMENDATION:
Minimal, 0 Å, threshold maintains accuracy while significantly reducing computational time.
AIFDEM_CTSTATES
Include charge-transfer-like cation/anion pair states in the AIFDEM basis.
TYPE:
LOGICAL
DEFAULT:
FALSE
OPTIONS:
TRUE
Include CT states.
FALSE
Do not include CT states.
RECOMMENDATION:
None
Example 13.338 Example showing singlet excited state calculation, on (HO). XPol is used to generate monomer wave functions with ChElPG charges. Minimal QM charge embedding is used for the exciton model with three excited states per fragment.
$rem
BASIS aug-cc-pvdz
EXCHANGE HF
CIS_N_ROOTS 3
CIS_TRIPLETS FALSE
XPOL TRUE
XPOL_CHARGE_TYPE QCHELPG
AIFDEM TRUE
AIFDEM_EMBED_RANGE 0
AIFDEM_NTOTHRESH 90
NTO_PAIRS 1
$end
$molecule
0 1
--H2O 0
0 1
O 1.74078 1.59716 -1.49814
H 2.22908 2.18316 -2.08914
H 0.88038 2.04726 -1.32684
--H2O 1
0 1
O 1.31998 -1.18934 -1.91734
H 1.49988 -0.22974 -1.89044
H 1.69058 -1.52594 -1.07704
--H2O 2
0 1
O -0.68982 2.59476 -0.72224
H -1.14372 3.37086 -1.07364
H -1.35592 1.84986 -0.78334
--H2O 3
0 1
O -1.27512 -1.77394 -1.69524
H -0.32252 -1.52884 -1.85604
H -1.53992 -2.30454 -2.45644
$end
There are many chemical processes of interest where motion of nuclei induces electronic transitions, in a breakdown of the Born-Oppenheimer approximation. In order to investigate such processes it is useful to calculate some quantity that codifies the coupling of adiabatic electronic states dues to nuclear motion. In molecular electronic structure theory this quantity is the nonadiabatic coupling (or “derivative coupling”) vector , which describes how the nuclear position derivative couples adiabatic (Born-Oppenheimer) electronic states and . In solid-state physics these ideas are typically not discussed in terms of the Born-Oppenheimer approximation but rather in terms of the so-called “Holstein” and “Peierls” exciton/phonon coupling constants (see below). Within the framework of the AIFDEM, each of these quantities can be computed from a common intermediate , which is the derivative of the AIFDEM Hamiltonian matrix with respect to some nuclear coordinate .[Morrison and Herbert(2017a), Morrison and Herbert(2017b)] Diagonal matrix elements describe how the exciton-site energies are modulated by nuclear motion and off-diagonal matrix elements describe how nuclear motion modifies the energy-transfer couplings.
Once has been constructed, then the nonadiabatic coupling vector between eigenstates and of the exciton Hamiltonian is simply
(13.46) |
The Holstein () and Peierls () coupling constants , expressed in dimensionless normal mode coordinates, are[Morrison and Herbert(2017b)]
(13.47) |
where the matrix is the transformation between Cartesians coordinates and normal (phonon) modes. The columns of contain the normalized Cartesian displacements of normal mode , whose frequency and effective mass are and , respectively. The tilde on, indicates that the matrix element derivatives have been orthogonalized (including the derivative of the orthogonalization transformation).[Morrison and Herbert(2017b)]
Analytic evaluation of and the analogous overlap derivative have been implemented in Q-Chem.[Morrison and Herbert(2017b)] To compute AIFDEM derivatives, request a standard AIFDEM job and set CIS_STATE_DERIV = 1. Currently, the AIFDEM derivatives do not support charge embedding so the keyword AIFDEM_EMBED_RANGE must be omitted from these jobs; this precludes the use of XPol wavefunctions for the fragments. Furthermore, only one excited state per fragment is supported so the keyword CIS_N_ROOTS = 1. is required.
The derivatives of the AIFDEM Hamiltonian matrix and overlap matrix are printed in the output file in sets of the three Cartesian coordinates that belong to a single atom. For convenience, the orthogonalized AIFDEM Hamiltonian matrix elements are saved in the scratch directory, $QCSCRATCH/aifdem_deriv. These are organized such that the derivatives for each unique matrix element are stored in individual files in the order of the atomic Cartesian coordinates. These files can facilitate external calculation of exciton/phonon coupling constants.
Example 13.339 A basic AIFDEM derivative calculation on a chain of helium atoms.
$rem
basis = cc-pvdz
exchange = hf
aifdem = true
cis_n_roots = 1
cis_singlets = true
cis_triplets = false
cis_state_deriv = 1
nto_pairs = 1
mem_total = 1000
mem_static = 1000
max_cis_cycles = 200
max_scf_cycles = 200
thresh = 10
aifdem_ntothresh = 100
$end
$molecule
0 1
--frgm 0
0 1
He 0.0 0.0 0.0
He 0.0 0.0 1.4
--frgm 1
0 1
He 0.0 0.0 2.8
He 0.0 0.0 4.2
$end