Opt

DESCRIPTION

This keyword requests that a geometry optimization be performed. The geometry will be adjusted until a stationary point on the potential surface is found. Analytic gradients will be used if available. For the Hartree-Fock, CIS, MP2, MP3, MP4(SDQ), CID, CISD, CCD, CCSD, QCISD, BD, CASSCF, and all DFT and semi-empirical methods, the default algorithm for both minimizations (optimizations to a local minimum) and optimizations to transition states and higher-order saddle points is the Berny algorithm using GEDIIS[Li06]in redundant internal coordinates[Pulay79,Fogarasi92,Pulay92,Baker93,Peng93,Peng96](corresponding to theRedundantoption). An brief overview of the Berny algorithm is provided in the final subsection of this discussion. The default algorithm for all methods lacking analytic gradients is the eigenvalue-following algorithm (Opt=EF).

Gaussian includes the STQN method for locating transition structures. This method, implemented by H. B. Schlegel and coworkers[Peng93,Peng96], uses a quadratic synchronous transit approach to get closer to the quadratic region of the transition state and then uses a quasi-Newton or eigenvector-following algorithm to complete the optimization. Like the default algorithm for minimizations, it performs optimizations by default in redundant internal coordinates. This method will converge efficiently when provided with an empirical estimate of the Hessian and suitable starting structures.

This method is requested with theQST2andQST3options.QST2requires two molecule specifications, for the reactants and products, as its input, whileQST3requires three molecule specifications: the reactants, the products, and an initial structure for the transition state, in that order.The order of the atoms must be identical within all molecule specifications. See the examples for sample input for and output from this method.

Basic information as well as techniques and pitfalls related to geometry optimizations are discussed in detail in chapter 3 ofExploring Chemistry with Electronic Structure Methods[Foresman96b]. For a review article on optimization and related subjects, see[Hratchian05a].

SELECTING THE OPTIMIZATION GOAL

By default, optimizations search for a local minimum.

QST2
Search for a transition structure using the STQN method. This option requires the reactant and product structures as input, specified in two consecutive groups of title and molecule specification sections. Note that the atoms must be specified in the same order in the two structures.TSshouldnotbe specified withQST2.

QST3
Search for a transition structure using the STQN method. This option requires the reactant, product, and initial TS structures as input, specified in three consecutive groups of title and molecule specification sections. Note that the atoms must be specified in the same order within the three structures.TSshouldnotbe specified withQST3.

TS
Requests optimization to a transition state rather than a local minimum, using the Berny algorithm.

Saddle=N
Requests optimization to a saddle point of orderNusing the Berny algorithm.

Conical
Search for a conical intersection or avoided crossing using the state-averaged CASSCF method.Avoidedis a synonym forConical. Note thatCASSCF=SlaterDetis needed in order to locate a conical intersection between a singlet state and a triplet state.

OPTIONS TO MODIFY THE INITIAL GEOMETRY

ModRedundant
Add, delete or modify redundant internal coordinate definitions (including scan and constraint information) before performing the calculation. This option requires a separate input section following the geometry specification. When used in conjunction withQST2orQST3, aModRedundantinput section must follow each geometry specification.AddRedundantis synonymous withModRedundant.

Lines in aModRedundantinput section use the following syntax:

[Type]N1 [N2 [N3 [N4]]] [A|F] [[min]max]] [Type]N1 [N2 [N3 [N4]]]B[[min]max]] [Type]N1 [N2 [N3 [N4]]]K|R[[min]max]] [Type]N1 [N2 [N3 [N4]]]D[[min]max]] [Type]N1 [N2 [N3 [N4]]]Hdiag-elem[[min]max]] [Type]N1 [N2 [N3 [N4]]]Snsteps stepsize[[min]max]]

N1,N2,N3 andN4 are atom numbers or wildcards (discussed below). Atom numbering begins at 1, and any dummy atoms are not counted.

The atom numbers are followed by a one-character code letter indicating the coordinate modification to be performed; the action code is sometimes followed by additional required parameters as indicated above. If no action code is included, the default action is to add the specified coordinate. These are the available action codes:

