Uses of Interface
org.biojava.nbio.structure.Atom
Package
Description
Interfaces and classes for protein structure (PDB).
Classes for the alignment of structures.
Classes related to the implementation of the CE alignment algorithm, here called jCE.
Classes related to the implementation of the FATCAT alignment algorithm, here called jFATCAT.
Utility methods for better interaction with Jmol.
Helper classes for structural alignment.
Classes for the pairwise alignment of structures.
Serialization and deserialization for structure alignment results (as AFPChain object) to XML.
Input and Output of Structures
-
Uses of Atom in org.biojava.nbio.protmod.structure
Modifier and TypeMethodDescriptionstatic Atom[]
StructureUtil.findLinkage
(Group group1, Group group2, String nameOfAtomOnGroup1, String nameOfAtomOnGroup2, double bondLengthTolerance) Find a linkage between two groups within tolerance of bond length.static Atom[]
StructureUtil.findNearestAtomLinkage
(Group group1, Group group2, List<String> potentialNamesOfAtomOnGroup1, List<String> potentialNamesOfAtomOnGroup2, boolean ignoreNCLinkage, double bondLengthTolerance) Find a linkage between two groups within tolerance of bond length, from potential atoms.Modifier and TypeMethodDescriptionstatic double
StructureUtil.getAtomDistance
(Atom atom1, Atom atom2) static StructureAtom
StructureUtil.getStructureAtom
(Atom atom, boolean isParentAminoAcid) static StructureAtomLinkage
StructureUtil.getStructureAtomLinkage
(Atom atom1, boolean isParentAminoAcid1, Atom atom2, boolean isParentAminoAcid2) -
Uses of Atom in org.biojava.nbio.structure
Modifier and TypeMethodDescriptionstatic final Atom
add two atoms ( a + b).static final Atom[]
Calc.centerAtoms
(Atom[] atomSet) Center the atoms at the Centroid.static final Atom[]
Calc.centerAtoms
(Atom[] atomSet, Atom centroid) Center the atoms at the Centroid, if the centroid is already know.static Atom
Calc.centerOfMass
(Atom[] points) Returns the center of mass of the set of atoms.static Atom[]
StructureTools.cloneAtomArray
(Atom[] ca) Provides an equivalent copy of Atoms in a new array.static final Atom
Calc.createVirtualCBAtom
(AminoAcid amino) creates a virtual C-beta atom. this might be needed when working with GLY thanks to Peter Lackner for a python template of this method.static Atom[]
StructureTools.duplicateCA2
(Atom[] ca2) Utility method for working with circular permutations.static Atom[]
StructureTools.getAllAtomArray
(Chain c) Returns and array of all atoms of the chain, including Hydrogens (if present) and all HETATOMs.static Atom[]
StructureTools.getAllAtomArray
(Structure s) Convert all atoms of the structure (all models) into an Atom arraystatic Atom[]
StructureTools.getAllAtomArray
(Structure s, int model) Convert all atoms of the structure (specified model) into an Atom arraystatic Atom[]
StructureTools.getAllNonHAtomArray
(Chain c, boolean hetAtoms) Returns and array of all non-Hydrogen atoms in the given Chain, optionally including HET atoms or not Waters are not included.static final Atom[]
StructureTools.getAllNonHAtomArray
(Structure s, boolean hetAtoms) Returns and array of all non-Hydrogen atoms in the given Structure, optionally including HET atoms or not.static Atom[]
StructureTools.getAllNonHAtomArray
(Structure s, boolean hetAtoms, int modelNr) Returns and array of all non-Hydrogen atoms in the given Structure, optionally including HET atoms or not.Group.getAtom
(int position) Get at atom by position.Get an atom given its PDB name.HetatomImpl.getAtom
(int position) Get at atom by position.Get an atom given its PDB name.Bond.getAtomA()
Gets atom 'A' of this bond.BondImpl.getAtomA()
Gets atom 'A' of this bond.static Atom[]
StructureTools.getAtomArray
(Chain c, String[] atomNames) Returns an array of the requested Atoms from the Chain object.static Atom[]
StructureTools.getAtomArray
(Structure s, String[] atomNames) Returns an array of the requested Atoms from the Structure object.static Atom[]
StructureTools.getAtomArrayAllModels
(Structure s, String[] atomNames) Returns an array of the requested Atoms from the Structure object.Bond.getAtomB()
Gets atom 'B' of this bond.BondImpl.getAtomB()
Gets atom 'B' of this bond.static Atom[]
StructureTools.getAtomCAArray
(Chain c) Returns an Atom array of the C-alpha atoms.static Atom[]
StructureTools.getAtomCAArray
(Structure s) Return an Atom array of the C-alpha atoms.static Atom[]
StructureTools.getBackboneAtomArray
(Structure s) Return an Atom array of the main chain atoms: CA, C, N, O Any group that contains those atoms will be included, be it a standard aminoacid or notAminoAcid.getC()
Get C atom.AminoAcidImpl.getC()
Get C atom.AminoAcid.getCA()
Get CA atom.AminoAcidImpl.getCA()
Get CA atom.AminoAcid.getCB()
Get CB atom.AminoAcidImpl.getCB()
Get CB atom.static final Atom
Calc.getCenterVector
(Atom[] atomSet) Returns the Vector that needs to be applied to shift a set of atoms to the Centroid.static final Atom
Calc.getCenterVector
(Atom[] atomSet, Atom centroid) Returns the Vector that needs to be applied to shift a set of atoms to the Centroid, if the centroid is already knownstatic final Atom
Calc.getCentroid
(Atom[] atomSet) Returns the centroid of the set of atoms.AminoAcid.getN()
Get N atom.AminoAcidImpl.getN()
Get N atom.AminoAcid.getO()
Get O atom.AminoAcidImpl.getO()
Get O atom.NucleotideImpl.getO3Prime()
Returns the O3' atom if present, otherwise nullNucleotideImpl.getO5Prime()
Returns the O5' atom if present, otherwise nullA utility method to get the other atom in a bond, given one of its atoms.A utility method to get the other atom in a bond, given one of its atoms.NucleotideImpl.getP()
Returns the P atom if present, otherwise nullstatic Atom[]
StructureTools.getRepresentativeAtomArray
(Chain c) Gets a representative atom for each group that is part of the chain backbone.static Atom[]
StructureTools.getRepresentativeAtomArray
(Structure s) Gets a representative atom for each group that is part of the chain backbone.static Atom
Calc.getTranslationVector
(javax.vecmath.Matrix4d transform) Extract the translational vector as an Atom of a transformation matrix.static final Atom
AtomIterator.next()
Return next atom.static Atom
Multiply elements of a by sstatic Atom
Perform linear transformation s*X+B, and store the result in bstatic Atom
Calc.scaleEquals
(Atom a, double s) Multiply elements of a by s (in place)static final Atom
subtract two atoms ( a - b).static final Atom
Calc.unitVector
(Atom a) Returns the unit vector of vector a .static final Atom
Calc.vectorProduct
(Atom a, Atom b) Vector product (cross product).Modifier and TypeMethodDescriptionGroup.getAtoms()
Get list of atoms.HetatomImpl.getAtoms()
Get list of atoms.Group.iterator()
Get an Atom Iterator.HetatomImpl.iterator()
Modifier and TypeMethodDescriptionstatic final Atom
add two atoms ( a + b).void
Add an atom to this group.void
Add an atom to this group.static final double
Gets the length of the vector (2-norm)static final double
Gets the angle between two vectorsstatic javax.vecmath.Point3d[]
Calc.atomsToPoints
(Atom[] atoms) Convert an array of atoms into an array of vecmath pointsstatic double
Calc.calcRotationAngleInDegrees
(Atom centerPt, Atom targetPt) Calculates the angle from centerPt to targetPt in degrees.static final Atom[]
Calc.centerAtoms
(Atom[] atomSet) Center the atoms at the Centroid.static final Atom[]
Calc.centerAtoms
(Atom[] atomSet, Atom centroid) Center the atoms at the Centroid, if the centroid is already know.static Atom
Calc.centerOfMass
(Atom[] points) Returns the center of mass of the set of atoms.static Atom[]
StructureTools.cloneAtomArray
(Atom[] ca) Provides an equivalent copy of Atoms in a new array.static Group[]
StructureTools.cloneGroups
(Atom[] ca) Clone a set of representative Atoms, but returns the parent groupsstatic String
StructureTools.convertAtomsToSeq
(Atom[] atoms) static Atom[]
StructureTools.duplicateCA2
(Atom[] ca2) Utility method for working with circular permutations.StructureTools.getAllGroupsFromSubset
(Atom[] atoms) Expand a set of atoms into all groups from the same structure.StructureTools.getAllGroupsFromSubset
(Atom[] atoms, GroupType types) Expand a set of atoms into all groups from the same structure.static final Atom
Calc.getCenterVector
(Atom[] atomSet) Returns the Vector that needs to be applied to shift a set of atoms to the Centroid.static final Atom
Calc.getCenterVector
(Atom[] atomSet, Atom centroid) Returns the Vector that needs to be applied to shift a set of atoms to the Centroid, if the centroid is already knownstatic final Atom
Calc.getCentroid
(Atom[] atomSet) Returns the centroid of the set of atoms.static final double
Calc.getDistance
(Atom a, Atom b) calculate distance between two atoms.static double
Calc.getDistanceFast
(Atom a, Atom b) Will calculate the square of distances between two atoms.StructureTools.getGroupDistancesWithinShell
(Structure structure, Atom centroid, Set<ResidueNumber> excludeResidues, double radius, boolean includeWater, boolean useAverageDistance) Finds Groups instructure
that contain at least one Atom that is withinradius
Angstroms ofcentroid
.StructureTools.getGroupsWithinShell
(Structure structure, Atom atom, Set<ResidueNumber> excludeResidues, double distance, boolean includeWater) StructureTools.getLigandsByProximity
(Collection<Group> target, Atom[] query, double cutoff) Finds all ligand groups from the target which fall within the cutoff distance of some atom from the query set.A utility method to get the other atom in a bond, given one of its atoms.A utility method to get the other atom in a bond, given one of its atoms.static double
Calc.getTMScore
(Atom[] atomSet1, Atom[] atomSet2, int len1, int len2) Calculate the TM-Score for the superposition.static double
Calc.getTMScore
(Atom[] atomSet1, Atom[] atomSet2, int len1, int len2, boolean normalizeMin) Calculate the TM-Score for the superposition.static javax.vecmath.Matrix4d
Calc.getTransformation
(Matrix rot, Atom trans) Convert JAMA rotation and translation to a Vecmath transformation matrix.StructureTools.getUnalignedGroups
(Atom[] ca) List of groups from the structure not included in ca (e.g. ligands).boolean
Test if another atom has a bond to this atomboolean
Test if another atom has a bond to this atomstatic boolean
StructureTools.hasDeuteratedEquiv
(Atom atom, Group currentGroup) Check to see if a Hydrogen has a Deuterated brother in the group.static boolean
StructureTools.hasNonDeuteratedEquiv
(Atom atom, Group currentGroup) Check to see if an Deuterated atom has a non deuterated brother in the group.static final Atom
static double
Calculate the RMSD of two Atom arrays, already superposed.static void
static final void
Rotate a single Atom aroud a rotation matrix.static final void
Rotate an Atom around a Matrix object.static final double
Calc.scalarProduct
(Atom a, Atom b) Scalar product (dot product).static Atom
Multiply elements of a by sstatic Atom
Perform linear transformation s*X+B, and store the result in bstatic Atom
Calc.scaleEquals
(Atom a, double s) Multiply elements of a by s (in place)static void
Shift an array of atoms at once.static final void
Shift a vector.static final void
Shift a Group with a vector.static final void
shift a structure with a vector.static final Atom
subtract two atoms ( a - b).static final double
Calc.torsionAngle
(Atom a, Atom b, Atom c, Atom d) Calculate the torsion angle, i.e. the angle between the normal vectors of the two plains a-b-c and b-c-d.static void
Transform an array of atoms at once.static final void
Transforms an atom object, given a Matrix4d (i.e. the vecmath library double-precision 4x4 rotation+translation matrix).static final void
Translates an atom object, given a Vector3d (i.e. the vecmath library double-precision 3-d vector)static final Atom
Calc.unitVector
(Atom a) Returns the unit vector of vector a .static final Atom
Calc.vectorProduct
(Atom a, Atom b) Vector product (cross product).Modifier and TypeMethodDescriptionstatic List
<javax.vecmath.Point3d> Calc.atomsToPoints
(Collection<Atom> atoms) Convert an array of atoms into an array of vecmath pointsvoid
Set the atoms of this group.void
Set the atoms of this group.ModifierConstructorDescriptionAtomPositionMap
(Atom[] atoms) Creates a new AtomPositionMap containing peptide alpha-carbon atomsAtomPositionMap
(Atom[] atoms, AtomPositionMap.GroupMatcher matcher) Creates a new AtomPositionMap containing only atoms matched bymatcher
.Constructs a new bond from a pair of atoms and the bond order of the bond between them.Constructs a new bond from a pair of atoms and the bond order of the bond between them. -
Uses of Atom in org.biojava.nbio.structure.align
Modifier and TypeMethodDescriptionAtom[]
StructurePairAligner.getAlignmentAtoms
(Structure s) Returns the atoms that are being used for the alignment.Atom[]
CallableStructureAlignment.getCa1()
Modifier and TypeMethodDescriptionabstract AFPChain
abstract AFPChain
Run an alignment while specifying the atoms to be aligned.run an alignment and also send a bean containing the parameters.void
StructurePairAligner.align
(Atom[] ca1, Atom[] ca2, StrucAligParameters params) Calculate the protein structure superimposition, between two sets of atoms.void
static Group[]
AFPTwister.twistOptimized
(AFPChain afpChain, Atom[] ca1, Atom[] ca2) superimposing according to the optimized alignmentstatic Group[]
calculate the total rmsd of the blocks output a merged pdb file for both proteins protein 1, in chain A protein 2 is twisted according to the twists detected, in chain BModifierConstructorDescriptionCallableStructureAlignment
(Atom[] ca1, Atom[] ca2, String algorithmName, ConfigStrucAligParams params) Constructor for all-to-all alignment calculation. -
Uses of Atom in org.biojava.nbio.structure.align.ce
Modifier and TypeMethodDescriptionstatic Atom[]
CECalculator.getShift()
Gets the shift from the last call tocalc_rmsd
.CeCalculatorEnhanced.getShift()
Gets the shift from the last call tocalc_rmsd
.Modifier and TypeMethodDescriptionAligns ca1 and ca2 using a heuristic to check for CPs.Align ca2 onto ca1.Finds the optimal alignment between two proteins allowing for a circular permutation (CP).OptimalCECPMain.alignOptimal
(Atom[] ca1, Atom[] ca2, Object param, AFPChain[] alignments) Finds the optimal alignment between two proteins allowing for a circular permutation (CP).OptimalCECPMain.alignPermuted
(Atom[] ca1, Atom[] ca2, Object param, int cp) Aligns ca1 with ca2 permuted by cp residues.double
superimpose and get rmsddouble
CeCalculatorEnhanced.calc_rmsd
(Atom[] pro1, Atom[] pro2, int strLen, boolean storeTransform, boolean show) superimpose and get rmsdvoid
CECalculator.convertAfpChain
(AFPChain afpChain, Atom[] ca1, Atom[] ca2) copy data from this class into AFPChain container object.void
CeCalculatorEnhanced.convertAfpChain
(AFPChain afpChain, Atom[] ca1, Atom[] ca2) copy data from this class into AFPChain container object.static Object
CECalculator.extractFragments
(AFPChain afpChain, Atom[] ca1, Atom[] ca2) CeCalculatorEnhanced.extractFragments
(AFPChain afpChain, Atom[] ca1, Atom[] ca2) static AFPChain
CeCPMain.filterDuplicateAFPs
(AFPChain afpChain, CECalculator ceCalc, Atom[] ca1, Atom[] ca2duplicated) Takes as input an AFPChain where ca2 has been artificially duplicated.static AFPChain
CeCPMain.filterDuplicateAFPs
(AFPChain afpChain, CECalculator ceCalc, Atom[] ca1, Atom[] ca2duplicated, CECPParameters params) static Structure
GuiWrapper.getAlignedStructure
(Atom[] ca1, Atom[] ca2) static Atom[]
double[][]
CECalculator.initSumOfDistances
(int nse1, int nse2, int winSize, int winSizeComb1, Atom[] ca1, Atom[] ca2) double[][]
CeCalculatorEnhanced.initSumOfDistances
(int nse1, int nse2, int winSize, int winSizeComb1, Atom[] ca1, Atom[] ca2) void
void
static AFPChain
CeCPMain.postProcessAlignment
(AFPChain afpChain, Atom[] ca1, Atom[] ca2m, CECalculator calculator) Circular permutation specific code to be run after the standard CE alignmentstatic AFPChain
CeCPMain.postProcessAlignment
(AFPChain afpChain, Atom[] ca1, Atom[] ca2m, CECalculator calculator, CECPParameters param) Circular permutation specific code to be run after the standard CE alignmentstatic void
GuiWrapper.showAlignmentImage
(AFPChain afpChain, Atom[] ca1, Atom[] ca2, Object jmol) void
CECalculator.traceFragmentMatrix
(AFPChain afpChain, Atom[] ca1, Atom[] ca2) void
CeCalculatorEnhanced.traceFragmentMatrix
(AFPChain afpChain, Atom[] ca1, Atom[] ca2) static double[][]
CECalculator.updateMatrixWithSequenceConservation
(double[][] max, Atom[] ca1, Atom[] ca2, CeParameters params) Modifies an alignment matrix by favoring the alignment of similar and identical amino acids and penalizing the alignment of unrelated ones.static double[][]
CeCalculatorEnhanced.updateMatrixWithSequenceConservation
(double[][] max, Atom[] ca1, Atom[] ca2, CeParameters params) Modifies an alignment matrix by favoring the alignment of similar and identical amino acids and penalizing the alignment of unrelated ones. -
Uses of Atom in org.biojava.nbio.structure.align.fatcat
Modifier and TypeMethodDescriptionprotected AFPChain
FatCat.align
(Atom[] ca1, Atom[] ca2, FatCatParameters params, boolean doRigid) FatCat.alignFlexible
(Atom[] ca1, Atom[] ca2, FatCatParameters params) FatCat.alignRigid
(Atom[] ca1, Atom[] ca2) FatCat.alignRigid
(Atom[] ca1, Atom[] ca2, FatCatParameters params) -
Uses of Atom in org.biojava.nbio.structure.align.fatcat.calc
Modifier and TypeMethodDescriptionvoid
FatCatAligner.align
(Atom[] ca1, Atom[] ca2, boolean doRigid, FatCatParameters params) protected static double
AFPChainer.calAfpRmsd
(int afpn, int[] afpPositions, int listStart, AFPChain afpChain, Atom[] ca1, Atom[] ca2) //return the rmsd of the residues from the segments that form the given AFP list //this value can be a measurement (1) for the connectivity of the AFPsstatic void
AFPChainer.doChainAfp
(FatCatParameters params, AFPChain afpChain, Atom[] ca1, Atom[] ca2) static void
AFPCalculator.extractAFPChains
(FatCatParameters params, AFPChain afpChain, Atom[] ca1, Atom[] ca2) static void
AFPOptimizer.optimizeAln
(FatCatParameters params, AFPChain afpChain, Atom[] ca1, Atom[] ca2) optimize the alignment by dynamic programmingstatic void
AFPPostProcessor.postProcess
(FatCatParameters params, AFPChain afpChain, Atom[] ca1, Atom[] ca2) static final void
ModifierConstructorDescriptionStructureAlignmentOptimizer
(int b1, int end1, Atom[] c1, int b2, int end2, Atom[] c2, int iniLen, int[][] iniSet) optimize the structural alignment by update the equivalent residues and then run dynamic programming input: len1 the length of structure 1; c1: the structure information of 1 len2 the length of structure 2; c2: the structure information of 2 iniLen and iniSet is the length and list of initial equivalent residues -
Uses of Atom in org.biojava.nbio.structure.align.gui
Modifier and TypeMethodDescriptionstatic final Atom[]
DisplayAFP.getAtomArray
(Atom[] ca, List<Group> hetatms) Returns the first atom for each groupstatic final Atom
DisplayAFP.getAtomForAligPos
(AFPChain afpChain, int chainNr, int aligPos, Atom[] ca, boolean getPrevious) Return the atom at alignment position aligPos. at the present only works with block 0Modifier and TypeMethodDescriptionstatic Structure
DisplayAFP.createArtificalStructure
(AFPChain afpChain, Atom[] ca1, Atom[] ca2) Create a "fake" Structure objects that contains the two sets of atoms aligned on top of each other.static final StructureAlignmentJmol
DisplayAFP.display
(AFPChain afpChain, Group[] twistedGroups, Atom[] ca1, Atom[] ca2, List<Group> hetatms1, List<Group> hetatms2) Note: ca2, hetatoms2 and nucleotides2 should not be rotated.static StructureAlignmentJmol
Display an AFPChain alignmentstatic final Atom[]
DisplayAFP.getAtomArray
(Atom[] ca, List<Group> hetatms) Returns the first atom for each groupstatic final Atom
DisplayAFP.getAtomForAligPos
(AFPChain afpChain, int chainNr, int aligPos, Atom[] ca, boolean getPrevious) Return the atom at alignment position aligPos. at the present only works with block 0DisplayAFP.getPDBresnum
(int aligPos, AFPChain afpChain, Atom[] ca) Return a list of pdb Strings corresponding to the aligned positions of the molecule.MultipleAlignmentJmolDisplay.getPDBresnum
(int structNum, MultipleAlignment multAln, Atom[] ca) Utility method used in theMultipleAlignmentJmol
Frame, when the aligned residues of a structure in the alignment have to be selected for formatting them (coloring and style).static void
DisplayAFP.showAlignmentPanel
(AFPChain afpChain, Atom[] ca1, Atom[] ca2, AbstractAlignmentJmol jmol) -
Uses of Atom in org.biojava.nbio.structure.align.gui.aligpanel
Modifier and TypeMethodDescriptionAtom[]
AligPanel.getCa1()
Atom[]
StatusDisplay.getCa1()
Atom[]
AligPanel.getCa2()
Atom[]
StatusDisplay.getCa2()
Modifier and TypeMethodDescriptionvoid
void
void
void
ModifierConstructorDescriptionMultipleAligPanel
(AFPChain afpChain, Atom[] ca1, Atom[] ca2, AbstractAlignmentJmol jmol) Constructor using an afpChain and the atom arrays for pairwise alignments. -
Uses of Atom in org.biojava.nbio.structure.align.gui.jmol
Modifier and TypeMethodDescriptionstatic String
StructureAlignmentJmol.getJmolScript4Block
(AFPChain afpChain, Atom[] ca1, Atom[] ca2, int blockNr) static String
StructureAlignmentJmol.getJmolString
(AFPChain afpChain, Atom[] ca1, Atom[] ca2) static final String
JmolTools.getPdbInfo
(Atom a) get jmol style info: jmol style: [MET]508:A.CA/1 #3918 insertion code: [ASP]1^A:A.CA/1 #2static final String
JmolTools.getPdbInfo
(Atom a, boolean printResName) void
Create and set a new structure from a given atom array. -
Uses of Atom in org.biojava.nbio.structure.align.helper
Modifier and TypeMethodDescriptionstatic Atom
Get the centroid for the set of atoms starting from position pos, length fragmentLenghtstatic Atom[]
AlignUtils.getFragment
(Atom[] caall, int pos, int fragmentLength) Get a continue subset of Atoms based by the starting position and the lengthstatic Atom[]
AlignUtils.getFragmentFromIdxList
(Atom[] caall, int[] idx) Get a subset of Atoms based by their positionsstatic Atom[]
AlignUtils.getFragmentNoClone
(Atom[] caall, int pos, int fragmentLength) Get a continue subset of Atoms based by the starting position and the length does not clone the original atoms.Modifier and TypeMethodDescriptionstatic Atom
Get the centroid for the set of atoms starting from position pos, length fragmentLenghtstatic double[]
AlignUtils.getDiagonalAtK
(Atom[] atoms, int k) Get distances along diagonal k from coordinate array coords.static Matrix
AlignUtils.getDistanceMatrix
(Atom[] ca1, Atom[] ca2) Matrix of all distances between two sets of Atoms.static Atom[]
AlignUtils.getFragment
(Atom[] caall, int pos, int fragmentLength) Get a continue subset of Atoms based by the starting position and the lengthstatic Atom[]
AlignUtils.getFragmentFromIdxList
(Atom[] caall, int[] idx) Get a subset of Atoms based by their positionsstatic Atom[]
AlignUtils.getFragmentNoClone
(Atom[] caall, int pos, int fragmentLength) Get a continue subset of Atoms based by the starting position and the length does not clone the original atoms. -
Uses of Atom in org.biojava.nbio.structure.align.model
Modifier and TypeMethodDescriptionvoid
AFPChain.setBlockShiftVector
(Atom[] blockShiftVector) static String
AfpChainWriter.toAlignedPairs
(AFPChain afpChain, Atom[] ca1, Atom[] ca2) Prints the alignment in the simplest form: a list of aligned residues.static String
static String
static String
AfpChainWriter.toFatCatCore
(AFPChain afpChain, Atom[] ca1, Atom[] ca2, boolean printLegend, boolean longHeader, boolean showHTML, boolean showAlignmentBlock) Output in FatCatCore formatstatic String
AfpChainWriter.toPrettyAlignment
(AFPChain afpChain, Atom[] ca1, Atom[] ca2, boolean showHTML, boolean showAlignmentBlock) static String
AfpChainWriter.toWebSiteDisplay
(AFPChain afpChain, Atom[] ca1, Atom[] ca2) Prints the afpChain as a nicely formatted alignment, including alignment statistics, the aligned sequences themselves, and information about the superposition.static String
AfpChainWriter.toWebSiteDisplay
(AFPChain afpChain, Atom[] ca1, Atom[] ca2, boolean showAlignmentBlock) Prints the afpChain as a nicely formatted alignment, including alignment statistics, the aligned sequences themselves, and information about the superposition. -
Uses of Atom in org.biojava.nbio.structure.align.multiple
ModifierConstructorDescriptionMultipleAlignmentEnsembleImpl
(AFPChain afp, Atom[] ca1, Atom[] ca2, boolean flexible) Constructor from an AFPChain instance. -
Uses of Atom in org.biojava.nbio.structure.align.multiple.util
Modifier and TypeMethodDescriptionstatic Atom
MultipleAlignmentTools.getAtomForSequencePosition
(MultipleAlignment msa, List<Integer> mapSeqToStruct, int str, int sequencePos) Returns the Atom of the specified structure that is aligned in the sequence alignment position specified. -
Uses of Atom in org.biojava.nbio.structure.align.pairwise
Modifier and TypeMethodDescriptionFragmentPair.getCenter1()
FragmentPair.getCenter2()
AlternativeAlignment.getShift()
returns the shift vector that has to be applied on structure to to shift on structure oneFragmentPair.getTrans()
FragmentPair.getUnitv()
Modifier and TypeMethodDescriptionFragmentJoiner.approach_ap3
(Atom[] ca1, Atom[] ca2, FragmentPair[] fraglst, StrucAligParameters params) void
AlternativeAlignment.calcScores
(Atom[] ca1, Atom[] ca2) calculates scores for this alignment ( %id )void
AlternativeAlignment.calculateSuperpositionByIdx
(Atom[] ca1, Atom[] ca2) void
FragmentJoiner.extendFragments
(Atom[] ca1, Atom[] ca2, JointFragments[] fragments, StrucAligParameters params) void
FragmentJoiner.extendFragments
(Atom[] ca1, Atom[] ca2, JointFragments fragments, StrucAligParameters params) void
AlternativeAlignment.finish
(StrucAligParameters params, Atom[] ca1, Atom[] ca2) static Matrix
AlternativeAlignment.getDistanceMatrix
(Atom[] ca1, Atom[] ca2) static double
FragmentJoiner.getRMS
(Atom[] ca1, Atom[] ca2, JointFragments frag) Get the RMS of the JointFragments pair fragvoid
AlternativeAlignment.refine
(StrucAligParameters params, Atom[] ca1, Atom[] ca2) Refinement procedure based on superposition and dynamic programming.void
FragmentPair.setCenter1
(Atom center1) void
FragmentPair.setCenter2
(Atom center2) void
void
void
AlignmentProgressListener.startingAlignment
(String name1, Atom[] ca1, String name2, Atom[] ca2) -
Uses of Atom in org.biojava.nbio.structure.align.quaternary
Modifier and TypeMethodDescriptionAtom[]
QsAlignResult.getAlignedAtomsForSubunits1
(int index) Atom[]
QsAlignResult.getAlignedAtomsForSubunits2
(int index) -
Uses of Atom in org.biojava.nbio.structure.align.seq
-
Uses of Atom in org.biojava.nbio.structure.align.util
Modifier and TypeMethodDescriptionstatic Atom[]
AFPAlignmentDisplay.getAlignedAtoms1
(AFPChain afpChain, Atom[] ca1) static Atom[]
AFPAlignmentDisplay.getAlignedAtoms2
(AFPChain afpChain, Atom[] ca2) Atom[]
Returns the CA atoms for the provided name.Atom[]
AtomCache.getAtoms
(StructureIdentifier name) RotationAxis.getProjectedPoint
(Atom point) Projects a given point onto the axis of rotationAtom[]
AtomCache.getRepresentativeAtoms
(String name) Returns the representative atoms for the provided name.Atom[]
AtomCache.getRepresentativeAtoms
(StructureIdentifier name) RotationAxis.getRotationAxis()
Get a unit vector along the rotation axisRotationAxis.getRotationPos()
Get a position on the rotation axis.RotationAxis.getScrewTranslation()
Get the component of translation parallel to the axis of rotationstatic Atom
AFPAlignmentDisplay.getTranslation
(AFPChain afpChain, Atom[] ca1, Atom[] ca2) Modifier and TypeMethodDescriptionRotationAxis.getAxisEnds
(Atom[] atoms) Find a segment of the axis that covers the specified set of atoms.Modifier and TypeMethodDescriptionstatic void
AlignmentTools.alignmentToSIF
(Writer out, AFPChain afpChain, Atom[] ca1, Atom[] ca2, String backboneInteraction, String alignmentInteraction) Creates a simple interaction format (SIF) file for an alignment.static AFPChain
AlignmentTools.createAFPChain
(Atom[] ca1, Atom[] ca2, ResidueNumber[] aligned1, ResidueNumber[] aligned2) Fundamentally, an alignment is just a list of aligned residues in each protein.static Structure
AFPAlignmentDisplay.createArtificalStructure
(AFPChain afpChain, Atom[] ca1, Atom[] ca2) static AFPChain
AlignmentTools.deleteColumn
(AFPChain afpChain, Atom[] ca1, Atom[] ca2, int block, int pos) Delete an alignment position from the original alignment object.static AFPChain
AlignmentTools.deleteHighestDistanceColumn
(AFPChain afpChain, Atom[] ca1, Atom[] ca2) Find the alignment position with the highest atomic distance between the equivalent atomic positions of the arrays and remove it from the alignment.static void
AlignmentTools.fillAlignedAtomArrays
(AFPChain afpChain, Atom[] ca1, Atom[] ca2, Atom[] ca1aligned, Atom[] ca2aligned) Fill the aligned Atom arrays with the equivalent residues in the afpChain.static void
Extract the alignment outputstatic void
static Atom[]
AFPAlignmentDisplay.getAlignedAtoms1
(AFPChain afpChain, Atom[] ca1) static Atom[]
AFPAlignmentDisplay.getAlignedAtoms2
(AFPChain afpChain, Atom[] ca2) AlignmentTools.getAlignedModel
(Atom[] ca) get an artificial List of chains containing the Atoms and groups.static final Structure
AlignmentTools.getAlignedStructure
(Atom[] ca1, Atom[] ca2) Get an artifical Structure containing both chains.RotationAxis.getAxisEnds
(Atom[] atoms) Find a segment of the axis that covers the specified set of atoms.RotationAxis.getJmolScript
(Atom[] atoms) Returns a Jmol script which will display the axis of rotation.RotationAxis.getJmolScript
(Atom[] atoms, int axisID) Returns a Jmol script which will display the axis of rotation.double
RotationAxis.getProjectedDistance
(Atom point) Get the distance from a point to the axis of rotationRotationAxis.getProjectedPoint
(Atom point) Projects a given point onto the axis of rotationstatic Matrix
static double
AFPChainScorer.getTMScore
(AFPChain align, Atom[] ca1, Atom[] ca2) static double
AFPChainScorer.getTMScore
(AFPChain align, Atom[] ca1, Atom[] ca2, boolean normalizeMin) static Atom
AFPAlignmentDisplay.getTranslation
(AFPChain afpChain, Atom[] ca1, Atom[] ca2) static Group[]
AlignmentTools.prepareGroupsForDisplay
(AFPChain afpChain, Atom[] ca1, Atom[] ca2) Rotate the Atoms/Groups so they are aligned for the 3D visualisationstatic AFPChain
AlignmentTools.replaceOptAln
(int[][][] newAlgn, AFPChain afpChain, Atom[] ca1, Atom[] ca2) It replaces an optimal alignment of an AFPChain and calculates all the new alignment scores and variables.static AFPChain
AlignmentTools.replaceOptAln
(AFPChain afpChain, Atom[] ca1, Atom[] ca2, int blockNum, int[] optLens, int[][][] optAln) static AFPChain
AlignmentTools.replaceOptAln
(AFPChain afpChain, Atom[] ca1, Atom[] ca2, Map<Integer, Integer> alignment) Takes an AFPChain and replaces the optimal alignment based on an alignment mapvoid
static void
only shift CA positions.static AFPChain
AlignmentTools.splitBlocksByTopology
(AFPChain a, Atom[] ca1, Atom[] ca2) static void
AlignmentTools.updateSuperposition
(AFPChain afpChain, Atom[] ca1, Atom[] ca2) After the alignment changes (optAln, optLen, blockNum, at a minimum), many other properties which depend on the superposition will be invalid.ModifierConstructorDescriptionRotationAxis
(Atom axis, Atom pos, double theta) Create a rotation axis from a vector, a point, and an angle.RotationAxis
(Matrix rotation, Atom translation) Determine the location of the rotation axis based on a rotation matrix and a translation vector -
Uses of Atom in org.biojava.nbio.structure.align.xml
Modifier and TypeMethodDescriptionstatic AFPChain
new utility method that checks that the order of the pair in the XML alignment is correct and flips the direction if neededstatic AFPChain
static void
AFPChainXMLConverter.printXMLEQRInferPositions
(PrettyXMLWriter xml, AFPChain afpChain, int bk, Atom[] ca1, Atom[] ca2) static void
AFPChainXMLParser.rebuildAFPChain
(AFPChain afpChain, Atom[] ca1, Atom[] ca2) replace the PDB res nums with atom positions:static void
AFPChainXMLConverter.toXML
(AFPChain afpChain, StringWriter swriter, Atom[] ca1, Atom[] ca2) Write the XML representation to a StringWriterstatic String
Convert an afpChain to a simple XML representation -
Uses of Atom in org.biojava.nbio.structure.asa
Modifier and TypeMethodDescriptionstatic double
Gets the van der Waals radius of the given atom following the values defined by Chothia (1976) J.Mol.Biol.105,1-14 NOTE: the vdw values defined by the paper assume no Hydrogens and thus "inflates" slightly the heavy atoms to account for Hydrogens.ModifierConstructorDescriptionAsaCalculator
(Atom[] atoms, double probe, int nSpherePoints, int nThreads) Constructs a new AsaCalculator. -
Uses of Atom in org.biojava.nbio.structure.cluster
Modifier and TypeMethodDescriptionAtom[]
SubunitCluster.getAlignedAtomsSubunit
(int index) Atom[]
Subunit.getRepresentativeAtoms()
Get all the representative Atoms of the Subunit.ModifierConstructorDescriptionSubunit
(Atom[] reprAtoms, String name, StructureIdentifier identifier, Structure structure) A Subunit is solely defined by the coordinates of the representative Atoms of its residues. -
Uses of Atom in org.biojava.nbio.structure.contact
Modifier and TypeMethodDescriptionprotected Atom[]
StructureInterface.getAtomsForAsa
(int cofactorSizeToUse) protected Atom[]
StructureInterface.getFirstAtomsForAsa
(int cofactorSizeToUse) protected Atom[]
StructureInterface.getSecondAtomsForAsa
(int cofactorSizeToUse) Modifier and TypeMethodDescriptionvoid
Adds a set of atoms, subsequent call toGrid.getIndicesContacts()
orGrid.getAtomContacts()
will produce the interatomic contacts.void
Adds the i and j atoms and fills the grid.void
Grid.addAtoms
(Atom[] atoms, BoundingBox bounds) Adds a set of atoms, subsequent call toGrid.getIndicesContacts()
orGrid.getAtomContacts()
will produce the interatomic contacts.void
Grid.addAtoms
(Atom[] iAtoms, BoundingBox icoordbounds, Atom[] jAtoms, BoundingBox jcoordbounds) Adds the i and j atoms and fills the grid, passing their bounds (array of size 6 with x,y,z minima and x,y,z maxima) This way the bounds don't need to be recomputed.AtomContactSet.getContact
(Atom atom1, Atom atom2) Returns the corresponding AtomContact or null if no contact exists between the 2 given atomsboolean
AtomContactSet.hasContact
(Atom atom1, Atom atom2) ModifierConstructorDescriptionStructureInterface
(Atom[] firstMolecule, Atom[] secondMolecule, String firstMoleculeId, String secondMoleculeId, AtomContactSet contacts, CrystalTransform firstTransf, CrystalTransform secondTransf) Constructs a StructureInterface -
Uses of Atom in org.biojava.nbio.structure.domain
Modifier and TypeMethodDescriptionLocalProteinDomainParser.suggestDomains
(Atom[] ca) Suggest domains for a set of Calpha atoms -
Uses of Atom in org.biojava.nbio.structure.domain.pdp
Modifier and TypeMethodDescriptionint
Cut.cut
(Atom[] ca, Domain dom, CutValues val, int[][] dist, PDPDistanceMatrix pdpMatrix) GetDistanceMatrix.getDistanceMatrix
(Atom[] protein) A set of Calpha atoms that are representing the protein -
Uses of Atom in org.biojava.nbio.structure.io
Modifier and TypeMethodDescriptionstatic String
Prints the content of an Atom object as a PDB formatted line.static String
static void
FileConvert.toPDB
(Atom a, StringBuffer str) static void
FileConvert.toPDB
(Atom a, StringBuffer str, String chainID) Print ATOM record in the following syntax -
Uses of Atom in org.biojava.nbio.structure.io.cif
ModifierConstructorDescriptionWrappedAtom
(int model, String chainName, String chainId, Atom atom, int atomId) Construct a new atoms. -
Uses of Atom in org.biojava.nbio.structure.io.mmtf
Modifier and TypeMethodDescriptionMmtfSummaryDataBean.getAllAtoms()
MmtfUtils.getAtomsForGroup
(Group inputGroup) Get a list of atoms for a group.Modifier and TypeMethodDescriptionstatic int
MmtfUtils.getNumBondsInGroup
(List<Atom> atomsInGroup) Find the number of bonds in a groupvoid
MmtfSummaryDataBean.setAllAtoms
(List<Atom> allAtoms) -
Uses of Atom in org.biojava.nbio.structure.symmetry.internal
Modifier and TypeMethodDescriptionprotected static CeSymmResult
CeSymm.align
(Atom[] atoms, CESymmParameters params) static CeSymmResult
Analyze the symmetries of the input Atom array using the DEFAULT parameters.static CeSymmResult
CeSymm.analyze
(Atom[] atoms, CESymmParameters params) Analyze the symmetries of the input Atom array using the provided parameters.static CeSymmResult
CeSymm.analyzeLevel
(Atom[] atoms, CESymmParameters params) Analyze a single level of symmetry.int
AngleOrderDetectorPlus.calculateOrder
(AFPChain afpChain, Atom[] ca) int
GraphComponentOrderDetector.calculateOrder
(AFPChain selfAlignment, Atom[] ca) int
OrderDetector.calculateOrder
(AFPChain afpChain, Atom[] ca) int
SequenceFunctionOrderDetector.calculateOrder
(AFPChain afpChain, Atom[] ca) This method uses iteratively CeSymm to calculate all symmetries in the input array of atoms and organize them in a multiple alignment of the repeats.Returns a refined symmetry alignment, where the repeat residues are aligned consistently in a MultipleAlignment.static AFPChain
SequenceFunctionRefiner.refineSymmetry
(AFPChain afpChain, Atom[] ca1, Atom[] ca2, int k) Refines a CE-Symm alignment so that it is perfectly symmetric.void
-
Uses of Atom in org.biojava.nbio.structure.symmetry.utils
Modifier and TypeMethodDescriptionstatic Atom[]
SymmetryTools.getRepresentativeAtoms
(Structure structure) Returns the representative Atom Array of the first model, if the structure is NMR, or the Array for each model, if it is a biological assembly with multiple models.Modifier and TypeMethodDescriptionstatic boolean[][]
SymmetryTools.blankOutBreakFlag
(AFPChain afpChain, Atom[] ca2, int rows, int cols, CECalculator calculator, boolean[][] breakFlag, int blankWindowSize) static Matrix
SymmetryTools.blankOutCEOrig
(Atom[] ca2, int rows, int cols, CECalculator calculator, Matrix origM, int blankWindowSize) static Matrix
SymmetryTools.blankOutPreviousAlignment
(AFPChain afpChain, Atom[] ca2, int rows, int cols, CECalculator calculator, Matrix max, int blankWindowSize) SymmetryTools.buildSymmetryGraph
(List<AFPChain> afps, Atom[] atoms, boolean undirected) Converts a set of AFP alignments into a Graph of aligned residues, where each vertex is a residue and each edge means the connection between the two residues in one of the alignments.static MultipleAlignment
Converts a refined symmetry AFPChain alignment into the standard representation of symmetry in a MultipleAlignment, that contains the entire Atom array of the strcuture and the symmetric repeats are orgaized in different rows in a single Block.static double
Returns the magnitude of the angle between the first and second blocks ofafpChain
, measured in degrees.SymmetryTools.getDkMatrix
(Atom[] ca1, Atom[] ca2, int fragmentLength, double[] dist1, double[] dist2, int rows, int cols) static Matrix
SymmetryTools.getDkMatrix
(Atom[] ca1, Atom[] ca2, int k, int fragmentLength) Returns the List of Groups of the corresponding representative Atom array.static Matrix
SymmetryTools.grayOutCEOrig
(Atom[] ca2, int rows, int cols, CECalculator calculator, Matrix origM, int blankWindowSize, double[] gradientPolyCoeff, double gradientExpCoeff) Grays out the main diagonal of a duplicated distance matrix.static Matrix
SymmetryTools.grayOutPreviousAlignment
(AFPChain afpChain, Atom[] ca2, int rows, int cols, CECalculator calculator, Matrix max, int blankWindowSize, double[] gradientPolyCoeff, double gradientExpCoeff)