Uses of Interface
org.biojava.bio.symbol.SymbolList
-
Packages that use SymbolList Package Description org.biojava.bio.alignment Classes to generate and describe sequence alignments.org.biojava.bio.chromatogram Interfaces and classes for chromatogram data, as produced by DNA sequencing equipment.org.biojava.bio.dist Probability distributions over Alphabets.org.biojava.bio.dp HMM and Dynamic Programming Algorithms.org.biojava.bio.dp.onehead org.biojava.bio.dp.twohead org.biojava.bio.gui.sequence Graphical displays of biological sequences and associated annotations.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.abi ABI Trace Handling.org.biojava.bio.program.fastq FASTQ and variants sequence format I/O.org.biojava.bio.program.phred Parser for Phred outputorg.biojava.bio.program.scf Support for the SCF chromatogram format.org.biojava.bio.program.ssaha SSAHA sequence searching API.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.homol The classes and interfaces for defining sequence similarity and honology.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.projection Code for projecting Feature objects and systematically altering their properties.org.biojava.bio.symbol Representation of the Symbols that make up a sequence, and locations within them.org.biojava.utils.automata org.biojava.utils.regex This package is used to perform regular expression searches of SymbolLists defined in arbitrary Alphabets.org.biojavax The Biojava extensions packages, classes that extend the core biojava functionalityorg.biojavax.bio.db.biosql Interface between biojava and biosql databasesorg.biojavax.bio.seq Rich implementations of Sequences, Locations and Features.org.biojavax.ga Classes to provide a genetic algorithm frameworkorg.biojavax.ga.functions GA functionsorg.biojavax.ga.impl Default implementations and abstract classes.org.biojavax.ga.util Utility functions and helper classes -
-
Uses of SymbolList in org.biojava.bio.alignment
Subinterfaces of SymbolList in org.biojava.bio.alignment Modifier and Type Interface Description interfaceAlignmentAn alignment containing multiple SymbolLists.interfaceARAlignmentARAlignment is an interface that defines methods for adding and removing seqeunces from an Alignment.interfaceUnequalLengthAlignmentUnequalLengthAlignment has the following behavior.Classes in org.biojava.bio.alignment that implement SymbolList Modifier and Type Class Description classAbstractULAlignmentclassAbstractULAlignment.SubULAlignmentclassAlignmentPairThis class stores the result of an alignment procedure that creates a pairwise alignment of two sequences.classFlexibleAlignmentFlexibleAlignment is a class which implements UnequalLengthAlignment, ARAlignment and EditableAlignment It places no restriction on where any sequence can be in the alignment so there could be gaps in the alignment.classSimpleAlignmentA simple implementation of an Alignment.Fields in org.biojava.bio.alignment declared as SymbolList Modifier and Type Field Description protected SymbolListSimpleAlignmentElement. seqMethods in org.biojava.bio.alignment that return SymbolList Modifier and Type Method Description SymbolListAlignmentElement. getSymbolList()SymbolListSimpleAlignmentElement. getSymbolList()SymbolListAlignment.SymbolListIterator. next()SymbolListAbstractULAlignment.SubULAlignment. symbolListForLabel(String label)SymbolListAlignment. symbolListForLabel(String label)Retrieve a single row of the alignment by label.SymbolListFlexibleAlignment. symbolListForLabel(String label)SymbolListSimpleAlignment. symbolListForLabel(String label)Methods in org.biojava.bio.alignment that return types with arguments of type SymbolList Modifier and Type Method Description Iterator<SymbolList>AbstractULAlignment.SubULAlignment. symbolListIterator()Iterator<SymbolList>AbstractULAlignment. symbolListIterator()Iterator<SymbolList>Alignment. symbolListIterator()Creates an Iterator over the SymbolLists in the alignment.Iterator<SymbolList>SimpleAlignment. symbolListIterator()Methods in org.biojava.bio.alignment with parameters of type SymbolList Modifier and Type Method Description protected booleanFlexibleAlignment. allGaps(SymbolList seq, int start, int end)make sure that all Symbols in this range are gapsabstract AlignmentPairAlignmentAlgorithm. pairwiseAlignment(SymbolList query, SymbolList subject)Performs a pairwise sequence alignment of the two given sequences.AlignmentPairNeedlemanWunsch. pairwiseAlignment(SymbolList query, SymbolList subject)Global pairwise sequence alignment of two BioJava-Sequence objects according to the Needleman-Wunsch-algorithm.AlignmentPairSmithWaterman. pairwiseAlignment(SymbolList query, SymbolList subject)Overrides the method inherited from the NeedlemanWunsch and performs only a local alignment.Constructors in org.biojava.bio.alignment with parameters of type SymbolList Constructor Description SimpleAlignmentElement(String label, SymbolList seq, Location loc)Constructor parameters in org.biojava.bio.alignment with type arguments of type SymbolList Constructor Description SimpleAlignment(Map<String,SymbolList> labelToResList)Generate an alignment from a list of SymbolLists. -
Uses of SymbolList in org.biojava.bio.chromatogram
Methods in org.biojava.bio.chromatogram that return SymbolList Modifier and Type Method Description protected SymbolListAbstractChromatogram. createImmutableSymbolList(Alphabet alpha, List syms)A factory method for creating new symbol lists with a given alphabet.static SymbolListChromatogramTools. getDNASequence(Chromatogram chromat)Get the called DNA sequence from a chromatogram.static SymbolListChromatogramTools. getTraceOffsets(Chromatogram chromat)Get the peak offsets for the called bases of a chromatogram.protected SymbolListAbstractChromatogram. reverseComplementBaseCallList(Object label)Return a symbol list containing the reverse complement of the base call data for the given label.Methods in org.biojava.bio.chromatogram with parameters of type SymbolList Modifier and Type Method Description static intChromatogramTools. getIntFromSymbolList(SymbolList list, int which)Retrieves, unwraps, and returns anintfrom a SymbolList containingIntegerAlphabet.IntegerSymbols.voidSimpleChromatogram. setSymbolLists(SymbolList dna, SymbolList offsets)Set the DNA and OFFSETS symbol lists for the basecall alignment. -
Uses of SymbolList in org.biojava.bio.dist
Methods in org.biojava.bio.dist that return SymbolList Modifier and Type Method Description static SymbolListDistributionTools. generateSymbolList(Distribution d, int length)Produces aSymbolListby randomly sampling a Distribution. -
Uses of SymbolList in org.biojava.bio.dp
Subinterfaces of SymbolList in org.biojava.bio.dp Modifier and Type Interface Description interfaceStatePathExtends the Alignment interface so that it is explicitly used to represent a state path through an HMM, and the associated emitted sequence and likelihoods.Classes in org.biojava.bio.dp that implement SymbolList Modifier and Type Class Description classSimpleStatePathA no-frills implementation of StatePath.Methods in org.biojava.bio.dp that return SymbolList Modifier and Type Method Description SymbolListSimpleStatePath. subList(int start, int end)SymbolListSimpleStatePath. symbolListForLabel(String label)SymbolList[]DPMatrix. symList()Methods in org.biojava.bio.dp that return types with arguments of type SymbolList Modifier and Type Method Description Iterator<SymbolList>SimpleStatePath. symbolListIterator()Methods in org.biojava.bio.dp with parameters of type SymbolList Modifier and Type Method Description abstract doubleDP. backward(SymbolList[] symList, ScoreType scoreType)abstract DPMatrixDP. backwardMatrix(SymbolList[] symList, DPMatrix matrix, ScoreType scoreType)abstract DPMatrixDP. backwardMatrix(SymbolList[] symList, ScoreType scoreType)abstract doubleDP. forward(SymbolList[] symList, ScoreType scoreType)abstract DPMatrixDP. forwardMatrix(SymbolList[] symList, DPMatrix matrix, ScoreType scoreType)abstract DPMatrixDP. forwardMatrix(SymbolList[] symList, ScoreType scoreType)DPMatrixDP. forwardsBackwards(SymbolList[] symList, ScoreType scoreType)static doubleDP. scoreWeightMatrix(WeightMatrix matrix, SymbolList symList, int start)Scores the SymbolList from symbol start to symbol (start+columns) with a weight matrix.static doubleDP. scoreWeightMatrix(WeightMatrix matrix, SymbolList symList, ScoreType scoreType, int start)Scores the SymbolList from symbol start to symbol (start+columns) with a weight matrix using a particular ScoreType.protected abstract doubleAbstractTrainer. singleSequenceIteration(ModelTrainer trainer, SymbolList symList)protected doubleBaumWelchSampler. singleSequenceIteration(ModelTrainer trainer, SymbolList symList)protected doubleBaumWelchSampler. singleSequenceIteration(ModelTrainer trainer, SymbolList symList, ScoreType scoreType)protected doubleBaumWelchTrainer. singleSequenceIteration(ModelTrainer trainer, SymbolList symList)abstract StatePathDP. viterbi(SymbolList[] symList, ScoreType scoreType)Constructors in org.biojava.bio.dp with parameters of type SymbolList Constructor Description ReverseIterator(SymbolList sym)SimpleStatePath(double score, SymbolList sequence, SymbolList states, SymbolList scores) -
Uses of SymbolList in org.biojava.bio.dp.onehead
Fields in org.biojava.bio.dp.onehead declared as SymbolList Modifier and Type Field Description protected SymbolList[]SingleDPMatrix. symListMethods in org.biojava.bio.dp.onehead that return SymbolList Modifier and Type Method Description SymbolListDPCursor. symList()The symbol list being looped over.SymbolList[]SingleDPMatrix. symList()SymbolListSmallCursor. symList()Methods in org.biojava.bio.dp.onehead with parameters of type SymbolList Modifier and Type Method Description doubleSingleDP. backward(SymbolList[] seq, ScoreType scoreType)DPMatrixSingleDP. backwardMatrix(SymbolList[] seq, DPMatrix matrix, ScoreType scoreType)DPMatrixSingleDP. backwardMatrix(SymbolList[] seq, ScoreType scoreType)doubleSingleDP. forward(SymbolList[] seq, ScoreType scoreType)DPMatrixSingleDP. forwardMatrix(SymbolList[] seq, DPMatrix matrix, ScoreType scoreType)DPMatrixSingleDP. forwardMatrix(SymbolList[] seq, ScoreType scoreType)StatePathSingleDP. viterbi(SymbolList[] symList, ScoreType scoreType)Constructors in org.biojava.bio.dp.onehead with parameters of type SymbolList Constructor Description SingleDPMatrix(DP dp, SymbolList symList)SmallCursor(State[] states, SymbolList symList, Iterator symIterator) -
Uses of SymbolList in org.biojava.bio.dp.twohead
Fields in org.biojava.bio.dp.twohead declared as SymbolList Modifier and Type Field Description protected SymbolList[]AbstractMatrixPairDPCursor. seqsMethods in org.biojava.bio.dp.twohead that return SymbolList Modifier and Type Method Description SymbolList[]PairDPMatrix. symList()Methods in org.biojava.bio.dp.twohead with parameters of type SymbolList Modifier and Type Method Description doublePairwiseDP. backward(SymbolList[] seqs, ScoreType scoreType)DPMatrixPairwiseDP. backwardMatrix(SymbolList[] seqs, DPMatrix d, ScoreType scoreType)DPMatrixPairwiseDP. backwardMatrix(SymbolList[] seqs, ScoreType scoreType)doublePairwiseDP. forward(SymbolList[] seqs, ScoreType scoreType)DPMatrixPairwiseDP. forwardMatrix(SymbolList[] seqs, DPMatrix d, ScoreType scoreType)DPMatrixPairwiseDP. forwardMatrix(SymbolList[] seqs, ScoreType scoreType)StatePathPairwiseDP. viterbi(SymbolList[] seqs, ScoreType scoreType)Constructors in org.biojava.bio.dp.twohead with parameters of type SymbolList Constructor Description AbstractMatrixPairDPCursor(SymbolList seq1, SymbolList seq2, int start1, int start2, int depth1, int depth2, PairDPMatrix matrix, EmissionCache eCache)BackMatrixPairDPCursor(SymbolList seq1, SymbolList seq2, int depth1, int depth2, PairDPMatrix matrix, EmissionCache eCache)LightPairDPCursor(SymbolList seq1, SymbolList seq2, int depth1, int depth2, int numStates, EmissionCache eCache)Constructor for the LightPairDPCursor objectMatrixPairDPCursor(SymbolList seq1, SymbolList seq2, int depth1, int depth2, PairDPMatrix matrix, EmissionCache eCache)PairDPMatrix(DP dp, SymbolList seq0, SymbolList seq1) -
Uses of SymbolList in org.biojava.bio.gui.sequence
Methods in org.biojava.bio.gui.sequence that return SymbolList Modifier and Type Method Description SymbolListPairwiseRenderContext. getSecondarySymbols()getSecondarySymbolsreturns the symbols of the secondary sequence.SymbolListPairwiseSequencePanel. getSecondarySymbols()getSecondarySymbolsreturns all of theSymbols belonging to the currently rendered secondarySequence.SymbolListSubPairwiseRenderContext. getSecondarySymbols()SymbolListCircularRendererPanel. getSequence()SymbolListSequencePanel. getSequence()SymbolListTranslatedSequencePanel. getSequence()getSequencereturns the entireSequencecurrently being rendered.SymbolListCircularRendererContext. getSymbols()The SymbolList that is currently rendered by this context.SymbolListHeadlessRenderContext. getSymbols()SymbolListPairwiseSequencePanel. getSymbols()getSymbolsreturns all of theSymbols belonging to the currently renderedSequence.SymbolListSequencePanel. getSymbols()Retrieve the currently rendered SymbolListSymbolListSequencePoster. getSymbols()Deprecated.Retrieve the currently rendered SymbolListSymbolListSequenceRenderContext. getSymbols()The SymbolList that is currently rendered by this SequenceRenderContext.SymbolListSubCircularRendererContext. getSymbols()SymbolListSubPairwiseRenderContext. getSymbols()SymbolListSubSequenceRenderContext. getSymbols()SymbolListTranslatedSequencePanel. getSymbols()getSymbolsreturns all of theSymbols belonging to the currently renderedSequence.Methods in org.biojava.bio.gui.sequence with parameters of type SymbolList Modifier and Type Method Description voidCircularRendererPanel. setSequence(SymbolList symList)voidSequencePanel. setSequence(SymbolList s)Set the SymboList to be rendered.voidTranslatedSequencePanel. setSequence(SymbolList sequence)setSequencesets theSequenceto be rendered.Constructors in org.biojava.bio.gui.sequence with parameters of type SymbolList Constructor Description SubCircularRendererContext(CircularRendererContext delegate, SymbolList symbols, FeatureHolder features, double radius)Create a new sub context.SubPairwiseRenderContext(PairwiseRenderContext context, SymbolList symbols, SymbolList secondarySymbols, FeatureHolder features, FeatureHolder secondaryFeatures, RangeLocation range, RangeLocation secondaryRange)Creates a newSubPairwiseRenderContext.SubSequenceRenderContext(SequenceRenderContext src, SymbolList symbols, FeatureHolder features, RangeLocation range)SubSequenceRenderContext(SequenceRenderContext src, SymbolList symbols, FeatureHolder features, RangeLocation range, int symOffset) -
Uses of SymbolList in org.biojava.bio.molbio
Fields in org.biojava.bio.molbio declared as SymbolList Modifier and Type Field Description protected SymbolListRestrictionEnzyme. siteMethods in org.biojava.bio.molbio that return SymbolList Modifier and Type Method Description SymbolListRestrictionEnzyme. getRecognitionSite()getRecognitionSitereturns the forward strand of the recognition site.Methods in org.biojava.bio.molbio with parameters of type SymbolList Modifier and Type Method Description voidComposition. setSymbolList(SymbolList symbolList)Set theSymbolListto calculation the composition of.Constructors in org.biojava.bio.molbio with parameters of type SymbolList Constructor Description RestrictionEnzyme(String name, SymbolList site, int dsForward, int dsReverse)Creates a newRestrictionEnzymewhich cuts within or downstream of the recognition site.RestrictionEnzyme(String name, SymbolList site, int usForward, int usReverse, int dsForward, int dsReverse)Creates a newRestrictionEnzymeof the unusual type which cuts both upstream and downstream of its recognition site. -
Uses of SymbolList in org.biojava.bio.program.abi
Methods in org.biojava.bio.program.abi that return SymbolList Modifier and Type Method Description SymbolListABITrace. getSequence()Returns the original programatically determined (unedited) sequence as aSymbolList.Methods in org.biojava.bio.program.abi with parameters of type SymbolList Modifier and Type Method Description static AlignmentABITools. getAlignment(SymbolList abiSeq)View a symbol list over the QUALITY alphabet as an alignment. -
Uses of SymbolList in org.biojava.bio.program.fastq
Methods in org.biojava.bio.program.fastq that return SymbolList Modifier and Type Method Description static SymbolListFastqTools. createDNA(Fastq fastq)Create and return a new DNASymbolListfrom the specified FASTQ formatted sequence.static SymbolListFastqTools. createQualityScores(Fastq fastq)Create and return a newSymbolListof quality scores from the specified FASTQ formatted sequence. -
Uses of SymbolList in org.biojava.bio.program.phred
Classes in org.biojava.bio.program.phred that implement SymbolList 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 that return SymbolList Modifier and Type Method Description static SymbolListPhredTools. createPhred(SymbolList dna, SymbolList quality)Merges a Symbol List from the DNA alphabet with a SymbolList from the [0..99] subset of the IntegerAlphabet into a SymbolList from the PHRED alphabet.SymbolListPhredSequence. getDNA()Extracts the DNA part of the PhredAlpahbet SymbolList and returns it as a SymbolListSymbolListPhredSequence. getQuality()Extracts the quality part if the Phred Alphabet and returns it as a SymbolList over the Integer SubAlphabet from 0..99.SymbolListQualitative. getQuality()Retreives the list of quality symbols from the underlying object.Methods in org.biojava.bio.program.phred with parameters of type SymbolList Modifier and Type Method Description static SymbolListPhredTools. createPhred(SymbolList dna, SymbolList quality)Merges a Symbol List from the DNA alphabet with a SymbolList from the [0..99] subset of the IntegerAlphabet into a SymbolList from the PHRED alphabet.Constructors in org.biojava.bio.program.phred with parameters of type SymbolList Constructor Description PhredSequence(SymbolList phredSequence, String name, String urn, Annotation anno)Constructs a new PhredSequence. -
Uses of SymbolList in org.biojava.bio.program.scf
Methods in org.biojava.bio.program.scf that return SymbolList Modifier and Type Method Description protected SymbolListSCF. reverseComplementBaseCallList(String label)OverridesAbstractChromatogram.reverseComplementBaseCallList(java.lang.Object)to support the 7 quality values from the SCF. -
Uses of SymbolList in org.biojava.bio.program.ssaha
Methods in org.biojava.bio.program.ssaha with parameters of type SymbolList Modifier and Type Method Description voidCompactedDataStore. search(String seqID, SymbolList symList, SearchListener listener)voidDataStore. search(String id, SymbolList symList, SearchListener listener)Search the DataStore with a symbol list. -
Uses of SymbolList in org.biojava.bio.proteomics
Methods in org.biojava.bio.proteomics that return SymbolList Modifier and Type Method Description SymbolListProtease. getCleaveageResidues()The list of residues that the protease will cleave at.SymbolListProtease. getNotCleaveResidues()The list of residues that will prevent cleavage if they follow the cleavage residue.Methods in org.biojava.bio.proteomics with parameters of type SymbolList Modifier and Type Method Description static ProteaseProteaseManager. createProtease(SymbolList cleaveRes, boolean endoProtease, String name)static ProteaseProteaseManager. createProtease(SymbolList cleaveRes, boolean endoProtease, SymbolList notCleaveRes, String name)Creates and registers a new Protease.static doubleIsoelectricPointCalc. getIsoelectricPoint(SymbolList peptide)Static public method to compute the pI for a polypeptide in denaturating and reduced conditions with both free ends.doubleMassCalc. getMass(SymbolList proteinSeq)Get the Mass of this peptide.static doubleMassCalc. getMass(SymbolList proteinSeq, String isotopicType, boolean MH_PLUS)getMasscalculates the mass of this peptide.static doubleMassCalc. getMolecularWeight(SymbolList proteinSeq)Calculate the molecular weight of a protein, making estimates whenever it is possible like averaging mass values for ambiguity symbols or counting zero when gaps are encountered.doubleIsoelectricPointCalc. getPI(SymbolList peptide, boolean hasFreeNTerm, boolean hasFreeCTerm)Computes isoelectric point of specified peptide.double[]MassCalc. getVariableMasses(SymbolList peptide)Get all masses including the variable mass.Constructors in org.biojava.bio.proteomics with parameters of type SymbolList Constructor Description Protease(SymbolList cleaveRes, boolean endoProtease, SymbolList notCleaveRes)Deprecated.Creating a Protease with this constructor will not register it with the ProteaseManager (use ProteaseManager.createProtease())Protease(SymbolList cleaveRes, boolean endoProtease, SymbolList notCleaveRes, String name) -
Uses of SymbolList in org.biojava.bio.search
Methods in org.biojava.bio.search that return SymbolList Modifier and Type Method Description SymbolListKnuthMorrisPrattSearch. getPattern()SymbolListMaxMismatchPattern. getPattern()SymbolListBioMatcher. group()Get the matching region as a SymbolList.SymbolListMaxMismatchMatcher. group()Methods in org.biojava.bio.search with parameters of type SymbolList Modifier and Type Method Description int[]KnuthMorrisPrattSearch. findMatches(SymbolList text)This will return an int[] giving the offsets of the matches intext(ie the location of the first symbol of each match in thetext).BioMatcherBioPattern. matcher(SymbolList symList)Get a matcher that will use these parameters to search a SymbolList.BioMatcherMaxMismatchPattern. matcher(SymbolList symList)BioMatcherSeqContentPattern. matcher(SymbolList symList)SeqSimilaritySearchResultSeqSimilaritySearcher. search(SymbolList querySeq, SequenceDB db, Map searchParameters)Using this sequence similarity searcher, search with the given sequence against the given sequence database.voidMaxMismatchPattern. setPattern(SymbolList pattern)Constructors in org.biojava.bio.search with parameters of type SymbolList Constructor Description KnuthMorrisPrattSearch(SymbolList pattern)Constructs a KMP matcher to find exact occurances ofpatternintextusing the Knuth-Morris-Pratt algorithm.MaxMismatchPattern(SymbolList pattern, int mismatches) -
Uses of SymbolList in org.biojava.bio.seq
Subinterfaces of SymbolList in org.biojava.bio.seq Modifier and Type Interface Description interfaceGappedSequenceExtension of GappedSymbolList which also projects features into the gapped coordinate system.interfaceSequenceA biological sequence.Classes in org.biojava.bio.seq that implement SymbolList 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.Methods in org.biojava.bio.seq that return SymbolList Modifier and Type Method Description static SymbolListDNATools. complement(SymbolList list)Retrieve a complement view of list.static SymbolListNucleotideTools. complement(SymbolList list)Retrieve a complement view of list.static SymbolListRNATools. complement(SymbolList list)Retrieve a complement view of list.static SymbolListDNATools. createDNA(String dna)Return a new DNA SymbolList for dna.static SymbolListNucleotideTools. createNucleotide(String nucleotide)Return a new Nucleotide SymbolList for nucleotide.static SymbolListProteinTools. createProtein(String theProtein)Return a new Protein SymbolList for protein.static SymbolListRNATools. createRNA(String rna)Return a new RNA SymbolList for rna.static SymbolListDNATools. flip(SymbolList list, StrandedFeature.Strand strand)Returns a SymbolList that is reverse complemented if the strand is negative, and the origninal one if it is not.SymbolListFeature. getSymbols()Return a list of symbols that are contained in this feature.SymbolListStrandedFeature. getSymbols()Return a list of symbols that are contained in this feature.static SymbolListDNATools. reverseComplement(SymbolList list)Retrieve a reverse-complement view of list.static SymbolListNucleotideTools. reverseComplement(SymbolList list)Retrieve a reverse-complement view of list.static SymbolListRNATools. reverseComplement(SymbolList list)Retrieve a reverse-complement view of list.SymbolListCircularView. subList(int start, int end)Over rides ViewSequence.SymbolListNewSimpleAssembly. subList(int start, int end)SymbolListSimpleAssembly. subList(int start, int end)static SymbolListDNATools. toProtein(SymbolList syms)Convenience method that directly converts a DNA sequence to RNA then to protein.static SymbolListDNATools. toProtein(SymbolList syms, int start, int end)Convenience method to translate a region of a DNA sequence directly into protein.static SymbolListDNATools. toRNA(SymbolList syms)Converts aSymbolListfrom the DNAAlphabetto the RNAAlphabet.static SymbolListGeneticCodes. transcribe(SymbolList theList)Transcribe DNA into RNA.static SymbolListRNATools. transcribe(SymbolList list)Deprecated.The naming of this method is confusing and inconsistent use either DNATools.toRNA(SymbolList list) or DNATools.transcribeToRNA(SymbolList list) depending on the desired behaivour.static SymbolListDNATools. transcribeToRNA(SymbolList syms)Transcribes DNA to RNA.static SymbolListGeneticCodes. translate(SymbolList theList)Translate RNA into protein (with termination symbols).static SymbolListRNATools. translate(SymbolList syms)Translate RNA into protein (with termination symbols).Methods in org.biojava.bio.seq with parameters of type SymbolList Modifier and Type Method Description static SymbolListDNATools. complement(SymbolList list)Retrieve a complement view of list.static SymbolListNucleotideTools. complement(SymbolList list)Retrieve a complement view of list.static SymbolListRNATools. complement(SymbolList list)Retrieve a complement view of list.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)static SymbolListDNATools. flip(SymbolList list, StrandedFeature.Strand strand)Returns a SymbolList that is reverse complemented if the strand is negative, and the origninal one if it is not.static SymbolListDNATools. reverseComplement(SymbolList list)Retrieve a reverse-complement view of list.static SymbolListNucleotideTools. reverseComplement(SymbolList list)Retrieve a reverse-complement view of list.static SymbolListRNATools. reverseComplement(SymbolList list)Retrieve a reverse-complement view of list.static SymbolListDNATools. toProtein(SymbolList syms)Convenience method that directly converts a DNA sequence to RNA then to protein.static SymbolListDNATools. toProtein(SymbolList syms, int start, int end)Convenience method to translate a region of a DNA sequence directly into protein.static SymbolListDNATools. toRNA(SymbolList syms)Converts aSymbolListfrom the DNAAlphabetto the RNAAlphabet.static SymbolListGeneticCodes. transcribe(SymbolList theList)Transcribe DNA into RNA.static SymbolListRNATools. transcribe(SymbolList list)Deprecated.The naming of this method is confusing and inconsistent use either DNATools.toRNA(SymbolList list) or DNATools.transcribeToRNA(SymbolList list) depending on the desired behaivour.static SymbolListDNATools. transcribeToRNA(SymbolList syms)Transcribes DNA to RNA.static SymbolListGeneticCodes. translate(SymbolList theList)Translate RNA into protein (with termination symbols).static SymbolListRNATools. translate(SymbolList syms)Translate RNA into protein (with termination symbols). -
Uses of SymbolList in org.biojava.bio.seq.homol
Classes in org.biojava.bio.seq.homol that implement SymbolList Modifier and Type Class Description static classSimilarityPairFeature.EmptyPairwiseAlignmentEmptyPairwiseAlignmentempty pairwise alignment which has labels to empty symbol lists.Methods in org.biojava.bio.seq.homol that return SymbolList Modifier and Type Method Description SymbolListSimilarityPairFeature.EmptyPairwiseAlignment. subList(int index1, int index2)SymbolListSimilarityPairFeature.EmptyPairwiseAlignment. symbolListForLabel(String label)Methods in org.biojava.bio.seq.homol that return types with arguments of type SymbolList Modifier and Type Method Description Iterator<SymbolList>SimilarityPairFeature.EmptyPairwiseAlignment. symbolListIterator() -
Uses of SymbolList in org.biojava.bio.seq.impl
Classes in org.biojava.bio.seq.impl that implement SymbolList Modifier and Type Class Description classAssembledSymbolListSupport class for applications which need to patch together sections of sequence into a single SymbolList.classDummySequenceA Sequence implementation that has a name and URI but no features, and a zero length symbol list.classNewAssembledSymbolListSupport class for applications which need to patch together sections of sequence into a single SymbolList.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.Methods in org.biojava.bio.seq.impl that return SymbolList Modifier and Type Method Description SymbolListSimpleFeature. getSymbols()SymbolListSimpleStrandedFeature. getSymbols()SymbolListAssembledSymbolList. subList(int start, int end)SymbolListDummySequence. subList(int start, int end)SymbolListNewAssembledSymbolList. subList(int start, int end)SymbolListSimpleSequence. subList(int start, int end)SymbolListSubSequence. subList(int start, int end)SymbolListViewSequence. subList(int start, int end)Methods in org.biojava.bio.seq.impl with parameters of type SymbolList Modifier and Type Method Description SequenceSimpleSequenceFactory. createSequence(SymbolList symList, String uri, String name, Annotation annotation)voidAssembledSymbolList. putComponent(Location l, SymbolList sl)Constructors in org.biojava.bio.seq.impl with parameters of type SymbolList Constructor Description SimpleSequence(SymbolList sym, String urn, String name, Annotation annotation)Create a SimpleSequence with the symbols and alphabet of sym, and the sequence properties listed.SimpleSequence(SymbolList sym, String urn, String name, Annotation annotation, FeatureRealizer realizer)Create a SimpleSequence using a specified FeatureRealizer. -
Uses of SymbolList in org.biojava.bio.seq.io
Methods in org.biojava.bio.seq.io that return SymbolList Modifier and Type Method Description SymbolListChunkedSymbolListFactory. make(SymbolReader sr)Method to create a Sequence with a SymbolReader.SymbolListChunkedSymbolListFactory. makeSymbolList()Converts accumulated Symbols to a SymbolListMethods in org.biojava.bio.seq.io with parameters of type SymbolList Modifier and Type Method Description StringAlternateTokenization. tokenizeSymbolList(SymbolList sl)StringCharacterTokenization. tokenizeSymbolList(SymbolList sl)StringSymbolTokenization. tokenizeSymbolList(SymbolList symList)Return a string representation of a list of symbols.StringWordTokenization. tokenizeSymbolList(SymbolList sl)Constructors in org.biojava.bio.seq.io with parameters of type SymbolList Constructor Description SymbolListCharSequence(SymbolList syms)Creates a newSymbolListCharSequencewrapping aSymbolList. -
Uses of SymbolList in org.biojava.bio.seq.projection
Methods in org.biojava.bio.seq.projection that return SymbolList Modifier and Type Method Description SymbolListProjectedFeature. getSymbols() -
Uses of SymbolList in org.biojava.bio.symbol
Subinterfaces of SymbolList in org.biojava.bio.symbol Modifier and Type Interface Description interfaceGappedSymbolListThis extends SymbolList with API for manipulating, inserting and deleting gaps.Classes in org.biojava.bio.symbol that implement SymbolList Modifier and Type Class Description classAbstractSymbolListAbstract helper implementation of the SymbolList core interface.classChunkedSymbolListSymbolList implementation using constant-size chunks.classDummySymbolListSymbol list which just consists of non-informative symbols.classPackedSymbolListA SymbolList that stores symbols as bit-patterns in an array of longs.classRelabeledAlignmentAn alignment that relabels another alignment.classSimpleGappedSymbolListThis implementation of GappedSymbolList wraps a SymbolList, allowing you to insert gaps.classSimpleSymbolListBasic implementation of SymbolList.Fields in org.biojava.bio.symbol declared as SymbolList Modifier and Type Field Description static SymbolListSymbolList. EMPTY_LISTA useful object that represents an empty symbol list, to avoid returning null.SymbolListEdit. replacementMethods in org.biojava.bio.symbol that return SymbolList Modifier and Type Method Description static SymbolListSymbolListViews. emptyList(Alphabet alpha)Get a new immutable, empty symbol list with the given alphabet.static SymbolListDoubleAlphabet. fromArray(double[] dArray)Retrieve a SymbolList view of an array of doubles.static SymbolListIntegerAlphabet. fromArray(int[] iArray)Retrieve a SymbolList view of an array of integers.SymbolListGappedSymbolList. getSourceSymbolList()Return the underlying (ungapped) SymbolList.SymbolListSimpleGappedSymbolList. getSourceSymbolList()SymbolListPackedSymbolListFactory. makeSymbolList(Symbol[] symbolArray, int size, Alphabet alfa)Makes a packed SymbolList out of a list of Symbols.SymbolListSimpleSymbolListFactory. makeSymbolList(Symbol[] symbolArray, int size, Alphabet alfa)Create a factory for SimpleSymbolLists.SymbolListSymbolListFactory. makeSymbolList(Symbol[] symbolArray, int size, Alphabet alfa)makes a SymbolList containing size Symbols from a Symbol array.static SymbolListSymbolListViews. orderNSymbolList(SymbolList source, int order)An n-th order view of another SymbolList.static SymbolListSymbolListViews. reverse(SymbolList symbols)A reversed view onto a SymbolList.SymbolListAbstractSymbolList. subList(int start, int end)SymbolListChunkedSymbolList. subList(int start, int end)SymbolListRelabeledAlignment. subList(int min, int max)SymbolListSimpleSymbolList. subList(int start, int end)create a subList of the original, this will be a view until either the original symbolList or the sublist is editedSymbolListSymbolList. subList(int start, int end)Return a new SymbolList for the symbols start to end inclusive.static SymbolListSymbolListViews. subList(SymbolList parent, int start, int end)View a portion of a SymbolList.SymbolListRelabeledAlignment. symbolListForLabel(String label)SymbolListAbstractLocationDecorator. symbols(SymbolList seq)SymbolListAbstractRangeLocation. symbols(SymbolList seq)SymbolListCircularLocation. symbols(SymbolList seq)SymbolListFuzzyPointLocation. symbols(SymbolList slist)SymbolListLocation. symbols(SymbolList seq)Return the symbols in a sequence that fall within this range.static SymbolListSymbolListViews. translate(SymbolList symbols, TranslationTable table)Provides a 'translated' view of an underlying SymbolList.static SymbolListSymbolListViews. windowedSymbolList(SymbolList source, int wsize)A view of windows onto another SymbolList.Methods in org.biojava.bio.symbol with parameters of type SymbolList Modifier and Type Method Description voidUkkonenSuffixTree. addSymbolList(SymbolList list, String name, boolean doNotTerminate)voidSuffixTree. addSymbols(SymbolList sList, int window)Add a count for all motifs with length of up towindowto this tree.static AlignmentSymbolListViews. alignment(List labels, SymbolList symList)View a SymbolList over a cross-product Alphabet as an Alignment.static StringMotifTools. createRegex(SymbolList motif)createRegexcreates a regular expression which matches theSymbolList.static intPackingFactory. nextWord(SymbolList symList, int word, int offset, int wordLength, Packing packing)static SymbolListSymbolListViews. orderNSymbolList(SymbolList source, int order)An n-th order view of another SymbolList.static intPackingFactory. primeWord(SymbolList symList, int wordLength, Packing packing)static SymbolListSymbolListViews. reverse(SymbolList symbols)A reversed view onto a SymbolList.static SymbolListSymbolListViews. subList(SymbolList parent, int start, int end)View a portion of a SymbolList.SymbolListAbstractLocationDecorator. symbols(SymbolList seq)SymbolListAbstractRangeLocation. symbols(SymbolList seq)SymbolListCircularLocation. symbols(SymbolList seq)SymbolListFuzzyPointLocation. symbols(SymbolList slist)SymbolListLocation. symbols(SymbolList seq)Return the symbols in a sequence that fall within this range.StringSoftMaskedAlphabet.CaseSensitiveTokenization. tokenizeSymbolList(SymbolList sl)static SymbolListSymbolListViews. translate(SymbolList symbols, TranslationTable table)Provides a 'translated' view of an underlying SymbolList.static SymbolListSymbolListViews. windowedSymbolList(SymbolList source, int wsize)A view of windows onto another SymbolList.Constructors in org.biojava.bio.symbol with parameters of type SymbolList Constructor Description ChunkedSymbolList(SymbolList[] chunks, int chunkSize, int length, Alphabet alpha)Edit(int pos, int length, SymbolList replacement)Create a new Edit.Edit(int pos, int length, SymbolList replacement, Map<String,Object> props)Create a new Edit with some properties.PackedSymbolList(Packing packing, SymbolList symList)Create a new PackedSymbolList as a packed copy of another symbol list.SimpleGappedSymbolList(SymbolList source)Create a new SimpleGappedSymbolList that will view source.SimpleSymbolList(SymbolList sl)Construct a copy of an existing SymbolList. -
Uses of SymbolList in org.biojava.utils.automata
Methods in org.biojava.utils.automata with parameters of type SymbolList Modifier and Type Method Description voidPatternBlitz. search(SymbolList sl) -
Uses of SymbolList in org.biojava.utils.regex
Methods in org.biojava.utils.regex that return SymbolList Modifier and Type Method Description SymbolListMatcher. group()Returns the input subsequence matched by the previous match.SymbolListMatcher. group(int group)Returns the input subsequence captured by the given group during the previous match operation.Methods in org.biojava.utils.regex with parameters of type SymbolList Modifier and Type Method Description MatcherPattern. matcher(SymbolList sl)Creates a matcher that will match the given input against this pattern.booleanSearch.Listener. reportMatch(SymbolList seq, Pattern pattern, int start, int end)MatcherMatcher. reset(SymbolList sl)Resets this matcher with a new input SymbolList.voidSearch. search(SymbolList seq)search the Sequence with the patterns already registered with this object.voidSearch. search(SymbolList seq, int loLimit, int hiLimit)search part of the SymbolList with the patterns already registered with this object. -
Uses of SymbolList in org.biojavax
Methods in org.biojavax that return SymbolList Modifier and Type Method Description SymbolListCrossReferenceResolver. getRemoteSymbolList(CrossRef cr, Alphabet a)Given a cross reference, return the corresponding symbol list.SymbolListDummyCrossReferenceResolver. getRemoteSymbolList(CrossRef cr, Alphabet a)Given a cross reference, return the corresponding symbol list. -
Uses of SymbolList in org.biojavax.bio.db.biosql
Methods in org.biojavax.bio.db.biosql that return SymbolList Modifier and Type Method Description SymbolListBioSQLCrossReferenceResolver. getRemoteSymbolList(CrossRef cr, Alphabet a)Given a cross reference, return the corresponding symbol list.SymbolListBioSQLRichSequenceHandler. subList(RichSequence seq, int start, int end)Return a new SymbolList for the symbols start to end inclusive. -
Uses of SymbolList in org.biojavax.bio.seq
Subinterfaces of SymbolList 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 SymbolList Modifier and Type Class Description classInfinitelyAmbiguousSymbolListA symbol list that isInteger.MAX_VALUElong, never gives index out of bounds and always returns ambiguity symbols for everything.classSimpleRichSequenceA simple implementation of RichSequence.classThinRichSequenceA simple implementation of RichSequence.Methods in org.biojavax.bio.seq that return SymbolList Modifier and Type Method Description SymbolListRichSequence. getInternalSymbolList()A special function that returns the SymbolList that this RichSequence is based around.SymbolListSimpleRichSequence. getInternalSymbolList()A special function that returns the SymbolList that this RichSequence is based around.SymbolListThinRichSequence. getInternalSymbolList()A special function that returns the SymbolList that this RichSequence is based around.SymbolListSimpleRichFeature. getSymbols()Return a list of symbols that are contained in this feature.SymbolListDummyRichSequenceHandler. subList(RichSequence seq, int start, int end)Return a new SymbolList for the symbols start to end inclusive.SymbolListInfinitelyAmbiguousSymbolList. subList(int start, int end)Return a new SymbolList for the symbols start to end inclusive.SymbolListRichSequenceHandler. subList(RichSequence seq, int start, int end)Return a new SymbolList for the symbols start to end inclusive.SymbolListThinRichSequence. subList(int start, int end)Return a new SymbolList for the symbols start to end inclusive.SymbolListCompoundRichLocation. symbols(SymbolList seq)Return the symbols in a sequence that fall within this range.SymbolListEmptyRichLocation. symbols(SymbolList seq)Return the symbols in a sequence that fall within this range.SymbolListSimpleRichLocation. symbols(SymbolList seq)Return the symbols in a sequence that fall within this range.Methods in org.biojavax.bio.seq with parameters of type SymbolList Modifier and Type Method Description static RichSequenceRichSequence.Tools. createRichSequence(String name, SymbolList syms)Create a new RichSequence in the default namespace.static RichSequenceRichSequence.Tools. createRichSequence(Namespace ns, String name, SymbolList syms)Create a new RichSequence in the specified namespace.SymbolListCompoundRichLocation. symbols(SymbolList seq)Return the symbols in a sequence that fall within this range.SymbolListEmptyRichLocation. symbols(SymbolList seq)Return the symbols in a sequence that fall within this range.SymbolListSimpleRichLocation. symbols(SymbolList seq)Return the symbols in a sequence that fall within this range.Constructors in org.biojavax.bio.seq with parameters of type SymbolList Constructor Description SimpleRichSequence(Namespace ns, String name, String accession, int version, SymbolList symList, Double seqversion)Creates a new instance of SimpleRichSequence. -
Uses of SymbolList in org.biojavax.ga
Methods in org.biojavax.ga that return SymbolList Modifier and Type Method Description SymbolList[]Organism. getChromosomes()Gets the organisms 'chromosome' sequencesMethods in org.biojavax.ga with parameters of type SymbolList Modifier and Type Method Description voidOrganism. setChromosomes(SymbolList[] chromosomes)Sets the organisms 'chromosome' sequences. -
Uses of SymbolList in org.biojavax.ga.functions
Methods in org.biojavax.ga.functions that return SymbolList Modifier and Type Method Description SymbolList[]GACross. getChromosomes()Gets the chromosomes after the crossSymbolList[]GACrossResult. getChromosomes()Gets the chromosomes after the crossSymbolList[]SimpleGACrossResult. getChromosomes()SymbolListMutationFunction. mutate(SymbolList seq)Produces a new SymbolList by mutation.SymbolListMutationFunction.NoMutation. mutate(SymbolList syml)SymbolListSimpleMutationFunction. mutate(SymbolList seq)SymbolListSwapMutationFunction. mutate(SymbolList seq)Methods in org.biojavax.ga.functions with parameters of type SymbolList Modifier and Type Method Description SymbolListMutationFunction. mutate(SymbolList seq)Produces a new SymbolList by mutation.SymbolListMutationFunction.NoMutation. mutate(SymbolList syml)SymbolListSimpleMutationFunction. mutate(SymbolList seq)SymbolListSwapMutationFunction. mutate(SymbolList seq)GACrossResultCrossOverFunction.NoCross. performCrossOver(SymbolList chromA, SymbolList chromB)GACrossResultCrossOverFunction. performCrossOver(SymbolList chromA, SymbolList chromB)Performs a cross between the pair of chromosomesGACrossResultOrderCrossover. performCrossOver(SymbolList chromA, SymbolList chromB)GACrossResultSimpleCrossOverFunction. performCrossOver(SymbolList chromA, SymbolList chromB)Constructors in org.biojavax.ga.functions with parameters of type SymbolList Constructor Description SimpleGACrossResult(PointLocation[] crossOverPositions, SymbolList[] chromosomes) -
Uses of SymbolList in org.biojavax.ga.impl
Fields in org.biojavax.ga.impl declared as SymbolList Modifier and Type Field Description protected SymbolList[]AbstractOrganism. chromosomesMethods in org.biojavax.ga.impl that return SymbolList Modifier and Type Method Description SymbolList[]AbstractOrganism. getChromosomes()Methods in org.biojavax.ga.impl with parameters of type SymbolList Modifier and Type Method Description protected abstract voidAbstractOrganism. setChromImpl(SymbolList[] chromosomes)protected voidSimpleOrganism. setChromImpl(SymbolList[] chromosomes)voidAbstractOrganism. setChromosomes(SymbolList[] chromosomes) -
Uses of SymbolList in org.biojavax.ga.util
Methods in org.biojavax.ga.util that return SymbolList Modifier and Type Method Description static SymbolListGATools. createBinary(String binarySequence)Creates aSymbolListin the GABinaryAlphabet
-