Uses of Class
ffx.crystal.Crystal
Packages that use Crystal
Package
Description
The Dynamics package implements molecular and stochastic dynamics using a pure Java code path and
via OpenMM.
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 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 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 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 Parsers package handles reading/writing files to/from the internal data structure.
The Real Space package implements real space structure refinement.
The Parsers package reads and writes CCP4 map files.
The X-ray package implements support for X-ray and Neutron refinement.
The Parsers package reads CNS files and reads/writes MTZ files.
-
Uses of Crystal in ffx.algorithms.dynamics
Methods in ffx.algorithms.dynamics that return CrystalModifier and TypeMethodDescriptionBarostat.getCrystal()Get the Crystal instance that specifies the periodic boundary conditions and symmetry.Methods in ffx.algorithms.dynamics with parameters of type CrystalModifier and TypeMethodDescriptionvoidBarostat.setCrystal(Crystal crystal) Set the Crystal instance that specifies the periodic boundary conditions and symmetry. -
Uses of Crystal in ffx.algorithms.optimize.manybody
Methods in ffx.algorithms.optimize.manybody with parameters of type CrystalModifier and TypeMethodDescriptionbooleanManyBodyCell.anyRotamerInsideCell(Residue residue, Crystal crystal, SymOp symOp, boolean variableOnly) Checks if any rotamer of a Residue is inside this BoxOptCell.booleanManyBodyCell.atomInsideCell(Atom atom, Crystal crystal, SymOp symOp) Checks if an Atom would be contained inside this cell.booleanManyBodyCell.residueInsideCell(Residue residue, Crystal crystal, SymOp symOp, boolean variableOnly) Checks if a Residue is inside this BoxOptCell.Constructors in ffx.algorithms.optimize.manybody with parameters of type CrystalModifierConstructorDescriptionDistanceRegion(int nt, int nResidues, Crystal crystal, int[][][] lists, IntegerSchedule schedule) -
Uses of Crystal in ffx.algorithms.thermodynamics
Methods in ffx.algorithms.thermodynamics that return CrystalModifier and TypeMethodDescriptionOrthogonalSpaceTempering.getCrystal()Get the Crystal instance that specifies the periodic boundary conditions and symmetry.Methods in ffx.algorithms.thermodynamics with parameters of type CrystalModifier and TypeMethodDescriptionvoidOrthogonalSpaceTempering.setCrystal(Crystal crystal) Set the Crystal instance that specifies the periodic boundary conditions and symmetry. -
Uses of Crystal in ffx.crystal
Subclasses of Crystal in ffx.crystalModifier and TypeClassDescriptionclassThe NCSCrystal class extends Crystal to support non-crystallographic symmetry (NCS).classThe ReplicatesCrystal class extends Crystal to generate additional symmetry operators needed to describe a "replicated" super-cell.Fields in ffx.crystal declared as CrystalMethods in ffx.crystal that return CrystalModifier and TypeMethodDescriptionstatic CrystalCrystal.checkProperties(org.apache.commons.configuration2.CompositeConfiguration properties) checkPropertiesCrystalPotential.getCrystal()Get the Crystal instance that specifies the periodic boundary conditions and symmetry.Crystal.getUnitCell()The ReplicatesCrystal over-rides this method to return the unit cell rather than the ReplicateCell.NCSCrystal.getUnitCell()The ReplicatesCrystal over-rides this method to return the unit cell rather than the ReplicateCell.ReplicatesCrystal.getUnitCell()The ReplicatesCrystal over-rides this method to return the unit cell rather than the ReplicateCell.static CrystalSpaceGroupConversions.hrConversion(double a, double b, double c, double alpha, double beta, double gamma, SpaceGroup currentSG) Convert between hexagonal and rhombohedral space groups.static CrystalSpaceGroupConversions.hrConversion(Crystal crystal) Convert between hexagonal and rhombohedral space groups.static CrystalNCSCrystal.NCSCrystalFactory(Crystal unitCell, List<SymOp> symOps) Returns an NCSCrystal by expanding the orignal unit cell with the symmetry operators provided by the BIOMT records in the PDB files.static CrystalReplicatesCrystal.replicatesCrystalFactory(Crystal unitCell, double cutOff2) Returns a ReplicatesCrystal large enough to satisfy the minimum image convention for the specified unit cell and cutoff criteria.static CrystalReplicatesCrystal.replicatesCrystalFactory(Crystal unitCell, double cutOff2, int[] replicatesVector) Returns a ReplicatesCrystal large enough to satisfy the minimum image convention for the specified unit cell and cutoff criteria.Methods in ffx.crystal with parameters of type CrystalModifier and TypeMethodDescriptionstatic CrystalSpaceGroupConversions.hrConversion(Crystal crystal) Convert between hexagonal and rhombohedral space groups.static CrystalNCSCrystal.NCSCrystalFactory(Crystal unitCell, List<SymOp> symOps) Returns an NCSCrystal by expanding the orignal unit cell with the symmetry operators provided by the BIOMT records in the PDB files.static CrystalReplicatesCrystal.replicatesCrystalFactory(Crystal unitCell, double cutOff2) Returns a ReplicatesCrystal large enough to satisfy the minimum image convention for the specified unit cell and cutoff criteria.static CrystalReplicatesCrystal.replicatesCrystalFactory(Crystal unitCell, double cutOff2, int[] replicatesVector) Returns a ReplicatesCrystal large enough to satisfy the minimum image convention for the specified unit cell and cutoff criteria.voidCrystalPotential.setCrystal(Crystal crystal) Set the Crystal instance that specifies the periodic boundary conditions and symmetry.Constructors in ffx.crystal with parameters of type CrystalModifierConstructorDescriptionReflectionList(Crystal crystal, Resolution resolution) Constructor for ReflectionList.ReflectionList(Crystal crystal, Resolution resolution, org.apache.commons.configuration2.CompositeConfiguration properties) Constructor for ReflectionList.ReplicatesCrystal(Crystal unitCell, int l, int m, int n, double cutOff2) Constructor for a ReplicatesCrystal. -
Uses of Crystal in ffx.potential
Methods in ffx.potential that return CrystalModifier and TypeMethodDescriptionDualTopologyEnergy.getCrystal()Get the Crystal instance that specifies the periodic boundary conditions and symmetry.ForceFieldEnergy.getCrystal()Get the Crystal instance that specifies the periodic boundary conditions and symmetry.MolecularAssembly.getCrystal()getCrystalQuadTopologyEnergy.getCrystal()Get the Crystal instance that specifies the periodic boundary conditions and symmetry.Methods in ffx.potential with parameters of type CrystalModifier and TypeMethodDescriptionvoidDualTopologyEnergy.setCrystal(Crystal crystal) Set the Crystal instance that specifies the periodic boundary conditions and symmetry.voidForceFieldEnergy.setCrystal(Crystal crystal) Set the Crystal instance that specifies the periodic boundary conditions and symmetry.voidForceFieldEnergy.setCrystal(Crystal crystal, boolean checkReplicatesCell) Set the boundary conditions for this calculation.voidMolecularAssembly.setCrystal(Crystal crystal) Set the Crystal for the Potential of this MolecularAssembly.voidQuadTopologyEnergy.setCrystal(Crystal crystal) Set the Crystal instance that specifies the periodic boundary conditions and symmetry. -
Uses of Crystal in ffx.potential.bonded
Constructors in ffx.potential.bonded with parameters of type CrystalModifierConstructorDescriptionRestrainDistance(Atom a1, Atom a2, Crystal crystal, boolean lambdaTerm, double lamStart, double lamEnd, UnivariateSwitchingFunction sf) Creates a distance restraint between two Atoms. -
Uses of Crystal in ffx.potential.nonbonded
Fields in ffx.potential.nonbonded declared as CrystalMethods in ffx.potential.nonbonded with parameters of type CrystalModifier and TypeMethodDescriptionvoidGeneralizedKirkwood.setCrystal(Crystal crystal) Setter for the fieldcrystal.voidNeighborList.setCrystal(Crystal crystal) The NeighborList will be re-configured, if necessary, for the supplied Crystal.voidParticleMeshEwald.setCrystal(Crystal crystal) voidReciprocalSpace.setCrystal(Crystal crystal) Setter for the fieldcrystal.final voidRowRegion.setCrystal(Crystal crystal, int gX, int gY, int gZ) Setter for the fieldcrystal.final voidSliceRegion.setCrystal(Crystal crystal, int gX, int gY, int gZ) Setter for the fieldcrystal.final voidSpatialDensityRegion.setCrystal(Crystal crystal, int gX, int gY, int gZ) Setter for the fieldcrystal.voidVanDerWaals.setCrystal(Crystal crystal) If the crystal being passed in is not equal to the current crystal, then some Van der Waals data structures may need to updated.voidVanDerWaalsTornado.setCrystal(Crystal crystal) If the crystal being passed in is not equal to the current crystal, then some Van der Waals data structures may need to updated.Constructors in ffx.potential.nonbonded with parameters of type CrystalModifierConstructorDescriptionGeneralizedKirkwood(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.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 Crystal in ffx.potential.nonbonded.implicit
Methods in ffx.potential.nonbonded.implicit with parameters of type CrystalModifier and TypeMethodDescriptionvoidBornGradRegion.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) 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) voidPermanentGKFieldRegion.init(Atom[] atoms, double[][][] globalMultipole, Crystal crystal, double[][][] sXYZ, int[][][] neighborLists, boolean[] use, double cut2, double[] born, AtomicDoubleArray3D sharedGKField) -
Uses of Crystal in ffx.potential.nonbonded.pme
Fields in ffx.potential.nonbonded.pme declared as CrystalModifier and TypeFieldDescriptionAlchemicalParameters.vaporCrystalBoundary conditions for the vapor end of the alchemical path.Methods in ffx.potential.nonbonded.pme with parameters of type CrystalModifier and TypeMethodDescriptionvoidExpandInducedDipolesRegion.init(Atom[] atoms, Crystal crystal, double[][][] inducedDipole, double[][][] inducedDipoleCR) 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) 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) 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) -
Uses of Crystal in ffx.potential.openmm
Methods in ffx.potential.openmm that return CrystalModifier and TypeMethodDescriptionOpenMMDualTopologySystem.getCrystal()Get the Crystal instance.OpenMMSystem.getCrystal()Get the Crystal instance.Methods in ffx.potential.openmm with parameters of type CrystalModifier and TypeMethodDescriptionvoidOpenMMEnergy.setCrystal(Crystal crystal) Set the Crystal instance that specifies the periodic boundary conditions and symmetry.voidOpenMMContext.setPeriodicBoxVectors(Crystal crystal) Set the periodic box vectors for a context based on the crystal instance. -
Uses of Crystal in ffx.potential.parsers
Methods in ffx.potential.parsers with parameters of type CrystalModifier and TypeMethodDescriptionbooleanreadDYNbooleanwriteDYNbooleanXPHFilter.writeFileAsP1(File saveFile, boolean append, Crystal crystal) writeFileAsP1booleanXPHFilter.writeFileAsP1(File saveFile, boolean append, Crystal crystal, String[] extraLines) writeFileAsP1booleanXYZFilter.writeFileAsP1(File saveFile, boolean append, Crystal crystal) writeFileAsP1booleanXYZFilter.writeFileAsP1(File saveFile, boolean append, Crystal crystal, int[] lmn, String[] extraLines) Write file as a P1 system in XYZ format.booleanXYZFilter.writeFileAsP1(File saveFile, boolean append, Crystal crystal, String[] extraLines) writeFileAsP1 -
Uses of Crystal in ffx.realspace
Methods in ffx.realspace that return CrystalModifier and TypeMethodDescriptionCrystal[]RealSpaceData.getCrystal()Getter for the fieldcrystal.RealSpaceEnergy.getCrystal()Get the Crystal instance that specifies the periodic boundary conditions and symmetry.Methods in ffx.realspace with parameters of type CrystalModifier and TypeMethodDescriptionvoidRealSpaceData.setCrystal(Crystal[] crystal) Setter for the fieldcrystal.voidRealSpaceEnergy.setCrystal(Crystal crystal) Set the Crystal instance that specifies the periodic boundary conditions and symmetry. -
Uses of Crystal in ffx.realspace.parsers
Methods in ffx.realspace.parsers that return CrystalModifier and TypeMethodDescriptionCCP4MapFilter.getCrystal(String fileName, org.apache.commons.configuration2.CompositeConfiguration properties) getCrystalRealSpaceFileFilter.getCrystal(String filename, org.apache.commons.configuration2.CompositeConfiguration properties) getCrystal -
Uses of Crystal in ffx.xray
Modifier and TypeMethodDescriptionCrystal[]DiffractionData.getCrystal()Getter for the fieldcrystal.RefinementEnergy.getCrystal()Get the Crystal instance that specifies the periodic boundary conditions and symmetry.XRayEnergy.getCrystal()Get the Crystal instance that specifies the periodic boundary conditions and symmetry.Modifier and TypeMethodDescriptionvoidRefinementEnergy.setCrystal(Crystal crystal) Set the Crystal instance that specifies the periodic boundary conditions and symmetry.voidXRayEnergy.setCrystal(Crystal crystal) Set the Crystal instance that specifies the periodic boundary conditions and symmetry. -
Uses of Crystal in ffx.xray.parsers
Methods in ffx.xray.parsers with parameters of type CrystalModifier and TypeMethodDescriptiondoubleCIFFilter.getResolution(File cifFile, Crystal crystal) Attempt to determine resolution of reflection file.doubleCNSFilter.getResolution(File cnsFile, Crystal crystal) Attempt to determine resolution of reflection file.doubleDiffractionFileFilter.getResolution(File file, Crystal crystal) Attempt to determine resolution of reflection file.doubleMTZFilter.getResolution(File mtzFile, Crystal crystal) Attempt to determine resolution of reflection file.Constructors in ffx.xray.parsers with parameters of type CrystalModifierConstructorDescriptionCCP4MapWriter(int orix, int oriy, int oriz, int extx, int exty, int extz, int nx, int ny, int nz, Crystal crystal, String filename) Constructor for CCP4MapWriter.CCP4MapWriter(int extx, int exty, int extz, Crystal crystal, String filename) construct mapwriter objectCNSMapWriter(int nx, int ny, int nz, Crystal crystal, String filename) Constructor for CNSMapWriter. -
Uses of Crystal in ffx.xray.solvent
Constructors in ffx.xray.solvent with parameters of type CrystalModifierConstructorDescriptionBulkSolventDensityRegion(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.