A Activate the coordinate for optimization if it has been frozen.
F Freeze the coordinate in the optimization.
B Add the coordinate and build all related coordinates.
K Remove the coordinate and kill all related coordinates containing this coordinate.
R Remove the coordinate from the definition list (but not the related coordinates).
D Calculate numerical second derivatives for the row and column of the initial Hessian for this coordinate.
H Change the diagonal element for this coordinate in the initial Hessian todiag-elem.
S Perform a relaxed potential energy surface scan. Increment the coordinate bystepsizea total ofnstepstimes, performing an optimization from each resulting starting geometry.

An asterisk (*) in the place of an atom number indicates a wildcard.Minandmaxonly apply to coordinate specifications containing wildcards. The action then specified by the action code is taken only if the value of the coordinate is in theminmaxrange (or below maximum value ifminis not given).

Here are some examples of wildcard use:

* All atoms specified by Cartesian coordinates
* * All defined bonds
3 * All defined bonds with atom 3
* * * All defined valence angles
* 4 * All defined valence angles around atom 4
* * * * All defined dihedral angles
* 3 4 * All defined dihedral angles around the bond connecting atoms 3 and 4

By default, the coordinate type is determined from the number of atoms specified: Cartesian coordinates for 1 atom, bond stretch for 2 atoms, valence angle for 3 atoms and dihedral angle for 4 atoms. Optionally,typecan be used to designate these and additional coordinate types:

X Cartesian coordinates.
B Bond length
A Valence angle
D Dihedral angle
L Linear bend specified by three atoms (ifN4 is-1) or by four atoms, where the fourth atom is used to determine the 2 orthogonal directions of the linear bend. In this case,minandmaxare each pairs of numbers, specifying the two orthogonal bending components.

By default, redundant internal coordinates for potential hydrogen bonds are not generated automatically. However, bond coordinates are still added to connect otherwise disjoint fragments, so coordinates for hydrogen bonds which connect fragments will still be included.

See the examples later in this section for illustrations of the use ofModRedundant.

ReadOptimize
Read an input section modifying which atoms are to be optimized. The atom list is specified in a separate input section (terminated by a blank line). By default, the atom list contains all atoms in the molecule, unless any atoms are designated as frozen within the molecule specification, in which case the initial atom list excludes them. If the structure is being read in from the checkpoint file, then the list of atoms to be optimized matches that in the checkpoint file.ReadOptandRdOptare synonyms for this option.ReadFreezeis a deprecated synonym.

The input section uses the following format:

atoms=list[notatoms=list]

where eachlistis a comma or space-separated list of atom numbers, atom number ranges and/or atom types. Keywords are applied in succession. Here are some examples:

atoms=3-6,17 notatoms=5Adds atoms 3, 4, 6 and 17 to the atom list. Removes 5 if present.atoms=3 C 18-30 notatoms=HAdds all C & non-H among atoms 3, 18-30.atoms=C N notatoms=5Adds all C and N atoms except atom 5.atoms=1-5 notatoms=H atoms=8-10Adds non-hydrogens among atoms 1-5,and atoms 8-10 regardless of element type.

Bare integers without a keyword are interpreted as atom numbers:

1,3,5 7Adds atoms 1, 3, 5 and 7.

For ONIOM optimizations only,blockandnotblockcan be similarly used to include/exclude rigid blocks defined in ONIOM molecule specifications. If there are contradictions between atoms specified as atoms and within blocks—e.g., an atom is included within a block but excluded by atom type—Gaussian 09 generates an error.

You can start from an empty atom list by placingnoatomsas the first item in the input section. For example, the following input optimizes all non-hydrogen atoms within atoms 1-100 and freezes all other atoms in the molecule:

noatoms atoms=1-100 notatoms=H

Atoms can also be specified by ONIOM layer via the [not]layerkeywords, which accept these values:realfor the real system,modelfor the model system in a 2-layer ONIOM,middlefor the middle layer in a 3-layer ONIOM, andsmallfor the model layer of a 3-layer ONIOM. Atoms may be similarly included/excluded by residue withresidueandnotresidue, which accept lists of residue names. Both keyword pairs function as shorthand forms for atom lists.

