Uses of Interface
org.biojava.nbio.core.sequence.template.Sequence
Package
Description
Set of classes that handles the reading and writing of xml files.
Interfaces and classes for protein structure (PDB).
Input and Output of Structures
This package contains the interfaces that need to be implemented by discrete alignment services.
-
Uses of Sequence in org.biojava.nbio.aaproperties.xml
Modifier and TypeMethodDescriptionboolean
CaseFreeAminoAcidCompoundSet.isValidSequence
(Sequence<AminoAcidCompound> sequence) boolean
ModifiedAminoAcidCompoundSet.isValidSequence
(Sequence<AminoAcidCompound> sequence) -
Uses of Sequence in org.biojava.nbio.alignment
Modifier and TypeClassDescriptionclass
FractionalIdentityInProfileScorer<S extends Sequence<C>,
C extends Compound> Implements an algorithm which computes a score for a sequence alignment pair picked from an alignmentProfile
.class
FractionalIdentityScorer<S extends Sequence<C>,
C extends Compound> Implements an algorithm which computes a score for a sequence alignment pair.class
FractionalSimilarityInProfileScorer<S extends Sequence<C>,
C extends Compound> Implements an algorithm which computes a score for a sequence alignment pair picked from an alignmentProfile
.class
FractionalSimilarityScorer<S extends Sequence<C>,
C extends Compound> Implements an algorithm which computes a score for a sequence alignment pair.class
Implements a data structure for a guide tree used during progressive multiple sequence alignment.class
NeedlemanWunsch<S extends Sequence<C>,
C extends Compound> class
SimpleProfileProfileAligner<S extends Sequence<C>,
C extends Compound> class
SmithWaterman<S extends Sequence<C>,
C extends Compound> Smith and Waterman defined an algorithm for pairwise local sequence alignments (best match of sections from eachSequence
).class
StandardRescoreRefiner<S extends Sequence<C>,
C extends Compound> class
SubstitutionMatrixScorer<S extends Sequence<C>,
C extends Compound> Scores using a substitution matrix.Modifier and TypeMethodDescriptionstatic <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) Alignments.getAllPairsScores
(List<S> sequences, Alignments.PairwiseSequenceScorerType type, GapPenalty gapPenalty, SubstitutionMatrix<C> subMatrix) 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 givenSequence
pair.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.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
Modifier and TypeClassDescriptionclass
AnchoredPairwiseSequenceAligner<S extends Sequence<C>,
C extends Compound> class
GuanUberbacher<S extends Sequence<C>,
C extends Compound> -
Uses of Sequence in org.biojava.nbio.alignment.template
Modifier and TypeClassDescriptionclass
AbstractMatrixAligner<S extends Sequence<C>,
C extends Compound> Implements common code for anAligner
which builds a score matrix during computation.class
AbstractPairwiseSequenceAligner<S extends Sequence<C>,
C extends Compound> class
AbstractProfileProfileAligner<S extends Sequence<C>,
C extends Compound> interface
class
CallablePairwiseSequenceAligner<S extends Sequence<C>,
C extends Compound> Implements a concurrency wrapper for aPairwiseSequenceAligner
.class
CallablePairwiseSequenceScorer<S extends Sequence<C>,
C extends Compound> Implements a concurrency wrapper for aPairwiseSequenceScorer
.class
CallableProfileProfileAligner<S extends Sequence<C>,
C extends Compound> Implements a concurrency wrapper for aProfileProfileAligner
.interface
GuideTreeNode<S extends Sequence<C>,
C extends Compound> Defines a data structure for the node in a guide tree used during progressive multiple sequence alignment.interface
HierarchicalClusterer<S extends Sequence<C>,
C extends Compound> Defines a clustering algorithm that converts a distance matrix into a tree.interface
MatrixAligner<S extends Sequence<C>,
C extends Compound> Defines anAligner
which builds a score matrix during computation.interface
PairInProfileScorer<S extends Sequence<C>,
C extends Compound> Defines an algorithm which computes a score for a sequence alignment pair picked from an alignmentProfile
.interface
PairwiseSequenceAligner<S extends Sequence<C>,
C extends Compound> interface
PairwiseSequenceScorer<S extends Sequence<C>,
C extends Compound> Defines an algorithm which computes a score for a pair of sequences.interface
PartitionRefiner<S extends Sequence<C>,
C extends Compound> Defines an algorithm which computes a new alignment profile by splitting a current alignment and realigning.interface
ProfileProfileAligner<S extends Sequence<C>,
C extends Compound> Defines anAligner
for a pair of profiles.interface
ProfileProfileScorer<S extends Sequence<C>,
C extends Compound> Defines an algorithm which computes a score for a pairing of alignment profiles.interface
RescoreRefiner<S extends Sequence<C>,
C extends Compound> Defines an algorithm which computes a new alignment profile by rescoring all pairs in an alignment and realigning. -
Uses of Sequence in org.biojava.nbio.core.alignment
Modifier and TypeClassDescriptionclass
SimpleAlignedSequence<S extends Sequence<C>,
C extends Compound> Implements a data structure for aSequence
within an alignment.class
SimpleProfile<S extends Sequence<C>,
C extends Compound> Implements a data structure for the results of sequence alignment.class
SimpleProfilePair<S extends Sequence<C>,
C extends Compound> Implements a data structure for the results of the alignment of a pair ofProfile
s.class
SimpleSequencePair<S extends Sequence<C>,
C extends Compound> Implements a data structure for the results of pairwise sequence alignment.Modifier and TypeClassDescriptionclass
SimpleAlignedSequence<S extends Sequence<C>,
C extends Compound> Implements a data structure for aSequence
within an alignment. -
Uses of Sequence in org.biojava.nbio.core.alignment.template
Modifier and TypeInterfaceDescriptioninterface
AlignedSequence<S extends Sequence<C>,
C extends Compound> Defines a data structure for aSequence
within an alignment.interface
MutableAlignedSequence<S extends Sequence<C>,
C extends Compound> Defines a mutable (editable) data structure for anAlignedSequence
.interface
MutableProfile<S extends Sequence<C>,
C extends Compound> Defines a mutable (editable) data structure for aProfile
.interface
MutableProfilePair<S extends Sequence<C>,
C extends Compound> Defines a mutable (editable) data structure for aProfilePair
.interface
MutableSequencePair<S extends Sequence<C>,
C extends Compound> Defines a mutable (editable) data structure for the results of pairwise sequence alignment.interface
Defines a data structure for the results of sequence alignment.interface
ProfilePair<S extends Sequence<C>,
C extends Compound> Defines a data structure for the results of the alignment of a pair ofProfile
s.interface
ProfileView<S extends Sequence<C>,
C extends Compound> Defines a data structure for a view of sequence alignment.interface
SequencePair<S extends Sequence<C>,
C extends Compound> Defines a data structure for the results of pairwise sequence alignment.Modifier and TypeInterfaceDescriptioninterface
AlignedSequence<S extends Sequence<C>,
C extends Compound> Defines a data structure for aSequence
within an alignment.interface
MutableAlignedSequence<S extends Sequence<C>,
C extends Compound> Defines a mutable (editable) data structure for anAlignedSequence
.Modifier and TypeMethodDescriptionProfile.getAlignedSequences
(S... sequences) Returns aList
containing some of the individualAlignedSequence
s of this alignment. -
Uses of Sequence in org.biojava.nbio.core.search.io
Modifier and TypeClassDescriptionclass
This class models a search Hsp.Modifier and TypeMethodDescriptionHit.getHitSequence()
returns the reference to the original and whole sequence hit in the database.Result.getQuerySequence()
returns the reference to the original and whole sequence used to query the database.Modifier and TypeMethodDescriptionvoid
ResultFactory.setDatabaseReferences
(List<Sequence> sequences) Specify the collection of sequences objects used as database in the Search run.void
ResultFactory.setQueryReferences
(List<Sequence> sequences) Specify the collection of sequences objects used as queries in the Search run.ModifierConstructorDescriptionHit
(int hitNum, String hitId, String hitDef, String hitAccession, int hitLen, List<Hsp> hsps, Sequence hitSequence) Result
(String program, String version, String reference, String dbFile, Map<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
Modifier and TypeMethodDescriptionBlastHitBuilder.setHitSequence
(Sequence s) BlastResultBuilder.setQuerySequence
(Sequence s) Modifier and TypeMethodDescriptionvoid
BlastTabularParser.setDatabaseReferences
(List<Sequence> sequences) Intended for use with run module.void
BlastXMLParser.setDatabaseReferences
(List<Sequence> sequences) void
BlastTabularParser.setQueryReferences
(List<Sequence> sequences) Intended for use with run module.void
BlastXMLParser.setQueryReferences
(List<Sequence> sequences) -
Uses of Sequence in org.biojava.nbio.core.sequence
Modifier and TypeClassDescriptionclass
MultipleSequenceAlignment<S extends Sequence<C>,
C extends Compound> Implements a minimal data structure for reading and writing a sequence alignment.Modifier and TypeClassDescriptionclass
BasicSequence<C extends Compound>
Bare bones version of the Sequence object to be used sparingly.class
Represents a exon or coding sequence in a gene.class
A ChromosomeSequence is a DNASequence but keeps track of geneSequencesclass
This is class should model the attributes associated with a DNA sequenceclass
A gene contains a collection of Exon sequencesclass
class
class
The representation of a ProteinSequenceclass
RNASequence where RNACompoundSet are the allowed valuesclass
Used to map the start codon feature on a geneclass
Used to map the stop codon sequence on a geneclass
This 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
Modifier and TypeMethodDescriptionboolean
AminoAcidCompoundSet.isValidSequence
(Sequence<AminoAcidCompound> sequence) -
Uses of Sequence in org.biojava.nbio.core.sequence.edits
Modifier and TypeMethodDescriptionEdit.AbstractEdit.getEmptySequence
(Sequence<C> editingSequence) Returns an empty sequence with the given compound set of the editing sequenceEdit.AbstractEdit.getFivePrime
(Sequence<C> editingSequence) Should return the 5-prime end of the given Sequence according to the edit.Edit.Delete.getFivePrime
(Sequence<C> editingSequence) Edit.Insert.getFivePrime
(Sequence<C> editingSequence) Edit.Substitute.getFivePrime
(Sequence<C> editingSequence) Edit.AbstractEdit.getTargetSequence
(Sequence<C> editingSequence) Returns the Sequence which is our edit.Edit.AbstractEdit.getThreePrime
(Sequence<C> editingSequence) Should return the 3-prime end of the given Sequence according to the edit.Edit.Delete.getThreePrime
(Sequence<C> editingSequence) Edit.Insert.getThreePrime
(Sequence<C> editingSequence) Edit.Substitute.getThreePrime
(Sequence<C> editingSequence) Modifier and TypeMethodDescriptionEdit.AbstractEdit.getEmptySequence
(Sequence<C> editingSequence) Returns an empty sequence with the given compound set of the editing sequenceint
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.Edit.AbstractEdit.getFivePrime
(Sequence<C> editingSequence) Should return the 5-prime end of the given Sequence according to the edit.Edit.Delete.getFivePrime
(Sequence<C> editingSequence) Edit.Insert.getFivePrime
(Sequence<C> editingSequence) Edit.Substitute.getFivePrime
(Sequence<C> editingSequence) Edit.AbstractEdit.getTargetSequence
(Sequence<C> editingSequence) Returns the Sequence which is our edit.Edit.AbstractEdit.getThreePrime
(Sequence<C> editingSequence) Should return the 3-prime end of the given Sequence according to the edit.Edit.Delete.getThreePrime
(Sequence<C> editingSequence) Edit.Insert.getThreePrime
(Sequence<C> editingSequence) Edit.Substitute.getThreePrime
(Sequence<C> editingSequence) protected void
Edit.AbstractEdit.setSequence
(Sequence<C> sequence) -
Uses of Sequence in org.biojava.nbio.core.sequence.io
Modifier and TypeClassDescriptionclass
FastaReader<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 filesclass
FastaWriter<S extends Sequence<?>,
C extends Compound> The FastaWriter writes a collection of sequences to an outputStream.class
GenbankWriter<S extends Sequence<?>,
C extends Compound> Modifier and TypeMethodDescriptionstatic void
FastaWriterHelper.writeSequence
(File file, Sequence<?> sequence) Write a sequence to a filestatic void
FastaWriterHelper.writeSequence
(OutputStream outputStream, Sequence<?> sequence) Write a sequence to OutputStreamstatic void
GenbankWriterHelper.writeSequence
(File file, Sequence<?> sequence) Write a sequence to a filestatic void
GenbankWriterHelper.writeSequence
(OutputStream outputStream, Sequence<?> sequence) Write a sequence to OutputStreamModifier and TypeMethodDescriptionstatic void
FastaWriterHelper.writeSequences
(OutputStream outputStream, Collection<Sequence<?>> sequences) Method which will write your given Sequences to the specifiedOutputStream
.static void
GenbankWriterHelper.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
Modifier and TypeInterfaceDescriptioninterface
FastaHeaderFormatInterface<S extends Sequence<?>,
C extends Compound> interface
GenbankHeaderFormatInterface<S extends Sequence<?>,
C extends Compound> interface
SequenceHeaderParserInterface<S extends Sequence<?>,
C extends Compound> -
Uses of Sequence in org.biojava.nbio.core.sequence.io.util
Modifier and TypeMethodDescriptionIOUtils.getGCGChecksum
(List<S> sequences) Calculates GCG checksum for entire list of sequencesIOUtils.getGCGChecksum
(S sequence) Calculates GCG checksum for a given sequenceIOUtils.getGCGHeader
(List<S> sequences) Assembles a GCG file headerIOUtils.getIDFormat
(List<S> sequences) Creates format String for accession IDs -
Uses of Sequence in org.biojava.nbio.core.sequence.loader
Modifier and TypeClassDescriptionclass
ArrayListProxySequenceReader<C extends Compound>
class
GenbankProxySequenceReader<C extends Compound>
class
SequenceFileProxyLoader<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.class
StringProxySequenceReader<C extends Compound>
An example of a ProxySequenceReader that is created from a String.class
UniprotProxySequenceReader<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
Modifier and TypeMethodDescriptionAbstractLocation.getRelevantSubSequence
(Sequence<C> sequence) 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 representedAbstractLocation.getSubSequence
(Sequence<C> sequence) If circular this will return the sequence represented by the sub locations joined.Location.getSubSequence
(Sequence<C> sequence) Will return a SequenceReader object which represents the outer bounds of this LocationAbstractLocation.reverseSequence
(Sequence<C> sequence) Reverses and (if possible) complements the Sequence so as to represent the reverse strand (if one exists).Modifier and TypeMethodDescriptionprotected <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 complementAbstractLocation.getRelevantSubSequence
(Sequence<C> sequence) 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 representedAbstractLocation.getSubSequence
(Sequence<C> sequence) If circular this will return the sequence represented by the sub locations joined.Location.getSubSequence
(Sequence<C> sequence) Will return a SequenceReader object which represents the outer bounds of this LocationAbstractLocation.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
Modifier and TypeClassDescriptionclass
ArrayListSequenceReader<C extends Compound>
Stores a Sequence as a collection of compounds in an ArrayListclass
BitSequenceReader<C extends Compound>
An implementation of the popular bit encodings.class
FourBitSequenceReader<C extends Compound>
Four bit encoding of the bit formats.class
JoiningSequenceReader<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.class
SingleCompoundSequenceReader<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).class
TwoBitSequenceReader<C extends NucleotideCompound>
Implementation of the 2bit encoding.Modifier and TypeMethodDescriptionboolean
void
Loops through the Compounds in a Sequence and passes them ontoBitSequenceReader.BitArrayWorker.setCompoundAt(Compound, int)
ModifierConstructorDescriptionBitArrayWorker
(Sequence<C> sequence) FourBitArrayWorker
(Sequence<C> sequence) FourBitSequenceReader
(Sequence<C> sequence) JoiningSequenceReader
(CompoundSet<C> compoundSet, Sequence<C>... sequences) JoiningSequenceReader
(Sequence<C>... sequences) TwoBitArrayWorker
(Sequence<C> sequence) TwoBitSequenceReader
(Sequence<C> sequence) ModifierConstructorDescriptionJoiningSequenceReader
(List<Sequence<C>> sequences) JoiningSequenceReader
(CompoundSet<C> compoundSet, List<Sequence<C>> sequences) -
Uses of Sequence in org.biojava.nbio.core.sequence.template
Modifier and TypeInterfaceDescriptioninterface
LightweightProfile<S extends Sequence<C>,
C extends Compound> Defines a minimal data structure for reading and writing a sequence alignment.Modifier and TypeInterfaceDescriptioninterface
ProxySequenceReader<C extends Compound>
interface
SequenceReader<C extends Compound>
interface
SequenceView<C extends Compound>
Modifier and TypeClassDescriptionclass
AbstractSequence<C extends Compound>
The base class for DNA, RNA and Protein sequences.class
SequenceProxyView<C extends Compound>
Modifier and TypeMethodDescriptionAbstractCompoundTranslator.createSequence
(Sequence<F> originalSequence) CompoundTranslator.createSequence
(Sequence<F> originalSequence) SequenceProxyView.getViewedSequence()
SequenceView.getViewedSequence()
Implements sequence shuffling by first materializing the givenSequence
into aList
, applyingCollections.shuffle(List)
and then returning the shuffled elements in a new instance ofSequence
which behaves as aSequence
.Modifier and TypeMethodDescriptionAbstractCompoundTranslator.createSequences
(Sequence<F> originalSequence) CompoundTranslator.createSequences
(Sequence<F> originalSequence) AbstractCompoundTranslator.workingListToSequences
(List<List<T>> workingList) Modifier and TypeMethodDescriptionPerforms a simple CRC64 checksum on any given sequence.static int
SequenceMixin.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 int
SequenceMixin.countGC
(Sequence<NucleotideCompound> sequence) Returns the count of GC in the given sequenceSequenceMixin.createIterator
(Sequence<C> sequence) Creates a simple sequence iterator which moves through a sequence going from 1 to the length of the Sequence.AbstractCompoundTranslator.createSequence
(Sequence<F> originalSequence) CompoundTranslator.createSequence
(Sequence<F> originalSequence) AbstractCompoundTranslator.createSequences
(Sequence<F> originalSequence) 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.SequenceMixin.getComposition
(Sequence<C> sequence) Does a linear scan over the given Sequence and records the number of times each base appears.SequenceMixin.getDistribution
(Sequence<C> sequence) Analogous toSequenceMixin.getComposition(Sequence)
but returns the distribution of thatCompound
over the given sequence.static <C extends Compound>
intPerforms a linear search of the given Sequence for the given compound.static <C extends Compound>
SequenceView<C> A method which attempts to do the right thing when is comes to a reverse/reverse complementboolean
AbstractCompoundSet.isValidSequence
(Sequence<C> sequence) boolean
CompoundSet.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 aReversedSequenceView
and 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.Implements sequence shuffling by first materializing the givenSequence
into aList
, applyingCollections.shuffle(List)
and then returning the shuffled elements in a new instance ofSequence
which behaves as aSequence
.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 aStringBuilder
object 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 outModifierConstructorDescriptionSequenceIterator
(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
Modifier and TypeMethodDescriptionDNAToRNATranslator.createSequence
(Sequence<NucleotideCompound> originalSequence) DNAToRNATranslator.createSequence
(Sequence<NucleotideCompound> originalSequence, Frame frame) TranscriptionEngine.translate
(Sequence<NucleotideCompound> dna) Quick method to let you go from a CDS to a Peptide quickly.<C extends NucleotideCompound>
Sequence<C> 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.Modifier and TypeMethodDescriptionDNAToRNATranslator.createSequences
(Sequence<NucleotideCompound> originalSequence) Overloaded local version which delegates to an optional translator when told to (specified during construction).RNAToAminoAcidTranslator.createSequences
(Sequence<NucleotideCompound> originalSequence) Performs the core conversion of RNA to Peptide.TranscriptionEngine.multipleFrameTranslation
(Sequence<NucleotideCompound> dna, Frame... frames) A way of translating DNA in a number of framesModifier and TypeMethodDescriptionDNAToRNATranslator.createSequence
(Sequence<NucleotideCompound> originalSequence) DNAToRNATranslator.createSequence
(Sequence<NucleotideCompound> originalSequence, Frame frame) DNAToRNATranslator.createSequences
(Sequence<NucleotideCompound> originalSequence) Overloaded local version which delegates to an optional translator when told to (specified during construction).RNAToAminoAcidTranslator.createSequences
(Sequence<NucleotideCompound> originalSequence) Performs the core conversion of RNA to Peptide.TranscriptionEngine.multipleFrameTranslation
(Sequence<NucleotideCompound> dna, Frame... frames) A way of translating DNA in a number of framesTranscriptionEngine.translate
(Sequence<NucleotideCompound> dna) Quick method to let you go from a CDS to a Peptide quickly.<C extends NucleotideCompound>
Sequence<C> 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 RNASequence
DNAToRNATranslator.wrapToRna
(Sequence<NucleotideCompound> dna) Takes in the given DNA Sequence and returns an instance of RNASequence which is usingRnaSequenceView
as aProxySequenceReader
. -
Uses of Sequence in org.biojava.nbio.core.sequence.views
Modifier and TypeClassDescriptionclass
ComplementSequenceView<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 Tclass
ReversedSequenceView<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.class
Attempts to do on the fly translation of RNA by not requesting the compounds until asked.Modifier and TypeMethodDescriptionWindowedSequence.getBackingSequence()
Access the sequence which backs this windowModifierConstructorDescriptionComplementSequenceView
(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
Modifier and TypeMethodDescriptionSequence
<?> SequenceTools.getSequenceFromString
(String sequence) Attempts to parse String as a DNA sequence first.
If this fails it tries to parse as a ProteinSequence. -
Uses of Sequence in org.biojava.nbio.phylo
Modifier and TypeMethodDescriptionForesterWrapper.convert
(MultipleSequenceAlignment<C, D> msa) Convert a BioJavaMultipleSequenceAlignment
to 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:d = -log(1 - D)
The gapped positons in the alignment are ignored in the calculation.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
Modifier and TypeMethodDescriptionSequence
<?> Chain.getBJSequence()
Converts the SEQRES groups of a Chain to a Biojava Sequence object.Sequence
<?> ChainImpl.getBJSequence()
-
Uses of Sequence in org.biojava.nbio.structure.io
Modifier and TypeMethodDescriptionstatic AFPChain
FastaAFPChainConverter.fastaToAfpChain
(SequencePair<Sequence<AminoAcidCompound>, AminoAcidCompound> alignment, Structure structure1, Structure structure2) Provided only for convenience. -
Uses of Sequence in org.biojava.nbio.ws.alignment
Modifier and TypeMethodDescriptionRemotePairwiseAlignmentService.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
Modifier and TypeMethodDescriptionNCBIQBlastService.sendAlignmentRequest
(Sequence<Compound> seq, RemotePairwiseAlignmentProperties rpa) Converts given sequence to String and callsNCBIQBlastService.sendAlignmentRequest(String, RemotePairwiseAlignmentProperties)