Uses of Class
org.biojava.bio.BioException
-
Packages that use BioException Package Description org.biojava.bio.alignment Classes to generate and describe sequence alignments.org.biojava.bio.annodb Databases of generic structured data (annotation) objects.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.formats Experimental parsers using the tagvalue framework.org.biojava.bio.program.gff GFF manipulation.org.biojava.bio.program.gff3 Support for reading and writing GFF3.org.biojava.bio.program.homologene Support classes for Homologene data.org.biojava.bio.program.indexdb A flat-file ascii index of ascii flat files as per the OBDA specification.org.biojava.bio.program.phred Parser for Phred outputorg.biojava.bio.program.sax.blastxml Parsers for the XML output from NCBI blast.org.biojava.bio.program.ssaha SSAHA sequence searching API.org.biojava.bio.program.ssbind Creation of objects from SAX events using the BioJava BlastLikeDataSetCollection DTD.org.biojava.bio.program.unigene Objects for representing Unigene clusters.org.biojava.bio.program.xff Event-driven parsing system for the Extensible Feature Format (XFF).org.biojava.bio.proteomics Utilities to aid in performing various physical analysis of proteins.org.biojava.bio.proteomics.aaindex Classes and interfaces to load Amino Acid Index database files.org.biojava.bio.search Interfaces and classes for representing sequence similarity search results.org.biojava.bio.seq Classes and interfaces for defining biological sequences and informatics objects.org.biojava.bio.seq.db Collections of biological sequence data.org.biojava.bio.seq.db.biofetch Client for the OBDA BioFetch protocol.org.biojava.bio.seq.db.biosql General purpose Sequence storage in a relational database.org.biojava.bio.seq.db.flat Support for OBDA flatfile databases.org.biojava.bio.seq.distributed Sequences and SequenceDBs which are composed from data taken from a number of data sources.org.biojava.bio.seq.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.bio.taxa Taxonomy object for representing species information.org.biojava.directory Open Bio Sequence Database Access (OBDA) registry support.org.biojava.utils.automata org.biojava.utils.math Mathematical utility classes.org.biojava.utils.regex This package is used to perform regular expression searches of SymbolLists defined in arbitrary Alphabets.org.biojava.utils.walker org.biojavax.bio Classes to represent biological entities and their relationships.org.biojavax.bio.alignment This package contains the interfaces that need to be implemented by discrete alignment services.org.biojavax.bio.alignment.blast This package holds implementations of the org.biojava3.ws.alignment interfaces for the NCBI remote QBlast services through the WWW.org.biojavax.bio.db Interactions between biojavax objects and a DB.org.biojavax.bio.db.biosql Interface between biojava and biosql databasesorg.biojavax.bio.db.ncbi Interfaces to NCBI data.org.biojavax.bio.seq Rich implementations of Sequences, Locations and Features.org.biojavax.bio.seq.io Classes to support the I/O of RichSequence and Bioentry objects. -
-
Uses of BioException in org.biojava.bio.alignment
Methods in org.biojava.bio.alignment that throw BioException Modifier and Type Method Description voidARAlignment. addSequence(AlignmentElement ae)voidFlexibleAlignment. addSequence(AlignmentElement ae)add a new a alignment usings a location to the reference sequence.StringAlignmentPair. formatOutput()StringAlignmentPair. formatOutput(int width)This method provides a BLAST-like formated alignment from the givenStrings, in which the sequence coordinates and the information "Query" or "Sbjct", respectively is added to each line.static SubstitutionMatrixSubstitutionMatrix. getSubstitutionMatrix(BufferedReader reader)This constructor can be used to guess the alphabet of this substitution matrix.static SubstitutionMatrixSubstitutionMatrix. getSubstitutionMatrix(FiniteAlphabet alphabet, BufferedReader reader)Return a new substitution matrix with the specified alphabet.static SubstitutionMatrixSubstitutionMatrix. getSubstitutionMatrix(FiniteAlphabet alphabet, BufferedReader reader, String name)Return a new substitution matrix with the specified alphabet and name.shortSubstitutionMatrix. getValueAt(Symbol row, Symbol col)There are some substitution matrices containing more columns than lines.SubstitutionMatrixSubstitutionMatrix. normalizeMatrix()With this method you can get a “normalized”SubstitutionMatrixobject; however, since this implementation uses an short matrix, the normalized matrix will be scaled by ten.AlignmentPairNeedlemanWunsch. pairwiseAlignment(SymbolList query, SymbolList subject)Global pairwise sequence alignment of two BioJava-Sequence objects according to the Needleman-Wunsch-algorithm.Constructors in org.biojava.bio.alignment that throw BioException Constructor Description AlignmentPair(Sequence query, Sequence subject, int queryStart, int queryEnd, int subjectStart, int subjectEnd, SubstitutionMatrix subMatrix)AlignmentPair(Sequence query, Sequence subject, SubstitutionMatrix subMatrix)FlexibleAlignment(List<AlignmentElement> seqList)construct this object with the reference sequence which can either be a gappedSymbolList or not label in all cases refers to an object that holds the display name (generally just a String). since more than one sequence in an alignment could have the same name this works as long as the labels are different objects even though they may hold the same name.SimpleAlignmentElement(String label, SymbolList seq, Location loc)SubstitutionMatrix(File file)This constructor can be used to guess the alphabet of this substitution matrix.SubstitutionMatrix(FiniteAlphabet alpha, File matrixFile)This constructs aSubstitutionMatrixobject that contains twoMapdata structures having BioJava symbols as keys and the value being the index of the matrix containing the substitution score.SubstitutionMatrix(FiniteAlphabet alpha, String matrixString, String name)With this constructor it is possible to construct a SubstitutionMatrix object from a substitution matrix file. -
Uses of BioException in org.biojava.bio.annodb
Constructors in org.biojava.bio.annodb that throw BioException Constructor Description IndexedAnnotationDB(String dbName, File storeLoc, Index2Model model, List toIndex, int maxKeyLen, AnnotationType schema, IndexedAnnotationDB.ParserListenerFactory plFactory)Create a new IndexedAnnotationDB. -
Uses of BioException in org.biojava.bio.chromatogram
Subclasses of BioException in org.biojava.bio.chromatogram Modifier and Type Class Description classUnsupportedChromatogramFormatExceptionException indicating that some provided data does not represent a supported chromatogram format. -
Uses of BioException in org.biojava.bio.dist
Methods in org.biojava.bio.dist that throw BioException Modifier and Type Method Description static booleanDistributionTools. areEmissionSpectraEqual(Distribution[] a, Distribution[] b)Compares the emission spectra of two distribution arrays.static booleanDistributionTools. areEmissionSpectraEqual(Distribution a, Distribution b)Compares the emission spectra of two distributions. -
Uses of BioException in org.biojava.bio.dp
Subclasses of BioException in org.biojava.bio.dp Modifier and Type Class Description classIllegalTransitionExceptionThis exception indicates that there is no transition between two states.Methods in org.biojava.bio.dp that throw BioException Modifier and Type Method Description SequenceWeightMatrixAnnotator. annotate(Sequence seq)voidHMMTrainer. completeCycle()indicate that a cycle of training is completed and the emission/transition matrices should be updated.voidSimpleHMMTrainer. completeCycle()DPDPFactory. createDP(MarkovModel model)DPDPFactory.DefaultFactory. createDP(MarkovModel model)DPMatrixDP. forwardsBackwards(SymbolList[] symList, ScoreType scoreType)StatePathDP. generate(int length)Generates an alignment from a model.static WeightMatrixXmlMarkovModel. readMatrix(Element root)static MarkovModelXmlMarkovModel. readModel(Element root)voidTrainable. registerWithTrainer(ModelTrainer mt)Perform any registration that is necessary with mt.voidWMAsMM. registerWithTrainer(ModelTrainer modelTrainer)State[]DP. stateList(MarkovModel mm)voidAbstractTrainer. train(SequenceDB db, double nullModelWeight, StoppingCriteria stopper)Trains the sequences in db until stopper says to finnish.voidTrainingAlgorithm. train(SequenceDB db, double nullWeight, StoppingCriteria stopper)Trains the sequences in db untill stopper says to finnish. -
Uses of BioException in org.biojava.bio.dp.onehead
Constructors in org.biojava.bio.dp.onehead that throw BioException Constructor Description SingleDP(MarkovModel model) -
Uses of BioException in org.biojava.bio.dp.twohead
Methods in org.biojava.bio.dp.twohead that throw BioException Modifier and Type Method Description CellCalculatorFactoryCellCalculatorFactoryMaker. make(DP dp)Constructors in org.biojava.bio.dp.twohead that throw BioException Constructor Description PairwiseDP(MarkovModel mm, CellCalculatorFactoryMaker ccfm) -
Uses of BioException in org.biojava.bio.gui
Methods in org.biojava.bio.gui that throw BioException Modifier and Type Method Description voidFeatureTree. setSequenceDB(SequenceDB db)Use this method to provide the sequences for the tree to work with. -
Uses of BioException in org.biojava.bio.molbio
Methods in org.biojava.bio.molbio that throw BioException Modifier and Type Method Description int[]RestrictionEnzyme. getUpstreamCut()getUpstreamCutreturns the cut site upstream of the recognition site.intRestrictionEnzyme. getUpstreamEndType()getUpstreamEndTypereturns the double-stranded end type produced by the secondary (upstream) cut. -
Uses of BioException in org.biojava.bio.program.formats
Methods in org.biojava.bio.program.formats that throw BioException Modifier and Type Method Description static FormatFormatTools. getFormat(String formatName)Attempt to find aformat for a format identifer string. -
Uses of BioException in org.biojava.bio.program.gff
Methods in org.biojava.bio.program.gff that throw BioException Modifier and Type Method Description static SequenceDBGFFTools. annotateSequences(SequenceDB seqs, GFFEntrySet ents)Annotates all sequences in a sequence DB with features from a GFF entry set.protected SimpleGFFRecordSequencesAsGFF. createGFFRecord(Feature feature, String id)Internal method to create a GFFRecord from an individual Feature.protected GFFRecordGFFParser. createRecord(GFFDocumentHandler handler, List aList, String rest, String comment)Actually turns a list of tokens, some value string and a comment into a GFFRecord and informs handler.protected voidSequencesAsGFF. doPreProcessSequence(Sequence seq, GFFDocumentHandler handler, String id)Emit any per-sequence header information.protected voidSequencesAsGFF. doProcessFeature(Feature feature, GFFDocumentHandler handler, String id)Internal method to process an individual Feature.protected voidSequencesAsGFF. doProcessSequence(Sequence seq, GFFDocumentHandler handler, String id)Internal method to process an individual Sequence.static GFFEntrySetGFFTools. gffFromSeqDB(SequenceDB seqDB)Creates a GFFEntrySet containing one entry for each feature on each sequence of a SequenceDB.static GFFEntrySetGFFTools. gffFromSequence(Sequence seq)Creates a GFFEntrySet containing one entry for each feature on a sequence.voidGFFWriter. invalidEnd(String token, NumberFormatException nfe)voidGFFWriter. invalidFrame(String token, NumberFormatException nfe)voidGFFWriter. invalidScore(String token, NumberFormatException nfe)voidGFFWriter. invalidStart(String token, NumberFormatException nfe)voidGFFWriter. invalidStrand(String token)voidGFFParser. parse(BufferedReader bReader, GFFDocumentHandler handler)Informs handler of each line of gff read from bReader.voidGFFParser. parse(BufferedReader bReader, GFFDocumentHandler handler, String locator)Informs handler of each line of GFF read from bReadervoidSequencesAsGFF. processDB(SequenceDB seqDB, GFFDocumentHandler handler)Process all Sequences within a SequenceDB, informing handler of any suitable features.voidSequencesAsGFF. processSequence(Sequence seq, GFFDocumentHandler handler)Process an individual Sequence, informing handler of any suitable features.static GFFEntrySetGFFTools. readGFF(BufferedReader gffIn)Read all GFF entries from a buffered reader.static GFFEntrySetGFFTools. readGFF(BufferedReader gffIn, GFFRecordFilter recFilt)Read all GFF entries matching a filter from a buffered reader.static GFFEntrySetGFFTools. readGFF(File inFile)Reads aGFFEntrySetfrom a file with no filtering.static GFFEntrySetGFFTools. readGFF(File inFile, GFFRecordFilter recFilt)Reads a GFFEntrySet from a file with the specified filter.static GFFEntrySetGFFTools. readGFF(String fileName)Deprecated.use: readGff(File)static GFFEntrySetGFFTools. readGFF(String fileName, GFFRecordFilter recFilt)Deprecated.use: readGff(File,GFFRecordFilter) -
Uses of BioException in org.biojava.bio.program.gff3
Methods in org.biojava.bio.program.gff3 that throw BioException Modifier and Type Method Description protected GFF3RecordGFF3Parser. createRecord(GFF3DocumentHandler handler, List aList, String rest, String comment, Ontology ontology, Ontology fallBack)Actually turns a list of tokens, some value string and a comment into a GFF3Record and informs handler.voidGFF3Parser. parse(BufferedReader bReader, GFF3DocumentHandler handler, Ontology ontology)Informs handler of each line of gff read from bReader.voidGFF3Parser. parse(BufferedReader bReader, GFF3DocumentHandler handler, Ontology ontology, String locator)Informs handler of each line of GFF read from bReader -
Uses of BioException in org.biojava.bio.program.homologene
Subclasses of BioException in org.biojava.bio.program.homologene Modifier and Type Class Description classDuplicateTaxonException -
Uses of BioException in org.biojava.bio.program.indexdb
Methods in org.biojava.bio.program.indexdb that throw BioException Modifier and Type Method Description BioStoreBioStoreFactory. createBioStore()createBioStorecreates aBioStorereflecting the current state of the factory and returns a reference to it.ListBioStore. get(String id, String namespace)RecordIndexStore. get(String id)getreturns a record specified by a primary identifier.ListIndexStore. get(String id, String namespace)getreturns a list ofRecords by searching against the primary identifiers if the namespace argument is equal to the primary namespace or otherwise by searching the secondary namespaces.static voidIndexTools. indexEmbl(String name, File location, File[] seqFiles, int alphabetIdentifier)indexEmblindexes DNA, RNA or protein EMBL format sequence files on ID as primary identifier and AC as secondary.static voidIndexTools. indexFasta(String name, File location, File[] seqFiles, int alphabetIdentifier)indexFastaindexes DNA, RNA or protein Fasta format sequence files on primary identifier.static voidIndexTools. indexGenbank(String name, File location, File[] seqFiles, int alphabetIdentifier)indexGenbankindexes DNA, RNA or protein Genbank format sequence files on LOCUS as primary identifier and ACCESSION as secondary.static voidIndexTools. indexSwissprot(String name, File location, File[] seqFiles)indexSwissprotindexes Swissprot format protein sequence files on ID as primary identifier.Constructors in org.biojava.bio.program.indexdb that throw BioException Constructor Description BioStore(File location, boolean cache)Creates a newBioStoreflatfile index at the specified location with the specified caching behaviour. -
Uses of BioException in org.biojava.bio.program.phred
Methods in org.biojava.bio.program.phred that throw BioException Modifier and Type Method Description static voidPhredTools. writePhredQuality(OutputStream qual, OutputStream seq, SequenceDB db)Writes Phred quality data in a Fasta type format. -
Uses of BioException in org.biojava.bio.program.sax.blastxml
Constructors in org.biojava.bio.program.sax.blastxml that throw BioException Constructor Description BlastXMLParserFacade() -
Uses of BioException in org.biojava.bio.program.ssaha
Methods in org.biojava.bio.program.ssaha that throw BioException 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)voidSequenceStreamer. reset()voidSequenceStreamer.FileStreamer. streamNext(SeqIOListener listener)voidSequenceStreamer.SequenceDBStreamer. streamNext(SeqIOListener listener)voidSequenceStreamer. streamNext(SeqIOListener listener) -
Uses of BioException in org.biojava.bio.program.ssbind
Methods in org.biojava.bio.program.ssbind that throw BioException Modifier and Type Method Description protected SequenceViewSequenceFactory. makeQueryViewSequence(String queryID)SeqSimilaritySearchResultBlastLikeSearchBuilder. makeSearchResult()protected SequenceViewSequenceFactory. makeSubjectViewSequence(String subjectID)static FiniteAlphabetAlphabetResolver. resolveAlphabet(String identifier)resolveAlphabetreturns an appropriateAlphabetfor an arbitrary identifier. -
Uses of BioException in org.biojava.bio.program.unigene
Methods in org.biojava.bio.program.unigene that throw BioException Modifier and Type Method Description UnigeneClusterUnigeneDB. addCluster(UnigeneCluster cluster)Add a cluster to a database.UnigeneDBFlatFileUnigeneFactory. createUnigene(URL unigeneLoc)UnigeneDBSQLUnigeneFactory. createUnigene(URL dbURL)UnigeneDBUnigeneFactory. createUnigene(URL unigeneURL)static UnigeneDBUnigeneTools. createUnigene(URL dbURL)Create a new UnigeneDB instance referred to by a URL.static UnigeneFactoryUnigeneTools. findFactory(URL dbURL)Find the UnigeneFactory that can accept a URL.UnigeneClusterUnigeneDB. getCluster(String clusterID)Fetch a cluster by its cluster id.UnigeneDBFlatFileUnigeneFactory. loadUnigene(URL unigeneLoc)UnigeneDBSQLUnigeneFactory. loadUnigene(URL dbURL)UnigeneDBUnigeneFactory. loadUnigene(URL unigeneURL)static UnigeneDBUnigeneTools. loadUnigene(URL dbURL)Load a UnigeneDB instance referred to by a URL. -
Uses of BioException in org.biojava.bio.program.xff
Methods in org.biojava.bio.program.xff that throw BioException Modifier and Type Method Description static voidXFFTools. annotateXFF(File xffFile, Sequence sequence)static voidXFFTools. annotateXFF(File xffFile, Sequence sequence, Annotation ann)static SequenceXFFTools. readXFF(File xffFile, String seqID)static SequenceXFFTools. readXFF(File xffFile, String seqID, FiniteAlphabet alpha) -
Uses of BioException in org.biojava.bio.proteomics
Methods in org.biojava.bio.proteomics that throw BioException Modifier and Type Method Description voidDigest. addDigestFeatures()Adds peptides as features to the Sequence in this class.static ProteaseProteaseManager. createProtease(String cleaveRes, boolean endoProtease, String name)static ProteaseProteaseManager. createProtease(String cleaveRes, boolean endoProtease, String notCleaveRes, String name)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.doubleIsoelectricPointCalc. getPI(SymbolList peptide, boolean hasFreeNTerm, boolean hasFreeCTerm)Computes isoelectric point of specified peptide.static ProteaseProtease. getProteaseByName(String proteaseName)Retrieves a reference to the named Protease.static ProteaseProteaseManager. getProteaseByName(String proteaseName)Gets a Protease instance by name.static voidProteaseManager. registerProtease(Protease prot)Registers a protease and ensures its flyweight statusConstructors in org.biojava.bio.proteomics that throw BioException Constructor Description Protease(String cleavageRes, boolean endoProtease)Deprecated.Creating a Protease with this constructor will not register it with the ProteaseManager (use ProteaseManager.createProtease())Protease(String cleaveRes, boolean endoProtease, String 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)Deprecated.Creating a Protease with this constructor will not register it with the ProteaseManager (use ProteaseManager.createProtease()) -
Uses of BioException in org.biojava.bio.proteomics.aaindex
Methods in org.biojava.bio.proteomics.aaindex that throw BioException Modifier and Type Method Description SymbolPropertyTableAAindexStreamReader. nextTable()Returns the nextSymbolPropertyTableobject.SymbolPropertyTableSymbolPropertyTableIterator. nextTable()Returns the nextSymbolPropertyTableobject.Constructors in org.biojava.bio.proteomics.aaindex that throw BioException Constructor Description SimpleSymbolPropertyTableDB(SymbolPropertyTableIterator tableIterator)Initializes the database by copying all symbol property tables from a given iterator into the database. -
Uses of BioException in org.biojava.bio.search
Methods in org.biojava.bio.search that throw BioException Modifier and Type Method Description SeqSimilaritySearchResultSearchBuilder. makeSearchResult()ThemakeSearchResultmethod returns aSeqSimilaritySearchResultinstance created from accumulated data.SeqSimilaritySearchResultSeqSimilaritySearcher. search(SymbolList querySeq, SequenceDB db, Map searchParameters)Using this sequence similarity searcher, search with the given sequence against the given sequence database.Constructors in org.biojava.bio.search that throw BioException Constructor Description FilteringContentHandler(BlastLikeSearchFilter filter)FilteringContentHandler(BlastLikeSearchFilter filter, SearchContentHandler delegate) -
Uses of BioException in org.biojava.bio.seq
Methods in org.biojava.bio.seq that throw BioException Modifier and Type Method Description static voidSequenceTools. addAllFeatures(Sequence seq, FeatureHolder fh)Add features to a sequence that contain the same information as all those in a feature holder.voidSimpleFeatureRealizer. addImplementation(Class template, Class impl)Install a new mapping from a class of Feature.Template to a class of Feature implementations.SequenceSequenceAnnotator. annotate(Sequence seq)Return an annotated version of a sequence.FeatureAbstractFeatureHolder. createFeature(Feature.Template temp)FeatureCircularView. createFeature(Feature.Template template)Over rides ViewSequence to allow the use of locations that have coordinates outside of the sequence length (which are needed to describe locations that overlap the origin of a circular sequence).FeatureFeatureHolder. createFeature(Feature.Template ft)Create a new Feature, and add it to this FeatureHolder.FeatureLazyFeatureHolder. createFeature(Feature.Template template)FeatureNewSimpleAssembly. createFeature(Feature.Template temp)FeatureSimpleAssembly. createFeature(Feature.Template temp)FeatureRemoteFeature. getRemoteFeature()Retrieve the Feature on some assembly Sequence that can represent this RemoteFeature properly.SequenceSequenceIterator. nextSequence()Returns the next sequence in the iterator.FeatureFeatureRealizer. realizeFeature(Sequence seq, FeatureHolder parent, Feature.Template template)Install a feature on the specified sequence.FeatureNewSimpleAssembly. realizeFeature(FeatureHolder fh, Feature.Template temp)FeatureRealizingFeatureHolder. realizeFeature(FeatureHolder parent, Feature.Template template)Realize a feature template.FeatureSimpleAssembly. realizeFeature(FeatureHolder fh, Feature.Template temp)FeatureSimpleFeatureRealizer. realizeFeature(Sequence seq, FeatureHolder parent, Feature.Template temp)voidAbstractFeatureHolder. removeFeature(Feature f)voidFeatureHolder. removeFeature(Feature f)Remove a feature from this FeatureHolder.voidLazyFeatureHolder. removeFeature(Feature f)FeatureRemoteFeature.Resolver. resolve(RemoteFeature rFeat)Resolve rFeat.static ObjectFilterUtils. visitFilter(FeatureFilter filter, Visitor visitor)Applies a visitor to a filter, and returns the visitor's result or null. -
Uses of BioException in org.biojava.bio.seq.db
Subclasses of BioException in org.biojava.bio.seq.db Modifier and Type Class Description classIllegalIDExceptionMethods in org.biojava.bio.seq.db that throw BioException Modifier and Type Method Description voidIndexedSequenceDB. addFile(File seqFile)Add sequences from a file to the sequence database.voidAbstractSequenceDB. addSequence(Sequence seq)voidDummySequenceDB. addSequence(Sequence seq)voidSequenceDBLite. addSequence(Sequence seq)Adds a sequence to the database.voidBioIndex. commit()voidEmblCDROMIndexStore. commit()commitcommits changes.voidIndexStore. commit()Commit the stored indices to permanent storage.voidTabIndexStore. commit()protected SequenceAnnotatedSequenceDB. doAnnotation(Sequence seq)Apply the annotation to a sequence.IndexBioIndex. fetch(String id)IndexEmblCDROMIndexStore. fetch(String id)IndexIndexStore. fetch(String id)Fetch an Index based upon an ID.IndexTabIndexStore. fetch(String id)SequenceAnnotatedSequenceDB. getSequence(String id)SequenceCachingSequenceDB. getSequence(String id)SequenceDummySequenceDB. getSequence(String id)SequenceGenpeptSequenceDB. getSequence(String id)SequenceIndexedSequenceDB. getSequence(String id)SequenceSequenceDBLite. getSequence(String id)Retrieve a single sequence by its id.SequenceSubSequenceDB. getSequence(String id)SequenceSwissprotSequenceDB. getSequence(String id)SequenceViewingSequenceDB. getSequence(String id)SequenceWebSequenceDB. getSequence(String id)Gets a sequence using its unique ID (eg for GenBank this would be the GI number)SequenceDBGenbankSequenceDB. getSequences(Set list)Retrieve sequences from a GenbankSequenceDBGenbankSequenceDB. getSequences(Set list, SequenceDB database)Retrieve sequences from a GenbankvoidAbstractSequenceDB. removeSequence(String id)voidDummySequenceDB. removeSequence(String id)voidHashSequenceDB. removeSequence(String id)voidSequenceDBLite. removeSequence(String id)Remove the sequence associated with an ID from the database.voidNCBISequenceDB. setDatabase(String dataBase)voidNCBISequenceDB. setSequenceFormat(SequenceFormat format)voidEmblCDROMIndexStore. store(Index index)storeadds anIndexto the store.voidIndexStore. store(Index indx)Add the Index to the store.voidTabIndexStore. store(Index indx)Constructors in org.biojava.bio.seq.db that throw BioException Constructor Description BioIndex(File indexDirectory)Load an existing index file.BioIndex(File indexDirectory, String namespace, int idLength)SubSequenceDB(SequenceDB parent, Set ids)TabIndexStore(File storeFile, File indexFile, String name, SequenceFormat format, SequenceBuilderFactory sbFactory, SymbolTokenization symbolParser)Create a new TabIndexStore. -
Uses of BioException in org.biojava.bio.seq.db.biofetch
Methods in org.biojava.bio.seq.db.biofetch that throw BioException Modifier and Type Method Description SequenceBioFetchSequenceDB. getSequence(String id)SequenceDBLiteBioFetchSequenceDBProvider. getSequenceDB(Map config) -
Uses of BioException in org.biojava.bio.seq.db.biosql
Methods in org.biojava.bio.seq.db.biosql that throw BioException Modifier and Type Method Description static TaxonTaxonSQL. addName(Connection conn, Taxon taxon, String nameClass, String newName)Deprecated.Adds a new name of the givennameClassto the taxon.voidBioSQLSequenceDB. addSequence(Sequence seq)Deprecated.voidBioSQLSequenceDB. createDummySequence(String id, Alphabet alphabet, int length)Deprecated.static StackTaxonSQL. getChildrenOf(Connection conn, String scientificName)Deprecated.Returns all children of the specified taxon.static StackTaxonSQL. getChildrenOf(Connection conn, Taxon t)Deprecated.Returns the children as aStackof this given taxon.SequenceBioSQLSequenceDB. getSequence(int bioentry_id)Deprecated.SequenceBioSQLSequenceDB. getSequence(String id)Deprecated.SequenceDBLiteBioSQLSequenceDBProvider. getSequenceDB(Map config)Deprecated.static TaxonTaxonSQL. removeName(Connection conn, DBHelper helper, Taxon taxon, String nameClass, String oldName)Deprecated.Deletes the specified name from of the taxon from the database.voidBioSQLSequenceDB. removeSequence(String id)Deprecated.static TaxonTaxonSQL. removeTaxon(Connection conn, int ncbi_id, DBHelper helper)Deprecated.Deletes the taxon given by it's NCBI-Taxon-ID from the database and returns the removed taxon.static TaxonTaxonSQL. removeTaxon(Connection conn, DBHelper helper, String name)Deprecated.Deletes a taxon specified by one of it's names with all it's different names, annotations and sequences from the database.static TaxonTaxonSQL. setCommonName(Connection conn, Taxon taxon, String newName)Deprecated.With this method the common name of the given taxon can be changed or created, if there was none before.Constructors in org.biojava.bio.seq.db.biosql that throw BioException Constructor Description BioSQLSequenceDB(String dbURL, String dbUser, String dbPass, String biodatabase, boolean create)Deprecated.Connect to a BioSQL database.BioSQLSequenceDB(String dbDriver, String dbURL, String dbUser, String dbPass, String biodatabase, boolean create)Deprecated.Connect to a BioSQL database.BioSQLSequenceDB(DataSource ds, String biodatabase, boolean create)Deprecated. -
Uses of BioException in org.biojava.bio.seq.db.flat
Methods in org.biojava.bio.seq.db.flat that throw BioException Modifier and Type Method Description SequenceFlatSequenceDB. getSequence(String id)SequenceDBLiteFlatSequenceDBProvider. getSequenceDB(Map config)Constructors in org.biojava.bio.seq.db.flat that throw BioException Constructor Description FlatSequenceDB(String location, String dbName) -
Uses of BioException in org.biojava.bio.seq.distributed
Methods in org.biojava.bio.seq.distributed that throw BioException Modifier and Type Method Description FeatureHolderDistDataSource. getFeatures(String id, FeatureFilter ff, boolean recurse)Get all features matching a FeatureFilter on a Sequence with an ID and recurse flats.FeatureHolderDistDataSource. getFeatures(FeatureFilter ff)Get all features matching a FeatureFilter provided by this DistDataSource.FeatureHolderGFFDataSource. getFeatures(String id, FeatureFilter ff, boolean recurse)FeatureHolderGFFDataSource. getFeatures(FeatureFilter ff)FeatureHolderSequenceDBDataSource. getFeatures(String id, FeatureFilter ff, boolean recurse)FeatureHolderSequenceDBDataSource. getFeatures(FeatureFilter ff)SequenceDistDataSource. getSequence(String id)Get a Sequence object for an ID.SequenceDistributedSequenceDB. getSequence(String id)SequenceGFFDataSource. getSequence(String id)SequenceSequenceDBDataSource. getSequence(String id)booleanDistDataSource. hasFeatures(String id)Find out if this DistDataSource can provide features on a sequence with a particular ID.booleanGFFDataSource. hasFeatures(String id)booleanSequenceDBDataSource. hasFeatures(String id)booleanDistDataSource. hasSequence(String id)Find out if this DistDataSource provides the sequence information for a sequence ID.booleanGFFDataSource. hasSequence(String id)booleanSequenceDBDataSource. hasSequence(String id)SetDistDataSource. ids(boolean topLevel)Get the complete set of sequence IDs provided by this DistDataSource.SetGFFDataSource. ids(boolean topLevel)SetSequenceDBDataSource. ids(boolean topLevel) -
Uses of BioException in org.biojava.bio.seq.homol
Methods in org.biojava.bio.seq.homol that throw BioException Modifier and Type Method Description voidSimpleHomology. setAlignment(Alignment alignment)setAlignmentsets the alignment which describes the homology. -
Uses of BioException in org.biojava.bio.seq.impl
Methods in org.biojava.bio.seq.impl that throw BioException Modifier and Type Method Description FeatureDummySequence. createFeature(Feature.Template template)FeatureLazyFilterFeatureHolder. createFeature(Feature.Template temp)FeatureRevCompSequence. createFeature(Feature.Template ft)createFeature() will call createFeature() on the underlying Sequence.FeatureSimpleFeature. createFeature(Feature.Template temp)FeatureSimpleGappedSequence. createFeature(Feature.Template templ)FeatureSimpleSequence. createFeature(Feature.Template template)FeatureSimpleSequence. createFeature(FeatureHolder fh, Feature.Template template)Deprecated.Please use new 1-arg createFeature instead.FeatureSubSequence. createFeature(Feature.Template templ)FeatureViewSequence. createFeature(Feature.Template template)FeatureSimpleRemoteFeature. getRemoteFeature()static Feature.TemplateTemplateUtils. instantiateTemplate(Feature feat)This attempts to divine the 'best' template class for a feature and return a new instance readly for pupulating.static Feature.TemplateTemplateUtils. makeTemplate(Feature feat)static voidTemplateUtils. populate(Feature.Template templ, Feature feat)This attempts to populate the fields of a template using the publically accessible information in a feature.FeatureSimpleFeature. realizeFeature(FeatureHolder fh, Feature.Template templ)FeatureSimpleSequence. realizeFeature(FeatureHolder parent, Feature.Template template)FeatureViewSequence. realizeFeature(FeatureHolder parent, Feature.Template template)voidDummySequence. removeFeature(Feature feature)voidLazyFilterFeatureHolder. removeFeature(Feature f)voidRevCompSequence. removeFeature(Feature f)voidSimpleGappedSequence. removeFeature(Feature f)voidSimpleSequence. removeFeature(Feature f)Remove a feature attached to this sequence.voidSubSequence. removeFeature(Feature f)FeatureSimpleRemoteFeature.DBResolver. resolve(RemoteFeature rFeat) -
Uses of BioException in org.biojava.bio.seq.io
Subclasses of BioException in org.biojava.bio.seq.io Modifier and Type Class Description classParseExceptionParseException should be thrown to indicate that there was a problem with parsing sequence information.Methods in org.biojava.bio.seq.io that throw BioException Modifier and Type Method Description ComponentFeatureSimpleAssemblyBuilder. addComponentSequence(ComponentFeature.Template cft)static voidSeqIOTools. biojavaToFile(int fileType, OutputStream os, Object biojava)Deprecated.Converts a Biojava object to the given filetype.static voidSeqIOTools. biojavaToFile(String formatName, String alphabetName, OutputStream os, Object biojava)Deprecated.Writes a BiojavaSequenceIterator,SequenceDB,SequenceorAligmentto anOutputStreamvoidFeatureTableParser. endFeature()Deprecated.voidFeatureTableParser. featureData(String line)Deprecated.static ObjectSeqIOTools. fileToBiojava(int fileType, BufferedReader br)Deprecated.Reads a file and returns the corresponding Biojava object.static ObjectSeqIOTools. fileToBiojava(String formatName, String alphabetName, BufferedReader br)Deprecated.Reads a file with the specified format and alphabetstatic SequenceBuilderFactorySeqIOTools. formatToFactory(SequenceFormat format, Alphabet alpha)Deprecated.as this essentially duplicates the operation available in the methodidentifyBuilderFactory.static FiniteAlphabetSeqIOTools. getAlphabet(int identifier)Deprecated.getAlphabetaccepts a value which represents a sequence format and returns the relevantFiniteAlphabetobject.static SequenceBuilderFactorySeqIOTools. getBuilderFactory(int identifier)Deprecated.getBuilderFactoryaccepts a value which represents a sequence format and returns the relevantSequenceBuilderFactoryobject.static SequenceFormatSeqIOTools. getSequenceFormat(int identifier)Deprecated.getSequenceFormataccepts a value which represents a sequence format and returns the relevantSequenceFormatobject.SymbolListChunkedSymbolListFactory. make(SymbolReader sr)Method to create a Sequence with a SymbolReader.SequenceSequenceBuilder. makeSequence()Return the Sequence object which has been constructed by this builder.SequenceSequenceBuilderBase. makeSequence()SequenceSequenceBuilderFilter. makeSequence()SequenceSequenceDBSequenceBuilder. makeSequence()create the sequenceSequenceSimpleAssemblyBuilder. makeSequence()SequenceSimpleSequenceBuilder. makeSequence()SequenceSmartSequenceBuilder. makeSequence()SequenceStreamReader. nextSequence()Pull the next sequence out of the stream.Feature.TemplateEmblLikeLocationParser. parseLocation(String location, Feature.Template theTemplate)Deprecated.parseLocationcreates aLocationfrom the String and returns a stranded location.static SequenceDBSeqIOTools. readFasta(InputStream seqFile, Alphabet alpha)Deprecated.Create a sequence database from a fasta file provided as an input stream.booleanSequenceFormat. readSequence(BufferedReader reader, SymbolTokenization symParser, SeqIOListener listener)Read a sequence and pass data on to a SeqIOListener.voidFeatureTableParser. startFeature(String type)Deprecated.voidFastaAlignmentFormat. write(OutputStream os, Alignment align, int fileType)Writes out the alignment to an FASTA file.voidMSFAlignmentFormat. write(OutputStream os, Alignment align, int fileType)voidFastaAlignmentFormat. writeDna(OutputStream os, Alignment align)voidMSFAlignmentFormat. writeDna(OutputStream os, Alignment align)static voidSeqIOTools. writeGenpept(OutputStream os, Sequence seq)Deprecated.Writes a single Sequence to an OutputStream in Genpept format.static voidSeqIOTools. writeGenpept(OutputStream os, SequenceIterator in)Deprecated.Writes a stream of Sequences to an OutputStream in Genpept format.voidFastaAlignmentFormat. writeProtein(OutputStream os, Alignment align)voidMSFAlignmentFormat. writeProtein(OutputStream os, Alignment align)static voidSeqIOTools. writeSwissprot(OutputStream os, Sequence seq)Deprecated.Writes a single Sequence to an OutputStream in SwissProt format.static voidSeqIOTools. writeSwissprot(OutputStream os, SequenceIterator in)Deprecated.Writes a stream of Sequences to an OutputStream in SwissProt format.Constructors in org.biojava.bio.seq.io that throw BioException Constructor Description CrossProductTokenization(Alphabet alpha) -
Uses of BioException in org.biojava.bio.seq.projection
Methods in org.biojava.bio.seq.projection that throw BioException Modifier and Type Method Description FeatureProjectedFeature. createFeature(Feature.Template temp)FeatureProjectedFeatureHolder. createFeature(Feature.Template templ)FeatureProjectionContext. createFeature(Feature.Template projTempl)Create a projected feature with properties matching the template.FeatureProjectionContext. createFeature(Feature projParent, Feature.Template projTempl)Create a new projected feature.FeatureReparentContext. createFeature(Feature.Template projTempl)FeatureReparentContext. createFeature(Feature f, Feature.Template projTempl)voidProjectedFeature. removeFeature(Feature f)voidProjectedFeatureHolder. removeFeature(Feature dyingChild)voidProjectionContext. removeFeature(Feature dyingChild)Remove the dying child.voidProjectionContext. removeFeature(Feature projParent, Feature dyingChild)Remove the dying child.voidReparentContext. removeFeature(Feature dyingChild)voidReparentContext. removeFeature(Feature f, Feature f2) -
Uses of BioException in org.biojava.bio.symbol
Subclasses of BioException in org.biojava.bio.symbol Modifier and Type Class Description classIllegalAlphabetExceptionThe exception to indicate that an invalid alphabet has been used.classIllegalSymbolExceptionThe exception to indicate that a symbol is not valid within a context.Methods in org.biojava.bio.symbol that throw BioException Modifier and Type Method Description static AlphabetIndexAlphabetManager. getAlphabetIndex(Symbol[] syms)Get an indexer for an array of symbols.SymbolTokenizationAbstractAlphabet. getTokenization(String name)SymbolTokenizationAlphabet. getTokenization(String name)Get a SymbolTokenization by name.SymbolTokenizationDoubleAlphabet.SubDoubleAlphabet. getTokenization(String name)SymbolTokenizationSoftMaskedAlphabet. getTokenization(String type)static voidAlphabetManager. loadAlphabets(InputSource is)Load additional Alphabets, defined in XML format, into the AlphabetManager's registry.static MergeLocationMergeLocation. mergeLocations(List componentLocations)Static Factory method for getting an instance of aMergeLocationstatic MergeLocationMergeLocation. mergeLocations(Location locA, Location locB)voidCodonPrefFilter.ByName. put(CodonPref codonPref)voidCodonPrefFilter.EverythingToXML. put(CodonPref codonPref)voidCodonPrefFilter. put(CodonPref codonPref)handles storage of a CodonPref objectstatic CodonPref[]CodonPrefTools. readFromXML(InputStream prefStream)static CodonPrefCodonPrefTools. readFromXML(InputStream prefStream, String name)reads a specified CodonPref from an file.static voidCodonPrefTools. readFromXML(InputStream prefStream, CodonPrefFilter filter)read an CodonPref XML stream and handle it with a CodonPrefFilter object.static voidCodonPrefTools. writeToXML(CodonPref codonPref, PrintWriter writer)write out a specified CodonPref object in XML format. -
Uses of BioException in org.biojava.bio.taxa
Subclasses of BioException in org.biojava.bio.taxa Modifier and Type Class Description classCircularReferenceExceptionDeprecated.replaced by classes inorg.biojavax.bio.taxa -
Uses of BioException in org.biojava.directory
Methods in org.biojava.directory that throw BioException Modifier and Type Method Description SequenceDBLiteRegistry. getDatabase(String dbName)getDatabaseretrieves a database instance known by a nameString.SequenceDBLiteSequenceDBProvider. getSequenceDB(Map config)Get a sequence database. -
Uses of BioException in org.biojava.utils.automata
Subclasses of BioException in org.biojava.utils.automata Modifier and Type Class Description classAutomatonExceptionAn exception thrown by classes of this package. -
Uses of BioException in org.biojava.utils.math
Methods in org.biojava.utils.math that throw BioException Modifier and Type Method Description static doubleBinarySearch. solve(double min, double max, double tolerance, ComputeObject obj)method that will attempt solving the equation. -
Uses of BioException in org.biojava.utils.regex
Subclasses of BioException in org.biojava.utils.regex Modifier and Type Class Description classRegexExceptionAn exception thrown by classes of this package. -
Uses of BioException in org.biojava.utils.walker
Methods in org.biojava.utils.walker that throw BioException Modifier and Type Method Description WalkerWalkerFactory. getWalker(Visitor visitor)Get a Walker that is customosed to a particular visitor. -
Uses of BioException in org.biojavax.bio
Methods in org.biojavax.bio that throw BioException Modifier and Type Method Description BioEntryBioEntryIterator. nextBioEntry() -
Uses of BioException in org.biojavax.bio.alignment
Methods in org.biojavax.bio.alignment that throw BioException Modifier and Type Method Description StringRemotePairwiseAlignmentProperties. getAlignmentOption(String key)Method that returns the value associated with the key given in parameter.InputStreamRemotePairwiseAlignmentService. getAlignmentResults(String rid, RemotePairwiseAlignmentOutputProperties out)Getting the actual alignment results from this instantiated service for a given ID with specific formatting parameters held in a RemotePairwiseAlignmentOutputProperties-implemented object.StringRemotePairwiseAlignmentOutputProperties. getOutputOption(String key)Method that returns the value associated with the key given in parameter.booleanRemotePairwiseAlignmentService. isReady(String id, long present)Simple method to check if the specified request has been completed by the service used.StringRemotePairwiseAlignmentService. sendAlignmentRequest(String str, RemotePairwiseAlignmentProperties rpa)Doing the actual analysis on the instantiated service using specified parameters on the string representation of the Sequence objectStringRemotePairwiseAlignmentService. sendAlignmentRequest(RichSequence rs, RemotePairwiseAlignmentProperties rpa)Doing the actual analysis on the instantiated service using specified parameters and the RichSequence object -
Uses of BioException in org.biojavax.bio.alignment.blast
Methods in org.biojavax.bio.alignment.blast that throw BioException Modifier and Type Method Description StringRemoteQBlastAlignmentProperties. getAlignmentOption(String key)InputStreamRemoteQBlastService. getAlignmentResults(String id, RemotePairwiseAlignmentOutputProperties rb)This method extracts the actual Blast report for this request ID.StringRemoteQBlastOutputProperties. getOutputOption(String o)Method that returns any value associated to any key for this RemoteQBlastOutputProperties object.booleanRemoteQBlastService. isReady(String id, long present)This method is used only for the executeBlastSearch method to check for completion of request using the NCBI specified RTOE variablevoidRemoteQBlastService. printRemoteBlastInfo()A simple method to check the availability of the QBlast serviceStringRemoteQBlastService. sendAlignmentRequest(int gid, RemotePairwiseAlignmentProperties rpa)This method is a wrapper that executes the Blast request via the Put command of the CGI-BIN interface with the specified parameters and a GenBank GID.StringRemoteQBlastService. sendAlignmentRequest(String str, RemotePairwiseAlignmentProperties rpa)This method is a wrapper that executes the Blast request via the Put command of the CGI-BIN interface with the specified parameters and a string representing the sequence.StringRemoteQBlastService. sendAlignmentRequest(RichSequence rs, RemotePairwiseAlignmentProperties rpa)This method is a wrapper that executes the Blast request via the Put command of the CGI-BIN interface with the specified parameters and a RichSequence.voidRemoteQBlastOutputProperties. setAlignmentOutputFormat(RemoteQBlastOutputFormat rf)This method is use to set the alignment output format to get from the QBlast servicevoidRemoteQBlastAlignmentProperties. setBlastProgram(String program)This method set the program to be use with blastall.voidRemoteQBlastOutputProperties. setOutputFormat(RemoteQBlastOutputFormat rf)This method is use to set the stream output format to get from the QBlast serviceConstructors in org.biojavax.bio.alignment.blast that throw BioException Constructor Description RemoteQBlastService()The constructor for a QBlast service request. -
Uses of BioException in org.biojavax.bio.db
Methods in org.biojavax.bio.db that throw BioException Modifier and Type Method Description voidAbstractBioEntryDB. addBioEntry(BioEntry seq)voidAbstractRichSequenceDB. addBioEntry(BioEntry seq)voidBioEntryDBLite. addBioEntry(BioEntry seq)Adds a sequence to the database.protected voidHashBioEntryDB. addBioEntry(String id, BioEntry seq)voidHashBioEntryDB. addBioEntry(BioEntry seq)Add a BioEntry, the name of the BioEntry will be used as the IDvoidAbstractRichSequenceDB. addRichSequence(RichSequence seq)protected voidHashRichSequenceDB. addRichSequence(String id, RichSequence seq)voidHashRichSequenceDB. addRichSequence(RichSequence seq)Add a sequence.voidRichSequenceDBLite. addRichSequence(RichSequence seq)Adds a sequence to the database.voidAbstractRichSequenceDB. addSequence(Sequence seq)BioEntryAbstractRichSequenceDB. getBioEntry(String id)BioEntryBioEntryDBLite. getBioEntry(String id)Retrieve a single BioEntry by its id.BioEntryHashBioEntryDB. getBioEntry(String id)BioEntryDBAbstractRichSequenceDB. getBioEntrys(Set ids)BioEntryDBAbstractRichSequenceDB. getBioEntrys(Set ids, BioEntryDB db)BioEntryDBBioEntryDBLite. getBioEntrys(Set ids)Retrieve multiple BioEntry by their ids.BioEntryDBBioEntryDBLite. getBioEntrys(Set ids, BioEntryDB db)Retrieve multiple BioEntry into a specific sequence database.BioEntryDBHashBioEntryDB. getBioEntrys(Set ids)BioEntryDBHashBioEntryDB. getBioEntrys(Set ids, BioEntryDB db)RichSequenceHashRichSequenceDB. getRichSequence(String id)RichSequenceRichSequenceDBLite. getRichSequence(String id)Retrieve a single RichSequence by its id.RichSequenceDBHashRichSequenceDB. getRichSequences(Set ids)RichSequenceDBHashRichSequenceDB. getRichSequences(Set ids, RichSequenceDB db)RichSequenceDBRichSequenceDBLite. getRichSequences(Set ids)Retrieve multiple RichSequence by its id.RichSequenceDBRichSequenceDBLite. getRichSequences(Set ids, RichSequenceDB db)Retrieve multiple RichSequence into a specific sequence database.SequenceAbstractRichSequenceDB. getSequence(String id)voidAbstractBioEntryDB. removeBioEntry(String id)voidAbstractRichSequenceDB. removeBioEntry(String id)voidBioEntryDBLite. removeBioEntry(String id)Remove the BioEntry associated with an ID from the database.voidHashBioEntryDB. removeBioEntry(String id)voidAbstractRichSequenceDB. removeRichSequence(String id)voidRichSequenceDBLite. removeRichSequence(String id)Remove the RichSequence associated with an ID from the database.voidAbstractRichSequenceDB. removeSequence(String id)voidHashRichSequenceDB. removeSequence(String id) -
Uses of BioException in org.biojavax.bio.db.biosql
Methods in org.biojavax.bio.db.biosql that throw BioException Modifier and Type Method Description voidBioSQLBioEntryDB. _addBioEntry(BioEntry seq)voidBioSQLBioEntryDB. addBioEntry(BioEntry seq)voidBioSQLRichSequenceDB. addRichSequence(RichSequence seq)RichSequenceBioSQLRichSequenceDB. fullyLoadRichSequence(RichSequence id)BioEntryBioSQLBioEntryDB. getBioEntry(String id)BioEntryDBBioSQLBioEntryDB. getBioEntrys(Set ids)BioEntryDBBioSQLBioEntryDB. getBioEntrys(Set ids, BioEntryDB db)RichSequenceBioSQLRichSequenceDB. getRichSequence(String id)RichSequenceDBBioSQLRichSequenceDB. getRichSequences(Set ids)RichSequenceDBBioSQLRichSequenceDB. getRichSequences(Set ids, RichSequenceDB db)voidBioSQLBioEntryDB. removeBioEntry(String id)voidBioSQLRichSequenceDB. removeRichSequence(String id) -
Uses of BioException in org.biojavax.bio.db.ncbi
Methods in org.biojavax.bio.db.ncbi that throw BioException Modifier and Type Method Description RichSequenceGenbankRichSequenceDB. getRichSequence(String id)Given the appropriate Genbank ID, return the matching RichSequence object.RichSequenceGenbankRichSequenceDB. getRichSequence(String id, Namespace nsp)Given the appropriate Genbank ID, return the matching RichSequence object.RichSequenceGenpeptRichSequenceDB. getRichSequence(String id)Given the appropriate Genbank ID, return the matching RichSequence object.RichSequenceGenpeptRichSequenceDB. getRichSequence(String id, Namespace nsp)Given the appropriate Genbank ID, return the matching RichSequence object.RichSequenceDBGenbankRichSequenceDB. getRichSequences(Set list)Retrieve rich sequences from a GenbankRichSequenceDBGenbankRichSequenceDB. getRichSequences(Set list, RichSequenceDB database)Retrieve rich sequences from a GenbankRichSequenceDBGenpeptRichSequenceDB. getRichSequences(Set list)Retrieve rich sequences from a GenbankRichSequenceDBGenpeptRichSequenceDB. getRichSequences(Set list, RichSequenceDB database)Retrieve rich sequences from a Genbank -
Uses of BioException in org.biojavax.bio.seq
Methods in org.biojavax.bio.seq that throw BioException Modifier and Type Method Description FeatureSimpleRichFeature. createFeature(Feature.Template ft)Create a new Feature, and add it to this FeatureHolder.FeatureThinRichSequence. createFeature(Feature.Template ft)Create a new Feature, and add it to this FeatureHolder.static RichSequenceRichSequence.Tools. createRichSequence(String namespace, String name, String seqString, Alphabet alpha)Create a new RichSequence in the specified namespace.static RichSequenceRichSequence.Tools. createRichSequence(String name, String seqString, Alphabet alpha)Create a new RichSequence in the default namespace.static RichSequenceRichSequence.Tools. createRichSequence(Namespace ns, String name, String seqString, Alphabet alpha)Create a new RichSequence in the specified namespace.RichSequenceRichSequenceIterator. nextRichSequence()static RichSequenceIteratorRichSequence.IOTools. readHashedFastaDNA(BufferedInputStream is, Namespace ns)Iterate over the sequences in an FASTA-format stream of DNA sequences.voidSimpleRichFeature. removeFeature(Feature f)Remove a feature from this FeatureHolder.voidThinRichSequence. removeFeature(Feature f)Remove a feature from this FeatureHolder.protected voidSimpleRichSequence. setAlphabetName(String alphaname)protected voidThinRichSequence. setAlphabetName(String alphaname)protected voidSimpleRichSequence. setStringSequence(String seq) -
Uses of BioException in org.biojavax.bio.seq.io
Methods in org.biojavax.bio.seq.io that throw BioException Modifier and Type Method Description RichSequenceRichSequenceBuilder. makeRichSequence()Build a RichSequence.RichSequenceSimpleRichSequenceBuilder. makeRichSequence()Build a RichSequence.SequenceRichSequenceBuilder. makeSequence()Return the Sequence object which has been constructed by this builder.SequenceSimpleRichSequenceBuilder. makeSequence()Return the Sequence object which has been constructed by this builder.BioEntryHashedFastaIterator. nextBioEntry()BioEntryRichStreamReader. nextBioEntry()RichSequenceHashedFastaIterator. nextRichSequence()RichSequenceRichStreamReader. nextRichSequence()SequenceHashedFastaIterator. nextSequence()SequenceRichStreamReader. nextSequence()Returns the next sequence in the iterator.booleanRichSequenceFormat. readRichSequence(BufferedReader reader, SymbolTokenization symParser, RichSeqIOListener listener, Namespace ns)Reads a sequence from the given buffered reader using the given tokenizer to parse sequence symbols.Constructors in org.biojavax.bio.seq.io that throw BioException Constructor Description HashedFastaIterator(BufferedInputStream is, Alphabet alpha, Namespace ns)
-