Uses of Interface
org.biojava.bio.seq.Sequence
-
Packages that use Sequence Package Description org.biojava.bio.alignment Classes to generate and describe sequence alignments.org.biojava.bio.dist Probability distributions over Alphabets.org.biojava.bio.dp HMM and Dynamic Programming Algorithms.org.biojava.bio.gui.sequence Graphical displays of biological sequences and associated annotations.org.biojava.bio.gui.sequence.tracklayout Classes for the handling of the layout of a WrappedSequencePanel.org.biojava.bio.molbio The classes and interfaces in this package cover common molecular biological techniques such as restriction digests and PCR.org.biojava.bio.program.fastq FASTQ and variants sequence format I/O.org.biojava.bio.program.gff GFF manipulation.org.biojava.bio.program.phred Parser for Phred outputorg.biojava.bio.program.ssbind Creation of objects from SAX events using the BioJava BlastLikeDataSetCollection DTD.org.biojava.bio.program.unigene Objects for representing Unigene clusters.org.biojava.bio.program.xff Event-driven parsing system for the Extensible Feature Format (XFF).org.biojava.bio.proteomics Utilities to aid in performing various physical analysis of proteins.org.biojava.bio.search Interfaces and classes for representing sequence similarity search results.org.biojava.bio.seq Classes and interfaces for defining biological sequences and informatics objects.org.biojava.bio.seq.db Collections of biological sequence data.org.biojava.bio.seq.db.biofetch Client for the OBDA BioFetch protocol.org.biojava.bio.seq.db.biosql General purpose Sequence storage in a relational database.org.biojava.bio.seq.db.flat Support for OBDA flatfile databases.org.biojava.bio.seq.distributed Sequences and SequenceDBs which are composed from data taken from a number of data sources.org.biojava.bio.seq.impl Standard in-memory implementations ofSequenceandFeature.org.biojava.bio.seq.io Classes and interfaces for processing and producing flat-file representations of sequences.org.biojava.bio.seq.io.agave Classes for converting between AGAVE XML and BioJava objects.org.biojava.bio.seq.projection Code for projecting Feature objects and systematically altering their properties.org.biojavax.bio.db Interactions between biojavax objects and a DB.org.biojavax.bio.seq Rich implementations of Sequences, Locations and Features.org.biojavax.bio.seq.io Classes to support the I/O of RichSequence and Bioentry objects. -
-
Uses of Sequence in org.biojava.bio.alignment
Methods in org.biojava.bio.alignment with parameters of type Sequence Modifier and Type Method Description static AlignmentPairAlignmentPair. align(Sequence query, Sequence subject, AlignmentAlgorithm algorithm)Constructors in org.biojava.bio.alignment with parameters of type Sequence Constructor Description AlignmentPair(Sequence query, Sequence subject, int queryStart, int queryEnd, int subjectStart, int subjectEnd, SubstitutionMatrix subMatrix)AlignmentPair(Sequence query, Sequence subject, SubstitutionMatrix subMatrix) -
Uses of Sequence in org.biojava.bio.dist
Methods in org.biojava.bio.dist that return Sequence Modifier and Type Method Description protected static SequenceDistributionTools. generateOrderNSequence(String name, OrderNDistribution d, int length)Deprecated.use generateSequence() or generateSymbolList() instead.static SequenceDistributionTools. generateSequence(String name, Distribution d, int length)Produces a sequence by randomly sampling the Distribution. -
Uses of Sequence in org.biojava.bio.dp
Methods in org.biojava.bio.dp that return Sequence Modifier and Type Method Description SequenceWeightMatrixAnnotator. annotate(Sequence seq)Methods in org.biojava.bio.dp with parameters of type Sequence Modifier and Type Method Description SequenceWeightMatrixAnnotator. annotate(Sequence seq) -
Uses of Sequence in org.biojava.bio.gui.sequence
Methods in org.biojava.bio.gui.sequence that return Sequence Modifier and Type Method Description SequencePairwiseSequencePanel. getSecondarySequence()getSecondarySequencereturns the entire secondarySequencecurrently being rendered.SequencePairwiseSequencePanel. getSequence()getSequencereturns the entireSequencecurrently being rendered.SequenceSequencePanelWrapper. getSequence()SequenceSequencePoster. getSequence()Deprecated.Methods in org.biojava.bio.gui.sequence with parameters of type Sequence Modifier and Type Method Description voidPairwiseSequencePanel. setSecondarySequence(Sequence sequence)setSecondarySequencesets the secondarySequenceto be rendered.voidPairwiseSequencePanel. setSequence(Sequence sequence)setSequencesets theSequenceto be rendered.voidSequencePanelWrapper. setSequence(Sequence seq)voidSequencePoster. setSequence(Sequence s)Deprecated.Set the SymboList to be rendered.Constructors in org.biojava.bio.gui.sequence with parameters of type Sequence Constructor Description HeadlessRenderContext(Sequence seq, RangeLocation range, int width) -
Uses of Sequence in org.biojava.bio.gui.sequence.tracklayout
Methods in org.biojava.bio.gui.sequence.tracklayout with parameters of type Sequence Modifier and Type Method Description voidSimpleTrackLayout. setSequence(Sequence seq)voidTrackLayout. setSequence(Sequence seq)voidUserDefinedTrackLayout. setSequence(Sequence seq)Constructors in org.biojava.bio.gui.sequence.tracklayout with parameters of type Sequence Constructor Description SimpleTrackLayout(Sequence seq, int wrap) -
Uses of Sequence in org.biojava.bio.molbio
Methods in org.biojava.bio.molbio that return Sequence Modifier and Type Method Description SequenceRestrictionMapper. annotate(Sequence sequence)annotateaddsFeatures which represent restriction sites.Methods in org.biojava.bio.molbio with parameters of type Sequence Modifier and Type Method Description SequenceRestrictionMapper. annotate(Sequence sequence)annotateaddsFeatures which represent restriction sites. -
Uses of Sequence in org.biojava.bio.program.fastq
Methods in org.biojava.bio.program.fastq that return Sequence Modifier and Type Method Description static SequenceFastqTools. createDNASequence(Fastq fastq)Create and return a new DNASequencefrom the specified FASTQ formatted sequence. -
Uses of Sequence in org.biojava.bio.program.gff
Methods in org.biojava.bio.program.gff that return Sequence Modifier and Type Method Description static SequenceGFFTools. annotateSequence(Sequence seq, GFFEntrySet ents)Annotates a sequence with the features from a GFF entry set with sequence name matching this sequence.static SequenceGFFTools. annotateSequence(Sequence seq, GFFEntrySet ents, boolean checkSeqName)Annotates a sequence with the features from a GFF entry set.Methods in org.biojava.bio.program.gff with parameters of type Sequence Modifier and Type Method Description static SequenceGFFTools. annotateSequence(Sequence seq, GFFEntrySet ents)Annotates a sequence with the features from a GFF entry set with sequence name matching this sequence.static SequenceGFFTools. annotateSequence(Sequence seq, GFFEntrySet ents, boolean checkSeqName)Annotates a sequence with the features from a GFF entry set.protected voidSequencesAsGFF. doPreProcessSequence(Sequence seq, GFFDocumentHandler handler, String id)Emit any per-sequence header information.protected voidSequencesAsGFF. doProcessSequence(Sequence seq, GFFDocumentHandler handler, String id)Internal method to process an individual Sequence.static GFFEntrySetGFFTools. gffFromSequence(Sequence seq)Creates a GFFEntrySet containing one entry for each feature on a sequence.voidSequencesAsGFF. processSequence(Sequence seq, GFFDocumentHandler handler)Process an individual Sequence, informing handler of any suitable features. -
Uses of Sequence in org.biojava.bio.program.phred
Classes in org.biojava.bio.program.phred that implement Sequence Modifier and Type Class Description classPhredSequencePhredSequence is an extension of SimpleSequence that implements Qualitative to hold Phred quality scores.Methods in org.biojava.bio.program.phred with parameters of type Sequence Modifier and Type Method Description protected StringPhredFormat. describeSequence(Sequence seq)Return a suitable description line for a Sequence.voidPhredFormat. writeSequence(Sequence seq, PrintStream os)This method will print symbols to the line width followed by a new line etc.voidPhredFormat. writeSequence(Sequence seq, String format, PrintStream os)Deprecated.use writeSequence(Sequence seq, PrintStream os) -
Uses of Sequence in org.biojava.bio.program.ssbind
Methods in org.biojava.bio.program.ssbind that return Sequence Modifier and Type Method Description SequenceSimilarityPairBuilder. getAnnotatedQuerySeq(String queryID)SequenceSimilarityPairBuilder. getAnnotatedSubjectSeq(String subjectID)protected SequenceViewSequenceFactory. makeQueryViewSequence(String queryID)protected SequenceViewSequenceFactory. makeSubjectViewSequence(String subjectID) -
Uses of Sequence in org.biojava.bio.program.unigene
Methods in org.biojava.bio.program.unigene that return Sequence Modifier and Type Method Description SequenceUnigeneCluster. getUnique()The unique sequence that is used as a representative for this cluster. -
Uses of Sequence in org.biojava.bio.program.xff
Methods in org.biojava.bio.program.xff that return Sequence Modifier and Type Method Description static SequenceXFFTools. readXFF(File xffFile, String seqID)static SequenceXFFTools. readXFF(File xffFile, String seqID, FiniteAlphabet alpha)Methods in org.biojava.bio.program.xff with parameters of type Sequence Modifier and Type Method Description static voidXFFTools. annotateXFF(File xffFile, Sequence sequence)static voidXFFTools. annotateXFF(File xffFile, Sequence sequence, Annotation ann) -
Uses of Sequence in org.biojava.bio.proteomics
Methods in org.biojava.bio.proteomics that return Sequence Modifier and Type Method Description SequenceDigest. getSequence()Methods in org.biojava.bio.proteomics with parameters of type Sequence Modifier and Type Method Description voidDigest. setSequence(Sequence sequence) -
Uses of Sequence in org.biojava.bio.search
Methods in org.biojava.bio.search that return Sequence Modifier and Type Method Description SequenceSeqSimilaritySearchResult. getQuerySequence()Returns the query sequence which was used to perform the search.SequenceSequenceDBSearchResult. getQuerySequence()Deprecated.SequenceSimpleSeqSimilaritySearchResult. getQuerySequence()Constructors in org.biojava.bio.search with parameters of type Sequence Constructor Description SequenceDBSearchResult(Sequence querySequence, SequenceDB sequenceDB, Map searchParameters, List hits, Annotation annotation)Deprecated.Creates a newSequenceDBSearchResult.SimpleSeqSimilaritySearchResult(Sequence querySequence, SequenceDB sequenceDB, Map searchParameters, List hits, Annotation annotation)Creates a newSimpleSeqSimilaritySearchResult. -
Uses of Sequence in org.biojava.bio.seq
Subinterfaces of Sequence in org.biojava.bio.seq Modifier and Type Interface Description interfaceGappedSequenceExtension of GappedSymbolList which also projects features into the gapped coordinate system.Classes in org.biojava.bio.seq that implement Sequence Modifier and Type Class Description classCircularViewA circular view onto another Sequence object.classNewSimpleAssemblyA Sequence which is assembled from other sequences contained in a set of ComponentFeature objects.classSimpleAssemblyA Sequence which is assembled from other sequences contained in a set of ComponentFeature objects.Fields in org.biojava.bio.seq declared as Sequence Modifier and Type Field Description SequenceComponentFeature.Template. componentSequenceMethods in org.biojava.bio.seq that return Sequence Modifier and Type Method Description SequenceSequenceAnnotator. annotate(Sequence seq)Return an annotated version of a sequence.static SequenceDNATools. createDNASequence(String dna, String name)Return a new DNA Sequence for dna.static SequenceSequenceTools. createDummy(String uri, String name)Create a new Sequence that has no annotation, no features and a zero-length symbol list.static SequenceSequenceTools. createDummy(Alphabet alpha, int length, Symbol sym, String uri, String name)Create a new Sequence that contains a single symbol repeated over and over.static SequenceNucleotideTools. createNucleotideSequence(String nucleotide, String name)Return a new Nucleotide Sequence for nucleotide.static SequenceProteinTools. createProteinSequence(String protein, String name)Return a new PROTEIN Sequence for protein.static SequenceRNATools. createRNASequence(String rna, String name)Return a new RNA Sequence for rna.SequenceSequenceFactory. createSequence(SymbolList symList, String uri, String name, Annotation annotation)Deprecated.Creates a sequence using these parameters.static SequenceSequenceTools. createSequence(SymbolList syms, String uri, String name, Annotation ann)SequenceComponentFeature. getComponentSequence()Get the sequence object which provides a component of this feature's parent sequence.SequenceFeature. getSequence()Return theSequenceobject to which this feature is (ultimately) attached.static SequenceSequenceTools. maskSequence(Sequence seq, RangeLocation loc)Mask of a sequence.SequenceSequenceIterator. nextSequence()Returns the next sequence in the iterator.static SequenceSequenceTools. reverseComplement(Sequence seq)Reverse-complement a sequence, and flip all of its features.static SequenceSequenceTools. subSequence(Sequence seq, int start, int end)Extract a sub-sequence from a sequence.static SequenceSequenceTools. subSequence(Sequence seq, int start, int end, String name)Extract a sub-sequence from a sequence.static SequenceSequenceTools. subSequence(Sequence seq, int start, int end, String name, StrandedFeature.Strand strand)Extract a sub-sequence from a sequence.Methods in org.biojava.bio.seq with parameters of type Sequence Modifier and Type Method Description static voidSequenceTools. addAllFeatures(Sequence seq, FeatureHolder fh)Add features to a sequence that contain the same information as all those in a feature holder.SequenceSequenceAnnotator. annotate(Sequence seq)Return an annotated version of a sequence.static GappedSequenceSequenceTools. gappedView(Sequence seq)Create a new gapped sequence for a sequence.static SequenceSequenceTools. maskSequence(Sequence seq, RangeLocation loc)Mask of a sequence.FeatureFeatureRealizer. realizeFeature(Sequence seq, FeatureHolder parent, Feature.Template template)Install a feature on the specified sequence.FeatureSimpleFeatureRealizer. realizeFeature(Sequence seq, FeatureHolder parent, Feature.Template temp)static SequenceSequenceTools. reverseComplement(Sequence seq)Reverse-complement a sequence, and flip all of its features.static SequenceSequenceTools. subSequence(Sequence seq, int start, int end)Extract a sub-sequence from a sequence.static SequenceSequenceTools. subSequence(Sequence seq, int start, int end, String name)Extract a sub-sequence from a sequence.static SequenceSequenceTools. subSequence(Sequence seq, int start, int end, String name, StrandedFeature.Strand strand)Extract a sub-sequence from a sequence.static ViewSequenceSequenceTools. view(Sequence seq)Create a new sequence that has all of the data in the original, but allows new features and top-level annotations to be added independantly.static ViewSequenceSequenceTools. view(Sequence seq, String name)Create a new sequence that has all of the data in the original, but allows new features and top-level annotations to be added independantly.static ViewSequenceSequenceTools. view(Sequence seq, FeatureRealizer fr)Creates a new Sequence with the data of the old but with a different FeatureRealizer that will be applied to new Features.Constructors in org.biojava.bio.seq with parameters of type Sequence Constructor Description CircularView(Sequence seq)CircularView(Sequence seq, FeatureRealizer fr) -
Uses of Sequence in org.biojava.bio.seq.db
Methods in org.biojava.bio.seq.db that return Sequence Modifier and Type Method Description protected SequenceAnnotatedSequenceDB. doAnnotation(Sequence seq)Apply the annotation to a sequence.SequenceAnnotatedSequenceDB. getSequence(String id)SequenceCachingSequenceDB. getSequence(String id)SequenceDummySequenceDB. getSequence(String id)SequenceGenbankSequenceDB. getSequence(String id)SequenceGenpeptSequenceDB. getSequence(String id)SequenceHashSequenceDB. getSequence(String id)SequenceIndexedSequenceDB. getSequence(String id)SequenceSequenceDBLite. getSequence(String id)Retrieve a single sequence by its id.SequenceSubSequenceDB. getSequence(String id)SequenceSwissprotSequenceDB. getSequence(String id)SequenceViewingSequenceDB. getSequence(String id)SequenceWebSequenceDB. getSequence(String id)Gets a sequence using its unique ID (eg for GenBank this would be the GI number)Methods in org.biojava.bio.seq.db with parameters of type Sequence Modifier and Type Method Description voidAbstractSequenceDB. addSequence(Sequence seq)voidDummySequenceDB. addSequence(Sequence seq)voidHashSequenceDB. addSequence(String id, Sequence seq)Add a sequence under a particular id.voidHashSequenceDB. addSequence(Sequence seq)voidSequenceDBLite. addSequence(Sequence seq)Adds a sequence to the database.voidWebSequenceDB. addSequence(Sequence seq)Not supported, You can't add sequences to a WebDB!StringIDMaker.ByName. calcID(Sequence seq)StringIDMaker.ByURN. calcID(Sequence seq)StringIDMaker. calcID(Sequence seq)Calculate the id for a sequence.protected SequenceAnnotatedSequenceDB. doAnnotation(Sequence seq)Apply the annotation to a sequence. -
Uses of Sequence in org.biojava.bio.seq.db.biofetch
Methods in org.biojava.bio.seq.db.biofetch that return Sequence Modifier and Type Method Description SequenceBioFetchSequenceDB. getSequence(String id)Methods in org.biojava.bio.seq.db.biofetch with parameters of type Sequence Modifier and Type Method Description voidBioFetchSequenceDB. addSequence(Sequence seq) -
Uses of Sequence in org.biojava.bio.seq.db.biosql
Methods in org.biojava.bio.seq.db.biosql that return Sequence Modifier and Type Method Description SequenceBioSQLSequenceDB. getSequence(int bioentry_id)Deprecated.SequenceBioSQLSequenceDB. getSequence(String id)Deprecated.Methods in org.biojava.bio.seq.db.biosql with parameters of type Sequence Modifier and Type Method Description voidBioSQLSequenceDB. addSequence(Sequence seq)Deprecated. -
Uses of Sequence in org.biojava.bio.seq.db.flat
Methods in org.biojava.bio.seq.db.flat that return Sequence Modifier and Type Method Description SequenceFlatSequenceDB. getSequence(String id)Methods in org.biojava.bio.seq.db.flat with parameters of type Sequence Modifier and Type Method Description voidFlatSequenceDB. addSequence(Sequence sequence)addSequencealways throws aChangeVetoExceptionas this implementation is immutable. -
Uses of Sequence in org.biojava.bio.seq.distributed
Methods in org.biojava.bio.seq.distributed that return Sequence Modifier and Type Method Description SequenceDistDataSource. getSequence(String id)Get a Sequence object for an ID.SequenceDistributedSequenceDB. getSequence(String id)SequenceGFFDataSource. getSequence(String id)SequenceSequenceDBDataSource. getSequence(String id)Methods in org.biojava.bio.seq.distributed with parameters of type Sequence Modifier and Type Method Description voidDistributedSequenceDB. addSequence(Sequence seq) -
Uses of Sequence in org.biojava.bio.seq.impl
Classes in org.biojava.bio.seq.impl that implement Sequence Modifier and Type Class Description classDummySequenceA Sequence implementation that has a name and URI but no features, and a zero length symbol list.classRevCompSequenceA reverse complement view ontoSequenceinterface.classSimpleGappedSequenceSimple implementation of GappedSequence.classSimpleSequenceA basic implementation of theSequenceinterface.classSubSequenceView a sub-section of a given sequence object, including all the features intersecting that region.classViewSequenceA view onto another Sequence object.Fields in org.biojava.bio.seq.impl declared as Sequence Modifier and Type Field Description protected SequenceRevCompSequence. origSeqMethods in org.biojava.bio.seq.impl that return Sequence Modifier and Type Method Description SequenceSimpleSequenceFactory. createSequence(SymbolList symList, String uri, String name, Annotation annotation)SequenceSimpleFeature. getSequence()SequenceSubSequence. getSequence()Return the parent sequence of which this is a partial viewConstructors in org.biojava.bio.seq.impl with parameters of type Sequence Constructor Description RevCompSequence(Sequence seq)URN, Name and Annotation are copied as is from the original Sequence, unless you use the the other contructor that sets these.RevCompSequence(Sequence seq, String urn, String name, Annotation annotation)SimpleFeature(Sequence sourceSeq, FeatureHolder parent, Feature.Template template)Create aSimpleFeatureon the given sequence.SimpleFramedFeature(Sequence sourceSeq, FeatureHolder parent, FramedFeature.Template template)SimpleGappedSequence(Sequence seq)SimpleHomologyFeature(Sequence sourceSeq, FeatureHolder parent, HomologyFeature.Template template)SimpleRemoteFeature(Sequence sourceSeq, FeatureHolder parent, RemoteFeature.Template template)SimpleRestrictionSite(Sequence sourceSeq, FeatureHolder parent, RestrictionSite.Template template)Creates a newSimpleRestrictionSite.SimpleSimilarityPairFeature(Sequence sourceSeq, FeatureHolder parent, SimilarityPairFeature.Template template)Creates a newSimpleSimilarityPairFeature.SimpleStrandedFeature(Sequence sourceSeq, FeatureHolder parent, StrandedFeature.Template template)SubSequence(Sequence seq, int start, int end)Construct a new SubSequence of the specified sequence.SubSequence(Sequence seq, int start, int end, String name)Construct a new SubSequence of the specified sequence.ViewSequence(Sequence seq)Construct a view onto an existing sequence which takes on that sequence's name.ViewSequence(Sequence seq, String name)Construct a view onto an existing sequence and give it a new name.ViewSequence(Sequence seq, FeatureRealizer fr)Construct a view onto a sequence, using a specific FeatureRealizer. -
Uses of Sequence in org.biojava.bio.seq.io
Fields in org.biojava.bio.seq.io declared as Sequence Modifier and Type Field Description protected SequenceSequenceBuilderBase. seqMethods in org.biojava.bio.seq.io that return Sequence Modifier and Type Method Description SequenceSequenceBuilder. makeSequence()Return the Sequence object which has been constructed by this builder.SequenceSequenceBuilderBase. makeSequence()SequenceSequenceBuilderFilter. makeSequence()SequenceSequenceDBSequenceBuilder. makeSequence()create the sequenceSequenceSimpleAssemblyBuilder. makeSequence()SequenceSimpleSequenceBuilder. makeSequence()SequenceSmartSequenceBuilder. makeSequence()SequenceStreamReader. nextSequence()Pull the next sequence out of the stream.Methods in org.biojava.bio.seq.io with parameters of type Sequence Modifier and Type Method Description protected StringFastaFormat. describeSequence(Sequence seq)Deprecated.Return a suitable description line for a Sequence.voidSeqIOEventEmitter. getSeqIOEvents(Sequence seq, SeqIOListener listener)Deprecated.getSeqIOEventsscans aSequenceobject and sends events describing its data to theSeqIOListener.static voidSeqIOTools. writeEmbl(OutputStream os, Sequence seq)Deprecated.Writes a single Sequence to an OutputStream in EMBL format.static voidSeqIOTools. writeFasta(OutputStream os, Sequence seq)Deprecated.Writes a single Sequence to an OutputStream in Fasta format.static voidSeqIOTools. writeGenbank(OutputStream os, Sequence seq)Deprecated.Writes a single Sequence to an OutputStream in Genbank format.static voidSeqIOTools. writeGenpept(OutputStream os, Sequence seq)Deprecated.Writes a single Sequence to an OutputStream in Genpept format.voidEmblLikeFormat. writeSequence(Sequence seq, PrintStream os)Deprecated.voidEmblLikeFormat. writeSequence(Sequence seq, String format, PrintStream os)Deprecated.use writeSequence(Sequence seq, PrintStream os)voidFastaFormat. writeSequence(Sequence seq, PrintStream os)Deprecated.Writes aSequenceorRichSequenceto aPrintStreamin FASTA format.voidFastaFormat. writeSequence(Sequence seq, String format, PrintStream os)Deprecated.use writeSequence(Sequence seq, PrintStream os)voidGAMEFormat. writeSequence(Sequence seq, PrintStream os)voidGAMEFormat. writeSequence(Sequence seq, String format, PrintStream os)voidGenbankFormat. writeSequence(Sequence seq, PrintStream os)Deprecated.voidGenbankFormat. writeSequence(Sequence seq, String format, PrintStream os)Deprecated.use writeSequence(Sequence seq, PrintStream os)voidSequenceFormat. writeSequence(Sequence seq, PrintStream os)writeSequencewrites a sequence to the specified PrintStream, using the default format.voidSequenceFormat. writeSequence(Sequence seq, String format, PrintStream os)Deprecated.use writeSequence(Sequence seq, PrintStream os)static voidSeqIOTools. writeSwissprot(OutputStream os, Sequence seq)Deprecated.Writes a single Sequence to an OutputStream in SwissProt format. -
Uses of Sequence in org.biojava.bio.seq.io.agave
Fields in org.biojava.bio.seq.io.agave declared as Sequence Modifier and Type Field Description protected SequenceAGAVEBioSeqHandler. sequenceprotected SequenceAGAVEContigHandler. sequenceMethods in org.biojava.bio.seq.io.agave with parameters of type Sequence Modifier and Type Method Description protected voidStAXFeatureHandler. addFeatureToSequence(Sequence seq)voidAGAVECallbackItf. reportSequence(Sequence sequence)voidAGAVEChromosomeCallbackItf. reportSequence(Sequence sequence)voidAGAVEChromosomeHandler. reportSequence(Sequence sequence)voidAGAVEContigCallbackItf. reportSequence(Sequence sequence)voidAGAVEContigHandler. reportSequence(Sequence sequence)voidAGAVEHandler. reportSequence(Sequence sequence)protected voidAgaveWriter. write(Sequence seq)Writing Sequence.voidAgaveWriter. writeSequence(Sequence seq, PrintStream os)Write sequence into AGAVE XML format. -
Uses of Sequence in org.biojava.bio.seq.projection
Methods in org.biojava.bio.seq.projection that return Sequence Modifier and Type Method Description SequenceProjectedFeature. getSequence()SequenceProjectionContext. getSequence(Feature projFeat)Get the sequence for a feature.SequenceReparentContext. getSequence(Feature f) -
Uses of Sequence in org.biojavax.bio.db
Methods in org.biojavax.bio.db that return Sequence Modifier and Type Method Description SequenceAbstractRichSequenceDB. getSequence(String id)Methods in org.biojavax.bio.db with parameters of type Sequence Modifier and Type Method Description voidAbstractRichSequenceDB. addSequence(Sequence seq) -
Uses of Sequence in org.biojavax.bio.seq
Subinterfaces of Sequence in org.biojavax.bio.seq Modifier and Type Interface Description interfaceRichSequenceA rich sequence is a combination of a org.biojavax.bio.Bioentry and a Sequence.Classes in org.biojavax.bio.seq that implement Sequence Modifier and Type Class Description classSimpleRichSequenceA simple implementation of RichSequence.classThinRichSequenceA simple implementation of RichSequence.Methods in org.biojavax.bio.seq that return Sequence Modifier and Type Method Description SequenceSimpleRichFeature. getSequence()Return theSequenceobject to which this feature is (ultimately) attached.SequenceRichSequence.IOTools.SingleRichSeqIterator. nextSequence()Returns the next sequence in the iterator.Methods in org.biojavax.bio.seq with parameters of type Sequence Modifier and Type Method Description static RichSequenceRichSequence.Tools. enrich(Sequence s)Boldly attempts to convert aSequenceinto aRichSequence.static voidRichSequence.IOTools. writeEMBL(OutputStream os, Sequence seq, Namespace ns)Writes a singleSequenceto anOutputStreamin EMBL format.static voidRichSequence.IOTools. writeEMBLxml(OutputStream os, Sequence seq, Namespace ns)Writes a singleSequenceto anOutputStreamin EMBLxml format.static voidRichSequence.IOTools. writeFasta(OutputStream os, Sequence seq, Namespace ns)Writes a singleSequenceto anOutputStreamin Fasta format.static voidRichSequence.IOTools. writeFasta(OutputStream os, Sequence seq, Namespace ns, FastaHeader header)Writes a singleSequenceto anOutputStreamin Fasta format.static voidRichSequence.IOTools. writeGenbank(OutputStream os, Sequence seq, Namespace ns)Writes a singleSequenceto anOutputStreamin GenBank format.static voidRichSequence.IOTools. writeINSDseq(OutputStream os, Sequence seq, Namespace ns)Writes a singleSequenceto anOutputStreamin INSDseq format.static voidRichSequence.IOTools. writeUniProt(OutputStream os, Sequence seq, Namespace ns)Writes a singleSequenceto anOutputStreamin UniProt format.static voidRichSequence.IOTools. writeUniProtXML(OutputStream os, Sequence seq, Namespace ns)Writes a singleSequenceto anOutputStreamin UniProt XML format.Constructors in org.biojavax.bio.seq with parameters of type Sequence Constructor Description SingleRichSeqIterator(Sequence seq)Creates an iterator over a single sequence. -
Uses of Sequence in org.biojavax.bio.seq.io
Methods in org.biojavax.bio.seq.io that return Sequence Modifier and Type Method Description SequenceRichSequenceBuilder. makeSequence()Return the Sequence object which has been constructed by this builder.SequenceSimpleRichSequenceBuilder. makeSequence()Return the Sequence object which has been constructed by this builder.SequenceHashedFastaIterator. nextSequence()SequenceRichStreamReader. nextSequence()Returns the next sequence in the iterator.Methods in org.biojavax.bio.seq.io with parameters of type Sequence Modifier and Type Method Description voidEMBLFormat. writeSequence(Sequence seq, PrintStream os)writeSequencewrites a sequence to the specified PrintStream, using the default format.voidEMBLFormat. writeSequence(Sequence seq, String format, PrintStream os)writeSequencewrites a sequence to the specifiedPrintStream, using the specified format.voidEMBLFormat. writeSequence(Sequence seq, String format, Namespace ns)As perEMBLFormat.writeSequence(Sequence, Namespace), except that it also takes a format parameter.voidEMBLFormat. writeSequence(Sequence seq, Namespace ns)Writes a sequence out to the outputstream given by beginWriting() using the default format of the implementing class.voidEMBLxmlFormat. writeSequence(Sequence seq, PrintStream os)writeSequencewrites a sequence to the specified PrintStream, using the default format.voidEMBLxmlFormat. writeSequence(Sequence seq, String format, PrintStream os)writeSequencewrites a sequence to the specifiedPrintStream, using the specified format.voidEMBLxmlFormat. writeSequence(Sequence seq, Namespace ns)Writes a sequence out to the outputstream given by beginWriting() using the default format of the implementing class.voidFastaFormat. writeSequence(Sequence seq, PrintStream os)writeSequencewrites a sequence to the specified PrintStream, using the default format.voidFastaFormat. writeSequence(Sequence seq, String format, PrintStream os)writeSequencewrites a sequence to the specifiedPrintStream, using the specified format.voidFastaFormat. writeSequence(Sequence seq, Namespace ns)Writes a sequence out to the outputstream given by beginWriting() using the default format of the implementing class.voidGenbankFormat. writeSequence(Sequence seq, PrintStream os)writeSequencewrites a sequence to the specified PrintStream, using the default format.voidGenbankFormat. writeSequence(Sequence seq, String format, PrintStream os)writeSequencewrites a sequence to the specifiedPrintStream, using the specified format.voidGenbankFormat. writeSequence(Sequence seq, Namespace ns)Writes a sequence out to the outputstream given by beginWriting() using the default format of the implementing class.voidINSDseqFormat. writeSequence(Sequence seq, PrintStream os)writeSequencewrites a sequence to the specified PrintStream, using the default format.voidINSDseqFormat. writeSequence(Sequence seq, String format, PrintStream os)writeSequencewrites a sequence to the specifiedPrintStream, using the specified format.voidINSDseqFormat. writeSequence(Sequence seq, Namespace ns)Writes a sequence out to the outputstream given by beginWriting() using the default format of the implementing class.voidRichSequenceFormat. writeSequence(Sequence seq, Namespace ns)Writes a sequence out to the outputstream given by beginWriting() using the default format of the implementing class.voidUniProtFormat. writeSequence(Sequence seq, PrintStream os)writeSequencewrites a sequence to the specified PrintStream, using the default format.voidUniProtFormat. writeSequence(Sequence seq, String format, PrintStream os)writeSequencewrites a sequence to the specifiedPrintStream, using the specified format.voidUniProtFormat. writeSequence(Sequence seq, Namespace ns)Writes a sequence out to the outputstream given by beginWriting() using the default format of the implementing class.voidUniProtXMLFormat. writeSequence(Sequence seq, PrintStream os)writeSequencewrites a sequence to the specified PrintStream, using the default format.voidUniProtXMLFormat. writeSequence(Sequence seq, String format, PrintStream os)writeSequencewrites a sequence to the specifiedPrintStream, using the specified format.voidUniProtXMLFormat. writeSequence(Sequence seq, Namespace ns)Writes a sequence out to the outputstream given by beginWriting() using the default format of the implementing class.
-