Separate sections are read for each geometry for transition state optimizations usingQST2orQST3. Be aware that providing contradictory input—e.g., different frozen atoms for the reactants and products—will produce unpredictable results.

NoFreeze
Activates (unfreezes) all variables, in other words freeze nothing and optimize all atoms. This option is useful when reading in a structure from a checkpoint file that contains frozen atoms (i.e. withGeom=Check).

GENERAL PROCEDURAL OPTIONS

MaxCycles=N
Sets the maximum number of optimization steps toN. The default is the maximum of 20 and twice the number of redundant internal coordinates in use (for the default procedure) or twice the number of variables to be optimized (for other procedures).

MaxStep=N
Sets the maximum size for an optimization step (the initial trust radius) to 0.01NBohr or radians. The default value forNis 30.

Restart
Restarts a geometry optimization from the checkpoint file. In this case, the entire route section will consist of theOptkeyword and the same options to it as specified for the original job (along withRestart). No other input is needed (see the examples).

InitialHarmonic=N
Add harmonic constraints to the initial structure with force constantN/1000000 Hartree/Bohr2.IHarmonicis a synonym for this option.

ChkHarmonic=N
Add harmonic constraints to the initial structure saved on the chk file with force constantN/1000000 Hartree/Bohr2.CHarmonicis a synonym for this option.

ReadHarmonic=N
Add harmonic constraints to a structure read in the input stream (in the input orientation), with force constantN/1000000 Hartree/Bohr2.RHarmonicis a synonym for this option.

MaxMicroiterations=N
Allow up toNmicroiterations. The default is based onNAtoms but is at least 5000.MaxMicrois a synonym for this option.

NGoDown=N
Mix at mostNHessian eigenvectors having negative eigenvalues when trying to go downhill. Defaults to 3. IfN=-1, do regular RFO step only.NoDownHillis equivalent toNGoDown = -1.

OPTIONS RELATED TO INITIAL FORCE CONSTANTS

Unless you specify otherwise, a Berny geometry optimization starts with an initial guess for the second derivative matrix—also known as the Hessian—which is determined using connectivity derived from atomic radii and a simple valence force field[Schlegel84a,Peng96]. The approximate matrix is improved at each point using the computed first derivatives. This scheme usually works fine, but for some cases the initial guess may be so poor that the optimization fails to start off properly or spends many early steps improving the Hessian without nearing the optimized structure. In addition, for optimizations to transition states, some knowledge of the curvature around the saddle point is essential, and the default approximate Hessian must always be improved.

The following options select methods for providing improved force constants:

ReadFC
Extract force constants from a checkpoint file. These will typically be the final approximate force constants from an optimization at a lower level, or (much better) the force constants computed correctly by a lower-level frequency calculation (the latter are greatly preferable to the former).

CalcFC
Specifies that the force constants be computed at the first point using the current method (available for the HF, MP2, CASSCF, DFT, CIS, and semi-empirical methods only).

CalcHFFC
Specifies that the analytic HF force constants are to be computed at the first point.CalcHFFCis used with MP2 optimizations, and it is equivalent toCalcFCfor DFT methods, AM1, PM3, PM3MM, PM6 and PDDG.

RCFC
Specifies that the computed force constants in Cartesian coordinates (as opposed to internal) from a frequency calculation are to be read from the checkpoint file. Normally it is preferable to pick up the force constants already converted to internal coordinates as described above (CalcFC). However, a frequency calculation occasionally reveals that a molecule needs to distort to lower symmetry. In this case, the computed force constants in terms of the old internal coordinates cannot be used, and insteadOpt=RCFCis used to read the Cartesian force constants and transform them. Note that Cartesian force constants are only available on the checkpoint file after a frequency calculation. You cannot use this option after an optimization dies because of a wrong number of negative eigenvalues in the approximate second derivative matrix. In the latter case, you may want to start from the most recent geometry and compute some derivatives numerically (see below).ReadCartesianFCis a synonym forRCFC.

CalcAll
Specifies that the force constants are to be computed at every point using the current method (available for the HF, MP2, CASSCF, DFT, CIS, and semi-empirical methods only). Note that vibrational frequency analysis is automatically done at the converged structure and the results of the calculation are archived as a frequency job.

