Uses of Interface
ffx.numerics.Potential
Package
Description
The Algorithms package has support for local and global optimization, molecular dynamics
simulations, and calculation of free energy differences.
The Algorithms CLI package defines options for PicoCLI command line scripts.
The Dynamics package implements molecular and stochastic dynamics using a pure Java code path and
via OpenMM.
The Integrators package implements integrators for molecular dynamics simulations.
The MC package implements a variety of Monte Carlo moves for optimization and simulation
algorithms.
The Misc package contains a few miscellaneous algorithms.
The Optimize package contains local and global optimization algorithms using pure Java and OpenMM
code paths.
The Thermodynamics package computes free energy differences using Orthogonal Space Tempering
(OST) sampling via pure Java or OpenMM (via Monte Carlo OST).
The Crystal package implements space group symmetry and periodic boundary condition support.
The Numerics package has support for atomic double arrays, FFTs (1D and 3D), numerical
integration (1D), complex numbers, vector operations, multipole tensors, multi-dimensional
optimization, special functions, splines and switching functions.
The Potential package implements molecular mechanics force fields with shared memory Parallel
Java and via OpenMM.
The Potential CLI package defines reusable options for PicoCLI command line scripts.
The Extended package is progress toward support for constant pH molecular dynamics using extended
system variables (i.e. lambda dynamics on protonation).
The Utils package implements core functionality needed for using the Potential package, such as
opening and closing structure files, basic force field energy evaluations, etc.
The Real Space package implements real space structure refinement.
The UI package provides views and controllers for manipulating molecular systems.
The X-ray package implements support for X-ray and Neutron refinement.
-
Uses of Potential in ffx.algorithms
Modifier and TypeMethodDescriptionAlgorithmFunctions.minimize
(MolecularAssembly assembly, double eps) Relax the coordinates of a MolecularAssembly and minimize its potential energyAlgorithmUtils.minimize
(MolecularAssembly assembly, double eps) Relax the coordinates of a MolecularAssembly and minimize its potential energy -
Uses of Potential in ffx.algorithms.cli
Modifier and TypeMethodDescriptionAlgorithmsScript.getPotentials()
Returns a List of all Potential objects associated with this script.Modifier and TypeMethodDescriptionAnnealOptions.createAnnealer
(DynamicsOptions dynamicsOptions, MolecularAssembly molecularAssembly, Potential potential, AlgorithmListener algorithmListener) Creates a SimulatedAnnealing object.AnnealOptions.createAnnealer
(DynamicsOptions dynamicsOptions, MolecularAssembly molecularAssembly, Potential potential, AlgorithmListener algorithmListener, File dynFile) Creates a SimulatedAnnealing object.void
MultiDynamicsOptions.distribute
(MolecularAssembly[] molecularAssemblies, Potential[] potentials, CrystalPotential crystalPotential, AlgorithmFunctions algorithmFunctions, int rank, int worldSize) If residues selected for distributing initial configurations, performs many-body optimization for this distribution.DynamicsOptions.getDynamics
(WriteoutOptions writeoutOptions, Potential potential, MolecularAssembly activeAssembly, AlgorithmListener algorithmListener) Initialize a MolecularDynamics from the parsed options.DynamicsOptions.getDynamics
(WriteoutOptions writeoutOptions, Potential potential, MolecularAssembly activeAssembly, AlgorithmListener algorithmListener, MDEngine requestedEngine) Initialize a MolecularDynamics from the parsed options. -
Uses of Potential in ffx.algorithms.dynamics
Modifier and TypeClassDescriptionclass
The Barostat class maintains constant pressure using random trial moves in lattice parameters, which are consistent with the space group.Modifier and TypeMethodDescriptionstatic MolecularDynamics
MolecularDynamics.dynamicsFactory
(MolecularAssembly assembly, Potential potentialEnergy, AlgorithmListener listener, ThermostatEnum requestedThermostat, IntegratorEnum requestedIntegrator) Method that determines whether a dynamics is done by the java implementation native to ffx or the OpenMM implementationstatic MolecularDynamics
MolecularDynamics.dynamicsFactory
(MolecularAssembly assembly, Potential potentialEnergy, AlgorithmListener listener, ThermostatEnum requestedThermostat, IntegratorEnum requestedIntegrator, MDEngine engine) dynamicsFactory.ModifierConstructorDescriptionMolecularDynamics
(MolecularAssembly assembly, Potential potentialEnergy, AlgorithmListener listener, ThermostatEnum requestedThermostat, IntegratorEnum requestedIntegrator) Constructor for MolecularDynamics.MolecularDynamicsOpenMM
(MolecularAssembly assembly, Potential potential, AlgorithmListener listener, ThermostatEnum thermostat, IntegratorEnum integrator) Constructs an MolecularDynamicsOpenMM object, to perform molecular dynamics using native OpenMM routines, avoiding the cost of communicating coordinates, gradients, and energies back and forth across the PCI bus.PhReplicaExchange
(MolecularDynamics molecularDynamics, File structureFile, double pH, double[] pHLadder, double temp, ExtendedSystem extendedSystem, double[] x, MolecularDynamicsOpenMM molecularDynamicsOpenMM, Potential potential, int worldSize) OpenMM cycled pHReplicaExchange constructor. -
Uses of Potential in ffx.algorithms.dynamics.integrators
Modifier and TypeMethodDescriptionvoid
Integrator pre-force evaluation operation.abstract void
Integrator pre-force evaluation operation.void
Integrator pre-force evaluation operation.void
Integrator pre-force evaluation operation.void
Integrator pre-force evaluation operation. -
Uses of Potential in ffx.algorithms.mc
ModifierConstructorDescriptionMDMove
(MolecularAssembly assembly, Potential potentialEnergy, AlgorithmListener listener, DynamicsOptions dynamics, long stepsPerCycle, File dynRestartFile) Constructor for MDMove.MolecularMC
(MolecularAssembly molecularAssembly, Potential potential) Constructs a DefaultMC instance with a molecular assembly and a specific Potential. -
Uses of Potential in ffx.algorithms.misc
ModifierConstructorDescriptionGenerateRotamers
(MolecularAssembly molecularAssembly, Potential potential, Residue residue, File file, int nChi, AlgorithmListener listener) Intended to create rotamer sets for nonstandard amino acids.GenerateRotamers
(MolecularAssembly molecularAssembly, Potential potential, Residue residue, File file, int nChi, AlgorithmListener listener, RotamerLibrary library) Intended to create rotamer sets for nonstandard amino acids. -
Uses of Potential in ffx.algorithms.optimize
Modifier and TypeFieldDescriptionprotected final Potential
Minimize.potential
The potential energy to optimize.protected final Potential
PhMinimize.potential
The potential energy to optimize.protected final Potential
RotamerOptimization.potential
The Potential to evaluate during rotamer optimization.Modifier and TypeMethodDescriptionCrystalMinimize.minimize
(int m, double eps, int maxIterations) minimizeMinimize.minimize()
minimizeMinimize.minimize
(double eps) minimizeMinimize.minimize
(double eps, int maxIterations) minimizeMinimize.minimize
(int m, double eps, int maxIterations) minimizeMinimizeOpenMM.minimize
(double eps, int maxIterations) minimizeMinimizeOpenMM.minimize
(int m, double eps, int maxIterations) Note the OpenMM L-BFGS minimizer does not accept the parameter "m" for the number of previous steps used to estimate the Hessian.PhMinimize.minimizeCoordinates()
minimizePhMinimize.minimizeCoordinates
(double eps) minimizePhMinimize.minimizeCoordinates
(double eps, int maxIterations) minimizePhMinimize.minimizeCoordinates
(int m, double eps, int maxIterations) minimizePhMinimize.minimizeTitration
(double eps, int maxIterations) minimizePhMinimize.minimizeTitration
(int m, double eps, int maxIterations) minimizeModifier and TypeMethodDescriptionstatic Minimize.MinimizationEngine
Minimize.defaultEngine
(MolecularAssembly molecularAssembly, Potential potentialEnergy) static Minimize
Minimize.minimizeFactory
(MolecularAssembly assembly, Potential potentialEnergy, AlgorithmListener listener, Minimize.MinimizationEngine engine) dynamicsFactory.ModifierConstructorDescriptionMinimize
(MolecularAssembly molecularAssembly, Potential potential, AlgorithmListener algorithmListener) Constructor for Minimize.PhMinimize
(MolecularAssembly molecularAssembly, Potential potential, AlgorithmListener algorithmListener, ExtendedSystem esvSystem) Constructor for Minimize.RotamerOptimization
(MolecularAssembly molecularAssembly, Potential potential, AlgorithmListener algorithmListener) RotamerOptimization constructor. -
Uses of Potential in ffx.algorithms.optimize.anneal
ModifierConstructorDescriptionSimulatedAnnealing
(MolecularAssembly molecularAssembly, Potential potentialEnergy, AlgorithmListener algorithmListener, ThermostatEnum requestedThermostat, IntegratorEnum requestedIntegrator, AnnealingSchedule annealingSchedule, long mdSteps, double timeStep, boolean reInitVelocity, File dynFile) Constructor for SimulatedAnnealing. -
Uses of Potential in ffx.algorithms.optimize.manybody
ModifierConstructorDescriptionEnergyExpansion
(RotamerOptimization rO, DistanceMatrix dM, EliminatedRotamers eR, MolecularAssembly molecularAssembly, Potential potential, AlgorithmListener algorithmListener, List<Residue> allResiduesList, int[][] resNeighbors, boolean threeBodyTerm, boolean decomposeOriginal, boolean usingBoxOptimization, boolean verbose, boolean pruneClashes, boolean prunePairClashes, boolean master) -
Uses of Potential in ffx.algorithms.thermodynamics
Modifier and TypeClassDescriptionclass
An implementation of the Orthogonal Space Tempering algorithm.Modifier and TypeMethodDescriptionOrthogonalSpaceTempering.getPotentialEnergy()
getPotentialEnergy.ModifierConstructorDescriptionMonteCarloOST
(Potential potentialEnergy, OrthogonalSpaceTempering orthogonalSpaceTempering, MolecularAssembly molecularAssembly, org.apache.commons.configuration2.CompositeConfiguration properties, AlgorithmListener listener, DynamicsOptions dynamics, boolean verbose, int cycleLength, File dynRestartFile) Constructor for MonteCarloOST. -
Uses of Potential in ffx.crystal
Modifier and TypeInterfaceDescriptioninterface
The CrystalPotential interface extends Potential to provide methods that change the periodic boundary conditions and symmetry via a Crystal instance. -
Uses of Potential in ffx.numerics
Modifier and TypeMethodDescriptionOptimizationInterface.getUnderlyingPotentials()
Returns a List of Potentials this Potential depends on with a recursive search, excluding the top level of this call. -
Uses of Potential in ffx.potential
Modifier and TypeClassDescriptionclass
class
Compute the potential energy and derivatives for a dual-topology system.class
Compute the potential energy and derivatives of a molecular system described by a force field.class
Implements an error-canceling quad topology, where two large dual-topology simulation legs are run simultaneously to arrive at a small sum.class
This class computes the energy and Cartesian coordinate gradient, plus finite difference derivatives of lattice parameters.Modifier and TypeMethodDescriptionDualTopologyEnergy.getUnderlyingPotentials()
QuadTopologyEnergy.getUnderlyingPotentials()
Modifier and TypeMethodDescriptionstatic double
FiniteDifferenceUtils.computedEdL
(Potential potential, LambdaInterface lambdaInterface, ForceField forceField) Compute dE/dL using finite differences. -
Uses of Potential in ffx.potential.cli
Modifier and TypeMethodDescriptionTopologyOptions.assemblePotential
(MolecularAssembly[] assemblies, int threadsAvail, StringBuilder sb) Performs the bulk of the work of setting up a multi-topology system.TopologyOptions.getTopology
(MolecularAssembly[] topologies, UnivariateSwitchingFunction sf, List<Integer> uniqueA, List<Integer> uniqueB, int numParallel, StringBuilder sb) Configure a Dual-, Quad- or Oct- Topology.Modifier and TypeMethodDescriptionPotentialCommand.getPotentials()
Returns a List of all Potential objects associated with this script.PotentialScript.getPotentials()
Returns a List of all Potential objects associated with this script. -
Uses of Potential in ffx.potential.commands
-
Uses of Potential in ffx.potential.extended
-
Uses of Potential in ffx.potential.openmm
Modifier and TypeClassDescriptionclass
Compute the potential energy and derivatives using OpenMM. -
Uses of Potential in ffx.potential.utils
-
Uses of Potential in ffx.realspace
Modifier and TypeClassDescriptionclass
Combine the Real Space target and chemical potential energy. -
Uses of Potential in ffx.ui
-
Uses of Potential in ffx.xray
Modifier and TypeClassDescriptionclass
Combine the X-ray target and chemical potential energy using theCrystalPotential
interfaceclass
Combine the X-ray target and chemical potential energy.