Uses of Class
org.biojava.bio.symbol.IllegalAlphabetException
-
Packages that use IllegalAlphabetException Package Description 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 Graphical interfaces for biojava objects.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 Java wrappers for interacting with external bioinformatics tools.org.biojava.bio.program.abi ABI Trace Handling.org.biojava.bio.program.fastq FASTQ and variants sequence format I/O.org.biojava.bio.program.hmmer Tools for working with profile Hidden Markov Models from the HMMer package.org.biojava.bio.program.phred Parser for Phred outputorg.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.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.bio.db.biosql Interface between biojava and biosql databasesorg.biojavax.bio.seq Rich implementations of Sequences, Locations and Features.org.biojavax.bio.seq.io Classes to support the I/O of RichSequence and Bioentry objects.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 IllegalAlphabetException in org.biojava.bio.chromatogram
Methods in org.biojava.bio.chromatogram that throw IllegalAlphabetException Modifier and Type Method Description protected voidAbstractChromatogram. setBaseCallAlignment(Alignment align)Provides the list of base calls.voidSimpleChromatogram. setSymbolLists(SymbolList dna, SymbolList offsets)Set the DNA and OFFSETS symbol lists for the basecall alignment. -
Uses of IllegalAlphabetException in org.biojava.bio.dist
Methods in org.biojava.bio.dist that throw IllegalAlphabetException Modifier and Type Method Description DistributionDistributionFactory. createDistribution(Alphabet alpha)Generate a new Distribution as requested.DistributionDistributionFactory.DefaultDistributionFactory. createDistribution(Alphabet alpha)DistributionOrderNDistributionFactory. createDistribution(Alphabet alpha)Creates an OrderNDistribution of the appropriate type.static Distribution[]DistributionTools. distOverAlignment(Alignment a)Equivalent to distOverAlignment(a, false, 0.0).static Distribution[]DistributionTools. distOverAlignment(Alignment a, boolean countGaps)Creates an array of distributions, one for each column of the alignment.static Distribution[]DistributionTools. distOverAlignment(Alignment a, boolean countGaps, double nullWeight)Creates an array of distributions, one for each column of the alignment.static DistributionDistributionTools. jointDistOverAlignment(Alignment a, boolean countGaps, double nullWeight, int[] cols)Creates a joint distribution.voidCount. setCounts(Count c)Set the counts in this Counts to be equal to the counts in c.voidIndexedCount. setCounts(Count c)voidOrderNDistribution. setDistribution(Symbol sym, Distribution dist)Set the distribution assocated with a symbol.voidAbstractDistribution. setNullModel(Distribution nullModel)voidDistribution. setNullModel(Distribution nullDist)Set the null model Distribution that this Distribution recognizes.voidGapDistribution. setNullModel(Distribution nullModel)voidPairDistribution. setNullModel(Distribution nullModel)voidTranslatedDistribution. setNullModel(Distribution dist)protected abstract voidAbstractDistribution. setNullModelImpl(Distribution nullModel)Implement this to set the null model.protected voidSimpleDistribution. setNullModelImpl(Distribution nullModel)protected voidUniformDistribution. setNullModelImpl(Distribution nullModel)Assign a background distribution.Constructors in org.biojava.bio.dist that throw IllegalAlphabetException Constructor Description AbstractOrderNDistribution(Alphabet alpha)Construct a new NthOrderDistribution.SimpleDistributionTrainer(Distribution dis)Deprecated.TranslatedDistribution(ReversibleTranslationTable table, Distribution other, DistributionFactory distFact)Create a new TranslatedDistribution. -
Uses of IllegalAlphabetException in org.biojava.bio.dp
Methods in org.biojava.bio.dp that throw IllegalAlphabetException Modifier and Type Method Description SequenceWeightMatrixAnnotator. annotate(Sequence seq)abstract doubleDP. backward(SymbolList[] symList, ScoreType scoreType)abstract DPMatrixDP. backwardMatrix(SymbolList[] symList, DPMatrix matrix, ScoreType scoreType)abstract DPMatrixDP. backwardMatrix(SymbolList[] symList, ScoreType scoreType)protected voidProfileHMM. connectModel()This is called by constructor in setting up the allowed transitions in the modelvoidSimpleStatePath. edit(Edit edit)static MarkovModelDP. flatView(MarkovModel model)abstract doubleDP. forward(SymbolList[] symList, ScoreType scoreType)abstract DPMatrixDP. forwardMatrix(SymbolList[] symList, DPMatrix matrix, ScoreType scoreType)abstract DPMatrixDP. forwardMatrix(SymbolList[] symList, ScoreType scoreType)static WeightMatrixXmlMarkovModel. readMatrix(Element root)static MarkovModelXmlMarkovModel. readModel(Element root)voidMarkovModel. setWeights(State source, Distribution dist)Set the probability distribution over the transitions from 'source'.voidSimpleMarkovModel. setWeights(State source, Distribution dist)Use this methods to customize the transition probabilities.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 that throw IllegalAlphabetException Constructor Description ProfileHMM(Alphabet alpha, int columns, DistributionFactory matchFactory, DistributionFactory insertFactory)Deprecated.ProfileHMM(Alphabet alpha, int columns, DistributionFactory matchFactory, DistributionFactory insertFactory, String name)Create a new ProfileHMM.SimpleWeightMatrix(Distribution[] columns)SimpleWeightMatrix(Alphabet alpha, int columns, DistributionFactory dFact) -
Uses of IllegalAlphabetException in org.biojava.bio.dp.onehead
Methods in org.biojava.bio.dp.onehead that throw IllegalAlphabetException 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) -
Uses of IllegalAlphabetException in org.biojava.bio.dp.twohead
Methods in org.biojava.bio.dp.twohead that throw IllegalAlphabetException 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)CellCalculatorCellCalculatorFactory. backwards(ScoreType scoreType)CellCalculatorDPInterpreter. backwards(ScoreType scoreType)voidCellCalculator. calcCell(Cell[][] cells)Calculate the 'scores' array in the cell at cells[0][0].doublePairwiseDP. forward(SymbolList[] seqs, ScoreType scoreType)DPMatrixPairwiseDP. forwardMatrix(SymbolList[] seqs, DPMatrix d, ScoreType scoreType)DPMatrixPairwiseDP. forwardMatrix(SymbolList[] seqs, ScoreType scoreType)CellCalculatorCellCalculatorFactory. forwards(ScoreType scoreType)CellCalculatorDPInterpreter. forwards(ScoreType scoreType)voidCellCalculator. initialize(Cell[][] cells)Initialize the cell at [0][0] to the recursion initial parameters.CellCalculatorCellCalculatorFactory. viterbi(ScoreType scoreType, BackPointer terminal)CellCalculatorDPInterpreter. viterbi(ScoreType scoreType, BackPointer terminal)StatePathPairwiseDP. viterbi(SymbolList[] seqs, ScoreType scoreType) -
Uses of IllegalAlphabetException in org.biojava.bio.gui
Methods in org.biojava.bio.gui that throw IllegalAlphabetException Modifier and Type Method Description voidDistributionLogo. setDistribution(Distribution dist)Set the dist to render. -
Uses of IllegalAlphabetException in org.biojava.bio.molbio
Constructors in org.biojava.bio.molbio that throw IllegalAlphabetException 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 IllegalAlphabetException in org.biojava.bio.program
Constructors in org.biojava.bio.program that throw IllegalAlphabetException Constructor Description Meme(InputStream is, SymbolTokenization symParser) -
Uses of IllegalAlphabetException in org.biojava.bio.program.abi
Methods in org.biojava.bio.program.abi that throw IllegalAlphabetException Modifier and Type Method Description static AlignmentABITools. getAlignment(SymbolList abiSeq)View a symbol list over the QUALITY alphabet as an alignment. -
Uses of IllegalAlphabetException in org.biojava.bio.program.fastq
Methods in org.biojava.bio.program.fastq that throw IllegalAlphabetException Modifier and Type Method Description static PhredSequenceFastqTools. createPhredSequence(Fastq fastq)Create and return a newPhredSequencefrom the specified FASTQ formatted sequence.static Distribution[]FastqTools. createSymbolDistribution(Fastq fastq)Create and return a new array of symbolDistributions from the specified FASTQ formatted sequence. -
Uses of IllegalAlphabetException in org.biojava.bio.program.hmmer
Methods in org.biojava.bio.program.hmmer that throw IllegalAlphabetException Modifier and Type Method Description protected voidHmmerProfileHMM. connectModel()This is called by constructor in setting up the allowed transitions in the modelConstructors in org.biojava.bio.program.hmmer that throw IllegalAlphabetException Constructor Description HmmerProfileHMM(Alphabet alpha, int columns, DistributionFactory matchFactory, DistributionFactory insertFactory, String name) -
Uses of IllegalAlphabetException in org.biojava.bio.program.phred
Methods in org.biojava.bio.program.phred that throw IllegalAlphabetException 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 that throw IllegalAlphabetException Constructor Description PhredSequence(SymbolList phredSequence, String name, String urn, Annotation anno)Constructs a new PhredSequence. -
Uses of IllegalAlphabetException in org.biojava.bio.program.ssaha
Methods in org.biojava.bio.program.ssaha that throw IllegalAlphabetException Modifier and Type Method Description DataStoreCompactedDataStoreFactory. buildDataStore(File storeFile, SequenceStreamer streamer, Packing packing, int wordLength, int stepSize, int threshold)DataStoreCompactedDataStoreFactory. buildDataStore(File storeFile, SequenceDB seqDB, Packing packing, int wordLength, int threshold)DataStoreDataStoreFactory. buildDataStore(File storeFile, SequenceDB seqDB, Packing packing, int wordLength, int threshold)Build a new DataStore.DataStoreMappedDataStoreFactory. buildDataStore(File storeFile, SequenceDB seqDB, Packing packing, int wordLength, int threshold)DataStoreNIODataStoreFactory. buildDataStore(File storeFile, SequenceDB seqDB, Packing packing, int wordLength, int threshold)voidDataStore. search(String id, SymbolList symList, SearchListener listener)Search the DataStore with a symbol list. -
Uses of IllegalAlphabetException in org.biojava.bio.proteomics
Methods in org.biojava.bio.proteomics that throw IllegalAlphabetException Modifier and Type Method Description static doubleIsoelectricPointCalc. getIsoelectricPoint(SymbolList peptide)Static public method to compute the pI for a polypeptide in denaturating and reduced conditions with both free ends.doubleIsoelectricPointCalc. getPI(SymbolList peptide, boolean hasFreeNTerm, boolean hasFreeCTerm)Computes isoelectric point of specified peptide. -
Uses of IllegalAlphabetException in org.biojava.bio.search
Methods in org.biojava.bio.search that throw IllegalAlphabetException Modifier and Type Method Description BioMatcherBioPattern. matcher(SymbolList symList)Get a matcher that will use these parameters to search a SymbolList.BioMatcherMaxMismatchPattern. matcher(SymbolList symList)BioMatcherSeqContentPattern. matcher(SymbolList symList) -
Uses of IllegalAlphabetException in org.biojava.bio.seq
Methods in org.biojava.bio.seq that throw IllegalAlphabetException Modifier and Type Method Description SequenceSequenceAnnotator. annotate(Sequence seq)Return an annotated version of a sequence.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.voidNewSimpleAssembly. edit(Edit e)voidSimpleAssembly. edit(Edit e)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 SequenceSequenceTools. reverseComplement(Sequence seq)Reverse-complement a sequence, and flip all of its features.static SequenceSequenceTools. subSequence(Sequence seq, int start, int end, String name, StrandedFeature.Strand strand)Extract a sub-sequence from a sequence.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 IllegalAlphabetException in org.biojava.bio.seq.homol
Methods in org.biojava.bio.seq.homol that throw IllegalAlphabetException Modifier and Type Method Description voidSimilarityPairFeature.EmptyPairwiseAlignment. edit(Edit edit) -
Uses of IllegalAlphabetException in org.biojava.bio.seq.impl
Methods in org.biojava.bio.seq.impl that throw IllegalAlphabetException Modifier and Type Method Description voidDummySequence. edit(Edit edit)Constructors in org.biojava.bio.seq.impl that throw IllegalAlphabetException Constructor Description RevCompSequence(Sequence seq)URN, Name and Annotation are copied as is from the original Sequence, unless you use the the other contructor that sets these.RevCompSequence(Sequence seq, String urn, String name, Annotation annotation)SimpleFramedFeature(Sequence sourceSeq, FeatureHolder parent, FramedFeature.Template template)SimpleHomologyFeature(Sequence sourceSeq, FeatureHolder parent, HomologyFeature.Template template)SimpleSimilarityPairFeature(Sequence sourceSeq, FeatureHolder parent, SimilarityPairFeature.Template template)Creates a newSimpleSimilarityPairFeature. -
Uses of IllegalAlphabetException in org.biojava.bio.seq.io
Methods in org.biojava.bio.seq.io that throw IllegalAlphabetException Modifier and Type Method Description voidChunkedSymbolListFactory. addSymbols(Alphabet alfa, Symbol[] syms, int pos, int len)tool to construct the SymbolList by adding Symbols.voidEmblFileFormer. addSymbols(Alphabet alpha, Symbol[] syms, int start, int length)Deprecated.voidGenbankFileFormer. addSymbols(Alphabet alpha, Symbol[] syms, int start, int length)Deprecated.voidProteinRefSeqFileFormer. addSymbols(Alphabet theAlphabet, Symbol[] theSymbols, int theStart, int theLength)Deprecated.voidSeqIOAdapter. addSymbols(Alphabet alpha, Symbol[] syms, int start, int length)voidSeqIOFilter. addSymbols(Alphabet alpha, Symbol[] syms, int start, int length)voidSeqIOListener. addSymbols(Alphabet alpha, Symbol[] syms, int start, int length)Notify the listener of symbol data.abstract voidSequenceBuilderBase. addSymbols(Alphabet alpha, Symbol[] syms, int pos, int len)voidSequenceBuilderFilter. addSymbols(Alphabet alpha, Symbol[] syms, int start, int length)voidSimpleAssemblyBuilder. addSymbols(Alphabet alpha, Symbol[] syms, int pos, int len)voidSimpleSequenceBuilder. addSymbols(Alphabet alpha, Symbol[] syms, int pos, int len)voidSmartSequenceBuilder. addSymbols(Alphabet alpha, Symbol[] syms, int pos, int len)voidSwissprotFileFormer. addSymbols(Alphabet theAlphabet, Symbol[] theSymbols, int theStart, int theLength)Deprecated.Prints out the sequences properties in order.protected ListProteinRefSeqFileFormer. breakSymbolArray(Alphabet theAlphabet, Symbol[] theSymbols, int theStart, int theLength)Deprecated.Converts the symbol list passed in into an array of strings.protected ListSwissprotFileFormer. breakSymbolArray(Alphabet theAlphabet, Symbol[] theSymbols, int theStart, int theLength)Deprecated.Converts the symbol list passed in into an array of strings.SymbolListChunkedSymbolListFactory. make(SymbolReader sr)Method to create a Sequence with a SymbolReader.SymbolListChunkedSymbolListFactory. makeSymbolList()Converts accumulated Symbols to a SymbolListprotected voidSwissprotFileFormer. printOutSequenceHeaderLine(Alphabet theAlphabet, Symbol[] theSymbols, int theStart, int theLength)Deprecated.Prints out sequence header with only length data.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) -
Uses of IllegalAlphabetException in org.biojava.bio.symbol
Methods in org.biojava.bio.symbol that throw IllegalAlphabetException Modifier and Type Method Description voidAbstractSymbolList. edit(Edit edit)voidChunkedSymbolList. edit(Edit edit)voidRelabeledAlignment. edit(Edit edit)voidSimpleSymbolList. edit(Edit edit)Apply and edit to the SymbolList as specified by Edit.voidSymbolList. edit(Edit edit)Apply an edit to the SymbolList as specified by the edit object.static AlphabetAlphabetManager. getCrossProductAlphabet(List aList, String name)Attempts to create a cross product alphabet and register it under a name.static SoftMaskedAlphabetSoftMaskedAlphabet. getInstance(FiniteAlphabet alphaToMask)Generates a soft masked Alphabet where lowercase tokens are assumed to be soft masked.static SoftMaskedAlphabetSoftMaskedAlphabet. getInstance(FiniteAlphabet alphaToMask, SoftMaskedAlphabet.MaskingDetector maskingDetector)Creates a compound alphabet that is a hybrid of the alphabet that is to be soft masked and a binary alphabet that indicates if anySymbolis soft masked or not.static PackingPackingFactory. getPacking(FiniteAlphabet alpha, boolean ambiguity)Get the default packing for an alphabet.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. translate(SymbolList symbols, TranslationTable table)Provides a 'translated' view of an underlying SymbolList.Constructors in org.biojava.bio.symbol that throw IllegalAlphabetException Constructor Description PackedSymbolList(Packing packing, Symbol[] symbols, int length, Alphabet alfa)Create a new PackedSymbolList from an array of Symbols.PackedSymbolList(Packing packing, SymbolList symList)Create a new PackedSymbolList as a packed copy of another symbol list.SimpleCodonPref(String geneticCodeName, Distribution codonPref, String name)SimpleReversibleTranslationTable(FiniteAlphabet source, FiniteAlphabet target)Construct a new translation table. -
Uses of IllegalAlphabetException in org.biojava.utils.automata
Methods in org.biojava.utils.automata that throw IllegalAlphabetException Modifier and Type Method Description StateMachineFactoryArrayStateMachineToolkit. getFactory(String factoryName, FiniteAutomaton fa)voidPatternBlitz. search(SymbolList sl) -
Uses of IllegalAlphabetException in org.biojava.utils.regex
Methods in org.biojava.utils.regex that throw IllegalAlphabetException Modifier and Type Method Description voidSearch. addPattern(String patternString, boolean overlap)add a search pattern to the searches to be conducted by this object.voidSearch. addPattern(String label, String patternString, boolean overlap)add a search pattern to the searches to be conducted by this object.PatternPatternFactory. compile(String pattern)Returns a Pattern object that applies the specified regex against SymbolLists in the Alphabet that this PatternFactory was defined against.PatternPatternFactory. compile(String pattern, String label)Returns a Pattern object that applies the specified regex against SymbolLists in the Alphabet that this PatternFactory was defined against. -
Uses of IllegalAlphabetException in org.biojavax.bio.db.biosql
Methods in org.biojavax.bio.db.biosql that throw IllegalAlphabetException Modifier and Type Method Description voidBioSQLRichSequenceHandler. edit(RichSequence seq, Edit edit)Apply an edit to the Sequence as specified by the edit object. -
Uses of IllegalAlphabetException in org.biojavax.bio.seq
Methods in org.biojavax.bio.seq that throw IllegalAlphabetException Modifier and Type Method Description voidDummyRichSequenceHandler. edit(RichSequence seq, Edit edit)Apply an edit to the Sequence as specified by the edit object.voidInfinitelyAmbiguousSymbolList. edit(Edit edit)Apply an edit to the SymbolList as specified by the edit object.voidRichSequenceHandler. edit(RichSequence seq, Edit edit)Apply an edit to the Sequence as specified by the edit object.voidThinRichSequence. edit(Edit edit)Apply an edit to the SymbolList as specified by the edit object. -
Uses of IllegalAlphabetException in org.biojavax.bio.seq.io
Methods in org.biojavax.bio.seq.io that throw IllegalAlphabetException Modifier and Type Method Description voidDebuggingRichSeqIOListener. addSymbols(Alphabet alpha, Symbol[] syms, int start, int length)voidRichSeqIOAdapter. addSymbols(Alphabet alpha, Symbol[] syms, int start, int length)voidSimpleRichSequenceBuilder. addSymbols(Alphabet alpha, Symbol[] syms, int start, int length)Notify the listener of symbol data. -
Uses of IllegalAlphabetException in org.biojavax.ga
Methods in org.biojavax.ga that throw IllegalAlphabetException Modifier and Type Method Description voidGeneticAlgorithm. run(GAStoppingCriteria stoppingCriteria)Iterates the Algorithm until the stopping criteria are met. -
Uses of IllegalAlphabetException in org.biojavax.ga.functions
Methods in org.biojavax.ga.functions that throw IllegalAlphabetException Modifier and Type Method Description SymbolListMutationFunction. mutate(SymbolList seq)Produces a new SymbolList by mutation.SymbolListSimpleMutationFunction. mutate(SymbolList seq)SymbolListSwapMutationFunction. mutate(SymbolList seq) -
Uses of IllegalAlphabetException in org.biojavax.ga.impl
Methods in org.biojavax.ga.impl that throw IllegalAlphabetException Modifier and Type Method Description voidSimpleGeneticAlgorithm. run(GAStoppingCriteria stoppingCriteria) -
Uses of IllegalAlphabetException in org.biojavax.ga.util
Methods in org.biojavax.ga.util that throw IllegalAlphabetException Modifier and Type Method Description static OrderNDistributionGATools. standardMutationDistribution(FiniteAlphabet a)Makes a mutationDistributionwhere the probability of aSymbolbeing mutated to itself is zero and the probability of it being changed to any otherSymbolin theAlphabet ais1.0 / (a.size() - 1.0)static OrderNDistributionGATools. uniformMutationDistribution(FiniteAlphabet a)Makes a 1st order distribution which is infact uniform (equivalent to a uniform zero order distribution).
-