VCD
Calculate VCD intensities at each point of a Hartree-Fock or DFTOpt=CalcAlloptimization.

NoRaman
Specifies that Raman intensities are not to be calculated at each point of a Hartree-FockOpt=CalcAlljob (since it includes a frequency analysis using the results of the final point of the optimization). The Raman intensities add 10-20% to the cost of each intermediate second derivative point.

There are two other approaches to providing the initial Hessian which are sometimes useful:

StarOnly
Specifies that the specified force constants are to be estimated numerically but that no optimization is to be done. Note that this has nothing to do with computation of vibrational frequencies.

NewEstmFC
Estimate the force constants using a valence force field. This is the default.

EstmFC
Estimate the force constants using the old diagonal guesses. Only available for the Berny algorithm.

CONVERGENCE-RELATED OPTIONS

These options are available for the Berny algorithm only.

Tight
This option tightens the cutoffs on forces and step size that are used to determine convergence. An optimization withOpt=Tightwill take several more steps than with the default cutoffs. For molecular systems with very small force constants (low frequency vibrational modes), this may be necessary to ensure adequate convergence and reliability of frequencies computed in a subsequent job step. This option can only be used with Berny optimizations. For DFT calculations,Int=UltraFineshould be specified as well.

VeryTight
Extremely tight optimization convergence criteria.VTightis a synonym forVeryTight. For DFT calculations,Int=UltraFineshould be specified as well.

EigenTest
EigenTestrequests andNoEigenTestsuppresses testing the curvature in Berny optimizations. The test is on by default only for transition states in internal (Z-matrix) or Cartesian coordinates, for which it is recommended. Occasionally, transition state optimizations converge even if the test is not passed, butNoEigenTestis only recommended for those with large computing budgets.

Expert
Relaxes various limits on maximum and minimum force constants and step sizes enforced by the Berny program. This option can lead to faster convergence but is quite dangerous. It is used by experts in cases where the forces and force constants are very different from typical molecules and Z-matrices, and sometimes in conjunction withOpt=CalcFCorOpt=CalcAll.NoExpertenforces the default limits and is the default.

Loose
Sets the optimization convergence criteria to a maximum step size of 0.01 au and an RMS force of 0.0017 au. These values are consistent with theInt(Grid=SG1)keyword, and may be appropriate for initial optimizations of large molecules using DFT methods which are intended to be followed by a full convergence optimization using the default (Fine) grid. It isnotrecommended for use by itself.

ALGORITHM-RELATED OPTIONS

GEDIIS
UseGEDIISoptimization algorithm. This is the default for minimizations when gradients are available.

RFO
Requests the Rational Function Optimization[Simons83]step during Berny optimizations. It is the default for transition state optimizations (Opt=TS). This was also the default algorithm for minimizations using gradients in Gaussian 03.

EF
Requests an eigenvalue-following algorithm[Cerjan81,Simons83,Banerjee85], which is useful only for methods without derivatives (for which it is the default). Available for both minima and transition states. andEigenvalueFolloware all synonyms forEF. When used withOpt=Z-Matrix, a maximum of 50 variables may be optimized.

ONIOM-RELATED OPTIONS

Micro
Use microiterations in ONIOM(MO:MM) optimizations. This is the default, with selection of L120 or L103 for the microiterations depending on whether electronic embedding is on or off.NoMicroforbids microiterations during ONIOM(MO:MM) optimizations.Mic120says to use microiterations in L120 for ONIOM(MO:MM), even for mechanical embedding. This is the default for electronic embedding.Mic103says to perform microiterations in L103 for ONIOM(MO:MM). It is the default for mechanical embedding, and it cannot be used with electronic embedding.

QuadMacro
Controls whether the coupled, quadratic macro step is used during ONIOM(MO:MM) geometry optimizations[Vreven06a].NoQuadMacrois the default.

COORDINATE SYSTEM SELECTION OPTIONS

Redundant
Perform the optimization using the Berny algorithm in redundant internal coordinates. This is the default for methods for which analytic gradients are available.

