Uses of Class
ffx.potential.bonded.Atom
Packages that use Atom
Package
Description
The Optimize package contains local and global optimization algorithms using pure Java and OpenMM
code paths.
The manybody package implements many-body rotamer optimization infrastructure,
including distance matrices, an energy expansion (self, two-body, three-body,
and four-body), Dead-end elimination criteria, Goldstein elimination criteria,
and supporting data structures for efficient optimization.
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 Potential CLI package defines reusable options for PicoCLI command line scripts.
The constraint package implements holonomic constraint algorithms used during
molecular dynamics and minimization, including CCMA, SETTLE, and SHAKE-style
constraints (as well as charge constraints).
The Extended package is progress toward support for constant pH molecular dynamics using extended
system variables (i.e. lambda dynamics on protonation).
The Nonbonded package implements nonbonded molecular mechanics terms such as van der Waals and
Particle Mesh Ewald electrostastics.
The implicit package implements implicit solvent models and related terms,
including Generalized Kirkwood (GK) electrostatics, surface area terms,
dispersion/cavitation contributions, and supporting parallel regions for
Born radii and field evaluation.
The pme package implements polarization and permanent electrostatics using
Particle Mesh Ewald (PME).
The openmm package contains utilities to construct and run Force Field X
potentials on the OpenMM platform, including system builders, custom forces,
alchemical fixed-charge forces, and integrators tailored to FFX simulations.
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.
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 X-ray package implements support for X-ray and Neutron refinement.
-
Uses of Atom in ffx.algorithms.optimize
Methods in ffx.algorithms.optimize that return types with arguments of type AtomMethod parameters in ffx.algorithms.optimize with type arguments of type AtomModifier and TypeMethodDescriptionbooleanTitrationManyBody.excludeExcessAtoms(Set<Atom> excludeAtoms, int[] optimalRotamers, MolecularAssembly molecularAssembly, List<Residue> residueList) booleanTitrationManyBody.excludeExcessAtoms(Set<Atom> excludeAtoms, int[] optimalRotamers, List<Residue> residueList) voidTitrationManyBody.setExcludeAtoms(Set<Atom> excludeAtoms) -
Uses of Atom in ffx.algorithms.optimize.manybody
Methods in ffx.algorithms.optimize.manybody with parameters of type AtomModifier and TypeMethodDescriptionbooleanManyBodyCell.atomInsideCell(Atom atom, Crystal crystal, SymOp symOp) Checks if an Atom would be contained inside this cell. -
Uses of Atom in ffx.potential
Methods in ffx.potential that return AtomModifier and TypeMethodDescriptionfindAtomfindAtomstatic AtomReturns an atom bonded to the "end" atom, which is not equal to "other".Atom[]MolecularAssembly.getActiveAtomArray()getActiveAtomArrayAtom[]ForceFieldEnergy.getAtomArray()Get all atoms that make up this ForceFieldEnergy.Atom[]MolecularAssembly.getAtomArray()Return an Array of all atoms in the System.MolecularAssembly.getAtomFromWireVertex(int i) getAtomFromWireVertexDualTopologyEnergy.getDualTopologyAtom(int topology, int index) Get the atom from the dual-topology atom array corresponding to the specified topology and index.Atom[]DualTopologyEnergy.getDualTopologyAtoms(int topology) Get the dual topology atoms for the specified topology.Methods in ffx.potential that return types with arguments of type AtomMethods in ffx.potential with parameters of type AtomModifier and TypeMethodDescriptionfindAtomfindAtomstatic AtomReturns an atom bonded to the "end" atom, which is not equal to "other".Method parameters in ffx.potential with type arguments of type AtomModifier and TypeMethodDescriptionstatic voidUtilities.biochemistry(MolecularAssembly molecularAssembly, List<Atom> atoms) This routine sub-divides a system into groups of ions, water, hetero molecules, and polynucleotides/polypeptides. -
Uses of Atom in ffx.potential.bonded
Fields in ffx.potential.bonded declared as AtomModifier and TypeFieldDescriptionfinal AtomBondedUtils.MissingAtomTypeException.atomprotected Atom[]BondedTerm.atomsAtoms that are used to form this term.Fields in ffx.potential.bonded with type parameters of type AtomModifier and TypeFieldDescriptionstatic Comparator<Atom> Atom.XYZIndexComparatorCompare two atoms (implementation of the Comparator interface).Methods in ffx.potential.bonded that return AtomModifier and TypeMethodDescriptionstatic AtomBondedUtils.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 AtomBondedUtils.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 AtomBondedUtils.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 AtomBondedUtils.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 AtomBondedUtils.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 AtomBondedUtils.buildHeavy(MSGroup residue, String atomName, Atom bondedTo, int key, ForceField forceField, List<Bond> bondList) Build a heavy atom.static AtomBondedUtils.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 AtomBondedUtils.findNitrogenAtom(Residue residue) Finds the backbone nitrogen of a residue.Find the other Atom in this Bond.Find the other Atom in this Bond.If the specified atom is not the central atom of this angle, the atom of the opposite leg is returned.If the specified atom is not a central atom of this torsion, the atom at the opposite end is returned.If the specified atom is not a central atom of this torsion, the atom at the opposite end is returned.If the specified atom is not a central atom of this torsion, the atom at the opposite end is returned.static AtomBondedUtils.getAlphaCarbon(Residue residue, Atom N) Finds the alpha carbon of a residue, and handles any C-terminal ACE caps while at it.BondedTerm.getAtom(int index) Get the constituent Atom specified by index.getAtomRestrainTorsion.getAtom(int index) Angle.getAtom4()Getter for the fieldatom4.Atom[]BondedTerm.getAtomArray()Returns all Atoms contained in this BondedTerm, regardless of whether they are child nodes in the tree structure.Atom[]BondedTerm.getAtomArray(boolean returnCopy) Returns all Atoms contained in this BondedTerm, regardless of whether they are child nodes in the tree structure.MSGroup.getAtomByName(String n, boolean caseInsensitive) getAtomByName.Residue.getAtomInitial()Atom[]BondedTerm.getAtoms()Returns a reference to the Atoms contained in this BondedTerm, regardless of whether they are child nodes in the tree structure.Atom[]ResidueState.getAtoms()Getter for the fieldatoms.Atom[]RestrainPosition.getAtoms()Returns a copy of the atoms array.Atom[]RestrainTorsion.getAtoms()Angle.getCentralAtom()getCentralAtom.TorsionTorsion.getChiralAtom()getChiralAtom.MSNode.getFirstActiveHeavyAtom()Returns the first active heavy atom in the list of atoms for the current structure.OutOfPlaneBend.getFirstAngleAtom()Get the first atom of the Angle.OutOfPlaneBend.getFourthAtom()The atom of this out-of-plane bend that was not part of the Angle.Angle.getFourthAtomOfTrigonalCenter()If the central atom of the angle is trigonal, the 4th member of the trigonal center (that is not a part of the angle) will be returned.OutOfPlaneBend.getLastAngleAtom()Get the first atom of the Angle.Residue.getReferenceAtom()Returns a reference Atom for a Residue, primarily intended for rough distance calculations.OutOfPlaneBend.getTrigonalAtom()Get the trigonal atom of this out-of-plane bend (central atom of the Angle).static Atom[]BondedUtils.sortAtomsByDistance(Atom reference, List<Atom> toCompare) Sorts toCompare by distance to the reference Atom, returning a sorted array.Methods in ffx.potential.bonded that return types with arguments of type AtomModifier and TypeMethodDescriptionBondedUtils.findAtomsOfElement(Residue residue, int element) Finds all Atoms belonging to a Residue of a given atomic number.BondedUtils.findBondedAtoms(Atom atom, int element) Finds Atoms bonded to a given Atom that match a certain atomic number.BondedUtils.findBondedAtoms(Atom atom, Atom toExclude, int element) Finds Atoms bonded to a given Atom that match a certain atomic number that do not match an excluded atom.BondedUtils.findNucleotideO4s(Residue residue) Find the O4' of a nucleic acid Residue.Atom.get12List()Get the list of 1-2 atoms ordered by XYZ index.Atom.get13List()Get the list of 1-3 atoms ordered by XYZ index.Atom.get14List()Get the list of 1-4 atoms ordered by XYZ index.Atom.get15List()Get the list of 1-5 atoms ordered by XYZ index.Atom.getAtomList()Returns a List of all Atoms below the present MSNode.MSNode.getAtomList()Returns a List of all Atoms below the present MSNode.MSNode.getAtomList(boolean originalOrder) getAtomList.Residue.getBackboneAtoms()Returns a list of backbone atoms; for our purposes, nucleic acid backbone atoms are those of the nucleobase.MSGroup.getDanglingAtoms()Returns the MultiScaleGroup's dangling Atoms list.MultiResidue.getDanglingAtoms()Returns the MultiScaleGroup's dangling Atoms list.MultiResidue.getSideChainAtoms()Returns a list of side chain atoms; for our purposes, nucleic acid side chain atoms are the sugar and the phosphate.Residue.getSideChainAtoms()Returns a list of side chain atoms; for our purposes, nucleic acid side chain atoms are the sugar and the phosphate.MultiResidue.getVariableAtoms()Returns a list of atoms liable to change during dead-end elimination repacking.Residue.getVariableAtoms()Returns a list of atoms liable to change during dead-end elimination repacking.NamingUtils.renameAlkyl(Atom carbon, Atom priorAtom, int protonOffset, char posName) Renames an atom, its bonded hydrogen, and returns the next atom in the chain.NamingUtils.renameBranchedAlkyl(Atom carbon, Atom priorAtom, int protonOffset, int branchNum, char posName) Renames a numbered carbon, its bonded hydrogen, and returns the next atom in the chain.NamingUtils.renameCommonPurine(Atom N9, Atom C1s) Renames atoms common to all standard purines (A, G)NamingUtils.renameCommonPyrimidine(Atom N1, Atom C1s) Renames atoms common to all standard pyrimidines (C, T, U)Methods in ffx.potential.bonded with parameters of type AtomModifier and TypeMethodDescriptionstatic booleanBondedUtils.atomAttachedToAtom(Atom a1, Atom a2) Checks if atom a1 is bonded to atom a2.static ResiduebuildAIB.static ResidueAminoAcidUtils.buildAlanine(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildAlanine.static ResidueAminoAcidUtils.buildArginine(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildArginine.static ResidueAminoAcidUtils.buildAsparagine(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildAsparagine.static ResidueAminoAcidUtils.buildAspartate(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildAspartate.static BondBuild a bond between two atoms.static ResidueAminoAcidUtils.buildCysteine(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildCysteine.static ResidueAminoAcidUtils.buildCystine(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildCystine.static ResidueAminoAcidUtils.buildDeprotonatedCysteine(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildDeprotonatedCysteine.static ResidueAminoAcidUtils.buildDeprotonatedLysine(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildDeprotonatedLysine.static ResidueAminoAcidUtils.buildDeprotonatedTyrosine(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildDeprotonatedTyrosine.static ResidueAminoAcidUtils.buildGlutamate(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildGlutamate.static ResidueAminoAcidUtils.buildGlutamine(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildGlutamine.static ResidueAminoAcidUtils.buildGlycine(Residue res, Atom CA, Atom N, Atom C, AminoAcidUtils.ResiduePosition position, ForceField ff, List<Bond> bonds) buildGlycine.static AtomBondedUtils.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 AtomBondedUtils.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 AtomBondedUtils.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 AtomBondedUtils.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 AtomBondedUtils.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 AtomBondedUtils.buildHeavy(MSGroup residue, String atomName, Atom bondedTo, int key, ForceField forceField, List<Bond> bondList) Build a heavy atom.static ResidueAminoAcidUtils.buildHistidine(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildHistidine.static AtomBondedUtils.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 ResidueAminoAcidUtils.buildIsoleucine(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildIsoleucine.static ResidueAminoAcidUtils.buildLeucine(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildLeucine.static ResidueAminoAcidUtils.buildLysine(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildLysine.static ResidueAminoAcidUtils.buildMethionine(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bond) buildMethionine.static ResidueAminoAcidUtils.buildNeutralAsparticAcid(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildNeutralAsparticAcid.static ResidueAminoAcidUtils.buildNeutralGlutamicAcid(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildNeutralGlutamicAcid.static ResidueAminoAcidUtils.buildNeutralHistidineD(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildNeutralHistidineD.static ResidueAminoAcidUtils.buildNeutralHistidineE(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildNeutralHistidineE.static ResidueAminoAcidUtils.buildOrnithine(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildOrnithine.static ResiduebuildPCA.static ResidueAminoAcidUtils.buildPhenylalanine(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildPhenylalanine.static ResidueAminoAcidUtils.buildProline(Residue res, Atom CA, Atom N, Atom C, AminoAcidUtils.ResiduePosition position, ForceField ff, List<Bond> bonds) buildProline.static ResidueAminoAcidUtils.buildSerine(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildSerine.static ResidueAminoAcidUtils.buildThreonine(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildThreonine.static ResidueAminoAcidUtils.buildTryptophan(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bond) buildTryptophan.static ResidueAminoAcidUtils.buildTwoProtonAsparticAcid(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildTwoProtonAsparticAcid.static ResidueAminoAcidUtils.buildTwoProtonGlutamicAcid(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildTwoProtonGlutamicAcid.static ResidueAminoAcidUtils.buildTyrosine(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildTyrosine.static ResidueAminoAcidUtils.buildValine(Residue res, Atom CA, Atom N, Atom C, ForceField ff, List<Bond> bonds) buildValine.booleancomparebooleancomparebooleancompareintBondedUtils.findBondedAtoms(Atom atom, int element) Finds Atoms bonded to a given Atom that match a certain atomic number.BondedUtils.findBondedAtoms(Atom atom, Atom toExclude, int element) Finds Atoms bonded to a given Atom that match a certain atomic number that do not match an excluded atom.Find the other Atom in this Bond.Find the other Atom in this Bond.If the specified atom is not the central atom of this angle, the atom of the opposite leg is returned.If the specified atom is not a central atom of this torsion, the atom at the opposite end is returned.If the specified atom is not a central atom of this torsion, the atom at the opposite end is returned.If the specified atom is not a central atom of this torsion, the atom at the opposite end is returned.static AtomBondedUtils.getAlphaCarbon(Residue residue, Atom N) Finds the alpha carbon of a residue, and handles any C-terminal ACE caps while at it.getAngle.getBondAtom.getTorsion(Atom atom2, Atom atom3, Atom atom4) Finds a Torsion which contains this atom, and atoms 2, 3, and 4.static booleanBondedUtils.hasAttachedAtom(Atom atom, int element) Checks if there is an Atom of a given atomic number bonded to the provided Atom.static voidBondedUtils.intxyz(Atom atom, Atom ia, double bond, Atom ib, double angle1, Atom ic, double angle2, int chiral) This routine was derived from a similar routine in TINKER.booleanis_1_3booleanAre these atoms 1-4 bonded?booleanAre these atoms 1-5 bonded?booleanAre these atoms 1-6 bonded?booleanAre these atoms 1-7 bonded?booleanAre these atoms 1-8 bonded?booleanAtom.is_12_or_13(Atom a) is_12_or_13booleanChecks to see if an Atom is bonded to this AtombooleanDetermine if atom is in a ring with second atom WARNING: Does not work for 8+ membered rings...static voidAngle.logNoAngleType(Atom a1, Atom a2, Atom a3, ForceField forceField) Log that no AngleType exists.static voidBond.logNoBondType(Atom a1, Atom a2, ForceField forceField) Log that no BondType exists.static voidTorsion.logNoTorsionType(Atom a0, Atom a1, Atom a2, Atom a3, ForceField forceField) Log that no TorsionType exists.static voidNamingUtils.nameAcetylCap(Residue residue, Atom aceC) Names the atoms in an N-terminal acetyl ACE capping group.static RestrainPositionRestrainPosition.parseRestrainPosition(String line, Atom[] atoms, boolean useLambda) Parse a Restrain-Position line and return a RestrainPosition instance.NamingUtils.renameAlkyl(Atom carbon, Atom priorAtom, int protonOffset, char posName) Renames an atom, its bonded hydrogen, and returns the next atom in the chain.NamingUtils.renameBranchedAlkyl(Atom carbon, Atom priorAtom, int protonOffset, int branchNum, char posName) Renames a numbered carbon, its bonded hydrogen, and returns the next atom in the chain.static voidNamingUtils.renameCommonAminoAcids(Residue residue, AminoAcidUtils.AminoAcid3 aa3, Atom CA, Atom CB) Renames atoms in common amino acids to PDB standard.static voidNamingUtils.renameCommonNucleobase(Atom N19, Atom C1s, NucleicAcidUtils.NucleicAcid3 na3) Renames the atoms of the common nucleobases (A, C, G, T, U, and deoxy variants).NamingUtils.renameCommonPurine(Atom N9, Atom C1s) Renames atoms common to all standard purines (A, G)NamingUtils.renameCommonPyrimidine(Atom N1, Atom C1s) Renames atoms common to all standard pyrimidines (C, T, U)static voidResidueState.revertAtomicCoordinates(Atom[] atoms, double[][] coords) Uses a double[nAtoms][3] to revert the coordinates of an array of atoms.voidResidue.setAtomInitial(Atom atomInitial) voidAdd a constituent Atom to the Term.voidAtom.setAxisAtoms(Atom... set) Setter for the fieldaxisAtoms.voidSet the color of this Bond's Java3D shapes based on the passed Atom.static voidBondedUtils.sortAtomsByDistance(Atom reference, Atom[] toCompare) In-place sorts toCompare by distance to the reference Atom.static Atom[]BondedUtils.sortAtomsByDistance(Atom reference, List<Atom> toCompare) Sorts toCompare by distance to the reference Atom, returning a sorted array.static double[][]ResidueState.storeAtomicCoordinates(Atom[] atoms) Returns a new double[nAtoms][3] with the coordinates of an array of atoms.Method parameters in ffx.potential.bonded with type arguments of type AtomModifier and TypeMethodDescriptionstatic voidNamingUtils.renameArginineHydrogen(Residue residue, List<Atom> resAtoms) renameArginineHydrogen.static voidNamingUtils.renameAsparagineHydrogen(Residue residue, List<Atom> resAtoms) renameAsparagineHydrogen.static voidNamingUtils.renameBetaHydrogen(Residue residue, List<Atom> resAtoms, int indexes) renameBetaHydrogen.static voidNamingUtils.renameDeltaHydrogen(Residue residue, List<Atom> resAtoms, int indexes) renameDeltaHydrogen.static voidNamingUtils.renameEpsilonHydrogen(Residue residue, List<Atom> resAtoms, int indexes) renameEpsilonHydrogen.static voidNamingUtils.renameGammaHydrogen(Residue residue, List<Atom> resAtoms, int indexes) renameGammaHydrogen.static voidNamingUtils.renameGlutamineHydrogen(Residue residue, List<Atom> resAtoms) renameGlutamineHydrogen.static voidNamingUtils.renameGlycineAlphaHydrogen(Residue residue, List<Atom> resAtoms) renameGlycineAlphaHydrogen.static voidNamingUtils.renameIsoleucineHydrogen(Residue residue, List<Atom> resAtoms) renameIsoleucineHydrogen.static voidNamingUtils.renameZetaHydrogen(Residue residue, List<Atom> resAtoms, int indexes) renameZetaHydrogen.voidMSGroup.setDanglingAtoms(List<Atom> a) Sets the MultiScaleGroup's danglingAtoms member toa.voidMultiResidue.setDanglingAtoms(List<Atom> a) Sets the MultiScaleGroup's danglingAtoms member toa.static Atom[]BondedUtils.sortAtomsByDistance(Atom reference, List<Atom> toCompare) Sorts toCompare by distance to the reference Atom, returning a sorted array.Constructors in ffx.potential.bonded with parameters of type AtomModifierConstructorDescriptionCreates a new Atom similar to an existing Atom (e.g. for tiling a solvent box over a solute).Bond constructor.MissingAtomTypeException(Residue residue, Atom atom) MissingHeavyAtomException(String atomName, AtomType atomType, Atom bondedTo) OutOfPlaneBend(Angle angle, Atom atom) OutOfPlaneBend constructor.RestrainDistance(Atom a1, Atom a2, Crystal crystal, boolean lambdaTerm, double lamStart, double lamEnd, UnivariateSwitchingFunction sf) Creates a distance restraint between two Atoms.RestrainPosition(Atom[] atoms, double[][] equilibriumCoordinates, double forceConst, double flatBottom, boolean lambdaTerm) Restrain atoms to a position in the global coordinate frame.RestrainTorsion(Atom a1, Atom a2, Atom a3, Atom a4, TorsionType torsionType, boolean lambdaEnabled, boolean reverseLambda, double units) Constructor for RestrainTorsion. -
Uses of Atom in ffx.potential.cli
Method parameters in ffx.potential.cli with type arguments of type AtomModifier and TypeMethodDescriptionstatic voidAtomSelectionOptions.actOnAtoms(MolecularAssembly assembly, String selection, BiConsumer<Atom, Boolean> action, String description) static voidAtomSelectionOptions.actOnResidueAtoms(MolecularAssembly assembly, String selection, BiConsumer<Atom, Boolean> action, String description) -
Uses of Atom in ffx.potential.constraint
Methods in ffx.potential.constraint with parameters of type AtomModifier and TypeMethodDescriptionstatic CcmaConstraintCcmaConstraint.ccmaFactory(List<Bond> constrainedBonds, List<Angle> constrainedAngles, Atom[] allAtoms, double[] masses, double nonzeroCutoff) Constructs a set of bond length Constraints to be satisfied using the Constaint Constraint Matrix Approximation, a parallelizable stable numeric method. -
Uses of Atom in ffx.potential.extended
Methods in ffx.potential.extended that return AtomModifier and TypeMethodDescriptionAtom[]ExtendedSystem.getExtendedAtoms()All atoms of the fully-protonated system (not just those affected by this system). -
Uses of Atom in ffx.potential.nonbonded
Fields in ffx.potential.nonbonded declared as AtomModifier and TypeFieldDescriptionprotected Atom[]ParticleMeshEwald.atomsAn ordered array of atoms in the system.Methods in ffx.potential.nonbonded with parameters of type AtomModifier and TypeMethodDescriptiondouble[]ParticleMeshEwald.computeMoments(Atom[] activeAtoms, boolean forceEnergy) Compute multipole moments for an array of atoms.voidSetter for the fieldatoms.voidThe NeighborList will be re-configured, if necessary, for the supplied atom list.voidvoidSetter for the fieldatoms.voidSetter for the fieldatoms.voidSetter for the fieldatoms.voidsetAtoms.voidSet the atoms and molecule arrays, and rebuild the neighbor list.voidSetter for the fieldatoms.Constructors in ffx.potential.nonbonded with parameters of type AtomModifierConstructorDescriptionGeneralizedKirkwood(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.NeighborList(Crystal crystal, Atom[] atoms, double cutoff, double buffer, ParallelTeam parallelTeam) Constructor for the NeighborList class.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.RowRegion(int gX, int gY, int gZ, double[] grid, int nSymm, int threadCount, Atom[] atoms, double[][][] coordinates) Constructor for RowRegion.SliceRegion(int gX, int gY, int gZ, double[] grid, int nSymm, int threadCount, Atom[] atoms, double[][][] coordinates) Constructor for SliceRegion.SpatialDensityRegion(int gX, int gY, int gZ, double[] grid, int basisSize, int nSymm, int minWork, int threadCount, Crystal crystal, Atom[] atoms, double[][][] coordinates) Constructor for SpatialDensityRegion.VanDerWaals(Atom[] atoms, int[] molecule, boolean[] neuralNetwork, Crystal crystal, ForceField forceField, ParallelTeam parallelTeam, double vdwCutoff, double neighborListCutoff) The VanDerWaals class constructor.VanDerWaalsTornado(Atom[] atoms, Crystal crystal, ForceField forceField, double vdwCutoff) The VanDerWaalsTornado class constructor. -
Uses of Atom in ffx.potential.nonbonded.implicit
Fields in ffx.potential.nonbonded.implicit declared as AtomModifier and TypeFieldDescriptionprotected Atom[]BornGradRegion.atomsAn ordered array of atoms in the system.protected Atom[]BornRadiiRegion.atomsAn ordered array of atoms in the system.protected Atom[]DispersionRegion.atomsAn ordered array of atoms in the system.protected Atom[]InducedGKFieldRegion.atomsAn ordered array of atoms in the system.protected Atom[]PermanentGKFieldRegion.atomsAn ordered array of atoms in the system.Methods in ffx.potential.nonbonded.implicit with parameters of type AtomModifier and TypeMethodDescriptionvoidAllocate storage given the Atom array.voidvoidBornGradRegion.init(Atom[] atoms, Crystal crystal, double[][][] sXYZ, int[][][] neighborLists, double[] baseRadius, double[] descreenRadius, double[] overlapScale, double[] neckScale, double descreenOffset, double[] unscaledBornIntegral, boolean[] use, double cut2, boolean nativeEnvironmentApproximation, double[] born, AtomicDoubleArray3D grad, AtomicDoubleArray sharedBornGrad) voidBornRadiiRegion.init(Atom[] atoms, Crystal crystal, double[][][] sXYZ, int[][][] neighborLists, double[] baseRadius, double[] descreenRadius, double[] overlapScale, double[] neckScale, double descreenOffset, boolean[] use, double cut2, boolean nativeEnvironmentApproximation, double[] born) voidInitialize this VolumeRegion instance for an energy evaluation.voidDispersionRegion.init(Atom[] atoms, Crystal crystal, boolean[] use, int[][][] neighborLists, double[] x, double[] y, double[] z, double cut2, boolean gradient, AtomicDoubleArray3D grad) Initialize the DispersionRegion for energy calculation.voidGKEnergyRegion.init(Atom[] atoms, double[][][] globalMultipole, double[][][] inducedDipole, double[][][] inducedDipoleCR, Crystal crystal, double[][][] sXYZ, int[][][] neighborLists, boolean[] use, double cut2, double[] baseRadius, double[] born, boolean gradient, ParallelTeam parallelTeam, AtomicDoubleArray3D grad, AtomicDoubleArray3D torque, AtomicDoubleArray sharedBornGrad) voidInducedGKFieldRegion.init(Atom[] atoms, double[][][] inducedDipole, double[][][] inducedDipoleCR, Crystal crystal, double[][][] sXYZ, int[][][] neighborLists, boolean[] use, double cut2, double[] born, AtomicDoubleArray3D sharedGKField, AtomicDoubleArray3D sharedGKFieldCR) voidInitializationRegion.init(GeneralizedKirkwood generalizedKirkwood, Atom[] atoms, boolean lambdaTerm, AtomicDoubleArray3D grad, AtomicDoubleArray3D torque, AtomicDoubleArray sharedBornGrad) voidPermanentGKFieldRegion.init(Atom[] atoms, double[][][] globalMultipole, Crystal crystal, double[][][] sXYZ, int[][][] neighborLists, boolean[] use, double cut2, double[] born, AtomicDoubleArray3D sharedGKField) Constructors in ffx.potential.nonbonded.implicit with parameters of type AtomModifierConstructorDescriptionChandlerCavitation(Atom[] atoms, ConnollyRegion connollyRegion, ForceField forceField) ChandlerCavitation(Atom[] atoms, GaussVol gaussVol, ForceField forceField) ConnollyRegion(Atom[] atoms, double[] baseRadius, int nThreads) ConnollyRegion constructor.DispersionRegion(int nt, Atom[] atoms, ForceField forceField) DispersionRegion constructor.GaussVol(Atom[] atoms, ForceField forceField, ParallelTeam parallelTeam) Creates/Initializes a GaussVol instance.HydrophobicPMFRegion(Atom[] atoms, double[] x, double[] y, double[] z, boolean[] use, double[][][] grad, int nt) SurfaceAreaRegion(Atom[] atoms, double[] x, double[] y, double[] z, boolean[] use, int[][][] neighborLists, AtomicDoubleArray3D grad, int nt, double probe, double surfaceTension) This class is a port of the Cavitation code in TINKER. -
Uses of Atom in ffx.potential.nonbonded.pme
Methods in ffx.potential.nonbonded.pme with parameters of type AtomModifier and TypeMethodDescriptionvoidDirectRegion.init(Atom[] atoms, double[] polarizability, double[][][] globalMultipole, double[][] cartMultipolePhi, AtomicDoubleArray3D field, AtomicDoubleArray3D fieldCR, boolean generalizedKirkwoodTerm, GeneralizedKirkwood generalizedKirkwood, EwaldParameters ewaldParameters, double soluteDielectric, double[][][] inducedDipole, double[][][] inducedDipoleCR, double[][] directDipole, double[][] directDipoleCR, double[][] directField, double[][] directFieldCR) voidExpandInducedDipolesRegion.init(Atom[] atoms, Crystal crystal, double[][][] inducedDipole, double[][][] inducedDipoleCR) voidInducedDipoleFieldReduceRegion.init(Atom[] atoms, double[][][] inducedDipole, double[][][] inducedDipoleCR, boolean generalizedKirkwoodTerm, GeneralizedKirkwood generalizedKirkwood, EwaldParameters ewaldParameters, double soluteDielectric, double[][] cartesianDipolePhi, double[][] cartesianDipolePhiCR, AtomicDoubleArray3D field, AtomicDoubleArray3D fieldCR) voidInducedDipoleFieldRegion.init(Atom[] atoms, Crystal crystal, boolean[] use, int[] molecule, double[] ipdamp, double[] thole, double[][][] coordinates, RealSpaceNeighborParameters realSpaceNeighborParameters, double[][][] inducedDipole, double[][][] inducedDipoleCR, boolean reciprocalSpaceTerm, ReciprocalSpace reciprocalSpace, LambdaMode lambdaMode, EwaldParameters ewaldParameters, AtomicDoubleArray3D field, AtomicDoubleArray3D fieldCR, PMETimings pmeTimings) voidInitializationRegion.init(boolean lambdaTerm, AlchemicalParameters alchemicalParameters, ExtendedSystem esvSystem, Atom[] atoms, double[][][] coordinates, Crystal crystal, MultipoleType.MultipoleFrameDefinition[] frame, int[][] axisAtom, double[][][] globalMultipole, double[][][] titrationMultipole, double[][][] tautomerMultipole, double[] polarizability, double[] titrationPolarizability, double[] tautomerPolarizability, double[] thole, double[] ipdamp, boolean[] use, int[][][] neighborLists, int[][][] realSpaceLists, AtomicDoubleArray3D grad, AtomicDoubleArray3D torque, AtomicDoubleArray3D lambdaGrad, AtomicDoubleArray3D lambdaTorque) voidOPTRegion.init(int currentOptOrder, Atom[] atoms, double[] polarizability, double[][][] inducedDipole, double[][][] inducedDipoleCR, double[][] cartesianDipolePhi, double[][] cartesianDipolePhiCR, AtomicDoubleArray3D field, AtomicDoubleArray3D fieldCR, boolean generalizedKirkwoodTerm, GeneralizedKirkwood generalizedKirkwood, EwaldParameters ewaldParameters, double dielectric) voidPCGSolver.init(Atom[] atoms, double[][][] coordinates, double[] polarizability, double[] ipdamp, double[] thole, boolean[] use, Crystal crystal, double[][][] inducedDipole, double[][][] inducedDipoleCR, double[][] directDipole, double[][] directDipoleCR, AtomicDoubleArray3D field, AtomicDoubleArray3D fieldCR, EwaldParameters ewaldParameters, double dieletric, ParallelTeam parallelTeam, IntegerSchedule realSpaceSchedule, PMETimings pmeTimings) voidPermanentFieldRegion.init(Atom[] atoms, Crystal crystal, double[][][] coordinates, double[][][] globalMultipole, double[][][] inducedDipole, double[][][] inducedDipoleCR, int[][][] neighborLists, ScaleParameters scaleParameters, boolean[] use, int[] molecule, double[] ipdamp, double[] thole, int[][] ip11, int[][] mask12, int[][] mask13, int[][] mask14, LambdaMode lambdaMode, boolean reciprocalSpaceTerm, ReciprocalSpace reciprocalSpace, EwaldParameters ewaldParameters, PCGSolver pcgSolver, IntegerSchedule permanentSchedule, RealSpaceNeighborParameters realSpaceNeighborParameters, AtomicDoubleArray3D field, AtomicDoubleArray3D fieldCR) voidPolarizationEnergyRegion.init(Atom[] atoms, double[] polarizability, double[][][] inducedDipole, double[][] directDipoleCR, double polarizationScale) voidRealSpaceEnergyRegion.init(Atom[] atoms, Crystal crystal, ExtendedSystem extendedSystem, boolean esvTerm, double[][][] coordinates, MultipoleType.MultipoleFrameDefinition[] frame, int[][] axisAtom, double[][][] globalMultipole, double[][][] titrationMultipole, double[][][] tautomerMultipole, double[][][] inducedDipole, double[][][] inducedDipoleCR, boolean[] use, int[] molecule, int[][] ip11, int[][] mask12, int[][] mask13, int[][] mask14, int[][] mask15, boolean[] isSoft, double[] ipdamp, double[] thole, RealSpaceNeighborParameters realSpaceNeighborParameters, boolean gradient, boolean lambdaTerm, boolean nnTerm, LambdaMode lambdaMode, Polarization polarization, EwaldParameters ewaldParameters, ScaleParameters scaleParameters, AlchemicalParameters alchemicalParameters, long[] realSpaceEnergyTime, AtomicDoubleArray3D grad, AtomicDoubleArray3D torque, AtomicDoubleArray3D lambdaGrad, AtomicDoubleArray3D lambdaTorque, SharedDouble shareddEdLambda, SharedDouble sharedd2EdLambda2) voidReciprocalEnergyRegion.init(Atom[] atoms, Crystal crystal, boolean gradient, boolean lambdaTerm, boolean esvTerm, boolean[] use, double[][][] globalMultipole, double[][][] globalFracMultipole, double[][][] titrationMultipole, double[][][] tautomerMultipole, double[][] cartMultipolePhi, double[][] fracMultipolePhi, Polarization polarization, double[][][] inducedDipole, double[][][] inducedDipoleCR, double[][] cartesianDipolePhi, double[][] cartesianDipolePhiCR, double[][] fracInducedDipolePhi, double[][] fracInducedDipolePhiCR, ReciprocalSpace reciprocalSpace, AlchemicalParameters alchemicalParameters, ExtendedSystem extendedSystem, AtomicDoubleArray3D grad, AtomicDoubleArray3D torque, AtomicDoubleArray3D lambdaGrad, AtomicDoubleArray3D lambdaTorque, SharedDouble shareddEdLambda, SharedDouble sharedd2EdLambda2) voidReduceRegion.init(boolean lambdaTerm, boolean gradient, Atom[] atoms, double[][][] coordinates, MultipoleType.MultipoleFrameDefinition[] frame, int[][] axisAtom, AtomicDoubleArray3D grad, AtomicDoubleArray3D torque, AtomicDoubleArray3D lambdaGrad, AtomicDoubleArray3D lambdaTorque) voidSORRegion.init(Atom[] atoms, double[] polarizability, double[][][] inducedDipole, double[][][] inducedDipoleCR, double[][] directDipole, double[][] directDipoleCR, double[][] cartesianDipolePhi, double[][] cartesianDipolePhiCR, AtomicDoubleArray3D field, AtomicDoubleArray3D fieldCR, boolean generalizedKirkwoodTerm, GeneralizedKirkwood generalizedKirkwood, EwaldParameters ewaldParameters) -
Uses of Atom in ffx.potential.openmm
Fields in ffx.potential.openmm declared as AtomModifier and TypeFieldDescriptionprotected Atom[]OpenMMSystem.atomsArray of atoms in the system.Methods in ffx.potential.openmm that return AtomMethods in ffx.potential.openmm with parameters of type AtomModifier and TypeMethodDescriptiondouble[]OpenMMState.getAccelerations(double[] a, Atom[] atoms) The acceleration array will contain the acceleration information for all atoms.double[]OpenMMState.getActiveAccelerations(double[] a, Atom[] atoms) The acceleration array will contain the acceleration information for all atoms.double[]OpenMMState.getActiveGradient(double[] g, Atom[] atoms) The force array contains the OpenMM force information for active atoms.double[]OpenMMState.getActivePositions(double[] x, Atom[] atoms) The position array contains the OpenMM atomic position information for active atoms.double[]OpenMMState.getActiveVelocities(double[] v, Atom[] atoms) The velocity array contains the OpenMM atomic position information for active atoms.voidAmoebaGeneralizedKirkwoodForce.updateForce(Atom[] atoms, OpenMMEnergy openMMEnergy) Update the force.voidAmoebaGKCavitationForce.updateForce(Atom[] atoms, OpenMMEnergy openMMEnergy) Update the Cavitation force.voidAmoebaMultipoleForce.updateForce(Atom[] atoms, int topology, OpenMMDualTopologyEnergy openMMDualTopologyEnergy) Update the force parameters for the AMOEBA Multipole Force in a dual topology system.voidAmoebaMultipoleForce.updateForce(Atom[] atoms, OpenMMEnergy openMMEnergy) Update the force parameters for the AMOEBA Multipole Force.voidAmoebaVdwForce.updateForce(Atom[] atoms, int topology, OpenMMDualTopologyEnergy openMMDualTopologyEnergy) Update the vdW force.voidAmoebaVdwForce.updateForce(Atom[] atoms, OpenMMEnergy openMMEnergy) Update the vdW force.voidAmoebaWcaDispersionForce.updateForce(Atom[] atoms, OpenMMEnergy openMMEnergy) Update the WCA force.voidFixedChargeGBForce.updateForce(Atom[] atoms, OpenMMEnergy openMMEnergy) Update the GB force.voidFixedChargeNonbondedForce.updateForce(Atom[] atoms, OpenMMEnergy openMMEnergy) Update an existing non-bonded force for the OpenMM System.voidOpenMMDualTopologyEnergy.updateParameters(Atom[] atoms) Update parameters if the Use flags and/or Lambda value has changed.voidOpenMMDualTopologySystem.updateParameters(Atom[] atoms) Update parameters if the Use flags and/or Lambda value has changed.voidOpenMMEnergy.updateParameters(Atom[] atoms) Update parameters if the Use flags and/or Lambda value has changed.voidOpenMMPotential.updateParameters(Atom[] atoms) Update parameters if the Use flags and/or Lambda value has changed.voidOpenMMSystem.updateParameters(Atom[] atoms) Update parameters if the Use flags and/or Lambda value has changed.Constructors in ffx.potential.openmm with parameters of type AtomModifierConstructorDescriptionOpenMMContext(Platform platform, OpenMMSystem openMMSystem, Atom[] atoms) Create an OpenMM Context for a single topology OpenMM system. -
Uses of Atom in ffx.potential.parameters
Methods in ffx.potential.parameters with parameters of type AtomModifier and TypeMethodDescriptionstatic voidMultipoleType.assignAxisAtoms(Atom atom) Assign local multipole frame defining atoms.static booleanMultipoleType.assignMultipole(ForceField.ELEC_FORM elecForm, Atom atom, ForceField forceField, double[] multipole, int i, int[][] axisAtom, MultipoleType.MultipoleFrameDefinition[] frame) Assign the multipole type.static voidPolarizeType.assignPolarizationGroups(Atom[] atoms, int[][] ip11, int[][] ip12, int[][] ip13) Assign polarization groups to atoms based on their connectivity.double[]TitrationUtils.getMultipole(Atom atom, double titrationLambda, double tautomerLambda, double[] multipole) double[]TitrationUtils.getMultipoleTautomerDeriv(Atom atom, double titrationLambda, double tautomerLambda, double[] multipole) double[]TitrationUtils.getMultipoleTitrationDeriv(Atom atom, double titrationLambda, double tautomerLambda, double[] multipole) doubleTitrationUtils.getPolarizability(Atom atom, double titrationLambda, double tautomerLambda, double defaultPolarizability) doubleTitrationUtils.getPolarizabilityTautomerDeriv(Atom atom, double titrationLambda, double tautomerLambda) doubleTitrationUtils.getPolarizabilityTitrationDeriv(Atom atom, double titrationLambda, double tautomerLambda) static SoluteTypeSoluteType.getSoluteType(Atom atom, ForceField forceField, SoluteType.SOLUTE_RADII_TYPE soluteRadiiType) static intTitrationUtils.getTitratingHydrogenDirection(AminoAcidUtils.AminoAcid3 aminoAcid3, Atom atom) static voidA recursive method that checks all atoms bonded to the seed atom for inclusion in the polarization group.static booleanTitrationUtils.isTitratingHeavy(AminoAcidUtils.AminoAcid3 aminoAcid3, Atom atom) Used to keep track of heavy atoms with changing polarizability.static booleanTitrationUtils.isTitratingHydrogen(AminoAcidUtils.AminoAcid3 aminoAcid3, Atom atom) static MultipoleTypeMultipoleType.multipoleTypeFactory(ForceField.ELEC_FORM elecForm, Atom atom, ForceField forceField) multipoleTypeFactory.static voidSoluteType.setSoluteRadii(ForceField forceField, Atom[] atoms, SoluteType.SOLUTE_RADII_TYPE soluteRadiiType) -
Uses of Atom in ffx.potential.parsers
Fields in ffx.potential.parsers with type parameters of type AtomModifier and TypeFieldDescriptionSystemFilter.atomListThe atomList is filled by filters that extend SystemFilter.Methods in ffx.potential.parsers that return types with arguments of type AtomModifier and TypeMethodDescriptionSystemFilter.atomListToSet(List<Integer> atomList, Atom[] atoms) Converts a list of atom indices to an array of atoms.SystemFilter.getAtomList()Getter for the fieldatomList.Methods in ffx.potential.parsers with parameters of type AtomModifier and TypeMethodDescriptionvoidSystemFilter.atomListToSet(List<Integer> atomList, Atom[] atoms) Converts a list of atom indices to an array of atoms.static intAdd bonds between atoms.static voidCIFFilter.collectAtoms(Atom seed, ArrayList<Atom> atoms) Finds all atoms that are bonded to one another.static StringCIFFilter.getAtomElement(Atom atom) Parse atom name to determine atomic element.static StringPDBFilter.toPDBAtomLine(Atom atom) Simple method useful for converting files to PDB format.Method parameters in ffx.potential.parsers with type arguments of type AtomModifier and TypeMethodDescriptionstatic voidCIFFilter.collectAtoms(Atom seed, ArrayList<Atom> atoms) Finds all atoms that are bonded to one another.booleanPDBFilter.writeFile(File saveFile, boolean append, Set<Atom> toExclude, boolean writeEnd, boolean versioning) writeFilebooleanPDBFilter.writeFile(File saveFile, boolean append, Set<Atom> toExclude, boolean writeEnd, boolean versioning, String[] extraLines) writeFileConstructor parameters in ffx.potential.parsers with type arguments of type AtomModifierConstructorDescriptionMergeFilter(MolecularAssembly f, ArrayList<Atom> a, ArrayList<Bond> b) Constructor for MergeFilter. -
Uses of Atom in ffx.potential.utils
Methods in ffx.potential.utils that return AtomModifier and TypeMethodDescriptionstatic Atom[]ConvexHullOps.identifyHullAtoms(QuickHull3D quickHull3D, Atom[] allAtoms) UNTESTED: Identifies atoms forming the convex hull.Methods in ffx.potential.utils with parameters of type AtomModifier and TypeMethodDescriptionstatic QuickHull3DConvexHullOps.constructHull(Atom[] atoms) Constructs a convex hull from a set of atoms.static Atom[]ConvexHullOps.identifyHullAtoms(QuickHull3D quickHull3D, Atom[] allAtoms) UNTESTED: Identifies atoms forming the convex hull.static doubleMaximum pairwise distance between atoms in an array.static double[][]StructureMetrics.momentsOfInertia(Atom[] atoms, boolean moved, boolean print, boolean pma) Compute the moments of inertia for all atoms in the supplied array.static doubleStructureMetrics.radiusOfGyration(Atom[] atoms) Compute the radius of gyration for all atoms in the supplied array.static double[]StructureMetrics.radiusOfGyrationComponents(Atom[] atoms) Compute the radius of gyration for all atoms in the supplied array. -
Uses of Atom in ffx.xray
Modifier and TypeMethodDescriptionvoidDiffractionData.writeModel(String filename, Set<Atom> excludeAtoms, double pH) Write current model to PDB file.ModifierConstructorDescriptionCrystalReciprocalSpace(ReflectionList reflectionList, Atom[] scatteringAtoms, ParallelTeam fftTeam, ParallelTeam parallelTeam) Crystal Reciprocal Space constructor, assumes this is not a bulk solvent mask and is not a neutron data setCrystalReciprocalSpace(ReflectionList reflectionList, Atom[] scatteringAtoms, ParallelTeam fftTeam, ParallelTeam parallelTeam, boolean solventMask) Crystal Reciprocal Space constructor, assumes this is not a neutron data set and implements a polynomial bulk solvent mask if neededCrystalReciprocalSpace(ReflectionList reflectionlist, Atom[] scatteringAtoms, ParallelTeam fftTeam, ParallelTeam parallelTeam, boolean solventMask, boolean neutron, SolventModel solventModel, GridMethod gridMethod) Crystal Reciprocal Space constructor, all parameters provided -
Uses of Atom in ffx.xray.refine
Fields in ffx.xray.refine declared as AtomModifier and TypeFieldDescriptionprotected final AtomRefinedParameter.atomThe primaryAtomthat serves as the central reference in a refinement process.Fields in ffx.xray.refine with type parameters of type AtomModifier and TypeFieldDescriptionRefinedOccupancy.complementListA collection of atoms that are constrained in relation to a primaryAtom.RefinedOccupancy.complementScatterListRefinedParameter.constrainedAtomsA collection of atoms that are constrained in relation to a primaryAtom.RefinedParameter.constrainedAtomsThatScatterMethods in ffx.xray.refine that return AtomModifier and TypeMethodDescriptionAtom[]RefinementModel.getActiveAtoms()Getter for the fieldactiveAtomArray.Atom[]RefinementModel.getScatteringAtoms()Getter for the fieldtotalAtomArray.Methods in ffx.xray.refine with parameters of type AtomModifier and TypeMethodDescriptionvoidRefinedBFactor.addConstrainedAtom(Atom atom) Adds the specified atom to the list of constrained atoms while applying specific constraints.voidRefinedCoordinates.addConstrainedAtom(Atom atom) voidRefinedOccupancy.addConstrainedAtom(Atom atom) abstract voidRefinedParameter.addConstrainedAtom(Atom atom) Adds an atom to the list of constrained atoms for the given primary atom.voidRefinedOccupancy.addConstrainedAtomComplement(Atom atom) Adds an atom constrained to this RefinedOccupancy instance.voidRefinedBFactor.addConstrainedAtomThatScatters(Atom atom) Adds the given atom to the list of constrained atoms that scatter in structural models.voidRefinedCoordinates.addConstrainedAtomThatScatters(Atom atom) voidRefinedOccupancy.addConstrainedAtomThatScatters(Atom atom) abstract voidRefinedParameter.addConstrainedAtomThatScatters(Atom atom) Adds an atom to the list of constrained atoms that contribute to experimental scattering.voidRefinedOccupancy.addConstrainedAtomThatScattersComplement(Atom atom) Adds an atom constrained to this RefinedOccupancy instance as a complementary, scattering atom.Constructors in ffx.xray.refine with parameters of type AtomModifierConstructorDescriptionRefinedBFactor(Atom atom) Constructor for the RefinableBfactor class.RefinedCoordinates(Atom atom) Constructs a new RefinableCoordinates instance for the specified atom.RefinedOccupancy(Atom atom) Constructs a RefinableOccupancy instance for managing the specified atom.RefinedParameter(Atom atom) Constructs a new RefinedParameters object for the specified primaryAtom. -
Uses of Atom in ffx.xray.scatter
Constructors in ffx.xray.scatter with parameters of type AtomModifierConstructorDescriptionNeutronFormFactor(Atom atom) Constructor for NeutronFormFactor.NeutronFormFactor(Atom atom, double badd) Constructor for NeutronFormFactor.NeutronFormFactor(Atom atom, double badd, double[] xyz) Constructor for NeutronFormFactor.SolventBinaryFormFactor(Atom atom, double probeRad) Constructor for SolventBinaryFormFactor.SolventBinaryFormFactor(Atom atom, double probeRad, double[] xyz) Constructor for SolventBinaryFormFactor.SolventGaussFormFactor(Atom atom, double sd) Constructor for SolventGaussFormFactor.SolventGaussFormFactor(Atom atom, double sd, double[] xyz) Constructor for SolventGaussFormFactor.SolventPolyFormFactor(Atom atom, double arad, double w) Constructor for SolventPolyFormFactor.SolventPolyFormFactor(Atom atom, double arad, double w, double[] xyz) Constructor for SolventPolyFormFactor.XRayFormFactor(Atom atom) Constructor for XRayFormFactor.XRayFormFactor(Atom atom, boolean use3G) Constructor for XRayFormFactor.XRayFormFactor(Atom atom, boolean use3G, double badd) Constructor for XRayFormFactor.XRayFormFactor(Atom atom, boolean use3G, double badd, double[] xyz) Constructor for XRayFormFactor. -
Uses of Atom in ffx.xray.solvent
Constructors in ffx.xray.solvent with parameters of type AtomModifierConstructorDescriptionBulkSolventDensityRegion(int gX, int gY, int gZ, double[] grid, int basisSize, int nSymm, int minWork, int threadCount, Crystal crystal, Atom[] atoms, double[][][] coordinates, double cutoff, ParallelTeam parallelTeam) Constructor for BulkSolventDensityRegion.BulkSolventList(Crystal crystal, Atom[] atoms, double cutoff, ParallelTeam parallelTeam) Constructor for the NeighborList class.BulkSolventRowRegion(int gX, int gY, int gZ, double[] grid, int nSymm, int threadCount, Crystal crystal, Atom[] atoms, double[][][] coordinates, double cutoff, ParallelTeam parallelTeam) Constructor for BulkSolventDensityRegion.BulkSolventSliceRegion(int gX, int gY, int gZ, double[] grid, int nSymm, int threadCount, Crystal crystal, Atom[] atoms, double[][][] coordinates, double cutoff, ParallelTeam parallelTeam) Constructor for BulkSolventDensityRegion.