Uses of Interface
org.biojava.nbio.structure.Structure
- 
- 
Uses of Structure in demo
Methods in demo that return Structure Modifier and Type Method Description static StructureDemoShowLargeAssembly. readStructure(String pdbId, int bioAssemblyId)Load a specific biological assembly for a PDB entryMethods in demo with parameters of type Structure Modifier and Type Method Description static voidDemoLoadSecStruc. printSecStruc(Structure s) - 
Uses of Structure in org.biojava.nbio.protmod.structure
Methods in org.biojava.nbio.protmod.structure with parameters of type Structure Modifier and Type Method Description voidProteinModificationIdentifier. identify(Structure structure)Identify all registered modifications in a structure.voidProteinModificationIdentifier. identify(Structure structure, Set<ProteinModification> potentialModifications)Identify a set of modifications in a structure. - 
Uses of Structure in org.biojava.nbio.structure
Classes in org.biojava.nbio.structure that implement Structure Modifier and Type Class Description classStructureImplImplementation of a PDB Structure.Methods in org.biojava.nbio.structure that return Structure Modifier and Type Method Description StructureStructure. clone()Return an identical copy of this Structure objectStructureStructureImpl. clone()returns an identical copy of this structure .static StructureStructureIO. getBiologicalAssembly(String pdbId)Returns the first biological assembly that is available for the given PDB id, using multiModel=falsestatic StructureStructureIO. getBiologicalAssembly(String pdbId, boolean multiModel)Returns the first biological assembly that is available for the given PDB id.static StructureStructureIO. getBiologicalAssembly(String pdbId, int biolAssemblyNr)Returns the biological assembly for the given PDB id and bioassembly identifier, using multiModel=falsestatic StructureStructureIO. getBiologicalAssembly(String pdbId, int biolAssemblyNr, boolean multiModel)Returns the biological assembly for the given PDB id and bioassembly identifier.StructureChain. getParent()Deprecated.use getStructure(Structure) instead.StructureChainImpl. getParent()Deprecated.use getStructure instead.StructureDBRef. getParent()Get the structure object that this DBRef relates to.static StructureStructureTools. getReducedStructure(Structure s, String chainId)Deprecated.UseStructureIdentifier.reduce(Structure)instead (v. 4.2.0)StructureChain. getStructure()Returns the parent Structure of this chain.StructureChainImpl. getStructure()Returns the parent Structure of this chain.static StructureStructureIO. getStructure(String name)Loads a structure based on a name.static StructureStructureTools. getStructure(String name)Short version ofStructureTools.getStructure(String, PDBFileParser, AtomCache)which creates new parsers when neededstatic StructureStructureTools. getStructure(String name, PDBFileParser parser, AtomCache cache)Flexibly get a structure from an input String.StructureBioAssemblyIdentifier. loadStructure(AtomCache cache)StructurePassthroughIdentifier. loadStructure(AtomCache cache)Passthrough identifiers don't know how to load a structureStructureStructureIdentifier. loadStructure(AtomCache cache)Loads a structure encompassing the structure identified.StructureSubstructureIdentifier. loadStructure(AtomCache cache)Loads the complete structure based onSubstructureIdentifier.getPdbId().StructureURLIdentifier. loadStructure(AtomCache cache)Load the structure from the URLStructureMutator. mutate(Structure struc, String chainId, String pdbResnum, String newType)creates a new structure which is identical with the original one.StructureBioAssemblyIdentifier. reduce(Structure input)StructurePassthroughIdentifier. reduce(Structure input)StructureStructureIdentifier. reduce(Structure input)Takes a complete structure as input and reduces it to the substructure represented by this StructureIdentifier.StructureSubstructureIdentifier. reduce(Structure s)Takes a complete structure as input and reduces it to residues present in the specified rangesStructureURLIdentifier. reduce(Structure input)static StructureStructureTools. removeModels(Structure s)Remove all models from a Structure and keep only the firstMethods in org.biojava.nbio.structure that return types with arguments of type Structure Modifier and Type Method Description static List<Structure>StructureIO. getBiologicalAssemblies(String pdbId)Returns all biological assemblies for the given PDB id, using multiModel=falsestatic List<Structure>StructureIO. getBiologicalAssemblies(String pdbId, boolean multiModel)Returns all biological assemblies for the given PDB id.Methods in org.biojava.nbio.structure with parameters of type Structure Modifier and Type Method Description static voidStructureTools. addGroupsToStructure(Structure s, Collection<Group> groups, int model, boolean clone)Add a list of groups to a new structure.static ChainStructureTools. addGroupToStructure(Structure s, Group g, int model, Chain chainGuess, boolean clone)Adds a particular group to a structure.static voidStructureTools. cleanUpAltLocs(Structure structure)Cleans up the structure's alternate location (altloc) groups.protected static voidSubstructureIdentifier. copyLigandsByProximity(Structure full, Structure reduced)Supplements the reduced structure with ligands from the full structure based on a distance cutoff.protected static voidSubstructureIdentifier. copyLigandsByProximity(Structure full, Structure reduced, double cutoff, int fromModel, int toModel)Supplements the reduced structure with ligands from the full structure based on a distance cutoff.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(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.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.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 notstatic GroupStructureTools. getGroupByPDBResidueNumber(Structure struc, ResidueNumber pdbResNum)Get a group represented by a ResidueNumber.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 Set<Group>StructureTools. getGroupsWithinShell(Structure structure, Group group, double distance, boolean includeWater)Returns a Set of Groups in a structure within the distance specified of a given group.static intStructureTools. getNrAtoms(Structure s)Count how many Atoms are contained within a Structure object.static intStructureTools. getNrGroups(Structure s)Count how many groups are contained within a structure object.static StructureStructureTools. getReducedStructure(Structure s, String chainId)Deprecated.UseStructureIdentifier.reduce(Structure)instead (v. 4.2.0)static Atom[]StructureTools. getRepresentativeAtomArray(Structure s)Gets a representative atom for each group that is part of the chain backbone.StructureMutator. mutate(Structure struc, String chainId, String pdbResnum, String newType)creates a new structure which is identical with the original one.static voidCalc. plus(Structure s, Matrix matrix)calculate structure + Matrix coodinates ...StructureBioAssemblyIdentifier. reduce(Structure input)StructurePassthroughIdentifier. reduce(Structure input)StructureStructureIdentifier. reduce(Structure input)Takes a complete structure as input and reduces it to the substructure represented by this StructureIdentifier.StructureSubstructureIdentifier. reduce(Structure s)Takes a complete structure as input and reduces it to residues present in the specified rangesStructureURLIdentifier. reduce(Structure input)static StructureStructureTools. removeModels(Structure s)Remove all models from a Structure and keep only the firststatic voidCalc. rotate(Structure structure, double[][] rotationmatrix)Rotate a structure.static voidCalc. rotate(Structure structure, Matrix m)Rotate a structure object.voidChain. setParent(Structure parent)Deprecated.use setStructure insteadvoidChainImpl. setParent(Structure parent)Deprecated.voidDBRef. setParent(Structure s)Set the structure object that this DBRef relates to.voidChain. setStructure(Structure parent)Sets the back-reference to its parent Structure.voidChainImpl. setStructure(Structure parent)Sets the back-reference to its parent Structure.static voidCalc. shift(Structure structure, Atom a)shift a structure with a vector.static voidCalc. transform(Structure structure, javax.vecmath.Matrix4d m)Transforms a structure object, given a Matrix4d (i.e. the vecmath library double-precision 4x4 rotation+translation matrix).static voidCalc. translate(Structure structure, javax.vecmath.Vector3d v)Translates a Structure object, given a Vector3d (i.e. the vecmath library double-precision 3-d vector)Constructors in org.biojava.nbio.structure with parameters of type Structure Constructor Description AtomIterator(Structure struct)Constructs an AtomIterator object over all modelsAtomIterator(Structure struct, int modelNr)Constructs an AtomIterator object over a single modelAtomPositionMap(Structure s)Creates a new AtomPositionMap containing representative atoms from a structure.GroupIterator(Structure struct)Constructs a GroupIterator object over all modelsGroupIterator(Structure struct, int modelNr)Constructs a GroupIterator object over a specific model - 
Uses of Structure in org.biojava.nbio.structure.align
Methods in org.biojava.nbio.structure.align with parameters of type Structure Modifier and Type Method Description voidStructurePairAligner. align(Structure s1, String chainId1, Structure s2, String chainId2)Align two chains from the structures.voidStructurePairAligner. align(Structure s1, String chainId1, Structure s2, String chainId2, StrucAligParameters params)Aligns two chains from the structures using user provided parameters.voidStructurePairAligner. align(Structure s1, Structure s2)Calculate the alignment between the two full structures with default parametersvoidStructurePairAligner. align(Structure s1, Structure s2, StrucAligParameters params)Calculate the alignment between the two full structures with user provided parametersAtom[]StructurePairAligner. getAlignmentAtoms(Structure s)Returns the atoms that are being used for the alignment.Constructors in org.biojava.nbio.structure.align with parameters of type Structure Constructor Description MultiThreadedDBSearch(String name, Structure structure, String outFile, StructureAlignment algorithm, int nrCPUs, boolean domainSplit) - 
Uses of Structure in org.biojava.nbio.structure.align.ce
Methods in org.biojava.nbio.structure.align.ce that return Structure Modifier and Type Method Description static StructureGuiWrapper. getAlignedStructure(Atom[] ca1, Atom[] ca2)Methods in org.biojava.nbio.structure.align.ce with parameters of type Structure Modifier and Type Method Description static voidGuiWrapper. showStructure(Structure structure)Shows a structure in Jmol - 
Uses of Structure in org.biojava.nbio.structure.align.client
Methods in org.biojava.nbio.structure.align.client that return Structure Modifier and Type Method Description StructureStructureName. loadStructure(AtomCache cache)StructureStructureName. reduce(Structure input)Methods in org.biojava.nbio.structure.align.client with parameters of type Structure Modifier and Type Method Description StructureStructureName. reduce(Structure input) - 
Uses of Structure in org.biojava.nbio.structure.align.gui
Methods in org.biojava.nbio.structure.align.gui that return Structure 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.StructureSelectPDBPanel. getStructure1()StructureSelectPDBPanel. getStructure2()Constructors in org.biojava.nbio.structure.align.gui with parameters of type Structure Constructor Description AlignmentCalc(AlignmentGui parent, Structure s1, Structure s2, String name1, String name2)requests an alignment of pdb1 vs pdb 2.AlignmentCalcDB(AlignmentGui parent, Structure s1, String name1, UserConfiguration config, String outFile, Boolean domainSplit)Constructor parameters in org.biojava.nbio.structure.align.gui with type arguments of type Structure Constructor Description MultipleAlignmentCalc(MultipleAlignmentGUI parent, List<Structure> structures, List<StructureIdentifier> names)Requests an alignment of the pdbs. - 
Uses of Structure in org.biojava.nbio.structure.align.gui.jmol
Fields in org.biojava.nbio.structure.align.gui.jmol declared as Structure Modifier and Type Field Description protected StructureAbstractAlignmentJmol. structureMethods in org.biojava.nbio.structure.align.gui.jmol that return Structure Modifier and Type Method Description StructureAbstractAlignmentJmol. getStructure()Return the current Structure in the AlignmentJmol instance.Methods in org.biojava.nbio.structure.align.gui.jmol with parameters of type Structure Modifier and Type Method Description voidAbstractAlignmentJmol. setStructure(Structure s)Set a new Structure to visualize in the AlignmentJmol window.voidJmolPanel. setStructure(Structure s)voidJmolPanel. setStructure(Structure s, boolean useMmtf) - 
Uses of Structure in org.biojava.nbio.structure.align.multiple.util
Methods in org.biojava.nbio.structure.align.multiple.util that return Structure Modifier and Type Method Description static StructureMultipleAlignmentTools. getAlignedStructure(List<Atom[]> atomArrays)Get an artificial Structure containing a different model for every input structure, so that the alignment result can be viewed in Jmol.static StructureMultipleAlignmentTools. toMultimodelStructure(MultipleAlignment multAln, List<Atom[]> transformedAtoms) - 
Uses of Structure in org.biojava.nbio.structure.align.pairwise
Methods in org.biojava.nbio.structure.align.pairwise that return Structure Modifier and Type Method Description StructureAlternativeAlignment. getAlignedStructure(Structure s1, Structure s2)create an artifical Structure object that contains the two structures superimposed onto each other.Methods in org.biojava.nbio.structure.align.pairwise with parameters of type Structure Modifier and Type Method Description StructureAlternativeAlignment. getAlignedStructure(Structure s1, Structure s2)create an artifical Structure object that contains the two structures superimposed onto each other.StringAlternativeAlignment. toPDB(Structure s1, Structure s2)converts the alignment to a PDB file each of the structures will be represented as a model. - 
Uses of Structure in org.biojava.nbio.structure.align.quaternary
Methods in org.biojava.nbio.structure.align.quaternary with parameters of type Structure Modifier and Type Method Description static QsAlignResultQsAlign. align(Structure s1, Structure s2, SubunitClustererParameters cParams, QsAlignParameters aParams) - 
Uses of Structure in org.biojava.nbio.structure.align.util
Methods in org.biojava.nbio.structure.align.util that return Structure Modifier and Type Method Description static StructureAFPAlignmentDisplay. createArtificalStructure(AFPChain afpChain, Atom[] ca1, Atom[] ca2)static StructureAlignmentTools. getAlignedStructure(Atom[] ca1, Atom[] ca2)Get an artifical Structure containing both chains.StructureAtomCache. getBiologicalAssembly(String pdbId, boolean multiModel)Returns the default biological unit (bioassemblyId=1, known in PDB as pdb1.gz).StructureAtomCache. getBiologicalAssembly(String pdbId, int bioAssemblyId, boolean multiModel)Returns the biological assembly for a given PDB ID and bioAssemblyId, by building the assembly from the biounit annotations found ingetPDBHeader()StructureAtomCache. getStructure(String name)Request a Structure based on a name.StructureAtomCache. getStructure(StructureIdentifier strucId)Get the structure corresponding to the givenStructureIdentifier.StructureAtomCache. getStructureForCathDomain(StructureName structureName)Returns aStructurecorresponding to the CATH identifier supplied instructureName, using the theCathDatabaseatCathFactory.getCathDatabase().StructureAtomCache. getStructureForCathDomain(StructureName structureName, CathDatabase cathInstall)Returns aStructurecorresponding to the CATH identifier supplied instructureName, using the specifiedCathDatabase.StructureAtomCache. getStructureForDomain(String scopId)Returns the representation of aScopDomainas a BioJavaStructureobject.StructureAtomCache. getStructureForDomain(String scopId, ScopDatabase scopDatabase)Returns the representation of aScopDomainas a BioJavaStructureobject.StructureAtomCache. getStructureForDomain(ScopDomain domain)Returns the representation of aScopDomainas a BioJavaStructureobject.StructureAtomCache. getStructureForDomain(ScopDomain domain, ScopDatabase scopDatabase)Returns the representation of aScopDomainas a BioJavaStructureobject.StructureAtomCache. getStructureForDomain(ScopDomain domain, ScopDatabase scopDatabase, boolean strictLigandHandling)Returns the representation of aScopDomainas a BioJavaStructureobject.StructureAtomCache. getStructureForPdbId(String pdbId)Loads a structure directly by PDB IDprotected StructureAtomCache. loadStructureFromCifByPdbId(String pdbId)protected StructureAtomCache. loadStructureFromPdbByPdbId(String pdbId)Methods in org.biojava.nbio.structure.align.util that return types with arguments of type Structure Modifier and Type Method Description List<Structure>AtomCache. getBiologicalAssemblies(String pdbId, boolean multiModel)Returns all biological assemblies for given PDB id. - 
Uses of Structure in org.biojava.nbio.structure.asa
Constructors in org.biojava.nbio.structure.asa with parameters of type Structure Constructor Description AsaCalculator(Structure structure, double probe, int nSpherePoints, int nThreads, boolean hetAtoms)Constructs a new AsaCalculator. - 
Uses of Structure in org.biojava.nbio.structure.basepairs
Fields in org.biojava.nbio.structure.basepairs declared as Structure Modifier and Type Field Description protected StructureBasePairParameters. structureConstructors in org.biojava.nbio.structure.basepairs with parameters of type Structure Constructor Description BasePairParameters(Structure structure)This constructor takes a Structure object, finds base pair and base-pair step parameters for double-helical regions within the structure for only canonical DNA pairs.BasePairParameters(Structure structure, boolean useRNA)This constructor takes a Structure object, and whether to use the RNA standard bases.BasePairParameters(Structure structure, boolean useRNA, boolean removeDups)This constructor takes a Structure object, whether to use RNA, and whether to remove duplicate sequences.BasePairParameters(Structure structure, boolean useRNA, boolean removeDups, boolean canonical)This constructor takes a Structure object, finds base pair and base-pair step parameters for double-helical regions within the structure.MismatchedBasePairParameters(Structure structure, boolean RNA, boolean removeDups, boolean canonical)This constructor is used to create the TertiaryBasePairParameters object.TertiaryBasePairParameters(Structure structure, boolean RNA, boolean removeDups) - 
Uses of Structure in org.biojava.nbio.structure.cath
Methods in org.biojava.nbio.structure.cath that return Structure Modifier and Type Method Description StructureCathDomain. loadStructure(AtomCache cache)StructureCathDomain. reduce(Structure input)Methods in org.biojava.nbio.structure.cath with parameters of type Structure Modifier and Type Method Description StructureCathDomain. reduce(Structure input) - 
Uses of Structure in org.biojava.nbio.structure.cluster
Methods in org.biojava.nbio.structure.cluster that return Structure Modifier and Type Method Description StructureSubunit. getStructure()The parent Structure from which the Subunit atoms were obtained.Methods in org.biojava.nbio.structure.cluster with parameters of type Structure Modifier and Type Method Description static StoichiometrySubunitClusterer. cluster(Structure structure, SubunitClustererParameters params)static List<Subunit>SubunitExtractor. extractSubunits(Structure structure, int absMinLen, double fraction, int minLen)Extract the information of each protein Chain in a Structure and converts them into a List of Subunit.Constructors in org.biojava.nbio.structure.cluster with parameters of type Structure 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 Structure in org.biojava.nbio.structure.contact
Methods in org.biojava.nbio.structure.contact with parameters of type Structure Modifier and Type Method Description static StructureInterfaceListStructureInterfaceList. calculateInterfaces(Structure struc)Calculates the interfaces for a structure using default parameters - 
Uses of Structure in org.biojava.nbio.structure.domain
Methods in org.biojava.nbio.structure.domain that return Structure Modifier and Type Method Description StructurePDPProvider. getDomain(String pdpDomainName, AtomCache cache)Get the structure for a particular PDP domainStructureRemotePDPProvider. getDomain(String pdpDomainName, AtomCache cache)Get the structure for a particular PDP domainStructurePDPDomain. loadStructure(AtomCache cache)StructurePDPDomain. reduce(Structure input)Methods in org.biojava.nbio.structure.domain with parameters of type Structure Modifier and Type Method Description StructurePDPDomain. reduce(Structure input)static List<Domain>LocalProteinDomainParser. suggestDomains(Structure s)Suggest domains for a protein structure - 
Uses of Structure in org.biojava.nbio.structure.ecod
Methods in org.biojava.nbio.structure.ecod that return Structure Modifier and Type Method Description StructureEcodDomain. loadStructure(AtomCache cache)StructureEcodDomain. reduce(Structure input)Methods in org.biojava.nbio.structure.ecod with parameters of type Structure Modifier and Type Method Description StructureEcodDomain. reduce(Structure input) - 
Uses of Structure in org.biojava.nbio.structure.gui
Methods in org.biojava.nbio.structure.gui with parameters of type Structure Modifier and Type Method Description voidBiojavaJmol. setStructure(Structure s)voidJmolViewerImpl. setStructure(Structure structure)voidStructureViewer. setStructure(Structure structure)voidSequenceDisplay. setStructure1(Structure structure)voidSequenceDisplay. setStructure2(Structure structure) - 
Uses of Structure in org.biojava.nbio.structure.gui.events
Methods in org.biojava.nbio.structure.gui.events with parameters of type Structure Modifier and Type Method Description voidJmolAlignedPositionListener. setStructure1(Structure structure1)voidJmolAlignedPositionListener. setStructure2(Structure structure2) - 
Uses of Structure in org.biojava.nbio.structure.gui.util
Methods in org.biojava.nbio.structure.gui.util that return Structure Modifier and Type Method Description StructurePDBDirPanel. getStructure1()StructurePDBServerPanel. getStructure1()StructurePDBUploadPanel. getStructure1()StructureScopSelectPanel. getStructure1()StructureStructurePairSelector. getStructure1()StructurePDBDirPanel. getStructure2()StructurePDBServerPanel. getStructure2()StructurePDBUploadPanel. getStructure2()StructureScopSelectPanel. getStructure2()StructureStructurePairSelector. getStructure2()Methods in org.biojava.nbio.structure.gui.util that return types with arguments of type Structure Modifier and Type Method Description List<Structure>SelectMultiplePanel. getStructures()Constructors in org.biojava.nbio.structure.gui.util with parameters of type Structure Constructor Description AlignmentCalc(AlignmentGui parent, Structure s1, Structure s2)requests an alignment of pdb1 vs pdb 2.AlternativeAlignmentFrame(Structure s1, Structure s2) - 
Uses of Structure in org.biojava.nbio.structure.io
Methods in org.biojava.nbio.structure.io that return Structure Modifier and Type Method Description StructureLocalPDBDirectory. getStructure(File filename)abstract StructureLocalPDBDirectory. getStructure(InputStream inStream)Handles the actual parsing of the file into a Structure object.StructureLocalPDBDirectory. getStructure(String filename)StructureLocalPDBDirectory. getStructure(URL u)StructureMMCIFFileReader. getStructure(InputStream inStream)StructureMMTFFileReader. getStructure(InputStream inStream)StructurePDBFileReader. getStructure(InputStream inStream)StructureStructureIOFile. getStructure(File file)Read file from File and returns a Structure object.StructureStructureIOFile. getStructure(String filename)Open filename and return a Structure object.StructureLocalPDBDirectory. getStructureById(String pdbId)StructureSandboxStyleStructureProvider. getStructureById(String pdbId)StructureStructureProvider. getStructureById(String pdbId)Get the structure for a PDB IDStructure[]FastaStructureParser. getStructures()Gets the protein structures mapped from the Fasta file.static StructureStructureSequenceMatcher. getSubstructureMatchingProteinSequence(ProteinSequence sequence, Structure wholeStructure)StructurePDBFileParser. parsePDBFile(BufferedReader buf)Parse a PDB file and return a datastructure implementing PDBStructure interface.StructurePDBFileParser. parsePDBFile(InputStream inStream)Parse a PDB file and return a datastructure implementing PDBStructure interface.Methods in org.biojava.nbio.structure.io with parameters of type Structure Modifier and Type Method Description static voidChargeAdder. addCharges(Structure structure)Function to add the charges to a given structure.voidSeqRes2AtomAligner. align(Structure s, List<Chain> seqResList)static AFPChainFastaAFPChainConverter. cpFastaToAfpChain(File fastaFile, Structure structure, int cpSite)Takes a structure and sequence corresponding to an alignment between a structure or sequence and itself (or even a structure with a sequence), where the result has a circular permutation sitecpSiteresidues to the right.static AFPChainFastaAFPChainConverter. cpFastaToAfpChain(String first, String second, Structure structure, int cpSite)static AFPChainFastaAFPChainConverter. cpFastaToAfpChain(ProteinSequence first, ProteinSequence second, Structure structure, int cpSite)Takes a structure and sequence corresponding to an alignment between a structure or sequence and itself (or even a structure with a sequence), where the result has a circular permutation sitecpSiteresidues to the right.static AFPChainFastaAFPChainConverter. fastaFileToAfpChain(File fastaFile, Structure structure1, Structure structure2)Reads the filefastaFile, expecting exactly two sequences which give a pairwise alignment.static AFPChainFastaAFPChainConverter. fastaStringToAfpChain(String sequence1, String sequence2, Structure structure1, Structure structure2)Returns an AFPChain corresponding to the alignment betweenstructure1andstructure2, which is given by the gapped protein sequencessequence1andsequence2.static AFPChainFastaAFPChainConverter. fastaToAfpChain(String sequence1, String sequence2, Structure structure1, Structure structure2)TODO Write commentstatic AFPChainFastaAFPChainConverter. fastaToAfpChain(Map<String,ProteinSequence> sequences, Structure structure1, Structure structure2)Uses two sequences each with a corresponding structure to create an AFPChain corresponding to the alignment.static AFPChainFastaAFPChainConverter. fastaToAfpChain(SequencePair<Sequence<AminoAcidCompound>,AminoAcidCompound> alignment, Structure structure1, Structure structure2)Provided only for convenience.static AFPChainFastaAFPChainConverter. fastaToAfpChain(ProteinSequence sequence1, ProteinSequence sequence2, Structure structure1, Structure structure2)Returns an AFPChain corresponding to the alignment betweenstructure1andstructure2, which is given by the gapped protein sequencessequence1andsequence2.static ProteinSequenceStructureSequenceMatcher. getProteinSequenceForStructure(Structure struct, Map<Integer,Group> groupIndexPosition)Generates a ProteinSequence corresponding to the sequence of struct, and maintains a mapping from the sequence back to the original groups.static StructureStructureSequenceMatcher. getSubstructureMatchingProteinSequence(ProteinSequence sequence, Structure wholeStructure)static ResidueNumber[]StructureSequenceMatcher. matchSequenceToStructure(ProteinSequence seq, Structure struct)Given a sequence and the corresponding Structure, get the ResidueNumber for each residue in the sequence.static voidSeqRes2AtomAligner. storeUnAlignedSeqRes(Structure structure, List<Chain> seqResChains, boolean headerOnly)Storing unaligned SEQRES groups in a Structure.Constructors in org.biojava.nbio.structure.io with parameters of type Structure Constructor Description BondMaker(Structure structure, FileParsingParameters params)FileConvert(Structure struc)Constructs a FileConvert object. - 
Uses of Structure in org.biojava.nbio.structure.io.mmcif
Methods in org.biojava.nbio.structure.io.mmcif that return Structure Modifier and Type Method Description StructureSimpleMMcifConsumer. getStructure()This method will return the parsed protein structure, once the parsing has been finishedMethods in org.biojava.nbio.structure.io.mmcif with parameters of type Structure Modifier and Type Method Description static List<AtomSite>MMCIFFileTools. convertStructureToAtomSites(Structure s)Converts a Structure into a List ofAtomSiteobjects - 
Uses of Structure in org.biojava.nbio.structure.io.mmtf
Methods in org.biojava.nbio.structure.io.mmtf that return Structure Modifier and Type Method Description StructureMmtfStructureReader. getStructure()Gets the structure.static StructureMmtfActions. readFromFile(Path filePath)Get a Structure object from a mmtf file.static StructureMmtfActions. readFromInputStream(InputStream inStream)Read a Biojava structure from anInputStreamstatic StructureMmtfActions. readFromWeb(String pdbId)Get a Biojava structure from the mmtf REST service.Methods in org.biojava.nbio.structure.io.mmtf with parameters of type Structure Modifier and Type Method Description static voidMmtfUtils. calculateDsspSecondaryStructure(Structure bioJavaStruct)Generate the secondary structure for a Biojava structure object.static voidMmtfUtils. fixMicroheterogenity(Structure bioJavaStruct)This sets all microheterogeneous groups (previously alternate location groups) as separate groups.static intMmtfUtils. getNumGroups(Structure structure)Count the total number of groups in the structurestatic MmtfSummaryDataBeanMmtfUtils. getStructureInfo(Structure structure)Get summary information for the structure.static voidMmtfActions. writeToFile(Structure structure, Path path)Write a Structure object to a file.static voidMmtfActions. writeToOutputStream(Structure structure, OutputStream outputStream)Write a Structure object to anOutputStreamConstructors in org.biojava.nbio.structure.io.mmtf with parameters of type Structure Constructor Description MmtfStructureWriter(Structure structure, org.rcsb.mmtf.api.StructureAdapterInterface dataTransferInterface)Pass data from Biojava structure to another generic output type. - 
Uses of Structure in org.biojava.nbio.structure.quaternary
Methods in org.biojava.nbio.structure.quaternary that return Structure Modifier and Type Method Description static StructureBioAssemblyTools. getReducedStructure(Structure orig)Reduce a structure to a single-atom representation (e.g.StructureBiologicalAssemblyBuilder. rebuildQuaternaryStructure(Structure asymUnit, List<BiologicalAssemblyTransformation> transformations, boolean useAsymIds, boolean multiModel)Builds a Structure object containing the quaternary structure built from given asymUnit and transformations, by adding symmetry partners as new models.Methods in org.biojava.nbio.structure.quaternary with parameters of type Structure Modifier and Type Method Description static double[][]BioAssemblyTools. getAtomCoordinateBounds(Structure s)static double[][]BioAssemblyTools. getBiologicalMoleculeBounds(Structure asymStructure, List<BiologicalAssemblyTransformation> transformations)static double[]BioAssemblyTools. getBiologicalMoleculeCentroid(Structure asymUnit, List<BiologicalAssemblyTransformation> transformations)Returns the centroid of the biological molecule.static doubleBioAssemblyTools. getBiologicalMoleculeMaximumExtend(Structure structure, List<BiologicalAssemblyTransformation> transformations)Returns the maximum extend of the biological molecule in the x, y, or z direction.static doubleBioAssemblyTools. getMaximumExtend(Structure structure)Returns the maximum extend of the structure in the x, y, or z direction.static StructureBioAssemblyTools. getReducedStructure(Structure orig)Reduce a structure to a single-atom representation (e.g.StructureBiologicalAssemblyBuilder. rebuildQuaternaryStructure(Structure asymUnit, List<BiologicalAssemblyTransformation> transformations, boolean useAsymIds, boolean multiModel)Builds a Structure object containing the quaternary structure built from given asymUnit and transformations, by adding symmetry partners as new models. - 
Uses of Structure in org.biojava.nbio.structure.scop
Methods in org.biojava.nbio.structure.scop that return Structure Modifier and Type Method Description StructureScopDomain. loadStructure(AtomCache cache)StructureScopDomain. reduce(Structure input)Methods in org.biojava.nbio.structure.scop with parameters of type Structure Modifier and Type Method Description StructureScopDomain. reduce(Structure input) - 
Uses of Structure in org.biojava.nbio.structure.secstruc
Methods in org.biojava.nbio.structure.secstruc with parameters of type Structure Modifier and Type Method Description static voidSecStrucTools. assignSecStruc(Structure s, List<SecStrucInfo> listSSI)List<SecStrucState>SecStrucCalc. calculate(Structure s, boolean assign)Predicts the secondary structure of this Structure object, using a DSSP implementation.static List<SecStrucState>DSSPParser. fetch(String pdb, Structure structure, boolean assign)Fetch and parse the DSSP file of the specified pdb code from the PDB web server and return the secondary structure annotation as a List ofSecStrucStateobjects.static List<SecStrucElement>SecStrucTools. getSecStrucElements(Structure s)Obtain the List of secondary structure elements (SecStrucElement) of a Structure.static List<SecStrucInfo>SecStrucTools. getSecStrucInfo(Structure s)Obtain the List of secondary structure information (SecStrucInfo) of a Structure.static List<SecStrucState>DSSPParser. parseFile(String dsspPath, Structure structure, boolean assign)Parse a DSSP output file and return the secondary structure annotation as a List ofSecStrucStateobjects.static List<SecStrucState>DSSPParser. parseInputStream(InputStream dsspIs, Structure structure, boolean assign)Parse a DSSP output file and return the secondary structure annotation as a List ofSecStrucStateobjects.static List<SecStrucState>DSSPParser. parseString(String dsspOut, Structure structure, boolean assign)Parse a DSSP format String and return the secondary structure annotation as a List ofSecStrucStateobjects. - 
Uses of Structure in org.biojava.nbio.structure.symmetry.core
Methods in org.biojava.nbio.structure.symmetry.core that return Structure Modifier and Type Method Description StructureQuatSymmetryResults. getStructure()Methods in org.biojava.nbio.structure.symmetry.core with parameters of type Structure Modifier and Type Method Description static QuatSymmetryResultsQuatSymmetryDetector. calcGlobalSymmetry(Structure structure, QuatSymmetryParameters symmParams, SubunitClustererParameters clusterParams)Calculate GLOBAL symmetry results.static List<QuatSymmetryResults>QuatSymmetryDetector. calcLocalSymmetries(Structure structure, QuatSymmetryParameters symmParams, SubunitClustererParameters clusterParams)Returns a List of LOCAL symmetry results.voidQuatSymmetryResults. setStructure(Structure structure) - 
Uses of Structure in org.biojava.nbio.structure.symmetry.gui
Constructors in org.biojava.nbio.structure.symmetry.gui with parameters of type Structure Constructor Description SymmetryCalc(SymmetryGui p, Structure s)Requests for a structure to analyze. - 
Uses of Structure in org.biojava.nbio.structure.symmetry.utils
Methods in org.biojava.nbio.structure.symmetry.utils that return types with arguments of type Structure Modifier and Type Method Description static List<Structure>SymmetryTools. divideStructure(CeSymmResult symmetry)Method that converts the symmetric units of a structure into different structures, so that they can be individually visualized.Methods in org.biojava.nbio.structure.symmetry.utils with parameters of type Structure 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. - 
Uses of Structure in org.biojava.nbio.structure.xtal
Methods in org.biojava.nbio.structure.xtal with parameters of type Structure Modifier and Type Method Description static voidCrystalBuilder. expandNcsOps(Structure structure, Map<String,String> chainOrigNames, Map<String,javax.vecmath.Matrix4d> chainNcsOps)Apply the NCS operators in the given Structure adding new chains as needed.voidUnitCellBoundingBox. setBbs(Structure structure, javax.vecmath.Matrix4d[] ops, boolean includeHetAtoms)Constructors in org.biojava.nbio.structure.xtal with parameters of type Structure Constructor Description CrystalBuilder(Structure structure)CrystalBuilder(Structure structure, Map<String,String> chainOrigNames, Map<String,javax.vecmath.Matrix4d> chainNcsOps)Special constructor for NCS-aware CrystalBuilder. 
 -