Z-matrix
Perform the optimization with the Berny algorithm using internal coordinates[Schlegel82,Schlegel89,Schlegel95]. In this case, the keywordFOptrather thanOptrequests that the program verify that a full optimization is being done (i.e., that the variables including inactive variables are linearly independent and span the degrees of freedom allowed by the molecular symmetry). ThePOptform requests a partial optimization in internal coordinates. It also suppresses the frequency analysis at the end of optimizations which include second derivatives at every point (via theCalcAlloption). SeeAppendix Cfor details and examples of Z-matrix molecule specifications.

Cartesian
Requests that the optimization be performed in Cartesian coordinates, using the Berny algorithm. Note that the initial structure may be input using any coordinate system. No partial optimization or freezing of variables can be done with purely Cartesian optimizations; the mixed optimization format with all atoms specified via Cartesian lines in the Z-matrix can be used along withOpt=Z-matrixif these features are needed. When a Z-matrix without any variables is used for the molecule specification, andOpt=Z-matrixis specified, then the optimization will actually be performed in Cartesian coordinates. Note that a variety of other coordinate systems, such as distance matrix coordinates, can be constructed using theModRedundantoption.

RARELY USED OPTIONS

Path=M
In combination with either theQST2or theQST3option, requests the simultaneous optimization of a transition state and anM-point reaction path in redundant internal coordinates[Ayala97]. No coordinate may be frozen during this type of calculation.

IfQST2is specified, the title and molecule specification sections for both reactant and product structures are required as input as usual. The remainingM-2 points on the path are then generated by linear interpolation between the reactant and product input structures. The highest energy structure becomes the initial guess for the transition structure. Each point is optimized to lie in the reaction path and the highest point is optimized toward the transition structure.

IfQST3is specified, a third set of title and molecule specification sections must be included in the input as a guess for the transition state as usual. The remainingM-3 points on the path are generated by two successive linear interpolations, first between the reactant and transition structure and then between the transition structure and product. By default, the central point is optimized to the transition structure, regardless of the ordering of the energies. In this case,Mmust be an odd number so that the points on the path may be distributed evenly between the two sides of the transition structure.

In the output for a simultaneous optimization calculation, the predicted geometry for the optimized transition structure is followed by a list of allMconverged reaction path structures.

The treatment of the input reactant and product structures is controlled by other options:OptReactant,OptProduct,BiMolecular.

Note that the SCF wavefunction for structures in the reactant valley may be quite different from that of structures in the product valley.Guess=Alwayscan be used to prevent the wavefunction of a reactant-like structure from being used as a guess for the wavefunction of a product-like structure.

OptReactant
Specifies that the input structure for the reactant in a path optimization calculation (Opt=Path) should be optimized to a local minimum. This is the default.NoOptReactantretains the input structure as a point that is already on the reaction path (which generally means that it should have been previously optimized to a minimum).OptReactantmay not be combined withBiMolecular.

BiMolecular
Specifies that the reactants or products are bimolecular and that the input structure will be used as an anchor point in anOpt=Pathoptimization. This anchor point will not appear as one of theMpoints on the path. Instead, it will be used to control how far the reactant side spreads out from the transition state. By default, this option is off.

OptProduct
Specifies that the input structure for the product in a path optimization calculation (Opt=Path) should be optimized to a local minimum. This is the default.NoOptProductretains the input structure as a point that is already on the reaction path (which generally means that it should have been previously optimized to a minimum).OptProductmay not be combined withBiMolecular.

Linear
Linearrequests andNoLinearsuppresses the linear search in Berny optimizations. The default is to use the linear search whenever possible.

TrustUpdate
TrustUpdaterequests andNoTrustUpdatesuppresses dynamic update of the trust radius in Berny optimizations. The default is to update for minima.

Newton
Use the Newton-Raphson step rather than the RFO step during Berny optimizations.

NRScale
NRScalerequests that if the step size in the Newton-Raphson step in Berny optimizations exceeds the maximum, then it is to be scaled back.NoNRScalecauses a minimization on the surface of the sphere of maximum step size[Golab83]. Scaling is the default for transition state optimizations and minimizing on the sphere is the default for minimizations.

