Uses of Interface
org.biojava.nbio.structure.Atom
- 
- 
Uses of Atom in org.biojava.nbio.protmod.structureMethods in org.biojava.nbio.protmod.structure that return Atom Modifier and Type Method Description static 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.Methods in org.biojava.nbio.protmod.structure with parameters of type Atom Modifier and Type Method Description static doubleStructureUtil. getAtomDistance(Atom atom1, Atom atom2)static StructureAtomStructureUtil. getStructureAtom(Atom atom, boolean isParentAminoAcid)static StructureAtomLinkageStructureUtil. getStructureAtomLinkage(Atom atom1, boolean isParentAminoAcid1, Atom atom2, boolean isParentAminoAcid2)
- 
Uses of Atom in org.biojava.nbio.structureClasses in org.biojava.nbio.structure that implement Atom Modifier and Type Class Description classAtomImplImplementation of an Atom of a PDB file.Fields in org.biojava.nbio.structure with type parameters of type Atom Modifier and Type Field Description protected List<Atom>HetatomImpl. atomsMethods in org.biojava.nbio.structure that return Atom Modifier and Type Method Description static AtomCalc. add(Atom a, Atom b)add two atoms ( a + b).static Atom[]Calc. centerAtoms(Atom[] atomSet)Center the atoms at the Centroid.static Atom[]Calc. centerAtoms(Atom[] atomSet, Atom centroid)Center the atoms at the Centroid, if the centroid is already know.static AtomCalc. 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 AtomCalc. 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 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.AtomGroup. getAtom(int position)Get at atom by position.AtomGroup. getAtom(String name)Get an atom given its PDB name.AtomHetatomImpl. getAtom(int position)Get at atom by position.AtomHetatomImpl. getAtom(String name)Get an atom given its PDB name.AtomBond. getAtomA()Gets atom 'A' of this bond.AtomBondImpl. 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.AtomBond. getAtomB()Gets atom 'B' of this bond.AtomBondImpl. 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 notAtomAminoAcid. getC()Get C atom.AtomAminoAcidImpl. getC()Get C atom.AtomAminoAcid. getCA()Get CA atom.AtomAminoAcidImpl. getCA()Get CA atom.AtomAminoAcid. getCB()Get CB atom.AtomAminoAcidImpl. getCB()Get CB atom.static AtomCalc. getCenterVector(Atom[] atomSet)Returns the Vector that needs to be applied to shift a set of atoms to the Centroid.static AtomCalc. 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 AtomCalc. getCentroid(Atom[] atomSet)Returns the centroid of the set of atoms.AtomAminoAcid. getN()Get N atom.AtomAminoAcidImpl. getN()Get N atom.AtomAminoAcid. getO()Get O atom.AtomAminoAcidImpl. getO()Get O atom.AtomNucleotideImpl. getO3Prime()Returns the O3' atom if present, otherwise nullAtomNucleotideImpl. getO5Prime()Returns the O5' atom if present, otherwise nullAtomBond. getOther(Atom exclude)A utility method to get the other atom in a bond, given one of its atoms.AtomBondImpl. getOther(Atom exclude)A utility method to get the other atom in a bond, given one of its atoms.AtomNucleotideImpl. 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 AtomCalc. getTranslationVector(javax.vecmath.Matrix4d transform)Extract the translational vector as an Atom of a transformation matrix.static AtomCalc. invert(Atom a)AtomAtomIterator. next()Return next atom.static AtomCalc. scale(Atom a, double s)Multiply elements of a by sstatic AtomCalc. scaleAdd(double s, Atom x, Atom b)Perform linear transformation s*X+B, and store the result in bstatic AtomCalc. scaleEquals(Atom a, double s)Multiply elements of a by s (in place)static AtomCalc. subtract(Atom a, Atom b)subtract two atoms ( a - b).static AtomCalc. unitVector(Atom a)Returns the unit vector of vector a .static AtomCalc. vectorProduct(Atom a, Atom b)Vector product (cross product).Methods in org.biojava.nbio.structure that return types with arguments of type Atom Modifier and Type Method Description List<Atom>Group. getAtoms()Get list of atoms.List<Atom>HetatomImpl. getAtoms()Get list of atoms.Iterator<Atom>Group. iterator()Get an Atom Iterator.Iterator<Atom>HetatomImpl. iterator()return an AtomIterator.Methods in org.biojava.nbio.structure with parameters of type Atom Modifier and Type Method Description static AtomCalc. add(Atom a, Atom b)add two atoms ( a + b).voidGroup. addAtom(Atom atom)Add an atom to this group.voidHetatomImpl. addAtom(Atom atom)Add an atom to this group.static doubleCalc. amount(Atom a)Gets the length of the vector (2-norm)static doubleCalc. angle(Atom a, Atom b)Gets the angle between two vectorsstatic javax.vecmath.Point3d[]Calc. atomsToPoints(Atom[] atoms)Convert an array of atoms into an array of vecmath pointsstatic doubleCalc. calcRotationAngleInDegrees(Atom centerPt, Atom targetPt)Calculates the angle from centerPt to targetPt in degrees.static Atom[]Calc. centerAtoms(Atom[] atomSet)Center the atoms at the Centroid.static Atom[]Calc. centerAtoms(Atom[] atomSet, Atom centroid)Center the atoms at the Centroid, if the centroid is already know.static AtomCalc. 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 StringStructureTools. convertAtomsToSeq(Atom[] atoms)static Atom[]StructureTools. duplicateCA2(Atom[] ca2)Utility method for working with circular permutations.static Set<Group>StructureTools. getAllGroupsFromSubset(Atom[] atoms)Expand a set of atoms into all groups from the same structure.static Set<Group>StructureTools. getAllGroupsFromSubset(Atom[] atoms, GroupType types)Expand a set of atoms into all groups from the same structure.static AtomCalc. getCenterVector(Atom[] atomSet)Returns the Vector that needs to be applied to shift a set of atoms to the Centroid.static AtomCalc. 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 AtomCalc. getCentroid(Atom[] atomSet)Returns the centroid of the set of atoms.static doubleCalc. getDistance(Atom a, Atom b)calculate distance between two atoms.static doubleCalc. getDistanceFast(Atom a, Atom b)Will calculate the square of distances between two atoms.static Map<Group,Double>StructureTools. getGroupDistancesWithinShell(Structure structure, Atom centroid, Set<ResidueNumber> excludeResidues, double radius, boolean includeWater, boolean useAverageDistance)Finds Groups instructurethat contain at least one Atom that is withinradiusAngstroms ofcentroid.static Set<Group>StructureTools. getGroupsWithinShell(Structure structure, Atom atom, Set<ResidueNumber> excludeResidues, double distance, boolean includeWater)static List<Group>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.AtomBond. getOther(Atom exclude)A utility method to get the other atom in a bond, given one of its atoms.AtomBondImpl. getOther(Atom exclude)A utility method to get the other atom in a bond, given one of its atoms.static doubleCalc. getTMScore(Atom[] atomSet1, Atom[] atomSet2, int len1, int len2)Calculate the TM-Score for the superposition.static doubleCalc. getTMScore(Atom[] atomSet1, Atom[] atomSet2, int len1, int len2, boolean normalizeMin)Calculate the TM-Score for the superposition.static javax.vecmath.Matrix4dCalc. getTransformation(Matrix rot, Atom trans)Convert JAMA rotation and translation to a Vecmath transformation matrix.static List<Group>StructureTools. getUnalignedGroups(Atom[] ca)List of groups from the structure not included in ca (e.g. ligands).booleanAtom. hasBond(Atom other)Test if another atom has a bond to this atombooleanAtomImpl. hasBond(Atom other)Test if another atom has a bond to this atomstatic booleanStructureTools. hasDeuteratedEquiv(Atom atom, Group currentGroup)Check to see if a Hydrogen has a Deuterated brother in the group.static booleanStructureTools. hasNonDeuteratedEquiv(Atom atom, Group currentGroup)Check to see if an Deuterated atom has a non deuterated brother in the group.static AtomCalc. invert(Atom a)static doubleCalc. rmsd(Atom[] x, Atom[] y)Calculate the RMSD of two Atom arrays, already superposed.static voidCalc. rotate(Atom[] ca, Matrix matrix)static voidCalc. rotate(Atom atom, double[][] m)Rotate a single Atom aroud a rotation matrix.static voidCalc. rotate(Atom atom, Matrix m)Rotate an Atom around a Matrix object.static doubleCalc. scalarProduct(Atom a, Atom b)Scalar product (dot product).static AtomCalc. scale(Atom a, double s)Multiply elements of a by sstatic AtomCalc. scaleAdd(double s, Atom x, Atom b)Perform linear transformation s*X+B, and store the result in bstatic AtomCalc. scaleEquals(Atom a, double s)Multiply elements of a by s (in place)static voidCalc. shift(Atom[] ca, Atom b)Shift an array of atoms at once.static voidCalc. shift(Atom a, Atom b)Shift a vector.static voidCalc. shift(Group group, Atom a)Shift a Group with a vector.static voidCalc. shift(Structure structure, Atom a)shift a structure with a vector.static AtomCalc. subtract(Atom a, Atom b)subtract two atoms ( a - b).static doubleCalc. 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 voidCalc. transform(Atom[] ca, javax.vecmath.Matrix4d t)Transform an array of atoms at once.static voidCalc. transform(Atom atom, javax.vecmath.Matrix4d m)Transforms an atom object, given a Matrix4d (i.e. the vecmath library double-precision 4x4 rotation+translation matrix).static voidCalc. translate(Atom atom, javax.vecmath.Vector3d v)Translates an atom object, given a Vector3d (i.e. the vecmath library double-precision 3-d vector)static AtomCalc. unitVector(Atom a)Returns the unit vector of vector a .static AtomCalc. vectorProduct(Atom a, Atom b)Vector product (cross product).Method parameters in org.biojava.nbio.structure with type arguments of type Atom Modifier and Type Method Description static List<javax.vecmath.Point3d>Calc. atomsToPoints(Collection<Atom> atoms)Convert an array of atoms into an array of vecmath pointsvoidGroup. setAtoms(List<Atom> atoms)Set the atoms of this group.voidHetatomImpl. setAtoms(List<Atom> atoms)Set the atoms of this group.Constructors in org.biojava.nbio.structure with parameters of type Atom Constructor Description AtomPositionMap(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.BondImpl(Atom atomA, Atom atomB, int bondOrder)Constructs a new bond from a pair of atoms and the bond order of the bond between them.BondImpl(Atom atomA, Atom atomB, int bondOrder, boolean addSelfToAtoms)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.alignMethods in org.biojava.nbio.structure.align that return Atom Modifier and Type Method Description Atom[]StructurePairAligner. getAlignmentAtoms(Structure s)Returns the atoms that are being used for the alignment.Atom[]CallableStructureAlignment. getCa1()Methods in org.biojava.nbio.structure.align with parameters of type Atom Modifier and Type Method Description abstract AFPChainAbstractStructureAlignment. align(Atom[] ca1, Atom[] ca2)abstract AFPChainAbstractStructureAlignment. align(Atom[] ca1, Atom[] ca2, Object params)AFPChainBioJavaStructureAlignment. align(Atom[] ca1, Atom[] ca2)AFPChainBioJavaStructureAlignment. align(Atom[] ca1, Atom[] ca2, Object params)AFPChainStructureAlignment. align(Atom[] ca1, Atom[] ca2)Run an alignment while specifying the atoms to be aligned.AFPChainStructureAlignment. align(Atom[] ca1, Atom[] ca2, Object params)run an alignment and also send a bean containing the parameters.voidStructurePairAligner. align(Atom[] ca1, Atom[] ca2, StrucAligParameters params)calculate the protein structure superimposition, between two sets of atoms.voidCallableStructureAlignment. setCa1(Atom[] ca1)static Group[]AFPTwister. twistOptimized(AFPChain afpChain, Atom[] ca1, Atom[] ca2)superimposing according to the optimized alignmentstatic Group[]AFPTwister. twistPDB(AFPChain afpChain, Atom[] ca1, Atom[] ca2)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 BConstructors in org.biojava.nbio.structure.align with parameters of type Atom Constructor Description CallableStructureAlignment(Atom[] ca1, Atom[] ca2, String algorithmName, ConfigStrucAligParams params)Constructor for all-to-all alignment calculation.
- 
Uses of Atom in org.biojava.nbio.structure.align.ceMethods in org.biojava.nbio.structure.align.ce that return Atom Modifier and Type Method Description static Atom[]GuiWrapper. getAtomArray(Atom[] ca, List<Group> hetatoms, List<Group> nucs)AtomCECalculator. getShift()Gets the shift from the last call tocalc_rmsd.AtomCeCalculatorEnhanced. getShift()Gets the shift from the last call tocalc_rmsd.Methods in org.biojava.nbio.structure.align.ce with parameters of type Atom Modifier and Type Method Description AFPChainCeCPMain. align(Atom[] ca1, Atom[] ca2, Object param)Aligns ca1 and ca2 using a heuristic to check for CPs.AFPChainCeMain. align(Atom[] ca1, Atom[] ca2)AFPChainCeMain. align(Atom[] ca1, Atom[] ca2, Object param)Align ca2 onto ca1.AFPChainOptimalCECPMain. align(Atom[] ca1, Atom[] ca2, Object param)Finds the optimal alignment between two proteins allowing for a circular permutation (CP).AFPChainOptimalCECPMain. alignOptimal(Atom[] ca1, Atom[] ca2, Object param, AFPChain[] alignments)Finds the optimal alignment between two proteins allowing for a circular permutation (CP).AFPChainOptimalCECPMain. alignPermuted(Atom[] ca1, Atom[] ca2, Object param, int cp)Aligns ca1 with ca2 permuted by cp residues.doubleCECalculator. calc_rmsd(Atom[] pro1, Atom[] pro2, int strLen, boolean storeTransform)superimpose and get rmsddoubleCeCalculatorEnhanced. calc_rmsd(Atom[] pro1, Atom[] pro2, int strLen, boolean storeTransform, boolean show)superimpose and get rmsdvoidCECalculator. convertAfpChain(AFPChain afpChain, Atom[] ca1, Atom[] ca2)copy data from this class into AFPChain container object.voidCeCalculatorEnhanced. convertAfpChain(AFPChain afpChain, Atom[] ca1, Atom[] ca2)copy data from this class into AFPChain container object.static ObjectGuiWrapper. display(AFPChain afpChain, Atom[] ca1, Atom[] ca2)AFPChainCECalculator. extractFragments(AFPChain afpChain, Atom[] ca1, Atom[] ca2)AFPChainCeCalculatorEnhanced. extractFragments(AFPChain afpChain, Atom[] ca1, Atom[] ca2)static AFPChainCeCPMain. filterDuplicateAFPs(AFPChain afpChain, CECalculator ceCalc, Atom[] ca1, Atom[] ca2duplicated)Takes as input an AFPChain where ca2 has been artificially duplicated.static AFPChainCeCPMain. filterDuplicateAFPs(AFPChain afpChain, CECalculator ceCalc, Atom[] ca1, Atom[] ca2duplicated, CECPParameters params)static StructureGuiWrapper. getAlignedStructure(Atom[] ca1, Atom[] ca2)static Atom[]GuiWrapper. getAtomArray(Atom[] ca, List<Group> hetatoms, List<Group> nucs)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)voidCECalculator. nextStep(AFPChain afpChain, Atom[] ca1, Atom[] ca2)voidCeCalculatorEnhanced. nextStep(AFPChain afpChain, Atom[] ca1, Atom[] ca2)static AFPChainCeCPMain. postProcessAlignment(AFPChain afpChain, Atom[] ca1, Atom[] ca2m, CECalculator calculator)Circular permutation specific code to be run after the standard CE alignmentstatic AFPChainCeCPMain. postProcessAlignment(AFPChain afpChain, Atom[] ca1, Atom[] ca2m, CECalculator calculator, CECPParameters param)Circular permutation specific code to be run after the standard CE alignmentstatic voidGuiWrapper. showAlignmentImage(AFPChain afpChain, Atom[] ca1, Atom[] ca2, Object jmol)voidCECalculator. traceFragmentMatrix(AFPChain afpChain, Atom[] ca1, Atom[] ca2)voidCeCalculatorEnhanced. 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.clientMethods in org.biojava.nbio.structure.align.client with parameters of type Atom Modifier and Type Method Description static AFPChainJFatCatClient. getAFPChainFromServer(String serverLocation, String method, String name1, String name2, Atom[] ca1, Atom[] ca2, int timeout)static AFPChainJFatCatClient. getAFPChainFromServer(String serverLocation, String name1, String name2, Atom[] ca1, Atom[] ca2)static voidJFatCatClient. sendAFPChainToServer(String serverLocation, AFPChain afpChain, Atom[] ca1, Atom[] ca2)
- 
Uses of Atom in org.biojava.nbio.structure.align.fatcatMethods in org.biojava.nbio.structure.align.fatcat with parameters of type Atom Modifier and Type Method Description protected AFPChainFatCat. align(Atom[] ca1, Atom[] ca2, FatCatParameters params, boolean doRigid)AFPChainFatCatFlexible. align(Atom[] ca1, Atom[] ca2)AFPChainFatCatFlexible. align(Atom[] ca1, Atom[] ca2, Object param)AFPChainFatCatRigid. align(Atom[] ca1, Atom[] ca2)AFPChainFatCatRigid. align(Atom[] ca1, Atom[] ca2, Object param)AFPChainFatCat. alignFlexible(Atom[] ca1, Atom[] ca2, FatCatParameters params)AFPChainFatCat. alignRigid(Atom[] ca1, Atom[] ca2)AFPChainFatCat. alignRigid(Atom[] ca1, Atom[] ca2, FatCatParameters params)
- 
Uses of Atom in org.biojava.nbio.structure.align.fatcat.calcMethods in org.biojava.nbio.structure.align.fatcat.calc with parameters of type Atom Modifier and Type Method Description voidFatCatAligner. align(Atom[] ca1, Atom[] ca2, boolean doRigid, FatCatParameters params)protected static doubleAFPChainer. 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 voidAFPChainer. doChainAfp(FatCatParameters params, AFPChain afpChain, Atom[] ca1, Atom[] ca2)// Key function: chain (assembly) the AFPs // a AFP (k) is defined as (i, j, k), with i and j are staring points // AFP extension (eg.static voidAFPCalculator. extractAFPChains(FatCatParameters params, AFPChain afpChain, Atom[] ca1, Atom[] ca2)static voidAFPOptimizer. optimizeAln(FatCatParameters params, AFPChain afpChain, Atom[] ca1, Atom[] ca2)optimize the alignment by dynamic programmingstatic voidAFPPostProcessor. postProcess(FatCatParameters params, AFPChain afpChain, Atom[] ca1, Atom[] ca2)static voidAFPCalculator. sortAfps(AFPChain afpChain, Atom[] ca1, Atom[] ca2)Constructors in org.biojava.nbio.structure.align.fatcat.calc with parameters of type Atom Constructor Description StructureAlignmentOptimizer(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.guiMethods in org.biojava.nbio.structure.align.gui that return Atom Modifier and Type Method Description static Atom[]DisplayAFP. getAtomArray(Atom[] ca, List<Group> hetatms)Returns the first atom for each groupstatic AtomDisplayAFP. 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 0Methods in org.biojava.nbio.structure.align.gui with parameters of type Atom Modifier and Type Method Description static StructureDisplayAFP. 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 StructureAlignmentJmolDisplayAFP. 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 StructureAlignmentJmolStructureAlignmentDisplay. display(AFPChain afpChain, Atom[] ca1, Atom[] ca2)Display an AFPChain alignmentstatic Atom[]DisplayAFP. getAtomArray(Atom[] ca, List<Group> hetatms)Returns the first atom for each groupstatic AtomDisplayAFP. 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 0static List<String>DisplayAFP. getPDBresnum(int aligPos, AFPChain afpChain, Atom[] ca)Return a list of pdb Strings corresponding to the aligned positions of the molecule.static List<String>MultipleAlignmentJmolDisplay. getPDBresnum(int structNum, MultipleAlignment multAln, Atom[] ca)Utility method used in theMultipleAlignmentJmolFrame, when the aligned residues of a structure in the alignment have to be selected for formatting them (coloring and style).static voidDisplayAFP. showAlignmentPanel(AFPChain afpChain, Atom[] ca1, Atom[] ca2, AbstractAlignmentJmol jmol)
- 
Uses of Atom in org.biojava.nbio.structure.align.gui.aligpanelMethods in org.biojava.nbio.structure.align.gui.aligpanel that return Atom Modifier and Type Method Description Atom[]AligPanel. getCa1()Atom[]StatusDisplay. getCa1()Atom[]AligPanel. getCa2()Atom[]StatusDisplay. getCa2()Methods in org.biojava.nbio.structure.align.gui.aligpanel with parameters of type Atom Modifier and Type Method Description voidAligPanel. setCa1(Atom[] ca1)voidStatusDisplay. setCa1(Atom[] ca1)voidAligPanel. setCa2(Atom[] ca2)voidStatusDisplay. setCa2(Atom[] ca2)Constructors in org.biojava.nbio.structure.align.gui.aligpanel with parameters of type Atom Constructor Description MultipleAligPanel(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.jmolMethods in org.biojava.nbio.structure.align.gui.jmol with parameters of type Atom Modifier and Type Method Description static StringStructureAlignmentJmol. getJmolScript4Block(AFPChain afpChain, Atom[] ca1, Atom[] ca2, int blockNr)static StringStructureAlignmentJmol. getJmolString(AFPChain afpChain, Atom[] ca1, Atom[] ca2)static StringJmolTools. getPdbInfo(Atom a)get jmol style info: jmol style: [MET]508:A.CA/1 #3918 insertion code: [ASP]1^A:A.CA/1 #2static StringJmolTools. getPdbInfo(Atom a, boolean printResName)voidAbstractAlignmentJmol. setAtoms(Atom[] atoms)Create and set a new structure from a given atom array.Constructors in org.biojava.nbio.structure.align.gui.jmol with parameters of type Atom Constructor Description StructureAlignmentJmol(AFPChain afpChain, Atom[] ca1, Atom[] ca2)
- 
Uses of Atom in org.biojava.nbio.structure.align.helperMethods in org.biojava.nbio.structure.align.helper that return Atom Modifier and Type Method Description static AtomAlignUtils. getCenter(Atom[] ca, int pos, int fragmentLength)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.Methods in org.biojava.nbio.structure.align.helper with parameters of type Atom Modifier and Type Method Description static AtomAlignUtils. getCenter(Atom[] ca, int pos, int fragmentLength)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 MatrixAlignUtils. 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.modelMethods in org.biojava.nbio.structure.align.model that return Atom Modifier and Type Method Description Atom[]AFPChain. getBlockShiftVector()Methods in org.biojava.nbio.structure.align.model with parameters of type Atom Modifier and Type Method Description voidAFPChain. setBlockShiftVector(Atom[] blockShiftVector)static StringAfpChainWriter. toAlignedPairs(AFPChain afpChain, Atom[] ca1, Atom[] ca2)Prints the alignment in the simplest form: a list of aligned residues.StringAFPChain. toCE(Atom[] ca1, Atom[] ca2)static StringAfpChainWriter. toCE(AFPChain afpChain, Atom[] ca1, Atom[] ca2)StringAFPChain. toFatcat(Atom[] ca1, Atom[] ca2)static StringAfpChainWriter. toFatCat(AFPChain afpChain, Atom[] ca1, Atom[] ca2)static StringAfpChainWriter. toFatCatCore(AFPChain afpChain, Atom[] ca1, Atom[] ca2, boolean printLegend, boolean longHeader, boolean showHTML, boolean showAlignmentBlock)Output in FatCatCore formatstatic StringAfpChainWriter. toPrettyAlignment(AFPChain afpChain, Atom[] ca1, Atom[] ca2, boolean showHTML, boolean showAlignmentBlock)static StringAfpChainWriter. 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 StringAfpChainWriter. 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.multipleConstructors in org.biojava.nbio.structure.align.multiple with parameters of type Atom Constructor Description MultipleAlignmentEnsembleImpl(AFPChain afp, Atom[] ca1, Atom[] ca2, boolean flexible)Constructor from an AFPChain instance.
- 
Uses of Atom in org.biojava.nbio.structure.align.multiple.utilMethods in org.biojava.nbio.structure.align.multiple.util that return Atom Modifier and Type Method Description static AtomMultipleAlignmentTools. 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.pairwiseMethods in org.biojava.nbio.structure.align.pairwise that return Atom Modifier and Type Method Description AtomFragmentPair. getCenter1()AtomFragmentPair. getCenter2()AtomAlternativeAlignment. getShift()returns the shift vector that has to be applied on structure to to shift on structure oneAtomFragmentPair. getTrans()AtomFragmentPair. getUnitv()Methods in org.biojava.nbio.structure.align.pairwise with parameters of type Atom Modifier and Type Method Description JointFragments[]FragmentJoiner. approach_ap3(Atom[] ca1, Atom[] ca2, FragmentPair[] fraglst, StrucAligParameters params)voidAlternativeAlignment. calcScores(Atom[] ca1, Atom[] ca2)calculates scores for this alignment ( %id )voidAlternativeAlignment. calculateSuperpositionByIdx(Atom[] ca1, Atom[] ca2)voidFragmentJoiner. extendFragments(Atom[] ca1, Atom[] ca2, JointFragments[] fragments, StrucAligParameters params)voidFragmentJoiner. extendFragments(Atom[] ca1, Atom[] ca2, JointFragments fragments, StrucAligParameters params)voidAlternativeAlignment. finish(StrucAligParameters params, Atom[] ca1, Atom[] ca2)static MatrixAlternativeAlignment. getDistanceMatrix(Atom[] ca1, Atom[] ca2)static doubleFragmentJoiner. getRMS(Atom[] ca1, Atom[] ca2, JointFragments frag)Get the RMS of the JointFragments pair fragvoidAlternativeAlignment. refine(StrucAligParameters params, Atom[] ca1, Atom[] ca2)Refinement procedure based on superposition and dynamic programming.voidFragmentPair. setCenter1(Atom center1)voidFragmentPair. setCenter2(Atom center2)voidFragmentPair. setTrans(Atom trans)voidFragmentPair. setUnitv(Atom unitv)voidAlignmentProgressListener. startingAlignment(String name1, Atom[] ca1, String name2, Atom[] ca2)
- 
Uses of Atom in org.biojava.nbio.structure.align.quaternaryMethods in org.biojava.nbio.structure.align.quaternary that return Atom Modifier and Type Method Description Atom[]QsAlignResult. getAlignedAtomsForSubunits1(int index)Atom[]QsAlignResult. getAlignedAtomsForSubunits2(int index)
- 
Uses of Atom in org.biojava.nbio.structure.align.seqMethods in org.biojava.nbio.structure.align.seq with parameters of type Atom Modifier and Type Method Description AFPChainSmithWaterman3Daligner. align(Atom[] ca1, Atom[] ca2)AFPChainSmithWaterman3Daligner. align(Atom[] ca1, Atom[] ca2, Object parameters)
- 
Uses of Atom in org.biojava.nbio.structure.align.utilMethods in org.biojava.nbio.structure.align.util that return Atom Modifier and Type Method Description static Atom[]AFPAlignmentDisplay. getAlignedAtoms1(AFPChain afpChain, Atom[] ca1)static Atom[]AFPAlignmentDisplay. getAlignedAtoms2(AFPChain afpChain, Atom[] ca2)Atom[]AtomCache. getAtoms(String name)Returns the CA atoms for the provided name.Atom[]AtomCache. getAtoms(StructureIdentifier name)AtomRotationAxis. 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)AtomRotationAxis. getRotationAxis()Get a unit vector along the rotation axisAtomRotationAxis. getRotationPos()Get a position on the rotation axis.AtomRotationAxis. getScrewTranslation()Get the component of translation parallel to the axis of rotationstatic AtomAFPAlignmentDisplay. getTranslation(AFPChain afpChain, Atom[] ca1, Atom[] ca2)Methods in org.biojava.nbio.structure.align.util that return types with arguments of type Atom Modifier and Type Method Description Pair<Atom>RotationAxis. getAxisEnds(Atom[] atoms)Find a segment of the axis that covers the specified set of atoms.Methods in org.biojava.nbio.structure.align.util with parameters of type Atom Modifier and Type Method Description static voidAlignmentTools. alignmentToSIF(Writer out, AFPChain afpChain, Atom[] ca1, Atom[] ca2, String backboneInteraction, String alignmentInteraction)Creates a simple interaction format (SIF) file for an alignment.static AFPChainAlignmentTools. createAFPChain(Atom[] ca1, Atom[] ca2, ResidueNumber[] aligned1, ResidueNumber[] aligned2)Fundamentally, an alignment is just a list of aligned residues in each protein.static StructureAFPAlignmentDisplay. createArtificalStructure(AFPChain afpChain, Atom[] ca1, Atom[] ca2)static AFPChainAlignmentTools. deleteColumn(AFPChain afpChain, Atom[] ca1, Atom[] ca2, int block, int pos)Delete an alignment position from the original alignment object.static AFPChainAlignmentTools. 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 voidAlignmentTools. fillAlignedAtomArrays(AFPChain afpChain, Atom[] ca1, Atom[] ca2, Atom[] ca1aligned, Atom[] ca2aligned)Fill the aligned Atom arrays with the equivalent residues in the afpChain.static voidAFPAlignmentDisplay. getAlign(AFPChain afpChain, Atom[] ca1, Atom[] ca2)Extract the alignment outputstatic voidAFPAlignmentDisplay. getAlign(AFPChain afpChain, Atom[] ca1, Atom[] ca2, boolean showSeq)static Atom[]AFPAlignmentDisplay. getAlignedAtoms1(AFPChain afpChain, Atom[] ca1)static Atom[]AFPAlignmentDisplay. getAlignedAtoms2(AFPChain afpChain, Atom[] ca2)static List<Chain>AlignmentTools. getAlignedModel(Atom[] ca)get an artificial List of chains containing the Atoms and groups.static StructureAlignmentTools. getAlignedStructure(Atom[] ca1, Atom[] ca2)Get an artifical Structure containing both chains.Pair<Atom>RotationAxis. getAxisEnds(Atom[] atoms)Find a segment of the axis that covers the specified set of atoms.StringRotationAxis. getJmolScript(Atom[] atoms)Returns a Jmol script which will display the axis of rotation.StringRotationAxis. getJmolScript(Atom[] atoms, int axisID)Returns a Jmol script which will display the axis of rotation.doubleRotationAxis. getProjectedDistance(Atom point)Get the distance from a point to the axis of rotationAtomRotationAxis. getProjectedPoint(Atom point)Projects a given point onto the axis of rotationstatic MatrixAFPAlignmentDisplay. getRotMax(AFPChain afpChain, Atom[] ca1, Atom[] ca2)static doubleAFPChainScorer. getTMScore(AFPChain align, Atom[] ca1, Atom[] ca2)static doubleAFPChainScorer. getTMScore(AFPChain align, Atom[] ca1, Atom[] ca2, boolean normalizeMin)static AtomAFPAlignmentDisplay. 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 AFPChainAlignmentTools. 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 AFPChainAlignmentTools. replaceOptAln(AFPChain afpChain, Atom[] ca1, Atom[] ca2, int blockNum, int[] optLens, int[][][] optAln)static AFPChainAlignmentTools. replaceOptAln(AFPChain afpChain, Atom[] ca1, Atom[] ca2, Map<Integer,Integer> alignment)Takes an AFPChain and replaces the optimal alignment based on an alignment mapvoidRotationAxis. rotate(Atom[] atoms, double theta)static voidAlignmentTools. shiftCA2(AFPChain afpChain, Atom[] ca2, Matrix m, Atom shift, Group[] twistedGroups)only shift CA positions.static AFPChainAlignmentTools. splitBlocksByTopology(AFPChain a, Atom[] ca1, Atom[] ca2)static voidAlignmentTools. 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.Constructors in org.biojava.nbio.structure.align.util with parameters of type Atom Constructor Description RotationAxis(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.xmlMethods in org.biojava.nbio.structure.align.xml with parameters of type Atom Modifier and Type Method Description static AFPChainAFPChainXMLParser. fromXML(String xml, String name1, String name2, Atom[] ca1, Atom[] ca2)new utility method that checks that the order of the pair in the XML alignment is correct and flips the direction if neededstatic AFPChainAFPChainXMLParser. fromXML(String xml, Atom[] ca1, Atom[] ca2)static voidAFPChainXMLConverter. printXMLEQRInferPositions(PrettyXMLWriter xml, AFPChain afpChain, int bk, Atom[] ca1, Atom[] ca2)static voidAFPChainXMLParser. rebuildAFPChain(AFPChain afpChain, Atom[] ca1, Atom[] ca2)replace the PDB res nums with atom positions:static voidAFPChainXMLConverter. toXML(AFPChain afpChain, StringWriter swriter, Atom[] ca1, Atom[] ca2)Write the XML representation to a StringWriterstatic StringAFPChainXMLConverter. toXML(AFPChain afpChain, Atom[] ca1, Atom[] ca2)Convert an afpChain to a simple XML representation
- 
Uses of Atom in org.biojava.nbio.structure.asaMethods in org.biojava.nbio.structure.asa with parameters of type Atom Modifier and Type Method Description static doubleAsaCalculator. getRadius(Atom atom)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.Constructors in org.biojava.nbio.structure.asa with parameters of type Atom Constructor Description AsaCalculator(Atom[] atoms, double probe, int nSpherePoints, int nThreads)Constructs a new AsaCalculator.
- 
Uses of Atom in org.biojava.nbio.structure.clusterMethods in org.biojava.nbio.structure.cluster that return Atom Modifier and Type Method Description Atom[]SubunitCluster. getAlignedAtomsSubunit(int index)Atom[]Subunit. getRepresentativeAtoms()Get all the representative Atoms of the Subunit.Constructors in org.biojava.nbio.structure.cluster with parameters of type Atom Constructor Description Subunit(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.contactMethods in org.biojava.nbio.structure.contact that return Atom Modifier and Type Method Description protected Atom[]StructureInterface. getAtomsForAsa(int cofactorSizeToUse)protected Atom[]StructureInterface. getFirstAtomsForAsa(int cofactorSizeToUse)protected Atom[]StructureInterface. getSecondAtomsForAsa(int cofactorSizeToUse)Methods in org.biojava.nbio.structure.contact that return types with arguments of type Atom Modifier and Type Method Description Pair<Atom>AtomContact. getPair()Methods in org.biojava.nbio.structure.contact with parameters of type Atom Modifier and Type Method Description voidGrid. addAtoms(Atom[] atoms)Adds a set of atoms, subsequent call toGrid.getIndicesContacts()orGrid.getAtomContacts()will produce the interatomic contacts.voidGrid. addAtoms(Atom[] iAtoms, Atom[] jAtoms)Adds the i and j atoms and fills the grid.voidGrid. addAtoms(Atom[] atoms, BoundingBox bounds)Adds a set of atoms, subsequent call toGrid.getIndicesContacts()orGrid.getAtomContacts()will produce the interatomic contacts.voidGrid. 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.AtomContactAtomContactSet. getContact(Atom atom1, Atom atom2)Returns the corresponding AtomContact or null if no contact exists between the 2 given atomsbooleanAtomContactSet. hasContact(Atom atom1, Atom atom2)Method parameters in org.biojava.nbio.structure.contact with type arguments of type Atom Modifier and Type Method Description voidAtomContact. setPair(Pair<Atom> pair)Constructors in org.biojava.nbio.structure.contact with parameters of type Atom Constructor Description StructureInterface(Atom[] firstMolecule, Atom[] secondMolecule, String firstMoleculeId, String secondMoleculeId, AtomContactSet contacts, CrystalTransform firstTransf, CrystalTransform secondTransf)Constructs a StructureInterfaceConstructor parameters in org.biojava.nbio.structure.contact with type arguments of type Atom Constructor Description AtomContact(Pair<Atom> pair, double distance)
- 
Uses of Atom in org.biojava.nbio.structure.domainMethods in org.biojava.nbio.structure.domain with parameters of type Atom Modifier and Type Method Description static List<Domain>LocalProteinDomainParser. suggestDomains(Atom[] ca)Suggest domains for a set of Calpha atoms
- 
Uses of Atom in org.biojava.nbio.structure.domain.pdpMethods in org.biojava.nbio.structure.domain.pdp with parameters of type Atom Modifier and Type Method Description intCut. cut(Atom[] ca, Domain dom, CutValues val, int[][] dist, PDPDistanceMatrix pdpMatrix)PDPDistanceMatrixGetDistanceMatrix. getDistanceMatrix(Atom[] protein)A set of Calpha atoms that are representing the proteinConstructors in org.biojava.nbio.structure.domain.pdp with parameters of type Atom Constructor Description CutDomain(Atom[] ca, PDPDistanceMatrix pdpMatrix)
- 
Uses of Atom in org.biojava.nbio.structure.ioMethods in org.biojava.nbio.structure.io with parameters of type Atom Modifier and Type Method Description static StringFileConvert. toPDB(Atom a)Prints the content of an Atom object as a PDB formatted line.static StringFileConvert. toPDB(Atom a, String chainId)static voidFileConvert. toPDB(Atom a, StringBuffer str)static voidFileConvert. toPDB(Atom a, StringBuffer str, String chainID)Print ATOM record in the following syntax
- 
Uses of Atom in org.biojava.nbio.structure.io.mmcifMethods in org.biojava.nbio.structure.io.mmcif with parameters of type Atom Modifier and Type Method Description static AtomSiteMMCIFFileTools. convertAtomToAtomSite(Atom a, int model, String chainName, String chainId)Converts an Atom object to anAtomSiteobject.static AtomSiteMMCIFFileTools. convertAtomToAtomSite(Atom a, int model, String chainName, String chainId, int atomId)Converts an Atom object to anAtomSiteobject.
- 
Uses of Atom in org.biojava.nbio.structure.io.mmtfMethods in org.biojava.nbio.structure.io.mmtf that return types with arguments of type Atom Modifier and Type Method Description List<Atom>MmtfSummaryDataBean. getAllAtoms()static List<Atom>MmtfUtils. getAtomsForGroup(Group inputGroup)Get a list of atoms for a group.Method parameters in org.biojava.nbio.structure.io.mmtf with type arguments of type Atom Modifier and Type Method Description static intMmtfUtils. getNumBondsInGroup(List<Atom> atomsInGroup)Find the number of bonds in a groupvoidMmtfSummaryDataBean. setAllAtoms(List<Atom> allAtoms)
- 
Uses of Atom in org.biojava.nbio.structure.symmetry.internalMethods in org.biojava.nbio.structure.symmetry.internal that return Atom Modifier and Type Method Description Atom[]CeSymmResult. getAtoms()Methods in org.biojava.nbio.structure.symmetry.internal with parameters of type Atom Modifier and Type Method Description protected static CeSymmResultCeSymm. align(Atom[] atoms, CESymmParameters params)static CeSymmResultCeSymm. analyze(Atom[] atoms)Analyze the symmetries of the input Atom array using the DEFAULT parameters.static CeSymmResultCeSymm. analyze(Atom[] atoms, CESymmParameters params)Analyze the symmetries of the input Atom array using the provided parameters.static CeSymmResultCeSymm. analyzeLevel(Atom[] atoms, CESymmParameters params)Analyze a single level of symmetry.intAngleOrderDetectorPlus. calculateOrder(AFPChain afpChain, Atom[] ca)intGraphComponentOrderDetector. calculateOrder(AFPChain selfAlignment, Atom[] ca)intOrderDetector. calculateOrder(AFPChain afpChain, Atom[] ca)intSequenceFunctionOrderDetector. calculateOrder(AFPChain afpChain, Atom[] ca)CeSymmResultCeSymmIterative. execute(Atom[] atoms)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.MultipleAlignmentGraphComponentRefiner. refine(AFPChain selfAlignment, Atom[] atoms, int order)MultipleAlignmentSequenceFunctionRefiner. refine(AFPChain selfAlignment, Atom[] atoms, int order)MultipleAlignmentSymmetryRefiner. refine(AFPChain selfAlignment, Atom[] atoms, int order)Returns a refined symmetry alignment, where the repeat residues are aligned consistently in a MultipleAlignment.static AFPChainSequenceFunctionRefiner. refineSymmetry(AFPChain afpChain, Atom[] ca1, Atom[] ca2, int k)Refines a CE-Symm alignment so that it is perfectly symmetric.voidCeSymmResult. setAtoms(Atom[] atoms)
- 
Uses of Atom in org.biojava.nbio.structure.symmetry.utilsMethods in org.biojava.nbio.structure.symmetry.utils that return Atom Modifier and Type Method Description static 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.Methods in org.biojava.nbio.structure.symmetry.utils with parameters of type Atom Modifier and Type Method Description static boolean[][]SymmetryTools. blankOutBreakFlag(AFPChain afpChain, Atom[] ca2, int rows, int cols, CECalculator calculator, boolean[][] breakFlag, int blankWindowSize)static MatrixSymmetryTools. blankOutCEOrig(Atom[] ca2, int rows, int cols, CECalculator calculator, Matrix origM, int blankWindowSize)static MatrixSymmetryTools. blankOutPreviousAlignment(AFPChain afpChain, Atom[] ca2, int rows, int cols, CECalculator calculator, Matrix max, int blankWindowSize)static List<List<Integer>>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 MultipleAlignmentSymmetryTools. fromAFP(AFPChain symm, Atom[] atoms)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 doubleSymmetryTools. getAngle(AFPChain afpChain, Atom[] ca1, Atom[] ca2)Returns the magnitude of the angle between the first and second blocks ofafpChain, measured in degrees.MatrixSymmetryTools. getDkMatrix(Atom[] ca1, Atom[] ca2, int fragmentLength, double[] dist1, double[] dist2, int rows, int cols)static MatrixSymmetryTools. getDkMatrix(Atom[] ca1, Atom[] ca2, int k, int fragmentLength)static List<Group>SymmetryTools. getGroups(Atom[] rAtoms)Returns the List of Groups of the corresponding representative Atom array.static MatrixSymmetryTools. 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 MatrixSymmetryTools. grayOutPreviousAlignment(AFPChain afpChain, Atom[] ca2, int rows, int cols, CECalculator calculator, Matrix max, int blankWindowSize, double[] gradientPolyCoeff, double gradientExpCoeff)
 
-