Uses of Class
ffx.potential.parameters.ForceField
Packages that use ForceField
Package
Description
The Optimize package contains local and global optimization algorithms using pure Java and OpenMM
code paths.
The Potential package implements molecular mechanics force fields with shared memory Parallel
Java and via OpenMM.
The Bonded package implements bonded molecular mechanics terms such as bonds, angles, torsions,
etc.
The Nonbonded package implements nonbonded molecular mechanics terms such as van der Waals and
Particle Mesh Ewald electrostastics.
The Parameters package stores force field atom types, bond types, etc, and keywords that define
the potential.
The Parsers package handles reading/writing files to/from the internal data structure.
-
Uses of ForceField in ffx.algorithms.optimize
Constructors in ffx.algorithms.optimize with parameters of type ForceFieldModifierConstructorDescriptionTitrationManyBody
(String filename, ForceField forceField, List<Integer> resNumberList, double pH) -
Uses of ForceField in ffx.potential
Fields in ffx.potential declared as ForceFieldMethods in ffx.potential that return ForceFieldModifier and TypeMethodDescriptionMolecularAssembly.getForceField()
Getter for the fieldforceField
.Methods in ffx.potential with parameters of type ForceFieldModifier and TypeMethodDescriptionstatic double
FiniteDifferenceUtils.computedEdL
(Potential potential, LambdaInterface lambdaInterface, ForceField forceField) Compute dE/dL using finite differences.void
MolecularAssembly.finalize
(boolean finalizeGroups, ForceField forceField) Abstract method that should specify how to finalize a MSGroupvoid
MolecularAssembly.setForceField
(ForceField forceField) Setter for the fieldforceField
. -
Uses of ForceField in ffx.potential.bonded
Methods in ffx.potential.bonded with parameters of type ForceFieldModifier and TypeMethodDescriptionstatic void
AminoAcidUtils.assignAminoAcidAtomTypes
(Residue residue, Residue previousResidue, Residue nextResidue, ForceField forceField, List<Bond> bondList) assignAminoAcidAtomTypes.static void
AminoAcidUtils.assignAminoAcidAtomTypes
(List<Residue> residues, ForceField forceField, List<Bond> bondList) Assign atom types to an amino acid polymer.void
MSGroup.assignBondedTerms
(ForceField forceField) assignBondedTermsvoid
MultiResidue.assignBondedTerms
(ForceField forceField) assignBondedTermsstatic void
NucleicAcidUtils.assignNucleicAcidAtomTypes
(List<Residue> residues, ForceField forceField, List<Bond> bondList) Assign atom types for a nucleic acid polymer.static Residue
buildAIB.static Residue
AminoAcidUtils.buildAlanine
(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildAlanine.static Residue
AminoAcidUtils.buildArginine
(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildArginine.static Residue
AminoAcidUtils.buildAsparagine
(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildAsparagine.static Residue
AminoAcidUtils.buildAspartate
(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildAspartate.static Bond
Build a bond between two atoms.static Residue
AminoAcidUtils.buildCysteine
(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildCysteine.static Residue
AminoAcidUtils.buildCystine
(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildCystine.static Residue
AminoAcidUtils.buildDeprotonatedCysteine
(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildDeprotonatedCysteine.static Residue
AminoAcidUtils.buildDeprotonatedLysine
(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildDeprotonatedLysine.static Residue
AminoAcidUtils.buildDeprotonatedTyrosine
(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildDeprotonatedTyrosine.static Residue
AminoAcidUtils.buildGlutamate
(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildGlutamate.static Residue
AminoAcidUtils.buildGlutamine
(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildGlutamine.static Residue
AminoAcidUtils.buildGlycine
(Residue res, Atom CA, Atom N, Atom C, AminoAcidUtils.ResiduePosition position, ForceField ff, List<Bond> bonds) buildGlycine.static Atom
BondedUtils.buildH
(MSGroup residue, AminoAcidUtils.SideChainType atomName, Atom ia, double bond, Atom ib, double angle1, Atom ic, double angle2, int chiral, ForceField forceField, List<Bond> bondList) Build a hydrogen atom.static Atom
BondedUtils.buildH
(MSGroup residue, String atomName, Atom ia, double bond, Atom ib, double angle1, Atom ic, double angle2, int chiral, int lookUp, ForceField forceField, List<Bond> bondList) Build a hydrogen atom.static Atom
BondedUtils.buildHeavy
(MSGroup residue, AminoAcidUtils.SideChainType atomName, Atom ia, double bond, Atom ib, double angle1, Atom ic, double angle2, int chiral, ForceField forceField, List<Bond> bondList) Build a heavy atom.static Atom
BondedUtils.buildHeavy
(MSGroup residue, String atomName, Atom ia, double bond, Atom ib, double angle1, Atom ic, double angle2, int chiral, int lookUp, ForceField forceField) Build a heavy atom.static Atom
BondedUtils.buildHeavy
(MSGroup residue, String atomName, Atom ia, double bond, Atom ib, double angle1, Atom ic, double angle2, int chiral, int lookUp, ForceField forceField, List<Bond> bondList) Build a heavy atom.static Atom
BondedUtils.buildHeavy
(MSGroup residue, String atomName, Atom bondedTo, int key, ForceField forceField, List<Bond> bondList) Build a heavy atom.static Residue
AminoAcidUtils.buildHistidine
(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildHistidine.static Atom
BondedUtils.buildHydrogenAtom
(MSGroup residue, String atomName, Atom ia, double bond, Atom ib, double angle1, Atom ic, double angle2, int chiral, AtomType atomType, ForceField forceField, List<Bond> bondList) Build a hydrogen atom.static Residue
AminoAcidUtils.buildIsoleucine
(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildIsoleucine.static Residue
AminoAcidUtils.buildLeucine
(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildLeucine.static Residue
AminoAcidUtils.buildLysine
(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildLysine.static Residue
AminoAcidUtils.buildMethionine
(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bond) buildMethionine.static Residue
AminoAcidUtils.buildNeutralAsparticAcid
(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildNeutralAsparticAcid.static Residue
AminoAcidUtils.buildNeutralGlutamicAcid
(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildNeutralGlutamicAcid.static Residue
AminoAcidUtils.buildNeutralHistidineD
(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildNeutralHistidineD.static Residue
AminoAcidUtils.buildNeutralHistidineE
(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildNeutralHistidineE.static Residue
AminoAcidUtils.buildOrnithine
(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildOrnithine.static Residue
buildPCA.static Residue
AminoAcidUtils.buildPhenylalanine
(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildPhenylalanine.static Residue
AminoAcidUtils.buildProline
(Residue res, Atom CA, Atom N, Atom C, AminoAcidUtils.ResiduePosition position, ForceField ff, List<Bond> bonds) buildProline.static Residue
AminoAcidUtils.buildSerine
(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildSerine.static Residue
AminoAcidUtils.buildThreonine
(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildThreonine.static Residue
AminoAcidUtils.buildTryptophan
(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bond) buildTryptophan.static Residue
AminoAcidUtils.buildTwoProtonAsparticAcid
(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildTwoProtonAsparticAcid.static Residue
AminoAcidUtils.buildTwoProtonGlutamicAcid
(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildTwoProtonGlutamicAcid.static Residue
AminoAcidUtils.buildTyrosine
(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildTyrosine.static Residue
AminoAcidUtils.buildValine
(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildValine.MSGroup.createJoint
(Bond bond, MSGroup group1, MSGroup group2, ForceField forceField) Create a joint between two chemical groups.MSGroup.createJoint
(MSGroup group1, MSGroup group2, ForceField forceField) Joiner joins Moieties m1 and m2 and returns the Geometry objects formed in a Joint.MultiResidue.createJoint
(Bond bond, MSGroup group1, MSGroup group2, ForceField forceField) Create a joint between two chemical groups.MultiResidue.createJoint
(MSGroup group1, MSGroup group2, ForceField forceField) Joiner joins Moieties m1 and m2 and returns the Geometry objects formed in a Joint.Polymer.createJoint
(Residue residue1, Residue residue2, ForceField forceField) void
Molecule.finalize
(boolean finalizeGeometry, ForceField forceField) Abstract method that should specify how to finalize a MSGroupabstract void
MSGroup.finalize
(boolean finalizeGroups, ForceField forceField) Abstract method that should specify how to finalize a MSGroupvoid
MultiResidue.finalize
(boolean finalizeGeometry, ForceField forceField) Abstract method that should specify how to finalize a MSGroupvoid
Polymer.finalize
(boolean finalizeGroups, ForceField forceField) Abstract method that should specify how to finalize a MSGroupvoid
Residue.finalize
(boolean finalizeGeometry, ForceField forceField) Abstract method that should specify how to finalize a MSGroupstatic AtomType
BondedUtils.findAtomType
(int key, ForceField forceField) findAtomType.double
Atom.getCharge
(ForceField ff) Gets the partial atomic charge.static void
Angle.logNoAngleType
(Atom a1, Atom a2, Atom a3, ForceField forceField) Log that no AngleType exists.static void
Bond.logNoBondType
(Atom a1, Atom a2, ForceField forceField) Log that no BondType exists.static void
Torsion.logNoTorsionType
(Atom a0, Atom a1, Atom a2, Atom a3, ForceField forceField) Log that no TorsionType exists.static OutOfPlaneBend
OutOfPlaneBend.outOfPlaneBendFactory
(Angle angle, ForceField forceField) Attempt to create a new OutOfPlaneBend instance for a given Angle and Force Field.static PiOrbitalTorsion
PiOrbitalTorsion.piOrbitalTorsionFactory
(Bond bond, ForceField forceField) Attempt to create a new PiOrbitalTorsion based on the supplied bond and forceField.static StretchTorsion
StretchTorsion.stretchTorsionFactory
(Torsion torsion, ForceField forceField) Attempt to create a new StretchTorsion based on the supplied torsion.static TorsionTorsion
TorsionTorsion.torsionTorsionFactory
(Bond firstBond, Angle angle, Bond lastBond, ForceField forceField) torsionTorsionFactory.static UreyBradley
UreyBradley.ureyBradlyFactory
(Angle angle, ForceField forceField) Attempt to create a new UreyBradley for the specified Angle.Constructors in ffx.potential.bonded with parameters of type ForceFieldModifierConstructorDescriptionMultiResidue
(Residue residue, ForceField forceField) Constructor for MultiResidue.RelativeSolvation
(RelativeSolvation.SolvationLibrary solvationLibrary, ForceField forceField) Constructor for RelativeSolvation.Residue
(String name, int resNumber, MSNode atoms, Residue.ResidueType residueType, ForceField forceField) As above, with atoms being a MSNode with this Residue's atoms as child nodes -
Uses of ForceField in ffx.potential.nonbonded
Constructors in ffx.potential.nonbonded with parameters of type ForceFieldModifierConstructorDescriptionGeneralizedKirkwood
(ForceField forceField, Atom[] atoms, ParticleMeshEwald particleMeshEwald, Crystal crystal, ParallelTeam parallelTeam, double gkCutoff) Constructor for GeneralizedKirkwood.NCSRestraint
(Atom[] atoms, ForceField forceField, Crystal crystal) This NCSRestraint is based on the unit cell parameters and symmetry operators of the supplied crystal.ParticleMeshEwald
(Atom[] atoms, int[] molecule, ForceField forceField, Crystal crystal, NeighborList neighborList, ForceField.ELEC_FORM elecForm, double ewaldCutoff, double gkCutoff, ParallelTeam parallelTeam) ParticleMeshEwald constructor.ReciprocalSpace
(ParticleMeshEwald particleMeshEwald, Crystal crystal, ForceField forceField, Atom[] atoms, double aewald, ParallelTeam fftTeam, ParallelTeam parallelTeam) Reciprocal Space PME contribution.ScfPredictor
(ScfPredictor.PredictorMode mode, int order, ForceField ff) Constructor for ScfPredictor.VanDerWaals
(Atom[] atoms, int[] molecule, boolean[] neuralNetwork, Crystal crystal, ForceField forceField, ParallelTeam parallelTeam, double vdwCutoff, double neighborListCutoff) The VanDerWaals class constructor.VanDerWaalsForm
(ForceField forceField) Constructor for VanDerWaalsForm.VanDerWaalsTornado
(Atom[] atoms, Crystal crystal, ForceField forceField, double vdwCutoff) The VanDerWaalsTornado class constructor. -
Uses of ForceField in ffx.potential.nonbonded.implicit
Constructors in ffx.potential.nonbonded.implicit with parameters of type ForceFieldModifierConstructorDescriptionBornRadiiRegion
(int nt, int nAtoms, ForceField forceField, boolean neckCorrection, boolean tanhCorrection, boolean perfectHCTScale) BornRadiiRegion Constructor.ChandlerCavitation
(Atom[] atoms, ConnollyRegion connollyRegion, ForceField forceField) ChandlerCavitation
(Atom[] atoms, GaussVol gaussVol, ForceField forceField) DispersionRegion
(int nt, Atom[] atoms, ForceField forceField) DispersionRegion constructor.GaussVol
(Atom[] atoms, ForceField forceField, ParallelTeam parallelTeam) Creates/Initializes a GaussVol instance. -
Uses of ForceField in ffx.potential.nonbonded.pme
Methods in ffx.potential.nonbonded.pme with parameters of type ForceFieldConstructors in ffx.potential.nonbonded.pme with parameters of type ForceFieldModifierConstructorDescriptionAlchemicalParameters
(ForceField forceField, boolean lambdaTerm, boolean nnTerm, Polarization polarization) InducedDipoleFieldRegion
(ParallelTeam parallelTeam, ForceField forceField, boolean lambdaTerm) InitializationRegion
(ParticleMeshEwald particleMeshEwald, int maxThreads, ForceField forceField) PCGSolver
(int maxThreads, double poleps, ForceField forceField, int nAtoms) Constructor the PCG solver.PermanentFieldRegion
(ParallelTeam pt, ForceField forceField, boolean lambdaTerm) RealSpaceEnergyRegion
(ForceField.ELEC_FORM elecForm, int nt, ForceField forceField, boolean lambdaTerm, double electric) ReduceRegion
(int threadCount, ForceField forceField) ScaleParameters
(ForceField.ELEC_FORM elecForm, ForceField forceField) SORRegion
(int nt, ForceField forceField) -
Uses of ForceField in ffx.potential.openmm
Methods in ffx.potential.openmm that return ForceFieldMethods in ffx.potential.openmm with parameters of type ForceFieldModifier and TypeMethodDescriptionstatic LangevinIntegrator
OpenMMIntegrator.createLangevinIntegrator
(double dt, double temperature, ForceField forceField) Create a Langevin integrator.static Platform
OpenMMContext.loadPlatform
(Platform requestedPlatform, ForceField forceField) Load an OpenMM Platform -
Uses of ForceField in ffx.potential.parameters
Methods in ffx.potential.parameters with parameters of type ForceFieldModifier and TypeMethodDescriptionstatic void
PolarizeType.addXMLAttributes
(Element node, ForceField forceField) Add constant attributes to the AmoebaMultipoleForcevoid
ForceField.append
(ForceField patch) Append a 2nd ForceField "patch" to the current ForceField.static boolean
MultipoleType.assignMultipole
(ForceField.ELEC_FORM elecForm, Atom atom, ForceField forceField, double[] multipole, int i, int[][] axisAtom, MultipoleType.MultipoleFrameDefinition[] frame) Assign the multipole type.static SoluteType
SoluteType.getFitSoluteType
(ForceField forceField, int type) static SoluteType
SoluteType.getSoluteType
(Atom atom, ForceField forceField, SoluteType.SOLUTE_RADII_TYPE soluteRadiiType) static Element
AtomType.getXMLAtomTypes
(Document doc, ForceField forceField) Create an AtomType Element.static Element
PiOrbitalTorsionType.getXMLElement
(Document doc, ForceField forceField) Create an AmoebaPiTorsionForce Element.static Element
AngleTorsionType.getXMLForce
(Document doc, ForceField forceField) Create an AmoebaAngleTorsionForce Element.static Element
AngleType.getXMLForce
(Document doc, ForceField forceField) Create an AmoebaAngleForcestatic Element
BondType.getXMLForce
(Document doc, ForceField forceField) static Element
MultipoleType.getXMLForce
(Document doc, ForceField forceField) Create an AmoebaMultipoleForce Element.static Element
OutOfPlaneBendType.getXMLForce
(Document doc, ForceField forceField) Create an AmoebaOutOfPlaneBendForce instance.static Element
StretchBendType.getXMLForce
(Document doc, ForceField forceField) Create an AmoebaStretchBendForce element.static Element
StretchTorsionType.getXMLForce
(Document doc, ForceField forceField) Create an AmoebaStretchTorsionForce Element.static Element
TorsionTorsionType.getXMLForce
(Document doc, ForceField forceField) Create an AmoebaTorsionTorsionForce Element.static Element
TorsionType.getXMLForce
(Document doc, ForceField forceField) Create a PeriodicTorsionForce Element.static Element
UreyBradleyType.getXMLForce
(Document doc, ForceField forceField) Create an AmoebaUreyBradleyForce element.static Element
VDWType.getXMLForce
(Document doc, ForceField forceField) Create an AmoebaVdwForce force node.static MultipoleType
MultipoleType.multipoleTypeFactory
(ForceField.ELEC_FORM elecForm, Atom atom, ForceField forceField) multipoleTypeFactory.static void
SoluteType.setSoluteRadii
(ForceField forceField, Atom[] atoms, SoluteType.SOLUTE_RADII_TYPE soluteRadiiType) Constructors in ffx.potential.parameters with parameters of type ForceFieldModifierConstructorDescriptionTitrationUtils
(ForceField forceField) TitrationUtils
(ForceField forceField, double proteinDielectric, boolean tanhCorrection) -
Uses of ForceField in ffx.potential.parsers
Fields in ffx.potential.parsers declared as ForceFieldModifier and TypeFieldDescriptionprotected ForceField
SystemFilter.forceField
The molecular mechanics force field being used.Methods in ffx.potential.parsers that return ForceFieldMethods in ffx.potential.parsers with parameters of type ForceFieldModifier and TypeMethodDescriptionvoid
SystemFilter.setForceField
(ForceField forceField) Setter for the fieldforceField
.Constructors in ffx.potential.parsers with parameters of type ForceFieldModifierConstructorDescriptionCIFFilter
(File file, MolecularAssembly molecularAssembly, ForceField forceField, org.apache.commons.configuration2.CompositeConfiguration properties, boolean saveCIF) Constructor for CIFFilter on a single file and a single assembly.CIFFilter
(File file, List<MolecularAssembly> molecularAssemblies, ForceField forceField, org.apache.commons.configuration2.CompositeConfiguration properties, boolean saveCIF) Constructor for CIFFilter on a single file and multiple assemblies.CIFFilter
(List<File> files, MolecularAssembly molecularAssembly, ForceField forceField, org.apache.commons.configuration2.CompositeConfiguration properties, boolean saveCIF) Constructor for CIFFilter on a multiple files and a single assembly.INTFilter
(File file, MolecularAssembly molecularAssembly, ForceField forceField, org.apache.commons.configuration2.CompositeConfiguration properties) Constructor for INTFilter.INTFilter
(List<File> files, MolecularAssembly molecularAssembly, ForceField forceField, org.apache.commons.configuration2.CompositeConfiguration properties) Constructor for INTFilter.OpenMMXmlFilter
(ForceField forceField) Constructor for outputting XML.OpenMMXmlFilter
(ForceField forceField, String saveName) Constructor for outputting XML with output path specified.PDBFilter
(File file, MolecularAssembly molecularAssembly, ForceField forceField, org.apache.commons.configuration2.CompositeConfiguration properties) Parse the PDB File from a URL.PDBFilter
(File file, MolecularAssembly molecularAssembly, ForceField forceField, org.apache.commons.configuration2.CompositeConfiguration properties, List<Integer> resNumberList) Constructor for PDBFilter with residue numbers.PDBFilter
(File file, List<MolecularAssembly> molecularAssemblies, ForceField forceField, org.apache.commons.configuration2.CompositeConfiguration properties) Parse the PDB File from a URL.PDBFilter
(List<File> files, MolecularAssembly molecularAssembly, ForceField forceField, org.apache.commons.configuration2.CompositeConfiguration properties) Constructor for PDBFilter.SystemFilter
(File file, MolecularAssembly molecularAssembly, ForceField forceField, org.apache.commons.configuration2.CompositeConfiguration properties) Constructor for SystemFilter.SystemFilter
(File file, List<MolecularAssembly> molecularAssemblies, ForceField forceField, org.apache.commons.configuration2.CompositeConfiguration properties) Constructor for SystemFilter.SystemFilter
(List<File> files, MolecularAssembly molecularAssembly, ForceField forceField, org.apache.commons.configuration2.CompositeConfiguration properties) Constructor for SystemFilter.XPHFilter
(File file, MolecularAssembly system, ForceField forceField, org.apache.commons.configuration2.CompositeConfiguration properties, ExtendedSystem esvSystem) Constructor for XPHFilter.XYZFilter
(File file, MolecularAssembly system, ForceField forceField, org.apache.commons.configuration2.CompositeConfiguration properties) Constructor for XYZFilter.XYZFilter
(List<File> files, MolecularAssembly system, ForceField forceField, org.apache.commons.configuration2.CompositeConfiguration properties) Constructor for XYZFilter.