Steep
Requests steepest descent instead of Newton-Raphson steps during Berny optimizations. This is only compatible with Berny local minimum optimizations. It may be useful when starting far from the minimum, but is unlikely to reach full convergence.

UpdateMethod=keyword
Specifies the Hessian update method.Keywordis one of:Powell,BFGS,PDBFGS,ND2Corr,OD2Corr,D2CorrBFGS,Bofill,D2CMixandNone.

HFError
Assume that numerical errors in the energy and forces are those appropriate for HF and post-SCF calculations (1.0D-07 and 1.0D-07, respectively). This is the default for optimizations using those methods and also for semi-empirical methods.

FineGridError
Assume that numerical errors in the energy and forces are those appropriate for DFT calculations using the default grid (1.0D-07 and 1.0D-06, respectively). This is the default for optimizations using a DFT method and using the default grid (or specifyingInt=FineGrid).

SG1Error
Assume that numerical errors in the energy and forces are those appropriate for DFT calculations using the SG-1 grid (1.0D-07 and 1.0D-05, respectively). This is the default for optimizations using a DFT method andInt(Grid=SG1Grid).

AVAILABILITY

Analytic gradients are available for the HF, all DFT methods, CIS, MP2, MP3, MP4(SDQ), CID, CISD, CCD, CCSD, QCISD, CASSCF, and all semi-empirical methods.

TheTight,VeryTight,Expert,EigentestandEstmFCoptions are available for the Berny algorithm only.

Optimizations of large molecules which have many very low frequency vibrational modes with DFT will often proceed more reliably when a larger DFT integration grid is requested (Int=UltraFine).

RELATED KEYWORDS

IRC,IRCMax,Scan,Force,Frequency

EXAMPLES

Output from Optimization Jobs. The stringGradGradGrad…delimits the output from the Berny optimization procedures. On the first, initialization pass, the program prints a table giving the initial values of the variables to be optimized. For optimizations in redundant internal coordinates,allcoordinates in use are displayed in the table (not merely those present in the molecule specification section):

GradGradGradGradGradGradGradGradGradGradGradGradGradGradGradGradGrad Berny optimization.The opt. algorithm is identified by the header format & this line.Initialization pass. ---------------------------- ! Initial Parameters ! ! (Angstroms and Degrees) ! -------------------- ---------------------- ! Name Definition Value Derivative Info. ! -------------------------------------------------------------------- ! R1 R(2,1) 1. estimate D2E/DX2 ! ! R2 R(3,1) 1. estimate D2E/DX2 ! ! A1 A(2,1,3) 104.5 estimate D2E/DX2 ! --------------------------------------------------------------------

The manner in which the initial second derivative are provided is indicated under the headingDerivative Info. In this case the second derivatives will be estimated.

Each subsequent step of the optimization is delimited by lines like these:

GradGradGradGradGradGradGradGradGradGradGradGradGradGradGradGradGrad Berny optimization. Search for a local minimum. Step number 4 out of a maximum of 20

Once the optimization completes, the final structure is displayed:

Optimization completed. -- Stationary point found. ---------------------------- ! Optimized Parameters ! ! (Angstroms and Degrees) ! -------------------- -------------------- ! Name Definition Value Derivative Info. ! -------------------------------------------------------------------- ! R1 R(2,1) 0.9892 -DE/DX = 0.0002 ! ! R2 R(3,1) 0.9892 -DE/DX = 0.0002 ! ! A1 A(2,1,3) 100.004 -DE/DX = 0.0001 ! --------------------------------------------------------------------

The redundant internal coordinate definitions are given in the second column of the table. The numbers in parentheses refer to the atoms within the molecule specification. For example, the variableR1, defined asR(2,1), specifies the bond length between atoms 1 and 2. The energy for the optimized structure will be found in the output from the final optimization step, whichprecedesthis table in the output file.

Compound Jobs. Optimizations are commonly followed by frequency calculations at the optimized structure. To facilitate this procedure, theOptkeyword may be combined withFreqin the route section of an input file, and this combination will automatically generate a two-step job.

It is also common to follow an optimization with a single point energy calculation at a higher level of theory. The following route section automatically performs an HF/6-31G(d,p) optimization followed by an MP4/6-31G(d,p) single point energy calculation :

