A PCM calculation is requested by setting SOLVENT_METHOD = PCM in the $rem section. As mentioned above, there are a variety of different theoretical models that fall within the PCM family, so additional fine-tuning may be required, as described below.
Most PCM job control is accomplished via options specified in the $pcm input section, which allows the user to specify which flavor of PCM will be used, which algorithm will be used to solve the PCM equations, and other options. The format of the $pcm section is analogous to that of the $rem section:
$pcm <Keyword> <parameter/option> $end
Note: The following job control variables belong only in the $pcm section. Do not place them in the $rem section.
Theory
Specifies the which polarizable continuum model will be used.
INPUT SECTION: $pcm
TYPE:
STRING
DEFAULT:
CPCM
OPTIONS:
CPCM
Conductor-like PCM of Ref.
258
J. Comput. Chem.
(2003),
24,
pp. 669.
Link
,
with .
CPCM1
Equivalent to CPCM.
CPCM2
Original conductor-like screening model of Ref.
, with
.
IEFPCM
IEF-PCM with an asymmetric matrix.
SSVPE
SS(V)PE model, equivalent to IEF-PCM with a symmetric matrix.
RECOMMENDATION:
The IEF-PCM/SS(V)PE model is more sophisticated model than C-PCM, and formally
more appropriate for low-dielectric solvents, but it is also more complicated to work with.
In practice there is often little difference between these models; see Ref.
529
Wiley Interdiscip. Rev.: Comput. Mol. Sci.
(2021),
11,
pp. e1519.
Link
.
Regarding the two versions of C-PCM and the choice of in Eq. (11.3),
the choice has been suggested for neutral solutes and for ions; again, see Ref.
529
Wiley Interdiscip. Rev.: Comput. Mol. Sci.
(2021),
11,
pp. e1519.
Link
for a discussion of these distinctions.
Method
Specifies which surface discretization method will be used.
INPUT SECTION: $pcm
TYPE:
STRING
DEFAULT:
SwiG
OPTIONS:
SwiG
Switching/Gaussian method
ISwiG
“Improved” Switching/Gaussian method with an alternative switching function
Spherical
Use a single, fixed sphere for the cavity surface.
Fixed
Use discretization point charges instead of smooth Gaussians.
RECOMMENDATION:
Use of SwiG is recommended only because it is slightly more
efficient than the switching function of ISwiG. On the other hand,
ISwiG offers some conceptually more appealing features and may be
superior in certain cases. Consult Refs.
714
J. Chem. Phys.
(2010),
133,
pp. 244111.
Link
,
716
Chem. Phys. Lett.
(2011),
509,
pp. 77.
Link
for a discussion of these differences. The Fixed option uses the
Variable Tesserae Number (VTN) algorithm of Li and
Jensen,
767
J. Comput. Chem.
(2004),
25,
pp. 1449.
Link
with Lebedev grid points. VTN uses point
charges with no switching function or Gaussian blurring, and is therefore
subject to discontinuities that may cause errors in analytic gradients and lead
to slow convergence in geometry optimizations.
713
J. Phys. Chem. Lett.
(2010),
1,
pp. 556.
Link
Its use is not recommended
except to make contact with other calculations in the literature.
Solver
Specifies the algorithm used to solve the PCM equations.
INPUT SECTION: $pcm
TYPE:
STRING
DEFAULT:
INVERSION
OPTIONS:
INVERSION
Direct matrix inversion
CG
Iterative conjugate gradient
RECOMMENDATION:
Matrix inversion is faster for small solutes because it needs to be performed
only once in a single-point calculation. However, the CG solver (which must be
applied at each SCF iteration) is recommended if the number of discretization
points approaches or exceeds 10,000. Linear-scaling options for large-scale
MM/PCM and QM/MM/PCM calculations are discussed in Section 11.2.5.
SwitchThresh
Threshold for discarding grid points on the cavity surface.
INPUT SECTION: $pcm
TYPE:
INTEGER
DEFAULT:
8
OPTIONS:
Discard grid points when the switching function is less than .
RECOMMENDATION:
Use the default, which is found to avoid discontinuities within machine precision.
Increasing reduces the cost of PCM calculations but can introduce discontinuities in
the potential energy surface. If the PCM part of the calculation becomes too expensive
it is better to reduce the number of discretization points (HeavyPoints and HPoints,
described below), or to use Solver = CG,
than it is to adjust SwitchThresh.
Construction of the solute cavity is an important part of the model and users
should consult the literature in this capacity, especially with regard to the
radii used for the atomic spheres. The default values provided in Q-Chem
correspond to the consensus choice that has emerged over several decades,
namely, to use vdW radii scaled by a factor ;
see Eq. (11.4). The most widely-used set
of vdW radii are those determined from crystallographic data by
Bondi,
136
J. Phys. Chem.
(1964),
68,
pp. 441.
Link
although the radius for hydrogen was later adjusted to
1.1 Å,
1108
J. Phys. Chem.
(1996),
100,
pp. 7384.
Link
and radii for those main-group elements not
addressed by Bondi were provided later.
831
J. Phys. Chem. A
(2009),
113,
pp. 5806.
Link
This extended set
of vdW is used by default in Q-Chem, and for simplicity we call these “Bondi
radii” regardless of whether they come from Bondi’s original paper or the
later work. Alternatively, atomic radii from the Universal Force Field (UFF)
are available.
1071
J. Am. Chem. Soc.
(1992),
114,
pp. 10024.
Link
The main appeal of UFF radii is that they are
defined for all atoms of the periodic table, though the quality of these radii
for PCM applications is unclear.
Finally, the user may specify his or her own
radii for cavity construction using a $van_der_waals input section, the format for
which is described in Section 11.2.10. No scaling factor is applied to
user-defined radii. Note that is allowed for a particular atomic radius,
in which case the atom in question is not used to construct the cavity surface.
This feature facilitates the construction of “united atom”
cavities,
71
J. Chem. Phys.
(1997),
107,
pp. 3210.
Link
in which the hydrogen atoms do not get their own
spheres and the heavy-atom radii are increased to compensate.
As an alternative to scaling the vdW radii , the user can choose to augment
each of them with a probe radius [see Eq. (11.4)]
to obtain the SAS cavity.
Radii
Specifies which set of atomic van der Waals radii will be used to define the solute cavity.
INPUT SECTION: $pcm
TYPE:
STRING
DEFAULT:
Bondi
OPTIONS:
Bondi
Use the (extended) set of Bondi radii.
FF
Use Lennard-Jones radii from a molecular mechanics force field.
UFF
Use radii from the Universal Force Field.
Read
Read the atomic radii from a $van_der_waals input section.
RECOMMENDATION:
Bondi radii are widely used. The FF option requires the user to
specify an MM force field using the FORCE_FIELD $rem variable, and
also to define the atom types in the $molecule section (see
Section 11.3). This is not required for UFF radii.
vdwScale
Scaling factor for the atomic van der Waals radii used to define the solute cavity.
INPUT SECTION: $pcm
TYPE:
FLOAT
DEFAULT:
1.2
OPTIONS:
Use a scaling factor of .
RECOMMENDATION:
The default value is widely used in PCM calculations, although a value of 1.0
might be appropriate if using a solvent-accessible surface.
SASradius
Form a “solvent accessible” surface with the given solvent probe radius.
INPUT SECTION: $pcm
TYPE:
FLOAT
DEFAULT:
0.0
OPTIONS:
Use a solvent probe radius of , in Å.
RECOMMENDATION:
The solvent probe radius is added to the scaled van der Waals radii of the solute atoms.
A common solvent probe radius for water is 1.4 Å, but smaller values (0.2–0.5 Å) have
also been used historically.
529
Wiley Interdiscip. Rev.: Comput. Mol. Sci.
(2021),
11,
pp. e1519.
Link
SurfaceType
Selects the solute cavity surface construction.
INPUT SECTION: $pcm
TYPE:
STRING
DEFAULT:
VDW_SAS
OPTIONS:
VDW_SAS
van der Waals or solvent-accessible surface
SES
solvent-excluded surface
RECOMMENDATION:
The vdW surface and the SAS are each comprised simply of atomic spheres and
thus share a common option; the only difference is the specification of a
solvent probe radius, SASradius. For a true vdW surface, the probe
radius should be zero (which is the default), whereas for the SAS the atomic
radii are traditionally not scaled, hence vdwScale should be set to
1.0 (which is not the default). For the SES, only SwiG discretization
is available, but this can be used with any set of (scaled or unscaled) atomic
radii, or with radii that are augmented by SASradius.
Historically, discretization of the cavity surface has involved
“tessellation” methods that divide the cavity surface area into finite
polygonal “tesserae”. (The GEPOL algorithm
972
J. Comput. Chem.
(1994),
15,
pp. 1127.
Link
is
perhaps the most widely-used tessellation scheme.) Tessellation methods,
however, suffer not only from discontinuities in the cavity surface area and
solvation energy as a function of the nuclear coordinates, but in addition they
lead to analytic energy gradients that are complicated to derive and implement.
To avoid these problems, Q-Chem’s SwiG-PCM
implementation
713
J. Phys. Chem. Lett.
(2010),
1,
pp. 556.
Link
,
714
J. Chem. Phys.
(2010),
133,
pp. 244111.
Link
,
716
Chem. Phys. Lett.
(2011),
509,
pp. 77.
Link
uses Lebedev grids to
discretize the atomic spheres. These are atom-centered grids with icosahedral
symmetry, and may consist of anywhere from 26 to 5294 grid points per atomic
sphere. The default values used by Q-Chem were selected based on extensive
numerical tests,
714
J. Chem. Phys.
(2010),
133,
pp. 244111.
Link
,
716
Chem. Phys. Lett.
(2011),
509,
pp. 77.
Link
and they are looser for MM atoms
(in MM/PCM or QM/MM/PCM jobs) than they are for QM atoms,
reflecting the more complicated electrostatic potential that is generated by a
QM density as compared to an MM point charge. For QM atoms, the default is to
use points for hydrogen atoms and points for all other atoms,
whereas for MM atoms the default is for hydrogen and for
non-hydrogen. These default values exhibit good rotational invariance
( kcal/mol differences in when the molecule is
rotated
714
J. Chem. Phys.
(2010),
133,
pp. 244111.
Link
) and absolute solvation energies that typically lie
within kcal/mol of the
limit,
714
J. Chem. Phys.
(2010),
133,
pp. 244111.
Link
,
716
Chem. Phys. Lett.
(2011),
509,
pp. 77.
Link
at least for charge-neutral solutes.
Note that earlier versions of Q-Chem used denser grids by default. (In
versions up to and including Q-Chem v. 4.2, the default was for all
QM atoms, but was switched to beginning with v. 4.2.1. The defaults
mentioned above are the current ones starting with v. 5.2.) However, grid
errors of 0.5 kcal/mol are well within the intrinsic accuracy of for these models. Grid errors in solvatochromatic
shifts for excitation energies tend to be 0.01–0.02 eV, which is well
within the intrinsic accuracy of nearly any excited-state methodology. If
questions about grid accuracy arise, we suggest using as a high-quality
option and as an essentially converged option.
714
J. Chem. Phys.
(2010),
133,
pp. 244111.
Link
,
716
Chem. Phys. Lett.
(2011),
509,
pp. 77.
Link
For large molecules it may be necessary to reduce the number of grid points
(e.g., to ) or to use linear-scaling solvers rather than matrix inversion, as
discussed in Section 11.2.5.
Note: The acceptable values for the number of Lebedev points per sphere are , 26, 38, 50, 86, 110, 146, 170, 194, 302, 350, 434, 590, 770, 974, 1202, 1454, 1730, 2030, 2354, 2702, 3074, 3470, 3890, 4334, 4802, 5294.
HeavyPoints
The number of Lebedev grid points to be placed non-hydrogen atoms in the QM system.
INPUT SECTION: $pcm
TYPE:
INTEGER
DEFAULT:
194
OPTIONS:
Acceptable values are listed above.
RECOMMENDATION:
Use the default for geometry optimizations. For absolute solvation energies,
the user may want to examine convergence with respect to .
HPoints
The number of Lebedev grid points to be placed on H atoms in the QM system.
INPUT SECTION: $pcm
TYPE:
INTEGER
DEFAULT:
110
OPTIONS:
Acceptable values are listed above.
RECOMMENDATION:
Use the default for geometry optimizations. For absolute solvation energies,
the user may want to examine convergence with respect to .
MMHeavyPoints
The number of Lebedev grid points to be placed on non-hydrogen atoms in the MM subsystem.
INPUT SECTION: $pcm
TYPE:
INTEGER
DEFAULT:
110
OPTIONS:
Acceptable values are listed above.
RECOMMENDATION:
Use the default for geometry optimizations. For absolute solvation energies,
the user may want to examine convergence with respect to . This option
applies only to MM/PCM or QM/MM/PCM calculations.
MMHPoints
The number of Lebedev grid points to be placed on H atoms in the MM subsystem.
INPUT SECTION: $pcm
TYPE:
INTEGER
DEFAULT:
50
OPTIONS:
Acceptable values are listed above.
RECOMMENDATION:
Use the default for geometry optimizations. For absolute solvation energies,
the user may want to examine convergence with respect to . This option
applies only to MM/PCM or QM/MM/PCM calculations.
Especially for complicated molecules, the user may want to visualize the cavity
surface. This can be accomplished by setting PrintLevel ,
which will trigger the generation of several .PQR files that describe
the cavity surface. (These are written to the Q-Chem output file.) The
.PQR format is similar to the common .PDB (Protein Data Bank)
format, but also contains charge and radius information for each atom. One of
the output .PQR files contains the charges computed in the PCM
calculation and radii (in Å) that are half of the square root of the surface
area represented by each surface grid point. Thus, in examining this
representation of the surface, larger discretization points are associated with
larger surface areas. A second .PQR file contains the solute’s
electrostatic potential (in atomic units), in place of the charge information,
and uses uniform radii for the grid points. These .PQR files can be
visualized using various third-party software, including the freely-available
Visual Molecular Dynamics (VMD) program,W. Humphrey, A. Dalke, and K. Schulten (1996), 15 which is
particularly useful for coloring the .PQR surface grid points according
to their charge, and sizing them according to their contribution to the
molecular surface area. (Examples of such visualizations can be found in
Ref.
713
J. Phys. Chem. Lett.
(2010),
1,
pp. 556.
Link
.)
PrintLevel
Controls the printing level during PCM calculations.
INPUT SECTION: $pcm
TYPE:
INTEGER
DEFAULT:
0
OPTIONS:
0
Prints PCM energy and basic surface grid information. Minimal additional printing.
1
Level 0 plus PCM solute-solvent interaction energy components and Gauss’ Law error.
2
Level 1 plus surface grid switching parameters and a .PQR file for
visualization of the cavity surface apparent surface charges.
3
Level 2 plus a .PQR file for visualization of the electrostatic
potential at the surface grid created by the converged solute.
4
Level 3 plus additional surface grid information, electrostatic potential
and apparent surface charges on each SCF cycle.
5
Level 4 plus extensive debugging information.
RECOMMENDATION:
Use the default unless further information is desired.
Finally, note that setting Method to Spherical in the $pcm input selection requests the construction of a solute cavity consisting of a single, fixed sphere. This is generally not recommended but is occasionally useful for making contact with the results of Born models in the literature, or the Kirkwood-Onsager model discussed in Section 11.2.2. In this case, the cavity radius and its center must also be specified in the $pcm section. The keyword HeavyPoints controls the number of Lebedev grid points used to discretize the surface.
CavityRadius
Specifies the solute cavity radius.
INPUT SECTION: $pcm
TYPE:
FLOAT
DEFAULT:
None
OPTIONS:
Use a radius of , in Ångstroms.
RECOMMENDATION:
None.
CavityCenter
Specifies the center of the spherical solute cavity.
INPUT SECTION: $pcm
TYPE:
FLOAT
DEFAULT:
0.0 0.0 0.0
OPTIONS:
Coordinates of the cavity center, in Ångstroms.
RECOMMENDATION:
The format is CavityCenter followed by three floating-point values,
delineated by spaces. Uses the same coordinate system as the $molecule
section.
$comment 2023/4/5 Add geom_opt_driver optimize per #2954, [39888/qchem] $end $molecule 0 1 C -0.245826 -0.351674 -0.019873 C 0.244003 0.376569 1.241371 O 0.862012 -0.527016 2.143243 F 0.776783 -0.909300 -0.666009 F -0.858739 0.511576 -0.827287 F -1.108290 -1.303001 0.339419 H -0.587975 0.878499 1.736246 H 0.963047 1.147195 0.961639 H 0.191283 -1.098089 2.489052 $end $rem JOBTYPE OPT BASIS 6-31G* METHOD B3LYP SOLVENT_METHOD PCM geom_opt_driver optimize $end $pcm Theory CPCM Method SWIG Solver Inversion HeavyPoints 194 HPoints 194 Radii Bondi vdwScale 1.2 $end $solvent Dielectric 78.39 $end
$molecule 0 1 O 0.00000000 0.00000000 0.11722303 H -0.75908339 0.00000000 -0.46889211 H 0.75908339 0.00000000 -0.46889211 $end $rem METHOD HF BASIS 6-31g** SOLVENT_METHOD pcm $end $pcm method spherical ! single spherical cavity with 590 discretization points HeavyPoints 590 CavityRadius 1.8 ! Solute Radius, in Angstrom CavityCenter 0.0 0.0 0.0 ! Will be at center of Standard Nuclear Orientation Theory SSVPE $end $solvent Dielectric 35.9 ! Acetonitrile $end
Finally, we consider an example of a united-atom cavity. Note that a user-defined vdW radius is supplied only for carbon, so the hydrogen radius is taken to be zero and thus the hydrogen atoms are not used to construct the cavity surface. (As mentioned above, the format for the $van_der_waals input section is discussion in Section 11.2.10).
$comment Benzene (in benzene), with a united-atom cavity construction R = 2.28 A for carbon, R = 0 for hydrogen $end $molecule 0 1 C 1.38620 0.000000 0.000000 C 0.69310 1.200484 0.000000 C -0.69310 1.200484 0.000000 C -1.38620 0.000000 0.000000 C -0.69310 -1.200484 0.000000 C 0.69310 -1.200484 0.000000 H 2.46180 0.000000 0.000000 H 1.23090 2.131981 0.000000 H -1.23090 2.131981 0.000000 H -2.46180 0.000000 0.000000 H -1.23090 -2.131981 0.000000 H 1.23090 -2.131981 0.000000 $end $rem EXCHANGE hf BASIS 6-31G* SOLVENT_METHOD pcm $end $pcm theory iefpcm ! this is a synonym for ssvpe method swig printlevel 1 radii read $end $solvent dielectric 2.27 $end $van_der_waals 1 6 2.28 1 0.00 $end
The solvent for PCM calculations is specified using the $solvent section, as documented in this section and the next one. Note that the $solvent section is also used to specify parameters for the Kirkwood-Onsager SCRF model (Section 11.2.2), and the particular options that can be listed in the $solvent section depend upon the value of SOLVENT_METHOD in the $rem section. A minimum requirement for a PCM calculation is that the $solvent section must specify the static dielectric constant (), and for nonequilibrium excited-state calculations the optical dielectric constant () must be specified as well. There are default values that are appropriate for water, but for any other solvent these constants must be specified. These can either be specified individually, using the variables Dielectric and OpticalDielectric in the $solvent section, or they can be set to predefined values by setting SolventName equal to one of the named solvents that is given in Table 11.4.
Unlike the SM models (Section 11.2.9), which also employ named solvents (specified in the $smx section), use of SolventName with a PCM serves only to specify the two dielectric constants. Nonelectrostatic interactions are not included in an automatic way, although they can be added in an ad hoc way as described in Section 11.2.4.4. The dielectric constants listed in Table 11.4 correspond to values at 20C. For water, this is slightly different than the default values of Dielectric and OpticalDielectric, which correspond to 25C. The latter two values are fully tunable, whereas the named solvents are limited to the pairs of values (, ) listed in Table 11.4.
Dielectric
Specifies the static dielectric constant for the PCM solvent.
INPUT SECTION: $solvent
TYPE:
FLOAT
DEFAULT:
78.39
OPTIONS:
Use a dielectric constant .
RECOMMENDATION:
The static (i.e., zero-frequency) dielectric constant is what is usually called “the”
dielectric constant. The default corresponds to water at 25C.
OpticalDielectric
Specifies the optical dielectric constant for the PCM solvent.
INPUT SECTION: $solvent
TYPE:
FLOAT
DEFAULT:
1.78
OPTIONS:
Use an optical dielectric constant .
RECOMMENDATION:
The default corresponds to water at 25C. Note that , where
is the solvent’s index of refraction.
SolventName
Specify both and for PCM calculations by naming the solvent.
INPUT SECTION: $solvent
TYPE:
STRING
DEFAULT:
NONE
OPTIONS:
name
Use values and corresponding to solvent name in
Table 11.4.
RECOMMENDATION:
The use of SolventName
is incompatible with explicit specification of either Dielectric or OpticalDielectric.
SolventName | SolventName | SolventName | ||||||
---|---|---|---|---|---|---|---|---|
acetic_acid | 6.2 | 1.37 | dimethoxyethane | 7.3 | 1.38 | iodobenzene | 4.7 | 1.62 |
acetone | 21.1 | 1.36 | 1-2-dimethoxyethane | isobutanol | 18.1 | 1.40 | ||
acetonitrile | 36.6 | 1.34 | glyme | 2-methyl-1-propanol | ||||
acetylacetone | 26.5 | 1.45 | dimethylacetamide | 40.2 | 1.44 | isopropanol | 20.2 | 1.38 |
pentane-2-4-dione | dimethylaminobenzene | 5.0 | 1.56 | 2-propanol | ||||
2-4-pentanedione | n-n-dimethylaniline | mesitylene | 2.3 | 1.50 | ||||
aniline | 7.1 | 1.59 | dimethylformamide | 38.2 | 1.43 | 1-3-5-trimethylbenzene | ||
benzenamine | N-N-dimethylformamide | methanol | 33.0 | 1.33 | ||||
anisole | 4.4 | 1.52 | dimethylsulfoxide | 47.2 | 1.48 | methyl_acetate | 6.8 | 1.36 |
methoxybenzene | DMSO | acetic_acid_methyl_ester | ||||||
benzaldehyde | 17.8 | 1.55 | dioxane | 2.2 | 1.42 | methyl_ethanoate | ||
benzene | 2.3 | 1.50 | 1-4-dioxane | nitrobenzene | 35.6 | 1.55 | ||
benzonitrile | 25.6 | 1.53 | ethanol | 25.3 | 1.36 | nonane | 2.0 | 1.41 |
benzyl_alcohol | 13.7 | 1.54 | ethanolamine | 31.9 | 1.46 | n-nonane | ||
phenyl_methanol | ethyl_acetate | octanol | 10.1 | 1.43 | ||||
bromobenzene | 5.5 | 1.56 | ethyl_ethanoate | 1-octanol | ||||
butanol | 18.1 | 1.40 | acetic_acid_ethyl_ester | p-xylene | 2.3 | 1.50 | ||
1-butanol | ethyl_acetoacetate | 14.0 | 1.42 | para-xylene | ||||
butanol | 17.1 | 1.40 | ethyl-3-oxobutanoate | 1-4-dimethylbenzene | ||||
sec-butanol | acetoacetic_acid_ethyl_ester | pentane | 1.8 | 1.36 | ||||
butanone | 18.6 | 1.38 | ethyl_benzoate | 6.2 | 1.51 | n-pentane | ||
2-butanone | benzoic_acid_ethyl_ester | 1-pentanol | 15.1 | 1.41 | ||||
butan-2-one | decane | 2.0 | 1.41 | 2-pentanol | 13.4 | 1.41 | ||
methyl_ethyl_ketone | n-decane | 3-pentanol | 14.0 | 1.41 | ||||
carbon_tetrachloride | 2.2 | 1.46 | ethyl_formate | 8.7 | 1.36 | 2-pentanone | 15.4 | 1.39 |
tetrachloromethane | ethyl_methanoate | pentan-2-one | ||||||
chlorobenzene | 5.7 | 1.52 | formic_acid_methyl_ester | methyl_propyl_ketone | ||||
chloroform | 4.8 | 1.44 | ethylene_glycol | 42.8 | 1.43 | phenol | 13.4 | 1.54 |
trichloromethane | 1-2-ethanediol | 1-propanol | 20.8 | 1.39 | ||||
cyclohexane | 2.0 | 1.43 | fluorobenzene | 5.5 | 1.49 | propanal | 17.4 | 1.36 |
cyclohexanol | 16.4 | 1.46 | formamide | 111.8 | 1.45 | propionaldehyde | ||
cyclohexanone | 16.1 | 1.45 | formic_acid | 51.1 | 1.37 | pyridine | 13.3 | 1.51 |
1-1-dichloroethane | 10.1 | 1.42 | heptane | 1.9 | 1.39 | t-butanol | 12.0 | 1.38 |
1-2-dichloroethane | 10.4 | 1.44 | n-heptane | tert-butanol | ||||
dichloromethane | 8.9 | 1.42 | heptanol | 11.9 | 1.42 | 2-methyl-2-propanol | ||
methylene_chloride | 1-heptanol | tetrahydrofuran | 7.5 | 1.40 | ||||
diethylamine | 3.7 | 1.39 | hexane | 1.9 | 1.37 | THF | ||
diethyl_ether | 4.3 | 1.83 | n-hexane | toluene | 2.4 | 1.50 | ||
diethyl_ketone | 17.0 | 1.39 | hexanol | 13.6 | 1.42 | triethylamine | 2.4 | 1.40 |
3-pentanone | 1-hexanol | n-n-diethylethanamine | ||||||
pentan-3-one | water | 80.2 | 1.78 |
A PCM describes only electrostatic interactions with the solute, based on the static
dielectric constant (for the initial state) and possibly the optical dielectric constant in the
case of a nonequilibrium excitation or ionization process. Nonelectrostatic interaction
terms,
529
Wiley Interdiscip. Rev.: Comput. Mol. Sci.
(2021),
11,
pp. e1519.
Link
describing cavitation (Pauli repulsion) and dispersion interactions, for example,
can be added in an ad hoc way but have not been specifically parameterized for PCMs.
(For solvation models with automatic incorporation of nonelectrostatic terms, which are needed to obtain
absolute solvation energies, see the SM models in Section 11.2.9 or the CMIRS approach in
Section 11.2.7.
To add nonelectrostatic interactions to a PCM calculation, use the $solvent section whose general form is shown below.
$solvent NonEls <Option> NSolventAtoms <Number unique of solvent atoms> SolventAtom <Number1> <Number2> <Number3> <SASradius> SolventAtom <Number1> <Number2> <Number3> <SASradius> . . . <Keyword> <parameter/option> . . . $end
The keyword SolventAtom requires multiple parameters, whereas all other
keywords require only a single parameter, including the Dielectric, OpticalDielectric,
and SolventName options that were discussed above.
The keyword SolventAtom requires multiple parameters, whereas all other
keywords require only a single parameter. Whereas the dielectric constant is required for any PCM
calculation (with a default value representing water), the nonelectrostatic parameters are optional
and have only infrequently been added to these models.
265
Acc. Chem. Res.
(2009),
42,
pp. 493.
Link
,
656
Acc. Chem. Res.
(2009),
42,
pp. 489.
Link
The nonelectrostatic interactions currently available in Q-Chem are based on
the work of Cossi et al.,
257
J. Comput. Chem.
(1996),
17,
pp. 57.
Link
and are computed outside of the
SCF procedure used to determine the electrostatic interactions. The
nonelectrostatic energy is highly dependent on the input parameters and can be
extremely sensitive to the radii chosen to define the solute cavity.
Accordingly, the inclusion of nonelectrostatic interactions is highly
empirical and probably needs to be considered on a case-by-case basis.
Following Ref.
257
J. Comput. Chem.
(1996),
17,
pp. 57.
Link
, the cavitation energy is computed using
the same solute cavity that is used to compute the electrostatic energy,
whereas the dispersion/repulsion energy is computed using a SAS cavity definition.
The following keywords (in the $solvent section) are used to define nonelectrostatic parameters for PCM calculations.
NonEls
Specifies what type of nonelectrostatic contributions to include.
INPUT SECTION: $solvent
TYPE:
STRING
DEFAULT:
None
OPTIONS:
Cav
Cavitation energy
Buck
Buckingham dispersion and repulsion energy from atomic number
LJ
Lennard-Jones dispersion and repulsion energy from force field
BuckCav
Buck + Cav
LJCav
LJ + Cav
RECOMMENDATION:
A very limited set of parameters for the Buckingham potential is available at present.
NSolventAtoms
The number of different types of atoms.
INPUT SECTION: $solvent
TYPE:
INTEGER
DEFAULT:
None
OPTIONS:
Specifies that there are different types of atoms.
RECOMMENDATION:
This keyword is necessary when NonEls = Buck, LJ, BuckCav, or LJCav.
Methanol (), for example, has three types of atoms (C, H, and O).
SolventAtom
Specifies a unique solvent atom.
INPUT SECTION: $solvent
TYPE:
Various
DEFAULT:
None.
OPTIONS:
Input (TYPE)
Description
Number1 (INTEGER):
The atomic number of the atom
Number2 (INTEGER):
How many of this atom are in a solvent molecule
Number3 (INTEGER):
Force field atom type
SASradius (FLOAT):
Probe radius (in Å) for defining the solvent accessible surface
RECOMMENDATION:
If not using LJ or LJCav, then Number3 should be set to 0. The SolventAtom keyword is
necessary when NonEls = Buck, LJ, BuckCav, or LJCav
Temperature
Specifies the solvent temperature.
INPUT SECTION: $solvent
TYPE:
FLOAT
DEFAULT:
300.0
OPTIONS:
Use a temperature of , in Kelvin.
RECOMMENDATION:
Used only for the cavitation energy.
Pressure
Specifies the solvent pressure.
INPUT SECTION: $solvent
TYPE:
FLOAT
DEFAULT:
1.0
OPTIONS:
Use a pressure of , in bar.
RECOMMENDATION:
Used only for the cavitation energy.
SolventRho
Specifies the solvent number density
INPUT SECTION: $solvent
TYPE:
FLOAT
DEFAULT:
Determined for water, based on temperature.
OPTIONS:
Use a density of , in molecules/Å.
RECOMMENDATION:
Used only for the cavitation energy.
SolventRadius
The radius of a solvent molecule of the PCM solvent.
INPUT SECTION: $solvent
TYPE:
FLOAT
DEFAULT:
None
OPTIONS:
Use a radius of , in Å.
RECOMMENDATION:
Used only for the cavitation energy.
The following example illustrates the use of the nonelectrostatic interactions.
$molecule 0 1 C -0.245826 -0.351674 -0.019873 23 C 0.244003 0.376569 1.241371 22 O 0.862012 -0.527016 2.143243 24 F 0.776783 -0.909300 -0.666009 26 F -0.858739 0.511576 -0.827287 26 F -1.108290 -1.303001 0.339419 26 H -0.587975 0.878499 1.736246 27 H 0.963047 1.147195 0.961639 27 H 0.191283 -1.098089 2.489052 25 $end $rem JOBTYPE OPT BASIS 6-31G* METHOD B3LYP SOLVENT_METHOD PCM FORCE_FIELD OPLSAA $end $pcm Theory CPCM Method SWIG Solver Inversion HeavyPoints 194 HPoints 194 Radii Bondi vdwScale 1.2 $end $solvent NonEls LJCav NSolventAtoms 2 SolventAtom 8 1 186 1.30 SolventAtom 1 2 187 0.01 SolventRadius 1.35 Temperature 298.15 Pressure 1.0 SolventRho 0.03333 Dielectric 78.39 $end
The OpticalDielectric keyword in the $solvent section is needed for nonequilibrium calculations, or it can be set to a predefined value by specifying SolventName instead. The LR-PCM excitation energy is automatically calculated whenever the CIS/TDDFT calculations are performed with PCM, but it is turned off while the perturbation scheme is employed.
ChargeSeparation
Partition fast and slow charges in solvent equilibrium state
INPUT SECTION: $pcm
TYPE:
STRING
DEFAULT:
No default.
OPTIONS:
Marcus
Do slow-fast charge separation with the Marcus partition.
Pekar
Do slow-fast charge separation with the Pekar partition.
RECOMMENDATION:
Charge separation is used in conjunction with the StateSpecific keyword in $pcm.
StateSpecific
Specifies which the state-specific PCM will be used.
INPUT SECTION: $pcm
TYPE:
Various
DEFAULT:
No default.
OPTIONS:
Perturb
Perform ptSS and ptLR for vertical excitations.
External
Perform self-consistent EI-SS-PCM to the excited state (for emission).
Internal
Perform self-consistent II-SS-PCM to the excited state (for emission or excitation).
RECOMMENDATION:
Use for vertical excition energies ptSS-PCM or in very polar cases the nonequilibrium II-SS-PCM,
and equilibrium EI-SS-PCM for emission energies of long-lived excited states.
TdNonEq
Specify the self-consistent SS-PCM/TDDFT method to calculate the solvent effects on vertical absorption
and emission in solution based on the constrained equilibrium principle for nonequilibrium solvation.
INPUT SECTION: $pcm
TYPE:
INTEGER
DEFAULT:
NONE
OPTIONS:
1
Calculate nonequilibrium excited-state free energy in absorption based on the equilibrium ground-state reaction field via an RPA calculation at the ground-state geometry.
2
Calculate nonequilibrium excited-state free energy in absorption based on the nonequilibrium excited-state reaction field via an RPA calculation at the ground-state geometry.
3
Calculate equilibrium excited-state free energy in emission based on the equilibrium excited-state reaction field via an RPA calculation at the excited-state geometry.
4
Calculate nonequilibrium ground-state free energy in emission based on the nonequilibrium ground-state reaction field via a pure single-point energy calculation at the excited-state geometry.
RECOMMENDATION:
Option 2 and 3 need to be iterated until the excited-state reaction field converges. Option 1 is the first iteration of option 2. After the equilibrium excited state reaction field of option 3 converges, option 4 is executed.
$molecule 0 1 C 0 0 0.0 O 0 0 1.21 $end $rem EXCHANGE B3LYP CIS_N_ROOTS 10 CIS_SINGLETS TRUE CIS_TRIPLETS TRUE RPA TRUE BASIS 6-31+G* SOLVENT_METHOD PCM $end $pcm Theory CPCM Method SWIG Solver Inversion Radii Bondi $end $solvent Dielectric 78.39 OpticalDielectric 1.777849 $end
$molecule 0 1 C 0.000046 -0.000398 1.904953 C 1.210027 0.000379 1.186051 C 1.214640 -0.000065 -0.194515 C 0.000164 -0.000616 -0.933832 C -1.214349 -0.001557 -0.194687 C -1.209753 -0.001846 1.185775 H 2.151949 0.001377 1.722018 H 2.164371 0.000481 -0.709640 H -2.164082 -0.002008 -0.709781 H -2.151763 -0.002287 1.721615 C -0.000227 0.001061 3.325302 N -0.000475 0.002405 4.484321 N 0.000053 -0.000156 -2.297372 C -1.258656 0.001284 -3.036994 H -1.041042 0.001615 -4.102376 H -1.860897 -0.885647 -2.811117 H -1.859247 0.889133 -2.810237 C 1.258563 -0.000660 -3.037285 H 1.860651 0.886208 -2.810755 H 1.859362 -0.888604 -2.811461 H 1.040664 -0.000097 -4.102609 $end $rem EXCHANGE LRC-wPBEPBE OMEGA 260 BASIS 6-31G* CIS_N_ROOTS 10 RPA 2 CIS_SINGLETS 1 CIS_TRIPLETS 0 CIS_RELAXED_DENSITY TRUE SOLVENT_METHOD PCM $end $pcm NonEquilibrium Theory IEFPCM StateSpecific Perturb $end $solvent Dielectric 35.688000 ! Acetonitrile OpticalDielectric 1.806874 $end
$molecule -1 1 N -0.068642000000 -0.600693000000 -0.723424000000 O 0.349666000000 0.711166000000 1.187490000000 O -0.948593000000 0.200668000000 -0.956940000000 O 0.659040000000 -0.386002000000 0.402650000000 $end $rem jobtype ¯¯ sp method ¯¯ PBE0 basis ¯¯¯ 3-21g point_group_symmetry False cis_n_roots 2 ! Number of excited states cis_singlets true cis_triplets false rpa false ! Tamm-Dancoff approximation cis_moments true ! Excited state multipole moments cis_relaxed_density true ! Excited state density relaxation solvent_method ¯ pcm $end $pcm StateSpecific External ! Keyword for External Iteration SS-PCM LinearResponse false ! Switch of LR-PCM $end $solvent Dielectric 35.68800 ! Acetonitrile OpticalDielectric 1.806874 $end @@@ $molecule read $end $rem jobtype ¯¯ sp method ¯¯ PBE0 basis ¯¯¯ 3-21g point_group_symmetry False cis_n_roots 2 cis_singlets true cis_triplets false rpa false cis_moments true cis_relaxed_density true solvent_method pcm $end $pcm StateSpecific External Eqsolv 15 ! Max. Number of iterations Eqstate 1 ! Ref. State to be equilibrated Eqs_Conv 4 ! Conv. criterion for SCF energy and surface charges EqState_Follow true ! State Following to remain on the same Ref. State LinearResponse false $end $solvent Dielectric 35.68800 ! Acetonitrile OpticalDielectric 1.806874 $end
$molecule -1 1 N -0.068642000000 -0.600693000000 -0.723424000000 O 0.349666000000 0.711166000000 1.187490000000 O -0.948593000000 0.200668000000 -0.956940000000 O 0.659040000000 -0.386002000000 0.402650000000 $end $rem jobtype ¯¯ sp method ¯¯ PBE0 basis ¯¯¯ 3-21g point_group_symmetry False cis_n_roots 4 ! Number of excited states cis_singlets true cis_triplets false rpa false ! Tamm-Dancoff approximation cis_moments true ! Excited state multipole moments cis_relaxed_density true ! Excited state density relaxation solvent_method pcm $end $pcm StateSpecific Internal ! Keyword for Internal Iteration SS-PCM ChargeSeparation MARCUS ! Keyword for the charge separation InternalIteration AEM(f) ! Procedure (VEM(f), VEM(d), AEM(f), or AEM(d)) + state sequence (add e.g.: -state 1 3 1 0) Eqsolv 10 ! Max. Number of iterations Eqstate 1 ! Ref. State to be equilibrated Eqs_Conv 4 ! Conv. criterion for SCF energy and surface charges EqState_Follow true ! State Following to remain on the same Ref. State theory iefpcm ! PCM Theory (else CPCM) rf_ptss_save true ! Save the eq. reaction field of Ref. State LinearResponse false ! Switch of LR-PCM $end $solvent Dielectric 35.68800 ! Acetonitrile OpticalDielectric 1.806874 $end @@@ $molecule read $end $rem jobtype sp method ¯¯ PBE0 basis 3-21g point_group_symmetry False solvent_method pcm $end $pcm theory iefpcm rf_ptss_read true ! Flag to read the reaction field and do RF-ptSS calc $end $solvent Dielectric 35.68800 ! Acetonitrile OpticalDielectric 1.806874 $end
$molecule 0 1 C 0.00000000 0.00000000 0.00000000 O 0.00000000 0.00000000 1.22027000 C 1.28132052 0.00000000 -0.79367740 H 2.14499626 -0.00083829 -0.12870724 H 1.30455453 -0.88067608 -1.44302080 H 1.30547296 0.88142003 -1.44198042 C -1.28127663 0.00458022 -0.79382239 H -2.14504139 0.00537545 -0.12895306 H -1.30703468 -0.87518579 -1.44430491 H -1.30295394 0.88686493 -1.44106115 $end $rem METHOD M062X BASIS 6-31+G* JOB_TYPE sp RPA 2 DFT_D D3 cis_singlets TRUE cis_triplets FALSE cis_n_roots 5 cis_state_deriv 1 CIS_DYNAMIC_MEM TRUE CIS_RELAXED_DENSITY TRUE CIS_MOMENTS TRUE SOLVENT_METHOD PCM $end $pcm Theory SSVPE ChargeSeparation Pekar StateSpecific Perturb TdNonEq 1 $end $solvent Dielectric 32.613 OpticalDielectric 1.766 $end @@@ $molecule read $end $rem METHOD M062X BASIS 6-31+G* JOB_TYPE sp RPA 2 DFT_D D3 cis_singlets TRUE cis_triplets FALSE cis_n_roots 5 cis_state_deriv 1 CIS_DYNAMIC_MEM TRUE CIS_RELAXED_DENSITY TRUE CIS_MOMENTS TRUE SOLVENT_METHOD PCM $end $pcm Theory SSVPE ChargeSeparation Pekar StateSpecific Perturb TdNonEq 2 $end $solvent Dielectric 32.613 OpticalDielectric 1.766 $end
$molecule 0 1 C 0.00000000 -0.57624800 0.00000000 H -0.95773500 -1.10813200 0.00000000 H 0.95773500 -1.10813200 0.00000000 O 0.00000000 0.70921900 0.00000000 $end $rem METHOD M062X BASIS 6-31+G* CIS_N_ROOTS 5 RPA 2 CIS_SINGLETS 1 CIS_TRIPLETS 0 CIS_DYNAMIC_MEM TRUE CIS_RELAXED_DENSITY TRUE SOLVENT_METHOD PCM POP_MULLIKEN -1 CIS_MOMENTS TRUE DFT_D D3 CIS_CONVERGENCE 5 MAX_CIS_CYCLES 150 $end $pcm Theory SSVPE Method SWIG ChargeSeparation EXCITED StateSpecific 1 TdNonEq 3 $end $solvent Dielectric 78.5 OpticalDielectric 1.778 $end @@@ $molecule read $end $rem METHOD M062X BASIS 6-31+G* SOLVENT_METHOD PCM POP_MULLIKEN -1 DFT_D D3 SCF_CONVERGENCE 8 $end $pcm Theory SSVPE Method SWIG ChargeSeparation Pekar StateSpecific Pekar TdNonEq 4 $end $solvent Dielectric 78.5 OpticalDielectric 1.778 $end
$molecule 0 1 C 0.00000000 -0.57624800 0.00000000 H -0.95773500 -1.10813200 0.00000000 H 0.95773500 -1.10813200 0.00000000 O 0.00000000 0.70921900 0.00000000 $end $rem METHOD M062X BASIS 6-31+G(d) SOLVENT_METHOD PCM POP_MULLIKEN -1 DFT_D D3 $end $pcm Theory SSVPE Method SWIG ChargeSeparation Pekar StateSpecific Pekar TdNonEq 4 $end $solvent Dielectric 78.5 OpticalDielectric 1.778 $end