Uses of Interface
org.biojava.nbio.structure.Structure
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.
This package deals with the server communication for auto-downloading pre-calculated alignments.
Utility methods for better interaction with Jmol.
Classes for the pairwise alignment of structures.
A few convenience classes to view protein structures with Jmol (if it is on the classpath),
to calculate a protein structure alignment and to investigate the internals of the protein structure alignment algorithm.
Some event classes for the protein structure GUIs.
Some utility classes for the protein structure GUIs.
Input and Output of Structures
Parsers and API for SCOP, Structural Classification of Proteins.
-
Uses of Structure in demo
Modifier and TypeMethodDescriptionstatic Structure
DemoShowLargeAssembly.readStructure
(String pdbId, int bioAssemblyId) Load a specific biological assembly for a PDB entry -
Uses of Structure in org.biojava.nbio.protmod.structure
Modifier and TypeMethodDescriptionvoid
Identify all registered modifications in a structure.void
ProteinModificationIdentifier.identify
(Structure structure, Set<ProteinModification> potentialModifications) Identify a set of modifications in a structure. -
Uses of Structure in org.biojava.nbio.structure
Modifier and TypeMethodDescriptionStructure.clone()
Return an identical copy of this Structure objectStructureImpl.clone()
Returns an identical copy of this structure .static Structure
StructureIO.getBiologicalAssembly
(String pdbId) Returns the first biological assembly that is available for the given PDB id, using multiModel=falsestatic Structure
StructureIO.getBiologicalAssembly
(String pdbId, boolean multiModel) Returns the first biological assembly that is available for the given PDB id.static Structure
StructureIO.getBiologicalAssembly
(String pdbId, int biolAssemblyNr) Returns the biological assembly for the given PDB id and bioassembly identifier, using multiModel=falsestatic Structure
StructureIO.getBiologicalAssembly
(String pdbId, int biolAssemblyNr, boolean multiModel) Returns the biological assembly for the given PDB id and bioassembly identifier.DBRef.getParent()
Get the structure object that this DBRef relates to.Chain.getStructure()
Returns the parent Structure of this chain.ChainImpl.getStructure()
static Structure
StructureIO.getStructure
(String name) Loads a structure based on a name.static Structure
StructureTools.getStructure
(String name) Short version ofStructureTools.getStructure(String, PDBFileParser, AtomCache)
which creates new parsers when neededstatic Structure
StructureTools.getStructure
(String name, PDBFileParser parser, AtomCache cache) Flexibly get a structure from an input String.BioAssemblyIdentifier.loadStructure
(AtomCache cache) PassthroughIdentifier.loadStructure
(AtomCache cache) Passthrough identifiers don't know how to load a structureStructureIdentifier.loadStructure
(AtomCache cache) Loads a structure encompassing the structure identified.SubstructureIdentifier.loadStructure
(AtomCache cache) Loads the complete structure based onSubstructureIdentifier.getPdbId()
.URLIdentifier.loadStructure
(AtomCache cache) Load the structure from the URLcreates a new structure which is identical with the original one.Takes a complete structure as input and reduces it to the substructure represented by this StructureIdentifier.Takes a complete structure as input and reduces it to residues present in the specified rangesstatic Structure
StructureTools.removeModels
(Structure s) Remove all models from a Structure and keep only the firstModifier and TypeMethodDescriptionStructureIO.getBiologicalAssemblies
(String pdbId) Returns all biological assemblies for the given PDB id, using multiModel=falseStructureIO.getBiologicalAssemblies
(String pdbId, boolean multiModel) Returns all biological assemblies for the given PDB id.Modifier and TypeMethodDescriptionstatic void
StructureTools.addGroupsToStructure
(Structure s, Collection<Group> groups, int model, boolean clone) Add a list of groups to a new structure.static Chain
StructureTools.addGroupToStructure
(Structure s, Group g, int model, Chain chainGuess, boolean clone) Adds a particular group to a structure.static void
StructureTools.cleanUpAltLocs
(Structure structure) Cleans up the structure's alternate location (altloc) groups.protected static void
SubstructureIdentifier.copyLigandsByProximity
(Structure full, Structure reduced) Supplements the reduced structure with ligands from the full structure based on a distance cutoff.protected static void
SubstructureIdentifier.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 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.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 Group
StructureTools.getGroupByPDBResidueNumber
(Structure struc, ResidueNumber pdbResNum) Get a group represented by a ResidueNumber.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.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 int
StructureTools.getNrAtoms
(Structure s) Count how many Atoms are contained within a Structure object.static int
StructureTools.getNrGroups
(Structure s) Count how many groups are contained within a structure object.static Atom[]
StructureTools.getRepresentativeAtomArray
(Structure s) Gets a representative atom for each group that is part of the chain backbone.creates a new structure which is identical with the original one.static final void
calculate structure + Matrix coodinates ...Takes a complete structure as input and reduces it to the substructure represented by this StructureIdentifier.Takes a complete structure as input and reduces it to residues present in the specified rangesstatic void
StructureTools.reduceToRepresentativeAtoms
(Structure structure) Remove all atoms but the representative atoms (C alphas or phosphates) from the given structure.static Structure
StructureTools.removeModels
(Structure s) Remove all models from a Structure and keep only the firststatic final void
Rotate a structure.static final void
Rotate a structure object.void
Set the structure object that this DBRef relates to.void
Chain.setStructure
(Structure parent) Sets the back-reference to its parent Structure.void
ChainImpl.setStructure
(Structure parent) static final void
shift a structure with a vector.static final void
Transforms a structure object, given a Matrix4d (i.e. the vecmath library double-precision 4x4 rotation+translation matrix).static final void
Translates a Structure object, given a Vector3d (i.e. the vecmath library double-precision 3-d vector)ModifierConstructorDescriptionAtomIterator
(Structure struct) Constructs an AtomIterator object over all modelsAtomIterator
(Structure struct, int modelNr) Constructs an AtomIterator object over a single modelCreates 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
Modifier and TypeMethodDescriptionvoid
Align two chains from the structures.void
StructurePairAligner.align
(Structure s1, String chainId1, Structure s2, String chainId2, StrucAligParameters params) Aligns two chains from the structures using user provided parameters.void
Calculate the alignment between the two full structures with default parametersvoid
StructurePairAligner.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. -
Uses of Structure in org.biojava.nbio.structure.align.ce
Modifier and TypeMethodDescriptionstatic Structure
GuiWrapper.getAlignedStructure
(Atom[] ca1, Atom[] ca2) Modifier and TypeMethodDescriptionstatic void
GuiWrapper.showStructure
(Structure structure) Shows a structure in Jmol -
Uses of Structure in org.biojava.nbio.structure.align.client
-
Uses of Structure in org.biojava.nbio.structure.align.gui
Modifier 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.SelectPDBPanel.getStructure1()
SelectPDBPanel.getStructure2()
ModifierConstructorDescriptionAlignmentCalc
(AlignmentGui parent, Structure s1, Structure s2, String name1, String name2) requests an alignment of pdb1 vs pdb 2.ModifierConstructorDescriptionMultipleAlignmentCalc
(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
Modifier and TypeMethodDescriptionAbstractAlignmentJmol.getStructure()
Return the current Structure in the AlignmentJmol instance.Modifier and TypeMethodDescriptionvoid
AbstractAlignmentJmol.setStructure
(Structure s) Set a new Structure to visualize in the AlignmentJmol window.void
JmolPanel.setStructure
(Structure s) void
JmolPanel.setStructure
(Structure s, boolean useMmtf) -
Uses of Structure in org.biojava.nbio.structure.align.multiple.util
Modifier and TypeMethodDescriptionstatic final Structure
MultipleAlignmentTools.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 Structure
MultipleAlignmentTools.toMultimodelStructure
(MultipleAlignment multAln, List<Atom[]> transformedAtoms) -
Uses of Structure in org.biojava.nbio.structure.align.pairwise
Modifier and TypeMethodDescriptionAlternativeAlignment.getAlignedStructure
(Structure s1, Structure s2) create an artifical Structure object that contains the two structures superimposed onto each other.Modifier and TypeMethodDescriptionAlternativeAlignment.getAlignedStructure
(Structure s1, Structure s2) create an artifical Structure object that contains the two structures superimposed onto each other.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
Modifier and TypeMethodDescriptionstatic QsAlignResult
QsAlign.align
(Structure s1, Structure s2, SubunitClustererParameters cParams, QsAlignParameters aParams) -
Uses of Structure in org.biojava.nbio.structure.align.util
Modifier and TypeMethodDescriptionstatic Structure
AFPAlignmentDisplay.createArtificalStructure
(AFPChain afpChain, Atom[] ca1, Atom[] ca2) static final Structure
AlignmentTools.getAlignedStructure
(Atom[] ca1, Atom[] ca2) Get an artifical Structure containing both chains.AtomCache.getBiologicalAssembly
(String pdbId, boolean multiModel) Returns the default biological unit (bioassemblyId=1, known in PDB as pdb1.gz).AtomCache.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()
AtomCache.getBiologicalAssembly
(PdbId 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()
AtomCache.getStructure
(String name) Request a Structure based on a name.AtomCache.getStructure
(StructureIdentifier strucId) Get the structure corresponding to the givenStructureIdentifier
.AtomCache.getStructureForCathDomain
(StructureName structureName) Returns aStructure
corresponding to the CATH identifier supplied instructureName
, using the theCathDatabase
atCathFactory.getCathDatabase()
.AtomCache.getStructureForCathDomain
(StructureName structureName, CathDatabase cathInstall) Returns aStructure
corresponding to the CATH identifier supplied instructureName
, using the specifiedCathDatabase
.AtomCache.getStructureForDomain
(String scopId) Returns the representation of aScopDomain
as a BioJavaStructure
object.AtomCache.getStructureForDomain
(String scopId, ScopDatabase scopDatabase) Returns the representation of aScopDomain
as a BioJavaStructure
object.AtomCache.getStructureForDomain
(ScopDomain domain) Returns the representation of aScopDomain
as a BioJavaStructure
object.AtomCache.getStructureForDomain
(ScopDomain domain, ScopDatabase scopDatabase) Returns the representation of aScopDomain
as a BioJavaStructure
object.AtomCache.getStructureForDomain
(ScopDomain domain, ScopDatabase scopDatabase, boolean strictLigandHandling) Returns the representation of aScopDomain
as a BioJavaStructure
object.AtomCache.getStructureForPdbId
(String id) Loads a structure directly by PDB IDAtomCache.getStructureForPdbId
(PdbId pdbId) Loads a structure directly by PDB IDprotected Structure
AtomCache.loadStructureFromBcifByPdbId
(String pdbId) protected Structure
AtomCache.loadStructureFromBcifByPdbId
(PdbId pdbId) protected Structure
AtomCache.loadStructureFromCifByPdbId
(String pdbId) protected Structure
AtomCache.loadStructureFromCifByPdbId
(PdbId pdbId) protected Structure
AtomCache.loadStructureFromPdbByPdbId
(String pdbId) protected Structure
AtomCache.loadStructureFromPdbByPdbId
(PdbId pdbId) Modifier and TypeMethodDescriptionAtomCache.getBiologicalAssemblies
(String pdbId, boolean multiModel) Returns all biological assemblies for given PDB id. -
Uses of Structure in org.biojava.nbio.structure.asa
ModifierConstructorDescriptionAsaCalculator
(Structure structure, double probe, int nSpherePoints, int nThreads, boolean hetAtoms) Constructs a new AsaCalculator. -
Uses of Structure in org.biojava.nbio.structure.basepairs
ModifierConstructorDescriptionBasePairParameters
(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
-
Uses of Structure in org.biojava.nbio.structure.cluster
Modifier and TypeMethodDescriptionSubunit.getStructure()
The parent Structure from which the Subunit atoms were obtained.Modifier and TypeMethodDescriptionstatic Stoichiometry
SubunitClusterer.cluster
(Structure structure, SubunitClustererParameters params) 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.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 Structure in org.biojava.nbio.structure.contact
Modifier and TypeMethodDescriptionstatic StructureInterfaceList
StructureInterfaceList.calculateInterfaces
(Structure struc) Calculates the interfaces for a structure using default parameters -
Uses of Structure in org.biojava.nbio.structure.domain
Modifier and TypeMethodDescriptionLocalProteinDomainParser.suggestDomains
(Structure s) Suggest domains for a protein structure -
Uses of Structure in org.biojava.nbio.structure.ecod
-
Uses of Structure in org.biojava.nbio.structure.gui
Modifier and TypeMethodDescriptionvoid
BiojavaJmol.setStructure
(Structure s) void
JmolViewerImpl.setStructure
(Structure structure) void
StructureViewer.setStructure
(Structure structure) void
SequenceDisplay.setStructure1
(Structure structure) void
SequenceDisplay.setStructure2
(Structure structure) -
Uses of Structure in org.biojava.nbio.structure.gui.events
Modifier and TypeMethodDescriptionvoid
JmolAlignedPositionListener.setStructure1
(Structure structure1) void
JmolAlignedPositionListener.setStructure2
(Structure structure2) -
Uses of Structure in org.biojava.nbio.structure.gui.util
Modifier and TypeMethodDescriptionPDBDirPanel.getStructure1()
PDBServerPanel.getStructure1()
PDBUploadPanel.getStructure1()
ScopSelectPanel.getStructure1()
StructurePairSelector.getStructure1()
PDBDirPanel.getStructure2()
PDBServerPanel.getStructure2()
PDBUploadPanel.getStructure2()
ScopSelectPanel.getStructure2()
StructurePairSelector.getStructure2()
ModifierConstructorDescriptionAlignmentCalc
(AlignmentGui parent, Structure s1, Structure s2) requests an alignment of pdb1 vs pdb 2. -
Uses of Structure in org.biojava.nbio.structure.io
Modifier and TypeMethodDescriptionBcifFileReader.getStructure
(InputStream inStream) CifFileReader.getStructure
(InputStream inStream) LocalPDBDirectory.getStructure
(File filename) abstract Structure
LocalPDBDirectory.getStructure
(InputStream inStream) Handles the actual parsing of the file into a Structure object.LocalPDBDirectory.getStructure
(String filename) LocalPDBDirectory.getStructure
(URL u) MMTFFileReader.getStructure
(InputStream inStream) PDBFileReader.getStructure
(InputStream inStream) StructureIOFile.getStructure
(File file) Read file from File and returns a Structure object.StructureIOFile.getStructure
(String filename) Open filename and return a Structure object.LocalPDBDirectory.getStructureById
(String pdbId) Get the structure for a PDB IDLocalPDBDirectory.getStructureById
(PdbId pdbId) Get the structure for a PDB IDStructureProvider.getStructureById
(String pdbId) Get the structure for a PDB IDStructureProvider.getStructureById
(PdbId pdbId) Get the structure for a PDB IDFastaStructureParser.getStructures()
Gets the protein structures mapped from the Fasta file.static Structure
StructureSequenceMatcher.getSubstructureMatchingProteinSequence
(ProteinSequence sequence, Structure wholeStructure) PDBFileParser.parsePDBFile
(BufferedReader buf) Parse a PDB file and return a datastructure implementing PDBStructure interface.PDBFileParser.parsePDBFile
(InputStream inStream) Parse a PDB file and return a datastructure implementing PDBStructure interface.Modifier and TypeMethodDescriptionstatic void
ChargeAdder.addCharges
(Structure structure) Function to add the charges to a given structure.void
static AFPChain
FastaAFPChainConverter.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 sitecpSite
residues to the right.static AFPChain
FastaAFPChainConverter.cpFastaToAfpChain
(String first, String second, Structure structure, int cpSite) static AFPChain
FastaAFPChainConverter.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 sitecpSite
residues to the right.static AFPChain
FastaAFPChainConverter.fastaFileToAfpChain
(File fastaFile, Structure structure1, Structure structure2) Reads the filefastaFile
, expecting exactly two sequences which give a pairwise alignment.static AFPChain
FastaAFPChainConverter.fastaStringToAfpChain
(String sequence1, String sequence2, Structure structure1, Structure structure2) Returns an AFPChain corresponding to the alignment betweenstructure1
andstructure2
, which is given by the gapped protein sequencessequence1
andsequence2
.static AFPChain
FastaAFPChainConverter.fastaToAfpChain
(String sequence1, String sequence2, Structure structure1, Structure structure2) TODO Write commentstatic AFPChain
FastaAFPChainConverter.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 AFPChain
FastaAFPChainConverter.fastaToAfpChain
(SequencePair<Sequence<AminoAcidCompound>, AminoAcidCompound> alignment, Structure structure1, Structure structure2) Provided only for convenience.static AFPChain
FastaAFPChainConverter.fastaToAfpChain
(ProteinSequence sequence1, ProteinSequence sequence2, Structure structure1, Structure structure2) Returns an AFPChain corresponding to the alignment betweenstructure1
andstructure2
, which is given by the gapped protein sequencessequence1
andsequence2
.static ProteinSequence
StructureSequenceMatcher.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 Structure
StructureSequenceMatcher.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 void
SeqRes2AtomAligner.storeUnAlignedSeqRes
(Structure structure, List<Chain> seqResChains, boolean headerOnly) Storing unaligned SEQRES groups in a Structure.ModifierConstructorDescriptionBondMaker
(Structure structure, FileParsingParameters params) FileConvert
(Structure struc) Constructs a FileConvert object. -
Uses of Structure in org.biojava.nbio.structure.io.cif
Modifier and TypeMethodDescriptionstatic Structure
CifStructureConverter.fromCifFile
(org.rcsb.cif.model.CifFile cifFile) Convert CifFile to Structure without any FileParsingParameters.static Structure
CifStructureConverter.fromCifFile
(org.rcsb.cif.model.CifFile cifFile, FileParsingParameters parameters) Convert CifFile to Structure.static Structure
CifStructureConverter.fromInputStream
(InputStream inputStream) Convert InputStream to Structure without any FileParsingParameters.static Structure
CifStructureConverter.fromInputStream
(InputStream inputStream, FileParsingParameters parameters) Convert InputStream to Structure.static Structure
Read data from a file and convert to Structure without any FileParsingParameters.static Structure
CifStructureConverter.fromPath
(Path path, FileParsingParameters parameters) Read data from a file and convert to Structure.static Structure
Get data from a URL and convert to Structure without any FileParsingParameters.static Structure
CifStructureConverter.fromURL
(URL url, FileParsingParameters parameters) Get data from a URL and convert to Structure.CifStructureConsumerImpl.getContainer()
Modifier and TypeMethodDescriptionorg.rcsb.cif.model.CifFile
protected org.rcsb.cif.model.CifFile
AbstractCifFileSupplier.getInternal
(Structure structure, List<AbstractCifFileSupplier.WrappedAtom> wrappedAtoms) static byte[]
Convert a structure to BCIF format.static void
CifStructureConverter.toBinaryFile
(Structure structure, Path path) Write a structure to a BCIF file.static org.rcsb.cif.model.CifFile
Convert Structure to CifFile.static String
Convert a structure to mmCIF format.static void
CifStructureConverter.toTextFile
(Structure structure, Path path) Write a structure to a CIF file. -
Uses of Structure in org.biojava.nbio.structure.io.mmtf
Modifier and TypeMethodDescriptionMmtfStructureReader.getStructure()
Gets the structure.static Structure
MmtfActions.readFromFile
(Path filePath) Get a Structure object from a mmtf file.static Structure
MmtfActions.readFromInputStream
(InputStream inStream) Read a Biojava structure from anInputStream
Modifier and TypeMethodDescriptionstatic void
MmtfUtils.calculateDsspSecondaryStructure
(Structure bioJavaStruct) Generate the secondary structure for a Biojava structure object.static void
MmtfUtils.fixMicroheterogenity
(Structure bioJavaStruct) This sets all microheterogeneous groups (previously alternate location groups) as separate groups.static int
MmtfUtils.getNumGroups
(Structure structure) Count the total number of groups in the structurestatic MmtfSummaryDataBean
MmtfUtils.getStructureInfo
(Structure structure) Get summary information for the structure.static void
MmtfActions.writeToFile
(Structure structure, Path path) Write a Structure object to a file.static void
MmtfActions.writeToOutputStream
(Structure structure, OutputStream outputStream) Write a Structure object to anOutputStream
ModifierConstructorDescriptionMmtfStructureWriter
(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
Modifier and TypeMethodDescriptionstatic Structure
BioAssemblyTools.getReducedStructure
(Structure orig) Reduce a structure to a single-atom representation (e.g.BiologicalAssemblyBuilder.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.Modifier and TypeMethodDescriptionstatic 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 double
BioAssemblyTools.getBiologicalMoleculeMaximumExtend
(Structure structure, List<BiologicalAssemblyTransformation> transformations) Returns the maximum extend of the biological molecule in the x, y, or z direction.static double
BioAssemblyTools.getMaximumExtend
(Structure structure) Returns the maximum extend of the structure in the x, y, or z direction.static Structure
BioAssemblyTools.getReducedStructure
(Structure orig) Reduce a structure to a single-atom representation (e.g.BiologicalAssemblyBuilder.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
-
Uses of Structure in org.biojava.nbio.structure.secstruc
Modifier and TypeMethodDescriptionstatic void
SecStrucTools.assignSecStruc
(Structure s, List<SecStrucInfo> listSSI) Predicts the secondary structure of this Structure object, using a DSSP implementation.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> Parse a DSSP output file and return the secondary structure annotation as a List ofSecStrucState
objects.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 ofSecStrucState
objects.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 ofSecStrucState
objects. -
Uses of Structure in org.biojava.nbio.structure.symmetry.core
Modifier and TypeMethodDescriptionstatic QuatSymmetryResults
QuatSymmetryDetector.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.void
QuatSymmetryResults.setStructure
(Structure structure) -
Uses of Structure in org.biojava.nbio.structure.symmetry.gui
ModifierConstructorDescriptionSymmetryCalc
(SymmetryGui p, Structure s) Requests for a structure to analyze. -
Uses of Structure in org.biojava.nbio.structure.symmetry.utils
Modifier and TypeMethodDescriptionSymmetryTools.divideStructure
(CeSymmResult symmetry) Method that converts the symmetric units of a structure into different structures, so that they can be individually visualized.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. -
Uses of Structure in org.biojava.nbio.structure.xtal
Modifier and TypeMethodDescriptionstatic void
CrystalBuilder.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.void
UnitCellBoundingBox.setBbs
(Structure structure, javax.vecmath.Matrix4d[] ops, boolean includeHetAtoms) ModifierConstructorDescriptionCrystalBuilder
(Structure structure) CrystalBuilder
(Structure structure, Map<String, String> chainOrigNames, Map<String, javax.vecmath.Matrix4d> chainNcsOps) Special constructor for NCS-aware CrystalBuilder.