# MP4/6-31G(d,p)//HF/6-31G(d,p) Test

Note that theOptkeyword is not required in this case. However, it may be included if setting any of its options is desired.

Modifying Redundant Internal Coordinates. The following input file illustrates the method for modifying redundant internal coordinates within an input file:

# HF/6-31G(d) Opt=ModRedun Test Opt job 0,1 C1 0.000 0.000 0.000 C2 0.000 0.000 1.505 O3 1.047 0.000 -0.651 H4 -1.000 -0.006 -0.484 H5 -0.735 0.755 1.898 H6 -0.295 -1.024 1.866 O7 1.242 0.364 2.065 H8 1.938 -0.001 1.499 3 8Adds hydrogen bond (but not angles or dihedrals).2 1 3Adds C-C-O angle.

This structure is acetaldehyde with an OH substituted for one of the hydrogens in the methyl group; the first input line forModRedundantcreates a hydrogen bond between that hydrogen atom and the oxygen atom in the carbonyl group. Note that this adds only the bond between these two atoms The associated angles and dihedral angles could be added as well using theBaction code:

3 8 B

Displaying the Value of a Desired Coordinate. The second input line forModRedundantspecifies the C-C=O bond angle, ensuring that its value will be displayed in the summary structure table for each optimization step.

Using Wildcards in Redundant Internal Coordinates. A distance matrix coordinate system can be activated using the following input:

* * BDefine all bonds between pairs of atoms* * * KRemove all other redundant internal coordinates

The following input defines partial distance matrix coordinates to connect only the closest layers of atoms:

* * B 1.1Define all bonds between atoms within 1.1 Å* * * KRemove all other redundant internal coordinates

The following input sets up an optimization in redundant internal coordinates in which atomsN1throughNnare frozen (such jobs may require theNoSymmkeyword). Note that the lines containing theBaction code will generate Cartesian coordinates for all of the coordinates involving the specified atom since only one atom number is specified:

N1 BGenerate Cartesian coordinates involving atom N1… Nn BGenerate Cartesian coordinates involving atom Nn* FFreeze all Cartesian coordinates

The following input defines special “spherical” internal coordinates appropriate for molecules like C60by removing all dihedral angles from the redundant internal coordinates:

* * * * RRemove all dihedral angles

Additional examples are found in the section on relaxed PES scans below.

Performing Partial Optimizations. The following job illustrates the method for freezing variables during an optimization:

# B3LYP/6-31G(d) Opt=ReadOpt Partial optimization of Fe2S2 cluster with phenylthiolates. -2,1 Fe 15.2630 -1.0091 7.0068 S 14.8495 1.1490 7.0431 Fe 17.0430 1.0091 7.0068 S 17.4565 -1.1490 7.0431 S 14.3762 -2.1581 8.7983 C 12.5993 -2.1848 8.6878 … C 14.8285 -3.8823 3.3884 H 14.3660 -3.3149 2.7071 noatoms atoms=1-4ReadOpt input.

The central cluster (the first four atoms) will be optimized while the phenylthiolates are frozen.

Restarting an Optimization. A failed optimization may be restarted from its checkpoint file by simply repeating the route section of the original job, adding theRestartoption to theOptkeyword. For example, this route section restarts a B3LYP/6-31G(d) Berny optimization to a second-order saddle point:

%Chk=saddle2 # Opt=(TS,Restart,MaxCyc=50) Test

The model chemistry and starting geometry are retrieved from the checkpoint file. Options specifying the optimization type and procedure are required in the route section for the restart job (e.g.,TSin the preceding example). Some parameter-setting options can be omitted to use the same values are for the original job, or they can be modified for the restarted job, such asMaxCyclein the example. Note that you must includeCalcFCto compute the Hessian at the first point of the restarted job. Second derivatives are computed only when this option is present in the route section of the restarted job, regardless of whether it was specified for the original job.

Reading a Structure from the Checkpoint File. Redundant internal coordinate structures may be retrieved from the checkpoint file withGeom=Checkpointas usual. The read-in structure may be altered by specifyingGeom=ModRedundantas well; modifications have a form identical to the input forOpt=ModRedundant:

