Uses of Interface
org.biojava.nbio.core.sequence.template.Sequence
-
-
Uses of Sequence in org.biojava.nbio.aaproperties.xml
Methods in org.biojava.nbio.aaproperties.xml with parameters of type Sequence Modifier and Type Method Description booleanCaseFreeAminoAcidCompoundSet. isValidSequence(Sequence<AminoAcidCompound> sequence)booleanModifiedAminoAcidCompoundSet. isValidSequence(Sequence<AminoAcidCompound> sequence) -
Uses of Sequence in org.biojava.nbio.alignment
Classes in org.biojava.nbio.alignment with type parameters of type Sequence Modifier and Type Class Description classFractionalIdentityInProfileScorer<S extends Sequence<C>,C extends Compound>Implements an algorithm which computes a score for a sequence alignment pair picked from an alignmentProfile.classFractionalIdentityScorer<S extends Sequence<C>,C extends Compound>Implements an algorithm which computes a score for a sequence alignment pair.classFractionalSimilarityInProfileScorer<S extends Sequence<C>,C extends Compound>Implements an algorithm which computes a score for a sequence alignment pair picked from an alignmentProfile.classFractionalSimilarityScorer<S extends Sequence<C>,C extends Compound>Implements an algorithm which computes a score for a sequence alignment pair.classGuideTree<S extends Sequence<C>,C extends Compound>Implements a data structure for a guide tree used during progressive multiple sequence alignment.classNeedlemanWunsch<S extends Sequence<C>,C extends Compound>classSimpleProfileProfileAligner<S extends Sequence<C>,C extends Compound>classSmithWaterman<S extends Sequence<C>,C extends Compound>Smith and Waterman defined an algorithm for pairwise local sequence alignments (best match of sections from eachSequence).classStandardRescoreRefiner<S extends Sequence<C>,C extends Compound>classSubstitutionMatrixScorer<S extends Sequence<C>,C extends Compound>Scores using a substitution matrix.Methods in org.biojava.nbio.alignment with type parameters of type Sequence Modifier and Type Method Description static <S extends Sequence<C>,C extends Compound>
List<SequencePair<S,C>>Alignments. getAllPairsAlignments(List<S> sequences, Alignments.PairwiseSequenceAlignerType type, GapPenalty gapPenalty, SubstitutionMatrix<C> subMatrix)static <S extends Sequence<C>,C extends Compound>
List<PairwiseSequenceScorer<S,C>>Alignments. getAllPairsScorers(List<S> sequences, Alignments.PairwiseSequenceScorerType type, GapPenalty gapPenalty, SubstitutionMatrix<C> subMatrix)static <S extends Sequence<C>,C extends Compound>
double[]Alignments. getAllPairsScores(List<S> sequences, Alignments.PairwiseSequenceScorerType type, GapPenalty gapPenalty, SubstitutionMatrix<C> subMatrix)static <S extends Sequence<C>,C extends Compound>
Profile<S,C>Alignments. getMultipleSequenceAlignment(List<S> sequences, Object... settings)static <S extends Sequence<C>,C extends Compound>
PairwiseSequenceAligner<S,C>Alignments. getPairwiseAligner(S query, S target, Alignments.PairwiseSequenceAlignerType type, GapPenalty gapPenalty, SubstitutionMatrix<C> subMatrix)Factory method which constructs a pairwise sequence aligner.static <S extends Sequence<C>,C extends Compound>
SequencePair<S,C>Alignments. getPairwiseAlignment(S query, S target, Alignments.PairwiseSequenceAlignerType type, GapPenalty gapPenalty, SubstitutionMatrix<C> subMatrix)Factory method which computes a sequence alignment for the givenSequencepair.static <S extends Sequence<C>,C extends Compound>
Profile<S,C>Alignments. getProgressiveAlignment(GuideTree<S,C> tree, Alignments.ProfileProfileAlignerType type, GapPenalty gapPenalty, SubstitutionMatrix<C> subMatrix)Factory method to run the profile-profile alignments of a progressive multiple sequence alignment concurrently.static <S extends Sequence<C>,C extends Compound>
double[]Alignments. runPairwiseScorers(List<PairwiseSequenceScorer<S,C>> scorers)Factory method to run a list of scorers concurrently. -
Uses of Sequence in org.biojava.nbio.alignment.routines
Classes in org.biojava.nbio.alignment.routines with type parameters of type Sequence Modifier and Type Class Description classAnchoredPairwiseSequenceAligner<S extends Sequence<C>,C extends Compound>classGuanUberbacher<S extends Sequence<C>,C extends Compound> -
Uses of Sequence in org.biojava.nbio.alignment.template
Classes in org.biojava.nbio.alignment.template with type parameters of type Sequence Modifier and Type Class Description classAbstractMatrixAligner<S extends Sequence<C>,C extends Compound>Implements common code for anAlignerwhich builds a score matrix during computation.classAbstractPairwiseSequenceAligner<S extends Sequence<C>,C extends Compound>classAbstractProfileProfileAligner<S extends Sequence<C>,C extends Compound>interfaceAligner<S extends Sequence<C>,C extends Compound>classCallablePairwiseSequenceAligner<S extends Sequence<C>,C extends Compound>Implements a concurrency wrapper for aPairwiseSequenceAligner.classCallablePairwiseSequenceScorer<S extends Sequence<C>,C extends Compound>Implements a concurrency wrapper for aPairwiseSequenceScorer.classCallableProfileProfileAligner<S extends Sequence<C>,C extends Compound>Implements a concurrency wrapper for aProfileProfileAligner.interfaceGuideTreeNode<S extends Sequence<C>,C extends Compound>Defines a data structure for the node in a guide tree used during progressive multiple sequence alignment.interfaceHierarchicalClusterer<S extends Sequence<C>,C extends Compound>Defines a clustering algorithm that converts a distance matrix into a tree.interfaceMatrixAligner<S extends Sequence<C>,C extends Compound>Defines anAlignerwhich builds a score matrix during computation.interfacePairInProfileScorer<S extends Sequence<C>,C extends Compound>Defines an algorithm which computes a score for a sequence alignment pair picked from an alignmentProfile.interfacePairwiseSequenceAligner<S extends Sequence<C>,C extends Compound>interfacePairwiseSequenceScorer<S extends Sequence<C>,C extends Compound>Defines an algorithm which computes a score for a pair of sequences.interfacePartitionRefiner<S extends Sequence<C>,C extends Compound>Defines an algorithm which computes a new alignmentProfileby splitting a current alignment and realigning.interfaceProfileProfileAligner<S extends Sequence<C>,C extends Compound>Defines anAlignerfor a pair ofProfiles.interfaceProfileProfileScorer<S extends Sequence<C>,C extends Compound>Defines an algorithm which computes a score for a pairing of alignment profiles.interfaceRescoreRefiner<S extends Sequence<C>,C extends Compound>Defines an algorithm which computes a new alignmentProfileby rescoring all pairs in an alignment and realigning. -
Uses of Sequence in org.biojava.nbio.core.alignment
Classes in org.biojava.nbio.core.alignment with type parameters of type Sequence Modifier and Type Class Description classSimpleAlignedSequence<S extends Sequence<C>,C extends Compound>Implements a data structure for aSequencewithin an alignment.classSimpleProfile<S extends Sequence<C>,C extends Compound>Implements a data structure for the results of sequence alignment.classSimpleProfilePair<S extends Sequence<C>,C extends Compound>Implements a data structure for the results of the alignment of a pair ofProfiles.classSimpleSequencePair<S extends Sequence<C>,C extends Compound>Implements a data structure for the results of pairwise sequence alignment.Classes in org.biojava.nbio.core.alignment that implement Sequence Modifier and Type Class Description classSimpleAlignedSequence<S extends Sequence<C>,C extends Compound>Implements a data structure for aSequencewithin an alignment.Methods in org.biojava.nbio.core.alignment with parameters of type Sequence Modifier and Type Method Description List<AlignedSequence<S,C>>SimpleProfile. getAlignedSequences(S... sequences) -
Uses of Sequence in org.biojava.nbio.core.alignment.template
Classes in org.biojava.nbio.core.alignment.template with type parameters of type Sequence Modifier and Type Interface Description interfaceAlignedSequence<S extends Sequence<C>,C extends Compound>Defines a data structure for aSequencewithin an alignment.interfaceMutableAlignedSequence<S extends Sequence<C>,C extends Compound>Defines a mutable (editable) data structure for anAlignedSequence.interfaceMutableProfile<S extends Sequence<C>,C extends Compound>Defines a mutable (editable) data structure for aProfile.interfaceMutableProfilePair<S extends Sequence<C>,C extends Compound>Defines a mutable (editable) data structure for aProfilePair.interfaceMutableSequencePair<S extends Sequence<C>,C extends Compound>Defines a mutable (editable) data structure for the results of pairwise sequence alignment.interfaceProfile<S extends Sequence<C>,C extends Compound>Defines a data structure for the results of sequence alignment.interfaceProfilePair<S extends Sequence<C>,C extends Compound>Defines a data structure for the results of the alignment of a pair ofProfiles.interfaceProfileView<S extends Sequence<C>,C extends Compound>Defines a data structure for a view of sequence alignment.interfaceSequencePair<S extends Sequence<C>,C extends Compound>Defines a data structure for the results of pairwise sequence alignment.Subinterfaces of Sequence in org.biojava.nbio.core.alignment.template Modifier and Type Interface Description interfaceAlignedSequence<S extends Sequence<C>,C extends Compound>Defines a data structure for aSequencewithin an alignment.interfaceMutableAlignedSequence<S extends Sequence<C>,C extends Compound>Defines a mutable (editable) data structure for anAlignedSequence.Methods in org.biojava.nbio.core.alignment.template with parameters of type Sequence Modifier and Type Method Description List<AlignedSequence<S,C>>Profile. getAlignedSequences(S... sequences)Returns aListcontaining some of the individualAlignedSequences of this alignment. -
Uses of Sequence in org.biojava.nbio.core.search.io
Classes in org.biojava.nbio.core.search.io with type parameters of type Sequence Modifier and Type Class Description classHsp<S extends Sequence<C>,C extends Compound>This class models a search Hsp.Methods in org.biojava.nbio.core.search.io that return Sequence Modifier and Type Method Description SequenceHit. getHitSequence()returns the reference to the original and whole sequence hit in the database.SequenceResult. getQuerySequence()returns the reference to the original and whole sequence used to query the database.Method parameters in org.biojava.nbio.core.search.io with type arguments of type Sequence Modifier and Type Method Description voidResultFactory. setDatabaseReferences(List<Sequence> sequences)Specify the collection of sequences objects used as database in the Search run.voidResultFactory. setQueryReferences(List<Sequence> sequences)Specify the collection of sequences objects used as queries in the Search run.Constructors in org.biojava.nbio.core.search.io with parameters of type Sequence Constructor Description Hit(int hitNum, String hitId, String hitDef, String hitAccession, int hitLen, List<Hsp> hsps, Sequence hitSequence)Result(String program, String version, String reference, String dbFile, HashMap<String,String> programSpecificParameters, int iterationNumber, String queryID, String queryDef, int queryLength, List<Hit> hits, Sequence querySequence) -
Uses of Sequence in org.biojava.nbio.core.search.io.blast
Methods in org.biojava.nbio.core.search.io.blast with parameters of type Sequence Modifier and Type Method Description BlastHitBuilderBlastHitBuilder. setHitSequence(Sequence s)BlastResultBuilderBlastResultBuilder. setQuerySequence(Sequence s)Method parameters in org.biojava.nbio.core.search.io.blast with type arguments of type Sequence Modifier and Type Method Description voidBlastTabularParser. setDatabaseReferences(List<Sequence> sequences)Intended for use with run module.voidBlastXMLParser. setDatabaseReferences(List<Sequence> sequences)voidBlastTabularParser. setQueryReferences(List<Sequence> sequences)Intended for use with run module.voidBlastXMLParser. setQueryReferences(List<Sequence> sequences)Constructors in org.biojava.nbio.core.search.io.blast with parameters of type Sequence Constructor Description BlastResult(String program, String version, String reference, String dbFile, HashMap<String,String> programSpecificParameters, int iterationNumber, String queryID, String queryDef, int queryLength, List<Hit> hits, Sequence querySequence) -
Uses of Sequence in org.biojava.nbio.core.sequence
Classes in org.biojava.nbio.core.sequence with type parameters of type Sequence Modifier and Type Class Description classMultipleSequenceAlignment<S extends Sequence<C>,C extends Compound>Implements a minimal data structure for reading and writing a sequence alignment.Classes in org.biojava.nbio.core.sequence that implement Sequence Modifier and Type Class Description classBasicSequence<C extends Compound>Bare bones version of the Sequence object to be used sparingly.classCDSSequenceRepresents a exon or coding sequence in a gene.classChromosomeSequenceA ChromosomeSequence is a DNASequence but keeps track of geneSequencesclassDNASequenceThis is class should model the attributes associated with a DNA sequenceclassExonSequenceA gene contains a collection of Exon sequencesclassGeneSequenceclassIntronSequenceclassProteinSequenceThe representation of a ProteinSequenceclassRNASequenceRNASequence where RNACompoundSet are the allowed valuesclassStartCodonSequenceUsed to map the start codon feature on a geneclassStopCodonSequenceUsed to map the stop codon sequence on a geneclassTranscriptSequenceThis is the sequence if you want to go from a gene sequence to a protein sequence. -
Uses of Sequence in org.biojava.nbio.core.sequence.compound
Methods in org.biojava.nbio.core.sequence.compound with parameters of type Sequence Modifier and Type Method Description booleanAminoAcidCompoundSet. isValidSequence(Sequence<AminoAcidCompound> sequence) -
Uses of Sequence in org.biojava.nbio.core.sequence.edits
Methods in org.biojava.nbio.core.sequence.edits that return Sequence Modifier and Type Method Description Sequence<C>Edit.AbstractEdit. edit(Sequence<C> editingSequence)Sequence<C>Edit. edit(Sequence<C> sequence)protected Sequence<C>Edit.AbstractEdit. getEmptySequence(Sequence<C> editingSequence)Returns an empty sequence with the given compound set of the editing sequenceprotected abstract Sequence<C>Edit.AbstractEdit. getFivePrime(Sequence<C> editingSequence)Should return the 5-prime end of the given Sequence according to the edit.protected Sequence<C>Edit.Delete. getFivePrime(Sequence<C> editingSequence)protected Sequence<C>Edit.Insert. getFivePrime(Sequence<C> editingSequence)protected Sequence<C>Edit.Substitute. getFivePrime(Sequence<C> editingSequence)Sequence<C>Edit.AbstractEdit. getTargetSequence(Sequence<C> editingSequence)Returns the Sequence which is our edit.protected abstract Sequence<C>Edit.AbstractEdit. getThreePrime(Sequence<C> editingSequence)Should return the 3-prime end of the given Sequence according to the edit.protected Sequence<C>Edit.Delete. getThreePrime(Sequence<C> editingSequence)protected Sequence<C>Edit.Insert. getThreePrime(Sequence<C> editingSequence)protected Sequence<C>Edit.Substitute. getThreePrime(Sequence<C> editingSequence)Methods in org.biojava.nbio.core.sequence.edits with parameters of type Sequence Modifier and Type Method Description Sequence<C>Edit.AbstractEdit. edit(Sequence<C> editingSequence)Sequence<C>Edit. edit(Sequence<C> sequence)protected Sequence<C>Edit.AbstractEdit. getEmptySequence(Sequence<C> editingSequence)Returns an empty sequence with the given compound set of the editing sequenceintEdit.Substitute. getEnd(Sequence<C> sequence)Must use this rather than the no-args getEnd as this can return -1 and the length of a sub is dependent on the length of the Sequence; we cannot assume 1:1 mapping between characters in a String and the number of compounds we will have to insert.protected abstract Sequence<C>Edit.AbstractEdit. getFivePrime(Sequence<C> editingSequence)Should return the 5-prime end of the given Sequence according to the edit.protected Sequence<C>Edit.Delete. getFivePrime(Sequence<C> editingSequence)protected Sequence<C>Edit.Insert. getFivePrime(Sequence<C> editingSequence)protected Sequence<C>Edit.Substitute. getFivePrime(Sequence<C> editingSequence)Sequence<C>Edit.AbstractEdit. getTargetSequence(Sequence<C> editingSequence)Returns the Sequence which is our edit.protected abstract Sequence<C>Edit.AbstractEdit. getThreePrime(Sequence<C> editingSequence)Should return the 3-prime end of the given Sequence according to the edit.protected Sequence<C>Edit.Delete. getThreePrime(Sequence<C> editingSequence)protected Sequence<C>Edit.Insert. getThreePrime(Sequence<C> editingSequence)protected Sequence<C>Edit.Substitute. getThreePrime(Sequence<C> editingSequence)protected voidEdit.AbstractEdit. setSequence(Sequence<C> sequence)Constructors in org.biojava.nbio.core.sequence.edits with parameters of type Sequence Constructor Description Insert(Sequence<C> sequence, int position)Insert(Sequence<C> sequence, int start, int stop)Substitute(Sequence<C> sequence, int position) -
Uses of Sequence in org.biojava.nbio.core.sequence.io
Classes in org.biojava.nbio.core.sequence.io with type parameters of type Sequence Modifier and Type Class Description classFastaReader<S extends Sequence<?>,C extends Compound>Use FastaReaderHelper as an example of how to use this class where FastaReaderHelper should be the primary class used to read Fasta filesclassFastaWriter<S extends Sequence<?>,C extends Compound>The FastaWriter writes a collection of sequences to an outputStream.classGenbankWriter<S extends Sequence<?>,C extends Compound>Methods in org.biojava.nbio.core.sequence.io with parameters of type Sequence Modifier and Type Method Description static voidFastaWriterHelper. writeSequence(File file, Sequence<?> sequence)Write a sequence to a filestatic voidFastaWriterHelper. writeSequence(OutputStream outputStream, Sequence<?> sequence)Write a sequence to OutputStreamstatic voidGenbankWriterHelper. writeSequence(File file, Sequence<?> sequence)Write a sequence to a filestatic voidGenbankWriterHelper. writeSequence(OutputStream outputStream, Sequence<?> sequence)Write a sequence to OutputStreamMethod parameters in org.biojava.nbio.core.sequence.io with type arguments of type Sequence Modifier and Type Method Description static voidFastaWriterHelper. writeSequences(OutputStream outputStream, Collection<Sequence<?>> sequences)Method which will write your given Sequences to the specifiedOutputStream.static voidGenbankWriterHelper. writeSequences(OutputStream outputStream, Collection<Sequence<?>> sequences)Method which will write your given Sequences to the specifiedOutputStream. -
Uses of Sequence in org.biojava.nbio.core.sequence.io.template
Classes in org.biojava.nbio.core.sequence.io.template with type parameters of type Sequence Modifier and Type Interface Description interfaceFastaHeaderFormatInterface<S extends Sequence<?>,C extends Compound>interfaceGenbankHeaderFormatInterface<S extends Sequence<?>,C extends Compound>interfaceSequenceHeaderParserInterface<S extends Sequence<?>,C extends Compound> -
Uses of Sequence in org.biojava.nbio.core.sequence.io.util
Methods in org.biojava.nbio.core.sequence.io.util with type parameters of type Sequence Modifier and Type Method Description static <S extends Sequence<C>,C extends Compound>
intIOUtils. getGCGChecksum(List<S> sequences)Calculates GCG checksum for entire list of sequencesstatic <S extends Sequence<C>,C extends Compound>
intIOUtils. getGCGChecksum(S sequence)Calculates GCG checksum for a given sequencestatic <S extends Sequence<C>,C extends Compound>
StringIOUtils. getGCGHeader(List<S> sequences)Assembles a GCG file headerstatic <S extends Sequence<C>,C extends Compound>
StringIOUtils. getIDFormat(List<S> sequences)Creates format String for accession IDs -
Uses of Sequence in org.biojava.nbio.core.sequence.loader
Classes in org.biojava.nbio.core.sequence.loader that implement Sequence Modifier and Type Class Description classArrayListProxySequenceReader<C extends Compound>classGenbankProxySequenceReader<C extends Compound>classSequenceFileProxyLoader<C extends Compound>This class represents the storage container of a sequence stored in a fasta file where the initial parsing of the file we store the offset and length of the sequence.classStringProxySequenceReader<C extends Compound>An example of a ProxySequenceReader that is created from a String.classUniprotProxySequenceReader<C extends Compound>Pass in a Uniprot ID and this ProxySequenceReader when passed to a ProteinSequence will get the sequence data and other data elements associated with the ProteinSequence by Uniprot. -
Uses of Sequence in org.biojava.nbio.core.sequence.location.template
Methods in org.biojava.nbio.core.sequence.location.template that return Sequence Modifier and Type Method Description <C extends Compound>
Sequence<C>AbstractLocation. getRelevantSubSequence(Sequence<C> sequence)<C extends Compound>
Sequence<C>Location. getRelevantSubSequence(Sequence<C> sequence)Will return a SequenceReader object which offers a view of all resolved locations i.e. those locations which are not complex and define the true Sequence represented<C extends Compound>
Sequence<C>AbstractLocation. getSubSequence(Sequence<C> sequence)If circular this will return the sequence represented by the sub locations joined.<C extends Compound>
Sequence<C>Location. getSubSequence(Sequence<C> sequence)Will return a SequenceReader object which represents the outer bounds of this Locationprotected <C extends Compound>
Sequence<C>AbstractLocation. reverseSequence(Sequence<C> sequence)Reverses and (if possible) complements the Sequence so as to represent the reverse strand (if one exists).Methods in org.biojava.nbio.core.sequence.location.template with parameters of type Sequence Modifier and Type Method Description protected <C extends Compound>
booleanAbstractLocation. canComplement(Sequence<C> sequence)Uses the Sequence's CompoundSet to decide if a compound can be assgined to ComplementCompound meaning it can complement<C extends Compound>
Sequence<C>AbstractLocation. getRelevantSubSequence(Sequence<C> sequence)<C extends Compound>
Sequence<C>Location. getRelevantSubSequence(Sequence<C> sequence)Will return a SequenceReader object which offers a view of all resolved locations i.e. those locations which are not complex and define the true Sequence represented<C extends Compound>
Sequence<C>AbstractLocation. getSubSequence(Sequence<C> sequence)If circular this will return the sequence represented by the sub locations joined.<C extends Compound>
Sequence<C>Location. getSubSequence(Sequence<C> sequence)Will return a SequenceReader object which represents the outer bounds of this Locationprotected <C extends Compound>
Sequence<C>AbstractLocation. reverseSequence(Sequence<C> sequence)Reverses and (if possible) complements the Sequence so as to represent the reverse strand (if one exists). -
Uses of Sequence in org.biojava.nbio.core.sequence.storage
Classes in org.biojava.nbio.core.sequence.storage that implement Sequence Modifier and Type Class Description classArrayListSequenceReader<C extends Compound>Stores a Sequence as a collection of compounds in an ArrayListclassBitSequenceReader<C extends Compound>An implementation of the popular bit encodings.classFourBitSequenceReader<C extends Compound>Four bit encoding of the bit formats.classJoiningSequenceReader<C extends Compound>This reader actually proxies onto multiple types of sequence in order to allow a number of sequence objects to act as if they are one sequence.classSingleCompoundSequenceReader<C extends Compound>An implementation of the SequenceReader interface which for every call will return only 1 compound (given to it during construction; a String is also valid but will require a CompoundSet).classTwoBitSequenceReader<C extends NucleotideCompound>Implementation of the 2bit encoding.Methods in org.biojava.nbio.core.sequence.storage with parameters of type Sequence Modifier and Type Method Description booleanSingleCompoundSequenceReader. equals(Sequence<C> o)voidBitSequenceReader.BitArrayWorker. populate(Sequence<C> sequence)Loops through the Compounds in a Sequence and passes them ontoBitSequenceReader.BitArrayWorker.setCompoundAt(Compound, int)Constructors in org.biojava.nbio.core.sequence.storage with parameters of type Sequence Constructor Description BitArrayWorker(Sequence<C> sequence)FourBitArrayWorker(Sequence<C> sequence)FourBitSequenceReader(Sequence<C> sequence)JoiningSequenceReader(CompoundSet<C> compoundSet, Sequence<C>... sequences)JoiningSequenceReader(Sequence<C>... sequences)Allows creation of the store from Vargs Sequenceobjects. TwoBitArrayWorker(Sequence<C> sequence)TwoBitSequenceReader(Sequence<C> sequence)Constructor parameters in org.biojava.nbio.core.sequence.storage with type arguments of type Sequence Constructor Description JoiningSequenceReader(List<Sequence<C>> sequences)Allows creation of the store from List>. JoiningSequenceReader(CompoundSet<C> compoundSet, List<Sequence<C>> sequences) -
Uses of Sequence in org.biojava.nbio.core.sequence.template
Classes in org.biojava.nbio.core.sequence.template with type parameters of type Sequence Modifier and Type Interface Description interfaceLightweightProfile<S extends Sequence<C>,C extends Compound>Defines a minimal data structure for reading and writing a sequence alignment.Subinterfaces of Sequence in org.biojava.nbio.core.sequence.template Modifier and Type Interface Description interfaceProxySequenceReader<C extends Compound>interfaceSequenceReader<C extends Compound>interfaceSequenceView<C extends Compound>Classes in org.biojava.nbio.core.sequence.template that implement Sequence Modifier and Type Class Description classAbstractSequence<C extends Compound>The base class for DNA, RNA and Protein sequences.classSequenceProxyView<C extends Compound>Methods in org.biojava.nbio.core.sequence.template that return Sequence Modifier and Type Method Description Sequence<T>AbstractCompoundTranslator. createSequence(Sequence<F> originalSequence)Sequence<T>CompoundTranslator. createSequence(Sequence<F> originalSequence)Sequence<C>SequenceProxyView. getViewedSequence()Sequence<C>SequenceView. getViewedSequence()static <C extends Compound>
Sequence<C>SequenceMixin. shuffle(Sequence<C> sequence)Implements sequence shuffling by first materializing the givenSequenceinto aList, applyingCollections.shuffle(List)and then returning the shuffled elements in a new instance ofSequenceBackingStorewhich behaves as aSequence.Methods in org.biojava.nbio.core.sequence.template that return types with arguments of type Sequence Modifier and Type Method Description List<Sequence<T>>AbstractCompoundTranslator. createSequences(Sequence<F> originalSequence)List<Sequence<T>>CompoundTranslator. createSequences(Sequence<F> originalSequence)protected List<Sequence<T>>AbstractCompoundTranslator. workingListToSequences(List<List<T>> workingList)Methods in org.biojava.nbio.core.sequence.template with parameters of type Sequence Modifier and Type Method Description static <C extends Compound>
StringSequenceMixin. checksum(Sequence<C> sequence)Performs a simple CRC64 checksum on any given sequence.static intSequenceMixin. countAT(Sequence<NucleotideCompound> sequence)Returns the count of AT in the given sequencestatic <C extends Compound>
intSequenceMixin. countCompounds(Sequence<C> sequence, C... compounds)For the given vargs of compounds this method counts the number of times those compounds appear in the given sequencestatic intSequenceMixin. countGC(Sequence<NucleotideCompound> sequence)Returns the count of GC in the given sequencestatic <C extends Compound>
Iterator<C>SequenceMixin. createIterator(Sequence<C> sequence)Creates a simple sequence iterator which moves through a sequence going from 1 to the length of the Sequence.Sequence<T>AbstractCompoundTranslator. createSequence(Sequence<F> originalSequence)Sequence<T>CompoundTranslator. createSequence(Sequence<F> originalSequence)List<Sequence<T>>AbstractCompoundTranslator. createSequences(Sequence<F> originalSequence)List<Sequence<T>>CompoundTranslator. createSequences(Sequence<F> originalSequence)static <C extends Compound>
SequenceView<C>SequenceMixin. createSubSequence(Sequence<C> sequence, int start, int end)Creates a simple sub sequence view delimited by the given start and end.static <C extends Compound>
Map<C,Integer>SequenceMixin. getComposition(Sequence<C> sequence)Does a linear scan over the given Sequence and records the number of times each base appears.static <C extends Compound>
Map<C,Double>SequenceMixin. getDistribution(Sequence<C> sequence)Analogous toSequenceMixin.getComposition(Sequence)but returns the distribution of thatCompoundover the given sequence.static <C extends Compound>
intSequenceMixin. indexOf(Sequence<C> sequence, C compound)Performs a linear search of the given Sequence for the given compound.static <C extends Compound>
SequenceView<C>SequenceMixin. inverse(Sequence<C> sequence)A method which attempts to do the right thing when is comes to a reverse/reverse complementbooleanAbstractCompoundSet. isValidSequence(Sequence<C> sequence)booleanCompoundSet. isValidSequence(Sequence<C> sequence)static <C extends Compound>
intSequenceMixin. lastIndexOf(Sequence<C> sequence, C compound)Performs a reversed linear search of the given Sequence by wrapping it in aReversedSequenceViewand passing it intoSequenceMixin.indexOf(Sequence, Compound).static <C extends Compound>
List<SequenceView<C>>SequenceMixin. nonOverlappingKmers(Sequence<C> sequence, int kmer)Produces kmers of the specified size e.g.static <C extends Compound>
List<SequenceView<C>>SequenceMixin. overlappingKmers(Sequence<C> sequence, int kmer)Used to generate overlapping k-mers such i.e.static <C extends Compound>
booleanSequenceMixin. sequenceEquality(Sequence<C> source, Sequence<C> target)A case-sensitive manner of comparing two sequence objects together.static <C extends Compound>
booleanSequenceMixin. sequenceEqualityIgnoreCase(Sequence<C> source, Sequence<C> target)A case-insensitive manner of comparing two sequence objects together.static <C extends Compound>
Sequence<C>SequenceMixin. shuffle(Sequence<C> sequence)Implements sequence shuffling by first materializing the givenSequenceinto aList, applyingCollections.shuffle(List)and then returning the shuffled elements in a new instance ofSequenceBackingStorewhich behaves as aSequence.static <C extends Compound>
List<C>SequenceMixin. toList(Sequence<C> sequence)static <C extends Compound>
StringSequenceMixin. toString(Sequence<C> sequence)Shortcut toSequenceMixin.toStringBuilder(org.biojava.nbio.core.sequence.template.Sequence)which calls toString() on the resulting object.static <C extends Compound>
StringBuilderSequenceMixin. toStringBuilder(Sequence<C> sequence)For the given Sequence this will return aStringBuilderobject filled with the results ofCompound#toString().static <C extends Compound>
voidSequenceMixin. write(Appendable appendable, Sequence<C> sequence)Used as a way of sending a Sequence to a writer without the cost of converting to a full length String and then writing the data outConstructors in org.biojava.nbio.core.sequence.template with parameters of type Sequence Constructor Description SequenceIterator(Sequence<C> sequence)SequenceProxyView(Sequence<C> sequence)SequenceProxyView(Sequence<C> sequence, Integer bioStart, Integer bioEnd)Main constructor for working with SequenceProxyViews -
Uses of Sequence in org.biojava.nbio.core.sequence.transcription
Methods in org.biojava.nbio.core.sequence.transcription that return Sequence Modifier and Type Method Description Sequence<NucleotideCompound>DNAToRNATranslator. createSequence(Sequence<NucleotideCompound> originalSequence)Sequence<NucleotideCompound>DNAToRNATranslator. createSequence(Sequence<NucleotideCompound> originalSequence, Frame frame)Sequence<AminoAcidCompound>TranscriptionEngine. translate(Sequence<NucleotideCompound> dna)Quick method to let you go from a CDS to a Peptide quickly.<C extends NucleotideCompound>
Sequence<C>Frame. wrap(Sequence<C> incoming)Optionally wraps a Sequence in a reverse complementing view (if the frame is on the reverse strand) and creates a sub sequence view if it is required.Methods in org.biojava.nbio.core.sequence.transcription that return types with arguments of type Sequence Modifier and Type Method Description List<Sequence<NucleotideCompound>>DNAToRNATranslator. createSequences(Sequence<NucleotideCompound> originalSequence)Overloaded local version which delegates to an optional translator when told to (specified during construction).List<Sequence<AminoAcidCompound>>RNAToAminoAcidTranslator. createSequences(Sequence<NucleotideCompound> originalSequence)Performs the core conversion of RNA to Peptide.Map<Frame,Sequence<AminoAcidCompound>>TranscriptionEngine. multipleFrameTranslation(Sequence<NucleotideCompound> dna, Frame... frames)A way of translating DNA in a number of framesMethods in org.biojava.nbio.core.sequence.transcription with parameters of type Sequence Modifier and Type Method Description Sequence<NucleotideCompound>DNAToRNATranslator. createSequence(Sequence<NucleotideCompound> originalSequence)Sequence<NucleotideCompound>DNAToRNATranslator. createSequence(Sequence<NucleotideCompound> originalSequence, Frame frame)List<Sequence<NucleotideCompound>>DNAToRNATranslator. createSequences(Sequence<NucleotideCompound> originalSequence)Overloaded local version which delegates to an optional translator when told to (specified during construction).List<Sequence<AminoAcidCompound>>RNAToAminoAcidTranslator. createSequences(Sequence<NucleotideCompound> originalSequence)Performs the core conversion of RNA to Peptide.Map<Frame,Sequence<AminoAcidCompound>>TranscriptionEngine. multipleFrameTranslation(Sequence<NucleotideCompound> dna, Frame... frames)A way of translating DNA in a number of framesSequence<AminoAcidCompound>TranscriptionEngine. translate(Sequence<NucleotideCompound> dna)Quick method to let you go from a CDS to a Peptide quickly.<C extends NucleotideCompound>
Sequence<C>Frame. wrap(Sequence<C> incoming)Optionally wraps a Sequence in a reverse complementing view (if the frame is on the reverse strand) and creates a sub sequence view if it is required.protected RNASequenceDNAToRNATranslator. wrapToRna(Sequence<NucleotideCompound> dna)Takes in the given DNA Sequence and returns an instance of RNASequence which is usingRnaSequenceViewas aProxySequenceReader. -
Uses of Sequence in org.biojava.nbio.core.sequence.views
Classes in org.biojava.nbio.core.sequence.views that implement Sequence Modifier and Type Class Description classComplementSequenceView<C extends ComplementCompound>For a given sequence this class will create a view over the top of it and for every request the code will return the complement of the underlying base e.g. base A will become base TclassReversedSequenceView<C extends Compound>For a given sequence this class will return the base at the reversed position i.e. in a sequence of size 10, if you request base 2 you will get back the base at position 9.classRnaSequenceViewAttempts to do on the fly translation of RNA by not requesting the compounds until asked.Methods in org.biojava.nbio.core.sequence.views that return Sequence Modifier and Type Method Description Sequence<C>WindowedSequence. getBackingSequence()Access the sequence which backs this windowConstructors in org.biojava.nbio.core.sequence.views with parameters of type Sequence Constructor Description ComplementSequenceView(Sequence<C> sequence)ReversedSequenceView(Sequence<C> sequence)RnaSequenceView(Sequence<NucleotideCompound> sourceDna)RnaSequenceView(Sequence<NucleotideCompound> sourceDna, CompoundSet<NucleotideCompound> rnaCompounds)WindowedSequence(Sequence<C> sequence, int windowSize) -
Uses of Sequence in org.biojava.nbio.core.util
Methods in org.biojava.nbio.core.util that return Sequence Modifier and Type Method Description Sequence<?>SequenceTools. getSequenceFromString(String sequence) -
Uses of Sequence in org.biojava.nbio.phylo
Methods in org.biojava.nbio.phylo with type parameters of type Sequence Modifier and Type Method Description static <C extends Sequence<D>,D extends Compound>
org.forester.msa.MsaForesterWrapper. convert(MultipleSequenceAlignment<C,D> msa)Convert a BioJavaMultipleSequenceAlignmentto a foresterMsa.static <C extends Sequence<D>,D extends Compound>
org.forester.evoinference.matrix.distance.DistanceMatrixDistanceMatrixCalculator. dissimilarityScore(MultipleSequenceAlignment<C,D> msa, SubstitutionMatrix<D> M)The dissimilarity score is the additive inverse of the similarity score (sum of scores) between two aligned sequences using a substitution model (Substitution Matrix).static <C extends Sequence<D>,D extends Compound>
org.forester.evoinference.matrix.distance.DistanceMatrixDistanceMatrixCalculator. fractionalDissimilarity(MultipleSequenceAlignment<C,D> msa)The fractional dissimilarity (D) is defined as the percentage of sites that differ between two aligned sequences.static <C extends Sequence<D>,D extends Compound>
org.forester.evoinference.matrix.distance.DistanceMatrixDistanceMatrixCalculator. fractionalDissimilarityScore(MultipleSequenceAlignment<C,D> msa, SubstitutionMatrix<D> M)The fractional dissimilarity score (Ds) is a relative measure of the dissimilarity between two aligned sequences.static <C extends Sequence<D>,D extends Compound>
org.forester.evoinference.matrix.distance.DistanceMatrixDistanceMatrixCalculator. kimuraDistance(MultipleSequenceAlignment<C,D> msa)The Kimura evolutionary distance (d) is a correction of the fractional dissimilarity (D) specially needed for large evolutionary distances.static <C extends Sequence<D>,D extends Compound>
org.forester.evoinference.matrix.distance.DistanceMatrixDistanceMatrixCalculator. pamMLdistance(MultipleSequenceAlignment<C,D> msa)The PAM (Point Accepted Mutations) distance is a measure of evolutionary distance in protein sequences.static <C extends Sequence<D>,D extends Compound>
org.forester.evoinference.matrix.distance.DistanceMatrixDistanceMatrixCalculator. percentageIdentity(MultipleSequenceAlignment<C,D> msa)BioJava implementation for percentage of identity (PID).static <C extends Sequence<D>,D extends Compound>
org.forester.evoinference.matrix.distance.DistanceMatrixDistanceMatrixCalculator. poissonDistance(MultipleSequenceAlignment<C,D> msa)The Poisson (correction) evolutionary distance (d) is a function of the fractional dissimilarity (D), given by:static <C extends Sequence<D>,D extends Compound>
org.forester.evoinference.matrix.distance.DistanceMatrixDistanceMatrixCalculator. structuralDistance(double[][] rmsdMat, double alpha, double rmsdMax, double rmsd0)The structural distance (dS) uses the structural similarity (or dissimilarity) from a the structural alignment of two protein strutures. -
Uses of Sequence in org.biojava.nbio.structure
Methods in org.biojava.nbio.structure that return Sequence Modifier and Type Method Description Sequence<?>Chain. getBJSequence()Converts the SEQRES groups of a Chain to a Biojava Sequence object.Sequence<?>ChainImpl. getBJSequence()Converts the SEQRES groups of a Chain to a Biojava Sequence object. -
Uses of Sequence in org.biojava.nbio.structure.io
Method parameters in org.biojava.nbio.structure.io with type arguments of type Sequence Modifier and Type Method Description static AFPChainFastaAFPChainConverter. fastaToAfpChain(SequencePair<Sequence<AminoAcidCompound>,AminoAcidCompound> alignment, Structure structure1, Structure structure2)Provided only for convenience. -
Uses of Sequence in org.biojava.nbio.ws.alignment
Methods in org.biojava.nbio.ws.alignment with parameters of type Sequence Modifier and Type Method Description StringRemotePairwiseAlignmentService. sendAlignmentRequest(Sequence<Compound> seq, RemotePairwiseAlignmentProperties rpa)Doing the actual analysis on the instantiated service using specified parameters and the RichSequence object -
Uses of Sequence in org.biojava.nbio.ws.alignment.qblast
Methods in org.biojava.nbio.ws.alignment.qblast with parameters of type Sequence Modifier and Type Method Description StringNCBIQBlastService. sendAlignmentRequest(Sequence<Compound> seq, RemotePairwiseAlignmentProperties rpa)Converts given sequence to String and callsNCBIQBlastService.sendAlignmentRequest(String, RemotePairwiseAlignmentProperties)
-