[Type]N1 [N2 [N3 [N4]]] [Action[Params]] [[Min]Max]]

Locating a Transition Structure with the STQN Method. TheQST2option initiates a search for a transition structure connecting specific reactants and products. The input for this option has this general structure (blank lines are omitted):

# HF/6-31G(d) Opt=QST2 # HF/6-31G(d) (Opt=QST2,ModRedun)
First title section First title section
Molecule specification for the reactants Molecule specification for the reactants
Second title section ModRedundant input for the reactants
Molecule specification for the products Second title section
Molecule specification for the products
ModRedundant input for the products (optional)

Note that each molecule specification is preceded by its own title section (and separating blank line). If theModRedundantoption is specified, then each molecule specification is followed by any desired modifications to the redundant internal coordinates.

Gaussian will automatically generate a starting structure for the transition structure midway between the reactant and product structures, and then perform an optimization to a first-order saddle point.

TheQST3option allows you to specify a better initial structure for the transition state. It requires the two title and molecule specification sections for the reactants and products as forQST2and also additional, third title and molecule specification sections for the initial transition state geometry (along with the usual blank line separators), as well as three corresponding modifications to the redundant internal coordinates if theModRedundantoption is specified. The program will then locate the transition structure connecting the reactants and products closest to the specified initial geometry.

The optimized structure found byQST2orQST3appears in the output in a format similar to that for other types of geometry optimizations:

---------------------------- ! Optimized Parameters ! ! (Angstroms and Degrees) ! --------------------- ---------------------- ! Name Definition Value Reactant Product Derivative Info. ! ------------------------------------------------------------------- ! R1 R(2,1) 1.0836 1.083 1.084 -DE/DX = 0. ! ! R2 R(3,1) 1.4233 1.4047 1.4426 -DE/DX = -0. ! ! R3 R(4,1) 1.4154 1.4347 1.3952 -DE/DX = -0. ! ! R4 R(5,3) 1.3989 1.3989 1.3984 -DE/DX = 0. ! ! R5 R(6,3) 1.1009 1.0985 1.0995 -DE/DX = 0. ! ! … ! -------------------------------------------------------------------

In addition to listing the optimized values, the table includes those for the reactants and products.

Performing a Relaxed Potential Energy Surface Scan. TheOpt=ModRedundantoption may also be used to perform a relaxed potential energy surface (PES) scan. Like the facility provided byScan, a relaxed PES scan steps over a rectangular grid on the PES involving selected internal coordinates. It differs fromScanin that a constrained geometry optimization is performed at each point.

Relaxed PES scans are available only for the Berny algorithm. If any scanning variable breaks symmetry during the calculation, then you must includeNoSymmin the route section of the job, since it may fail with an error.

Redundant internal coordinates specified with theOpt=ModRedundantoption may be scanned using theScode letter:N1N2 [N3 [N4]]Ssteps step-size. For example, this input adds a bond between atoms 2 and 3, specifying three scan steps of 0.05 Å each:

2 3 S 3 0.05

Wildcards in theModRedundantinput may also be useful in setting up relaxed PES scans. For example, the following input is appropriate for a potential energy surface scan involving the N1-N2-N3-N4 dihedral angle:

N1 N2 N3 N4 S 20 2.0Specify a relaxed PES scan of 20 steps in 2° increments

Cartesian coordinates can also include scan specifications:

XatomSx-stepsx-sizey-stepsy-sizez-stepsz-size

For example, the followingModRedundantinput performs a relaxed potential energy surface scan. Starting at the initial position of atom 1 and moving in five 0.2 Angstrom steps in the X direction and three 0.1 Angstrom steps in the Z direction:

X 1 S 5 0.2 0 0.0 3 0.1

THE BERNY OPTIMIZATION ALGORITHM

The Berny geometry optimization algorithm in Gaussian is based on an earlier program written by H. B. Schlegel which implemented his published algorithm[Schlegel82]. The program has been considerably enhanced since this earlier version using techniques either taken from other algorithms or never published, and consequently it is appropriate to summarize the current status of the Berny algorithm here.

At each step of a Berny optimization the following actions are taken:


Last update: 22 May 2014

Baidu
map