|
class | FeatureDeconvolution |
| An algorithm to decharge features (i.e. as found by FeatureFinder). More...
|
|
class | ILPDCWrapper |
|
class | MetaboliteFeatureDeconvolution |
| An algorithm to decharge small molecule features (i.e. as found by FeatureFinder). More...
|
|
class | AccurateMassSearchResult |
|
class | AccurateMassSearchEngine |
| An algorithm to search for exact mass matches from a spectrum against a database (e.g. HMDB). More...
|
|
struct | Hit |
|
struct | AA |
|
class | Index |
|
struct | ACNode |
|
struct | ACSpawn |
| a spin-off search path through the trie, which can deal with ambiguous AAs and mismatches More...
|
|
struct | ACTrieState |
|
class | ACTrie |
| An Aho Corasick trie (a set of nodes with suffix links mainly) More...
|
|
class | ProbablePhosphoSites |
|
class | AScore |
| Implementation of the Ascore For a given peptide sequence and its MS/MS spectrum it identifies the most probable phosphorylation-site(s). For each phosphorylation site a probability score is calculated. The algorithm is implemented according to Beausoleil et al. (Nat. Biotechnol. 2006). More...
|
|
class | BasicProteinInferenceAlgorithm |
| Algorithm class that implements simple protein inference by aggregation of peptide scores. It has multiple parameter options like the aggregation method, when to distinguish peptidoforms, and if you want to use shared peptides ("use_shared_peptides"). First, the best PSM per spectrum is used, then only the best PSM per peptidoform is aggregated. Peptidoforms can optionally be distinguished via the treat_X_separate parameters: More...
|
|
class | BayesianProteinInferenceAlgorithm |
| Performs a Bayesian protein inference on Protein/Peptide identifications or ConsensusMap (experimental). More...
|
|
class | ConsensusIDAlgorithm |
| Abstract base class for all ConsensusID algorithms (that calculate a consensus from multiple ID runs). More...
|
|
class | ConsensusIDAlgorithmAverage |
| Calculates a consensus from multiple ID runs by averaging the search scores. More...
|
|
class | ConsensusIDAlgorithmBest |
| Calculates a consensus from multiple ID runs by taking the best search score. More...
|
|
class | ConsensusIDAlgorithmIdentity |
| Abstract base class for ConsensusID algorithms that compare only identical sequences. More...
|
|
class | ConsensusIDAlgorithmPEPIons |
| Calculates a consensus from multiple ID runs based on PEPs and shared ions. More...
|
|
class | ConsensusIDAlgorithmPEPMatrix |
| Calculates a consensus from multiple ID runs based on PEPs and sequence similarities. More...
|
|
class | ConsensusIDAlgorithmRanks |
| Calculates a consensus from multiple ID runs based on the ranks of the search hits. More...
|
|
class | ConsensusIDAlgorithmSimilarity |
| Abstract base class for ConsensusID algorithms that take peptide similarity into account. More...
|
|
class | ConsensusIDAlgorithmWorst |
| Calculates a consensus from multiple ID runs by taking the worst search score (conservative approach). More...
|
|
class | ConsensusMapMergerAlgorithm |
| Merges identification data in ConsensusMaps. More...
|
|
class | FalseDiscoveryRate |
| Calculates false discovery rates (FDR) from identifications. More...
|
|
class | FIAMSDataProcessor |
| Data processing for FIA-MS data. More...
|
|
class | FIAMSScheduler |
|
struct | HyperScore |
| An implementation of the X!Tandem HyperScore PSM scoring function. More...
|
|
class | IDConflictResolverAlgorithm |
| Resolves ambiguous annotations of features with peptide identifications. More...
|
|
class | IDDecoyProbability |
| IDDecoyProbability calculates probabilities using decoy approach. More...
|
|
class | IDMapper |
| Annotates an MSExperiment, FeatureMap or ConsensusMap with peptide identifications. More...
|
|
class | IDMergerAlgorithm |
| Creates a new Protein ID run into which other runs can be inserted. Creates union of protein hits but concatenates PSMs. Checks search engine consistency of all inserted runs. It differs from the IDMerger tool, in that it is an algorithm class and it allows inserting multiple peptide hits per peptide sequence (not only the first occurrence). More...
|
|
class | IDRipper |
| Ripping protein/peptide identification according their file origin. More...
|
|
struct | ScoreToTgtDecLabelPairs |
|
class | IDScoreGetterSetter |
| A class for extracting and reinserting IDScores from Peptide/ProteinIdentifications and from ConsensusMaps. More...
|
|
class | IDScoreSwitcherAlgorithm |
|
class | IonIdentityMolecularNetworking |
|
struct | PrecursorMassComparator |
|
class | SpectralMatch |
|
struct | SpectralMatchScoreComparator |
|
class | MetaboliteSpectralMatching |
|
struct | MorpheusScore |
| An implementation of the Morpheus PSM scoring function Inspired by a C# implementation by C. Wenger released under MIT license. More...
|
|
class | NeighborSeq |
| The Neighbor Peptide functionality is designed to find peptides (neighbors) in a given set of sequences (FASTA file) that are similar to a target peptide (aka relevant peptide) based on mass and spectral characteristics. This provides more power when searching complex samples, when only a subset of the peptides/proteins is of interest. More...
|
|
class | PeptideIndexing |
| Refreshes the protein references for all peptide hits in a vector of PeptideIdentifications and adds target/decoy information. More...
|
|
struct | ConnectedComponent |
|
class | PeptideProteinResolution |
| Resolves shared peptides based on protein scores. More...
|
|
class | PercolatorFeatureSetHelper |
| Percolator feature set and integration helper. More...
|
|
class | PrecursorPurity |
| Precursor purity or noise estimation. More...
|
|
struct | PScore |
| Implementation of the PScore PSM scoring algorithm. More...
|
|
class | SimpleSearchEngineAlgorithm |
|
class | SiriusExportAlgorithm |
|
class | SiriusMSFile |
|
class | BaseGroupFinder |
| The base class of all element group finding algorithms. More...
|
|
class | BaseSuperimposer |
| The base class of all superimposer algorithms. More...
|
|
class | ConsensusMapNormalizerAlgorithmMedian |
| Algorithms of ConsensusMapNormalizer. More...
|
|
class | ConsensusMapNormalizerAlgorithmQuantile |
| Algorithms of ConsensusMapNormalizer. More...
|
|
class | ConsensusMapNormalizerAlgorithmThreshold |
| Algorithms of ConsensusMapNormalizer. More...
|
|
class | FeatureDistance |
| A functor class for the calculation of distances between features or consensus features. More...
|
|
class | FeatureGroupingAlgorithm |
| Base class for all feature grouping algorithms. More...
|
|
class | ClusterProxyKD |
| Proxy for a (potential) cluster. More...
|
|
class | FeatureGroupingAlgorithmKD |
| A feature grouping algorithm for unlabeled data. More...
|
|
class | FeatureGroupingAlgorithmLabeled |
| A map feature grouping algorithm for labeling techniques with two labels. More...
|
|
class | FeatureGroupingAlgorithmQT |
| A feature grouping algorithm for unlabeled data. More...
|
|
class | FeatureGroupingAlgorithmUnlabeled |
| A map feature grouping algorithm for unlabeled data. More...
|
|
class | FeatureMapping |
|
class | LabeledPairFinder |
| The LabeledPairFinder allows the matching of labeled features (features with a fixed distance). More...
|
|
class | MapAlignmentAlgorithmIdentification |
| A map alignment algorithm based on peptide identifications from MS2 spectra. More...
|
|
class | MapAlignmentAlgorithmKD |
| An efficient reference-free feature map alignment algorithm for unlabeled data. More...
|
|
class | MapAlignmentAlgorithmPoseClustering |
| A map alignment algorithm based on pose clustering. More...
|
|
class | MapAlignmentAlgorithmTreeGuided |
| A map alignment algorithm based on peptide identifications from MS2 spectra. More...
|
|
class | MapAlignmentEvaluationAlgorithm |
| Base class for all Caap evaluation algorithms. More...
|
|
class | MapAlignmentEvaluationAlgorithmPrecision |
| Caap evaluation algorithm to obtain a precision value. More...
|
|
class | MapAlignmentEvaluationAlgorithmRecall |
| Caap evaluation algorithm to obtain a recall value. More...
|
|
class | MapAlignmentTransformer |
| This class collects functions for applying retention time transformations to data structures. More...
|
|
class | PoseClusteringAffineSuperimposer |
| A superimposer that uses a voting scheme, also known as pose clustering, to find a good affine transformation. More...
|
|
class | PoseClusteringShiftSuperimposer |
| A superimposer that uses a voting scheme, also known as pose clustering, to find a good shift transformation. More...
|
|
class | QTClusterFinder |
| A variant of QT clustering for the detection of feature groups. More...
|
|
class | StablePairFinder |
| This class implements a pair finding algorithm for consensus features. More...
|
|
class | TransformationDescription |
| Generic description of a coordinate transformation. More...
|
|
class | TransformationModel |
| Base class for transformation models. More...
|
|
class | TransformationModelBSpline |
| B-spline (non-linear) model for transformations. More...
|
|
class | TransformationModelInterpolated |
| Interpolation model for transformations. More...
|
|
class | TransformationModelLinear |
| Linear model for transformations. More...
|
|
class | TransformationModelLowess |
| Lowess (non-linear) model for transformations. More...
|
|
class | ReactionMonitoringTransition |
| This class stores a SRM/MRM transition. More...
|
|
class | ChromatogramExtractor |
| The ChromatogramExtractor extracts chromatograms from a spectra file. More...
|
|
class | ChromatogramExtractorAlgorithm |
| The ChromatogramExtractorAlgorithm extracts chromatograms from a MS data. More...
|
|
class | ConfidenceScoring |
|
class | OpenSwathDataAccessHelper |
| Several helpers to convert OpenMS datastructures to structures that implement the OpenSWATH interfaces. More...
|
|
class | FeatureOpenMS |
| An implementation of the OpenSWATH Feature Access interface using OpenMS. More...
|
|
class | MRMFeatureOpenMS |
| An implementation of the OpenSWATH MRM Feature Access interface using OpenMS. More...
|
|
class | TransitionGroupOpenMS |
| An implementation of the OpenSWATH Transition Group Access interface using OpenMS. More...
|
|
class | SignalToNoiseOpenMS |
| An implementation of the OpenSWATH SignalToNoise Access interface using OpenMS. More...
|
|
class | SimpleOpenMSSpectraFactory |
| A factory method that returns two ISpectrumAccess implementations. More...
|
|
class | SpectrumAccessOpenMS |
| An implementation of the OpenSWATH Spectrum Access interface using OpenMS. More...
|
|
class | SpectrumAccessOpenMSCached |
| An implementation of the Spectrum Access interface using on-disk caching. More...
|
|
class | SpectrumAccessOpenMSInMemory |
| An implementation of the OpenSWATH Spectrum Access interface completely in memory. More...
|
|
class | SpectrumAccessQuadMZTransforming |
| A transforming m/z wrapper around spectrum access using a quadratic equation. More...
|
|
class | SpectrumAccessSqMass |
| An implementation of the Spectrum Access interface using SQL files. More...
|
|
class | SpectrumAccessTransforming |
| An abstract base class implementing a transforming wrapper around spectrum access. More...
|
|
class | DiaPrescore |
| Scoring of an spectrum given library intensities of a transition group. More...
|
|
class | DIAScoring |
| Scoring of an spectrum at the peak apex of an chromatographic elution peak. More...
|
|
class | IonMobilityScoring |
| A class that calls the ion mobility scoring routines. More...
|
|
class | MasstraceCorrelator |
| Correlates individual masstraces found in mass spectrometric maps. More...
|
|
class | MRMAssay |
| Generate assays from a TargetedExperiment. More...
|
|
class | MRMBatchFeatureSelector |
|
class | MRMDecoy |
| This class generates a TargetedExperiment object with decoys based on a TargetedExperiment object. More...
|
|
class | MRMFeatureFilter |
| The MRMFeatureFilter either flags components and/or transitions that do not pass the QC criteria or filters out components and/or transitions that do not pass the QC criteria. More...
|
|
class | MRMFeatureFinderScoring |
| The MRMFeatureFinder finds and scores peaks of transitions that co-elute. More...
|
|
class | MRMFeaturePicker |
| MRMFeaturePicker defines the structures containing parameters to be used in MRMTransitionGroupPicker for components and components groups. More...
|
|
class | MRMFeatureQC |
| The MRMFeatureQC is a class to handle the parameters and options for MRMFeatureFilter. More...
|
|
class | MRMFeatureSelector |
|
class | MRMFeatureSelectorQMIP |
|
class | MRMFeatureSelectorScore |
|
class | MRMFeatureSelector_test |
|
class | MRMIonSeries |
| Generate theoretical fragment ion series for use in MRMAssay and MRMDecoy. More...
|
|
class | MRMRTNormalizer |
| The MRMRTNormalizer will find retention time peptides in data. More...
|
|
class | MRMTransitionGroupPicker |
| The MRMTransitionGroupPicker finds peaks in chromatograms that belong to the same precursors. More...
|
|
class | OpenSwathHelper |
| A helper class that is used by several OpenSWATH tools. More...
|
|
class | OpenSwathOSWWriter |
| Class to write out an OpenSwath OSW SQLite output (PyProphet input). More...
|
|
struct | OpenSwath_Scores_Usage |
| A structure to store which scores should be used by the OpenSWATH Algorithm. More...
|
|
struct | OpenSwath_Scores |
| A structure to hold the different scores computed by OpenSWATH. More...
|
|
struct | OpenSwath_Ind_Scores |
|
class | OpenSwathScoring |
| A class that calls the scoring routines. More...
|
|
class | OpenSwathTSVWriter |
| Class to write out an OpenSwath TSV output (mProphet input). More...
|
|
class | OpenSwathWorkflowBase |
|
class | OpenSwathCalibrationWorkflow |
| Execute all steps for retention time and m/z calibration of SWATH-MS data. More...
|
|
class | OpenSwathWorkflow |
| Execute all steps in an OpenSwath analysis. More...
|
|
class | OpenSwathWorkflowSonar |
| Execute all steps in an OpenEcho analysis (OpenSwath for SONAR data) More...
|
|
class | PeakIntegrator |
| Compute the area, background and shape metrics of a peak. More...
|
|
class | PeakPickerChromatogram |
| The PeakPickerChromatogram finds peaks a single chromatogram. More...
|
|
class | SONARScoring |
| Scoring of an spectrum using SONAR data. More...
|
|
class | SpectrumAddition |
| The SpectrumAddition is used to add up individual spectra. More...
|
|
class | SwathMapMassCorrection |
| A class containing correction functions for Swath MS maps. More...
|
|
class | SwathWindowLoader |
| Class to read a file describing the Swath Windows. More...
|
|
class | TargetedSpectraExtractor |
| This class filters, annotates, picks, and scores spectra (e.g., taken from a DDA experiment) based on a target list. More...
|
|
class | TransitionPQPFile |
| This class supports reading and writing of PQP files. More...
|
|
class | TransitionTSVFile |
|
class | AbsoluteQuantitation |
| AbsoluteQuantitation is a class to support absolute or relative quantitation for targeted or untargeted quantitation workflows (e.g., Isotope Dilution Mass Spectrometry). More...
|
|
class | AbsoluteQuantitationMethod |
| AbsoluteQuantitationMethod is a class to hold information about the quantitation method and for applying and/or generating the quantitation method. More...
|
|
class | IsobaricChannelExtractor |
| Extracts individual channels from MS/MS spectra for isobaric labeling experiments. More...
|
|
class | IsobaricIsotopeCorrector |
| Performs isotope impurity correction on the intensities extracted from an isobaric labeling experiment. More...
|
|
class | IsobaricNormalizer |
| Performs median normalization on the extracted ratios of isobaric labeling experiment. More...
|
|
class | IsobaricQuantifier |
| Given the extracted channel intensities the IsobaricQuantifier corrects and normalizes the intensities for further processing. More...
|
|
class | IsobaricQuantifierStatistics |
| Statistics for quantitation performance and comparison of NNLS vs. naive method (aka matrix inversion) More...
|
|
class | Matrix |
| A class representing a thin wrapper around an Eigen matrix. More...
|
|
class | IsobaricQuantitationMethod |
| Abstract base class describing an isobaric quantitation method in terms of the used channels and an isotope correction matrix. More...
|
|
class | IsotopeLabelingMDVs |
| IsotopeLabelingMDVs is a class to support and analyze isotopic labeling experiments (i.e. MDVs : Mass Distribution Vectors, also known as Mass Isotopomer Distribution (MID)) More...
|
|
class | ItraqConstants |
| Some constants used throughout iTRAQ classes. More...
|
|
class | ItraqEightPlexQuantitationMethod |
| iTRAQ 8 plex quantitation to be used with the IsobaricQuantitation. More...
|
|
class | ItraqFourPlexQuantitationMethod |
| iTRAQ 4 plex quantitation to be used with the IsobaricQuantitation. More...
|
|
class | KDTreeFeatureMaps |
| Stores a set of features, together with a 2D tree for fast search. More...
|
|
class | KDTreeFeatureNode |
| A node of the kD-tree with pointer to corresponding data and index. More...
|
|
class | PeptideAndProteinQuant |
| Helper class for peptide and protein quantification based on feature data annotated with IDs. More...
|
|
class | ProteinInference |
| [experimental class] given a peptide quantitation, infer corresponding protein quantities More...
|
|
class | TMTEighteenPlexQuantitationMethod |
| TMT 18plex quantitation to be used with the IsobaricQuantitation. More...
|
|
class | TMTElevenPlexQuantitationMethod |
| TMT 11plex quantitation to be used with the IsobaricQuantitation. More...
|
|
class | TMTSixPlexQuantitationMethod |
| TMT 6plex quantitation to be used with the IsobaricQuantitation. More...
|
|
class | TMTSixteenPlexQuantitationMethod |
| TMT 16plex quantitation to be used with the IsobaricQuantitation. More...
|
|
class | TMTTenPlexQuantitationMethod |
| TMT 10plex quantitation to be used with the IsobaricQuantitation. More...
|
|
struct | RNPxlMarkerIonExtractor |
|
class | NeedlemanWunsch |
| This class contains functions that are used to calculate the global alignment score of two amino acid sequences. This class uses the Needleman-Wunsch algorithm. For match and mismatch it uses a similarity scoring matrix. More...
|
|
class | IncludeExcludeTarget |
| This class stores a SRM/MRM transition. More...
|
|
class | MetaboTargetedAssay |
| This class provides methods for the extraction of targeted assays for metabolomics. More...
|
|
class | MetaboTargetedTargetDecoy |
| Resolve overlapping fragments and missing decoys for experimental specific decoy generation in targeted/pseudo targeted metabolomics. More...
|
|
class | MRMMapping |
| A class to map targeted assays to chromatograms. More...
|
|
class | TargetedExperiment |
| A description of a targeted experiment containing precursor and production ions. More...
|
|
class | DeconvolvedSpectrum |
| A class representing a deconvolved spectrum. DeconvolvedSpectrum consists of PeakGroups representing masses. For MSn n>1, a PeakGroup representing the precursor mass is also added in this class. Properly assigning a precursor mass from the original precursor peak and its deconvolution result is very important in top down proteomics. This assignment is performed here for conventional datasets. But for FLASHIda acquired datasets, the assignment is already done by FLASHIda. So this class simply use the results from FLASHIda log file for assignment. The parsing of FLASHIda log file is done in FLASHDeconv tool class. More...
|
|
class | FLASHDeconvAlgorithm |
| FLASHDeconv algorithm: ultrafast mass deconvolution algorithm for top down mass spectrometry dataset From MSSpectrum, this class outputs DeconvolvedSpectrum. Deconvolution takes three steps: i) decharging and select candidate masses - speed up via binning ii) collecting isotopes from the candidate masses and deisotope - peak groups are defined here iii) scoring and filter out low scoring masses (i.e., peak groups) More...
|
|
struct | FLASHDeconvHelperStructs |
| Wrapper struct for all the structs needed by the FLASHDeconv Three structures are defined: PrecalculatedAveragine, TopPicItem, and LogMzPeak i) PrecalculatedAveragine - to match observed isotopic envelope against theoretical one, theoretical envelope from averagine model should be quickly calculated. To do so, precalculate averagines for different masses at the beginning of FLASHDeconv runs ii) TopPicItem - represent TopPic identification. Currently used for Qscore training. TopPic is the top-down proteomics identification tool (https://www.toppic.org/). iii) LogMzPeak - Log transformed peak from original peak. Contains information such as charge, isotope index, and uncharged mass. More...
|
|
class | MassFeatureTrace |
| Feature trace in mass dimension for FLASHDeconv This class performs mass tracing on the deconvolved masses by FLASHDeconvAlgorithm In other words, per spectrum deconvolved masses are converted into deconvolved features Currently only works for MS1 spectra. (Top-down DIA is not yet used much). Every time an MS1 spectrum is deconvolved, the relevant information is stored in this class. Tracing is performed at the end of FLASHDeconv run. This class also comes with tsv, TopFD, ProMex format output functions. More...
|
|
class | PeakGroup |
| Class describing a deconvolved mass. A mass contains multiple (LogMz) peaks of different charges and isotope indices. PeakGroup is the set of such peaks representing a single monoisotopic mass. PeakGroup also contains features that define the quality of it. It is used by Qscore calculation. DeconvolvedSpectrum consists of PeakGroups. More...
|
|
class | Qscore |
| Qscore : quality score for PeakGroup. This class is being updated. For now, simply it calculate the Qscore using a fixed weight vector. The weight vector has been determined by logistic regression. But afterwards, the training part for the Qscore should be added in here. Or other technique such as deep learning would be used. This class also contains tsv output function. The tsv file contains features of PeakGroups which are used for training. More...
|
|
class | Qvalue |
| Qvalue : contains functions to calculate Qvalues from deconvolution quality score. More...
|
|
class | OpenPepXLAlgorithm |
| Search for peptide pairs linked with a labeled cross-linker. More...
|
|
class | OpenPepXLLFAlgorithm |
| Search for cross-linked peptide pairs in tandem MS spectra. More...
|
|
class | OPXLDataStructs |
|
class | OPXLHelper |
| The OPXLHelper class contains functions needed by OpenPepXL and OpenPepXLLF to reduce duplicated code. More...
|
|
class | OPXLSpectrumProcessingAlgorithms |
|
class | XFDRAlgorithm |
| Calculates false discovery rate estimates on crosslink identifications. More...
|
|
class | XQuestScores |
| An implementation of the scores for cross-link identification from the xQuest algorithm (O. Rinner et al., 2008, "Identification of cross-linked peptides from large sequence databases") More...
|
|
class | ConsoleUtils |
|
class | INIUpdater |
|
class | TOPPOpenSwathBase |
|
struct | ParameterInformation |
| Struct that captures all information of a command line parameter. More...
|
|
class | SearchEngineBase |
| Base class for Search Engine Adapters. More...
|
|
class | ToolHandler |
|
struct | Citation |
| Stores Citations for individual TOPP tools. More...
|
|
class | TOPPBase |
| Base class for TOPP applications. More...
|
|
class | AAIndex |
| Representation of selected AAIndex properties. More...
|
|
class | AASequence |
| Representation of a peptide/protein sequence. More...
|
|
class | AdductInfo |
|
class | CrossLinksDB |
|
class | DecoyGenerator |
| Methods to generate isobaric decoy sequences for DDA target-decoy searches. More...
|
|
class | DigestionEnzyme |
| Base class for digestion enzymes. More...
|
|
class | DigestionEnzymeDB |
| Digestion enzyme database (base class) More...
|
|
class | DigestionEnzymeProtein |
| Representation of a digestion enzyme for proteins (protease) More...
|
|
class | DigestionEnzymeRNA |
| Representation of a digestion enzyme for RNA (RNase) More...
|
|
class | Element |
| Representation of an element. More...
|
|
class | ElementDB |
| Singleton that stores elements and isotopes. More...
|
|
class | EmpiricalFormula |
| Representation of an empirical formula. More...
|
|
class | EnzymaticDigestion |
| Class for the enzymatic digestion of sequences. More...
|
|
class | CoarseIsotopePatternGenerator |
| Isotope pattern generator for coarse isotope distributions. More...
|
|
class | FineIsotopePatternGenerator |
| Isotope pattern generator for fine isotope distributions. More...
|
|
class | IsoSpecGeneratorWrapper |
| Interface for the IsoSpec algorithm - a generator of infinitely-resolved theoretical spectra. More...
|
|
class | IsoSpecWrapper |
| A convenience class for the IsoSpec algorithm - easier to use than the IsoSpecGeneratorWrapper classes. More...
|
|
class | IsoSpecTotalProbGeneratorWrapper |
| Generate a p-set of configurations for a given p (that is, a set of configurations such that their probabilities sum up to p). The p in normal usage will usually be close to 1 (e.g. 0.99). More...
|
|
class | IsoSpecThresholdGeneratorWrapper |
| Provides a threshold-based generator of isotopologues: generates all isotopologues more probable than a given probability threshold. More...
|
|
class | IsoSpecOrderedGeneratorWrapper |
| Generate the stream of configurations, ordered from most likely to least likely. More...
|
|
class | IsoSpecTotalProbWrapper |
| Create a p-set of configurations for a given p (that is, a set of configurations such that their probabilities sum up to p). The p in normal usage will usually be close to 1 (e.g. 0.99). More...
|
|
class | IsoSpecThresholdWrapper |
| A non-generator version of IsoSpecThresholdGeneratorWrapper. More...
|
|
class | IsotopeDistribution |
|
class | IsotopePatternGenerator |
| Provides an interface for different isotope pattern generator methods. More...
|
|
class | MassDecomposition |
| Class represents a decomposition of a mass into amino acids. More...
|
|
class | MassDecompositionAlgorithm |
| Mass decomposition algorithm, given a mass it suggests possible compositions. More...
|
|
class | ModificationDefinition |
|
class | ModificationDefinitionsSet |
|
class | ModificationsDB |
| database which holds all residue modifications from UniMod More...
|
|
class | ModifiedNASequenceGenerator |
|
class | ModifiedPeptideGenerator |
|
class | NASequence |
| Representation of a nucleic acid sequence. More...
|
|
class | NucleicAcidSpectrumGenerator |
| Generates theoretical spectra for nucleic acid sequences. More...
|
|
class | ProteaseDB |
| Database for enzymes that digest proteins (proteases) More...
|
|
class | ProteaseDigestion |
| Class for the enzymatic digestion of proteins represented as AASequence or String. More...
|
|
class | Residue |
| Representation of an amino acid residue. More...
|
|
class | ResidueDB |
| OpenMS stores a central database of all residues in the ResidueDB. All (unmodified) residues are added to the database on construction. Modified residues get created and added if getModifiedResidue is called. More...
|
|
class | ResidueModification |
| Representation of a modification on an amino acid residue. More...
|
|
class | Ribonucleotide |
| Representation of a ribonucleotide (modified or unmodified) More...
|
|
class | RibonucleotideDB |
| Database of ribonucleotides (modified and unmodified) More...
|
|
class | RNaseDB |
| Database for enzymes that digest RNA (RNases) More...
|
|
class | RNaseDigestion |
| Class for the enzymatic digestion of RNAs. More...
|
|
class | SimpleTSGXLMS |
| Generates theoretical spectra for cross-linked peptides. More...
|
|
class | SpectrumAnnotator |
| Annotates spectra from identifications and theoretical spectra or identifications from spectra and theoretical spectra matching with various options. More...
|
|
class | Tagger |
| Calculate sequence tags from m/z values. More...
|
|
class | TheoreticalSpectrumGenerator |
| Generates theoretical spectra for peptides with various options. More...
|
|
class | TheoreticalSpectrumGeneratorXLMS |
|
class | BinnedSharedPeakCount |
| Compare functor scoring the shared peaks for similarity measurement. More...
|
|
class | BinnedSpectralContrastAngle |
| Compare functor scoring the spectral contrast angle for similarity measurement. More...
|
|
class | BinnedSpectrumCompareFunctor |
| Base class for compare functors of BinnedSpectra. More...
|
|
class | BinnedSumAgreeingIntensities |
| Sum of agreeing intensities for similarity measurement. More...
|
|
class | PeakAlignment |
| make a PeakAlignment of two PeakSpectra More...
|
|
class | PeakSpectrumCompareFunctor |
| Base class for compare functors of spectra, that return a similarity value for two spectra. More...
|
|
class | SpectraSTSimilarityScore |
| Similarity score of SpectraST. More...
|
|
class | SpectrumAlignment |
| Aligns the peaks of two sorted spectra Method 1: Using a banded (width via 'tolerance' parameter) alignment if absolute tolerances are given. Scoring function is the m/z distance between peaks. Intensity does not play a role! More...
|
|
class | SpectrumAlignmentScore |
| Similarity score via spectra alignment. More...
|
|
class | SpectrumCheapDPCorr |
| SpectrumCheapDPCorr calculates an optimal alignment on stick spectra. More...
|
|
class | SpectrumPrecursorComparator |
| SpectrumPrecursorComparator compares just the parent mass of two spectra. More...
|
|
class | SteinScottImproveScore |
| Similarity score based of Stein & Scott. More...
|
|
class | ZhangSimilarityScore |
| Similarity score of Zhang. More...
|
|
class | Colorizer |
| Color and style the fonts shown on cout/cerr (or other streams) More...
|
|
class | FuzzyStringComparator |
| Fuzzy comparison of strings, tolerates numeric differences. More...
|
|
class | LogConfigHandler |
| The LogConfigHandler provides the functionality to configure the internal logging of OpenMS algorithms that use the global instances of LogStream. More...
|
|
struct | PrecisionWrapper |
| Wrapper class to implement output with appropriate precision. See precisionWrapper(). More...
|
|
class | ProgressLogger |
| Base class for all classes that want to report their progress. More...
|
|
class | RAIICleanup |
| Exception-safe way of executing arbitrary code at the end of a scope. More...
|
|
class | StreamHandler |
| Provides a central class to register globally used output streams. Currently supported streams are. More...
|
|
class | UniqueIdGenerator |
| A generator for unique ids. More...
|
|
class | UniqueIdIndexer |
| A base class for containers with elements derived from UniqueIdInterface. This adds functionality to convert a unique id into an index into the container. More...
|
|
class | UniqueIdInterface |
| A base class defining a common interface for all classes having a unique id. More...
|
|
class | VersionInfo |
| Version information class. More...
|
|
class | Adduct |
|
class | BinaryTreeNode |
| Elements of a binary tree used to represent a hierarchical clustering process. More...
|
|
class | CalibrationData |
| A helper class, holding all calibration points. More...
|
|
class | ChargePair |
| Representation of a (putative) link between two Features, which stem from the same compound but have different charge (including different adduct ions (H+, Na+, ..) More...
|
|
class | Compomer |
| Holds information on an edge connecting two features from a (putative) charge ladder. More...
|
|
class | ConstRefVector |
| This vector holds pointer to the elements of another container. More...
|
|
class | ConvexHull2D |
|
class | CVMappingRule |
| Representation of a CV Mapping rule used by CVMappings. More...
|
|
class | CVMappings |
| Representation of controlled vocabulary mapping rules (for PSI formats) More...
|
|
class | CVMappingTerm |
| Representation of controlled vocabulary term. More...
|
|
class | CVReference |
| Controlled Vocabulary Reference. More...
|
|
class | DataValue |
| Class to hold strings, numeric values, lists of strings and lists of numeric values. More...
|
|
class | Date |
| Date Class. More...
|
|
class | DateTime |
| DateTime Class. More...
|
|
class | DBoundingBox |
| A D-dimensional bounding box. More...
|
|
class | DefaultParamHandler |
| A base class for all classes handling default parameters. More...
|
|
class | DistanceMatrix |
| A two-dimensional distance matrix, similar to OpenMS::Matrix. More...
|
|
class | DPosition |
| Representation of a coordinate in D-dimensional space. More...
|
|
class | DRange |
| A D-dimensional half-open interval. More...
|
|
class | ExposedVector |
|
class | FASTAContainer |
| template parameter for vector-based FASTA access More...
|
|
class | FASTAContainer< TFI_File > |
| FASTAContainer<TFI_File> will make FASTA entries available chunk-wise from start to end by loading it from a FASTA file. This avoids having to load the full file into memory. While loading, the container will memorize the file offsets of each entry, allowing to read an arbitrary i'th entry again from disk. If possible, only entries from the currently cached chunk should be queried, otherwise access will be slow. More...
|
|
class | FASTAContainer< TFI_Vector > |
| FASTAContainer<TFI_Vector> simply takes an existing vector of FASTAEntries and provides the same interface with a potentially huge speed benefit over FASTAContainer<TFI_File> since it does not need disk access, but at the cost of memory. More...
|
|
class | DecoyHelper |
| Helper class for calculations on decoy proteins. More...
|
|
class | FlagSet |
| Stores and handles combinations of enum values, e.g. a set of flags as bits flipped in an UInt64. More...
|
|
class | GridFeature |
| Representation of a feature in a hash grid. More...
|
|
struct | IsotopeCluster |
| Stores information about an isotopic cluster (i.e. potential peptide charge variants) More...
|
|
class | ListUtils |
| Collection of utility functions for management of vectors. More...
|
|
struct | VecLowPrecision |
|
class | LPWrapper |
|
class | MassExplainer |
| computes empirical formulas for given mass differences using a set of allowed elements More...
|
|
class | MatchedIterator |
| For each element in the reference container the closest peak in the target will be searched. If no match is found within the tolerance window, the peak will be skipped over. More...
|
|
struct | ValueTrait |
| Trait for MatchedIterator to find pairs with a certain distance, which is computed directly on the value_type of the container. More...
|
|
struct | PpmTrait |
|
struct | DaTrait |
|
struct | OSWHierarchy |
| hierarchy levels of the OSWData tree More...
|
|
struct | OSWIndexTrace |
|
struct | OSWTransition |
| high-level meta data of a transition More...
|
|
class | OSWPeakGroup |
|
class | OSWPeptidePrecursor |
| A peptide with a charge state. More...
|
|
class | OSWProtein |
| A Protein is the highest entity and contains one or more peptides which were found/traced. More...
|
|
class | OSWData |
| Holds all or partial information from an OSW file. More...
|
|
class | Param |
| Management and storage of parameters / INI files. More...
|
|
class | ParamValue |
| Class to hold strings, numeric values, vectors of strings and vectors of numeric values using the stl types. More...
|
|
class | QTCluster |
| A representation of a QT cluster used for feature grouping. More...
|
|
class | String |
| A more convenient string class. More...
|
|
class | StringListUtils |
| Utilities operating on lists of Strings. More...
|
|
class | StringUtilsHelper |
|
class | StringView |
| StringView provides a non-owning view on an existing string. More...
|
|
class | MapUtilities |
| Utilities for Feature and ConsensusMap. More...
|
|
class | BaseModel |
| Abstract base class for 1-dimensional models. More...
|
|
class | BiGaussFitter1D |
| BiGaussian distribution fitter (1-dim.) approximated using linear interpolation. More...
|
|
class | BiGaussModel |
|
class | EGHTraceFitter |
| A RT Profile fitter using an Exponential Gaussian Hybrid background model. More...
|
|
class | ElutionModelFitter |
| Helper class for fitting elution models to features. More...
|
|
class | ElutionPeakDetection |
| Extracts chromatographic peaks from a mass trace. More...
|
|
class | EmgFitter1D |
| Exponentially modified gaussian distribution fitter (1-dim.) using Levenberg-Marquardt algorithm (Eigen implementation) for parameter optimization. More...
|
|
class | EmgModel |
|
class | EmgScoring |
| Scoring of an elution peak using an exponentially modified gaussian distribution model. More...
|
|
class | ExtendedIsotopeFitter1D |
| Extended isotope distribution fitter (1-dim.) approximated using linear interpolation. More...
|
|
class | ExtendedIsotopeModel |
|
struct | Summary |
| Summary of fitting results. More...
|
|
class | FeatureFinderAlgorithm |
| Abstract base class for FeatureFinder algorithms. More...
|
|
class | FeatureFinderAlgorithmMetaboIdent |
|
struct | FeatureFinderDefs |
| The purpose of this struct is to provide definitions of classes and typedefs which are used throughout all FeatureFinder classes.
More...
|
|
class | FeatureFinderAlgorithmPicked |
| FeatureFinderAlgorithm for picked peaks. More...
|
|
struct | FeatureFinderAlgorithmPickedHelperStructs |
| Wrapper struct for all the classes needed by the FeatureFinderAlgorithmPicked and the associated classes. More...
|
|
class | FeatureFinderIdentificationAlgorithm |
|
class | FeatureFinderMultiplexAlgorithm |
|
class | FeatureHypothesis |
| Internal structure used in FeatureFindingMetabo that keeps track of a feature hypothesis (isotope group hypothesis). More...
|
|
class | CmpMassTraceByMZ |
|
class | CmpHypothesesByScore |
|
struct | Range |
| Internal structure to store a lower and upper bound of an m/z range. More...
|
|
class | FeatureFindingMetabo |
| Method for the assembly of mass traces belonging to the same isotope pattern, i.e., that are compatible in retention times, mass-to-charge ratios, and isotope abundances. More...
|
|
class | Fitter1D |
| Abstract base class for all 1D-dimensional model fitter. More...
|
|
class | GaussFitter1D |
| Gaussian distribution fitter (1-dim.) approximated using linear interpolation. More...
|
|
class | GaussModel |
| Normal distribution approximated using linear interpolation. More...
|
|
class | GaussTraceFitter |
| Fitter for RT profiles using a Gaussian background model. More...
|
|
class | InterpolationModel |
| Abstract class for 1D-models that are approximated using linear interpolation. More...
|
|
class | IsotopeFitter1D |
| Isotope distribution fitter (1-dim.) approximated using linear interpolation. More...
|
|
class | IsotopeModel |
|
class | LevMarqFitter1D |
| Abstract class for 1D-model fitter using Levenberg-Marquardt algorithm for parameter optimization. More...
|
|
class | MassTraceDetection |
| A mass trace extraction method that gathers peaks similar in m/z and moving along retention time. More...
|
|
class | MaxLikeliFitter1D |
| Abstract base class for all 1D-model fitters using maximum likelihood optimization. More...
|
|
class | ModelDescription |
| Stores the name and parameters of a model. More...
|
|
class | MultiplexClustering |
| clusters results from multiplex filtering More...
|
|
class | MultiplexDeltaMasses |
| data structure for mass shift pattern More...
|
|
class | MultiplexDeltaMassesGenerator |
| generates complete list of all possible mass shifts due to isotopic labelling More...
|
|
class | MultiplexFilteredMSExperiment |
| data structure storing all peaks (and optionally their raw data points) of an experiment corresponding to one specific peak pattern More...
|
|
class | MultiplexFilteredPeak |
| data structure storing a single peak that passed all filters More...
|
|
class | MultiplexFiltering |
| base class for filtering centroided and profile data for peak patterns More...
|
|
class | MultiplexFilteringCentroided |
| filters centroided data for peak patterns More...
|
|
class | MultiplexFilteringProfile |
| filters centroided and profile data for peak patterns More...
|
|
class | MultiplexIsotopicPeakPattern |
| data structure for pattern of isotopic peaks More...
|
|
class | MultiplexSatelliteCentroided |
| data structure storing a single satellite peak More...
|
|
class | MultiplexSatelliteProfile |
| data structure storing a single satellite data point More...
|
|
class | PeakWidthEstimator |
| Rough estimation of the peak width at m/z. More...
|
|
class | SeedListGenerator |
| Generate seed lists for feature detection. More...
|
|
class | TraceFitter |
| Abstract fitter for RT profile fitting. More...
|
|
class | AbsoluteQuantitationMethodFile |
| File adapter for AbsoluteQuantitationMethod files. More...
|
|
class | AbsoluteQuantitationStandardsFile |
| Load files containing runConcentration data. More...
|
|
class | Base64 |
| Class to encode and decode Base64. More...
|
|
class | Bzip2Ifstream |
| Decompresses files which are compressed in the bzip2 format (*.bz2) More...
|
|
class | Bzip2InputStream |
| Implements the BinInputStream class of the xerces-c library in order to read bzip2 compressed XML files. More...
|
|
class | CachedmzML |
| An class that uses on-disk caching to read and write spectra and chromatograms. More...
|
|
class | ChromeleonFile |
| Load Chromeleon HPLC text file and save it into a MSExperiment . More...
|
|
class | CompressedInputSource |
| This class is based on xercesc::LocalFileInputSource. More...
|
|
class | ConsensusXMLFile |
| This class provides Input functionality for ConsensusMaps and Output functionality for alignments and quantitation. More...
|
|
class | ControlledVocabulary |
|
class | CsvFile |
| This class handles csv files. Currently only loading is implemented. Does NOT support comment lines! More...
|
|
class | CVMappingFile |
| Used to load CvMapping files. More...
|
|
class | MSDataAggregatingConsumer |
| Aggregates spectra by retention time. More...
|
|
class | MSDataCachedConsumer |
| Transforming and cached writing consumer of MS data. More...
|
|
class | MSDataChainingConsumer |
| Consumer class that passes all consumed data through a set of operations. More...
|
|
class | MSDataSqlConsumer |
| A data consumer that inserts MS data into a SQLite database. More...
|
|
class | MSDataStoringConsumer |
| Consumer class that simply stores the data. More...
|
|
class | MSDataTransformingConsumer |
| Transforming consumer of MS data. More...
|
|
class | MSDataWritingConsumer |
| Consumer class that writes MS data to disk using the mzML format. More...
|
|
class | PlainMSDataWritingConsumer |
| Consumer class that writes MS data to disk using the mzML format. More...
|
|
class | NoopMSDataWritingConsumer |
| Consumer class that perform no operation. More...
|
|
class | NoopMSDataConsumer |
| Consumer class that performs no operation. More...
|
|
class | SiriusFragmentAnnotation |
|
class | FullSwathFileConsumer |
| Abstract base class which can consume spectra coming from SWATH experiment stored in a single file. More...
|
|
class | RegularSwathFileConsumer |
| In-memory implementation of FullSwathFileConsumer. More...
|
|
class | CachedSwathFileConsumer |
| On-disk cached implementation of FullSwathFileConsumer. More...
|
|
class | MzMLSwathFileConsumer |
| On-disk mzML implementation of FullSwathFileConsumer. More...
|
|
class | DTA2DFile |
| DTA2D File adapter. More...
|
|
class | DTAFile |
| File adapter for DTA files. More...
|
|
class | EDTAFile |
|
class | ExperimentalDesignFile |
| Load an experimental design from a TSV file. (see ExperimentalDesign for details on the supported format) More...
|
|
class | FASTAFile |
| This class serves for reading in and writing FASTA files If the protein/gene sequence contains unusual symbols (such as translation end (*)), they will be kept! You can use aggregate methods load() and store() to read/write a set of protein sequences at the cost of memory. More...
|
|
class | FeatureXMLFile |
| This class provides Input/Output functionality for feature maps. More...
|
|
class | FileHandler |
| Facilitates file handling by file type recognition. More...
|
|
struct | FileTypes |
| Centralizes the file types recognized by FileHandler. More...
|
|
class | FileTypeList |
| holds a vector of known file types, e.g. as a way to specify supported input formats More...
|
|
class | FLASHDeconvFeatureFile |
| FLASHDeconv feature level output *.tsv, *.ms1ft (for Promex), *.feature (for TopPIC) file formats. More...
|
|
class | FLASHDeconvSpectrumFile |
| FLASHDeconv Spectrum level output *.tsv, *.msalign (for TopPIC) file formats. More...
|
|
class | GNPSMetaValueFile |
|
class | GNPSMGFFile |
|
class | GNPSQuantificationFile |
|
class | GzipIfstream |
| Decompresses files which are compressed in the gzip format (*.gzip) More...
|
|
class | GzipInputStream |
| Implements the BinInputStream class of the xerces-c library in order to read gzip compressed XML files. More...
|
|
class | IndexedMzMLDecoder |
| A class to analyze indexedmzML files and extract the offsets of individual tags. More...
|
|
class | MzMLSpectrumDecoder |
| A class to decode input strings that contain an mzML chromatogram or spectrum tag. More...
|
|
class | HDF5Connector |
| File adapter for HDF5 files. More...
|
|
class | IBSpectraFile |
| Implements the export of consensusmaps into the IBSpectra format used by isobar to load quantification results. More...
|
|
class | IdXMLFile |
| Used to load and store idXML files. More...
|
|
class | IndentedStream |
| Class for writing data which spans multiple lines with an indentation for each line (all except the first). More...
|
|
class | IndexedMzMLFileLoader |
| A class to load an indexedmzML file. More...
|
|
class | InspectInfile |
| Inspect input file adapter. More...
|
|
class | InspectOutfile |
|
class | KroenikFile |
| File adapter for Kroenik (HardKloer sibling) files. More...
|
|
class | MascotGenericFile |
| Read/write Mascot generic files (MGF). More...
|
|
class | MascotInfile |
| Mascot input file adapter. More...
|
|
class | MascotRemoteQuery |
| Class which handles the communication between OpenMS and the Mascot server. More...
|
|
class | MascotXMLFile |
| Used to load Mascot XML files. More...
|
|
class | MRMFeaturePickerFile |
| MRMFeaturePickerFile loads components and components groups parameters from a .csv file. More...
|
|
class | MRMFeatureQCFile |
| File adapter for MRMFeatureQC files. More...
|
|
class | MS2File |
|
class | MsInspectFile |
|
class | MSNumpressCoder |
| Class to encode and decode data encoded with MSNumpress. More...
|
|
class | MSPFile |
| File adapter for MSP files (NIST spectra library) More...
|
|
class | MSPGenericFile |
| Load MSP text file and save it into an MSExperiment More...
|
|
class | MSPGenericFile_friend |
|
class | MSstatsFile |
| File adapter for MSstats files. More...
|
|
class | MzDataFile |
| File adapter for MzData files. More...
|
|
class | MzIdentMLFile |
| File adapter for MzIdentML files. More...
|
|
class | MzMLFile |
| File adapter for MzML files. More...
|
|
class | MzQCFile |
| File adapter for mzQC files used to load and store mzQC files. More...
|
|
class | MzTabModification |
| Data model of MzTab files. More...
|
|
class | MzTabModificationList |
|
struct | MzTabModificationMetaData |
|
struct | MzTabAssayMetaData |
|
struct | MzTabMSRunMetaData |
|
struct | MzTabStudyVariableMetaData |
|
class | MzTabMetaData |
| all meta data of a mzTab file. Please refer to specification for documentation. More...
|
|
struct | MzTabProteinSectionRow |
| PRT - Protein section (Table based) More...
|
|
struct | MzTabPeptideSectionRow |
| PEP - Peptide section (Table based) More...
|
|
struct | MzTabPSMSectionRow |
| PSM - PSM section (Table based) More...
|
|
struct | MzTabSmallMoleculeSectionRow |
| SML Small molecule section (table based) More...
|
|
struct | MzTabNucleicAcidSectionRow |
| NUC - Nucleic acid section (table-based) More...
|
|
struct | MzTabOligonucleotideSectionRow |
| OLI - Oligonucleotide section (table-based) More...
|
|
struct | MzTabOSMSectionRow |
| OSM - OSM (oligonucleotide-spectrum match) section (table-based) More...
|
|
class | MzTab |
| Data model of MzTab files. Please see the official MzTab specification at https://code.google.com/p/mztab/. More...
|
|
class | MzTabDouble |
|
class | MzTabDoubleList |
|
class | MzTabInteger |
|
class | MzTabIntegerList |
|
class | MzTabBoolean |
|
class | MzTabString |
|
class | MzTabParameter |
|
class | MzTabParameterList |
|
class | MzTabStringList |
|
class | MzTabSpectraRef |
|
struct | MzTabSoftwareMetaData |
|
struct | MzTabSampleMetaData |
|
struct | MzTabCVMetaData |
|
struct | MzTabInstrumentMetaData |
|
struct | MzTabContactMetaData |
|
class | MzTabBase |
|
class | MzTabFile |
| File adapter for MzTab files. More...
|
|
struct | CompareMzTabMMatchRef |
| Data model of MzTabM files. Please see the official MzTabM specification at https://github.com/HUPO-PSI/mzTab/tree/master/specification_document-releases/2_0-Metabolomics-Release. More...
|
|
class | MzTabMAssayMetaData |
| MztabM Assay Metadata. More...
|
|
class | MzTabMMSRunMetaData |
| MztabM MSRun Metadata. More...
|
|
class | MzTabMStudyVariableMetaData |
| MztabM StudyVariable Metadata. More...
|
|
class | MzTabMDatabaseMetaData |
| MztabM Database Metadata. More...
|
|
class | MzTabMMetaData |
| MztabM Metadata. More...
|
|
class | MzTabMSmallMoleculeSectionRow |
| SML Small molecule section (mztab-m) More...
|
|
class | MzTabMSmallMoleculeFeatureSectionRow |
| SMF Small molecule feature section (mztab-m) More...
|
|
class | MzTabMSmallMoleculeEvidenceSectionRow |
| SME Small molecule evidence section (mztab-m) More...
|
|
class | MzTabM |
| Data model of MzTab-M files Please see the MzTab-M specification at https://github.com/HUPO-PSI/mzTab/blob/master/specification_document-releases/2_0-Metabolomics-Release/mzTab_format_specification_2_0-M_release.adoc#use-cases-for-mztab. More...
|
|
class | MzTabMFile |
| File adapter for MzTab-M files. More...
|
|
class | MzXMLFile |
| File adapter for MzXML 3.1 files. More...
|
|
class | OMSFile |
| This class supports reading and writing of OMS files. More...
|
|
class | OMSSACSVFile |
|
class | OMSSAXMLFile |
| Used to load OMSSAXML files. More...
|
|
class | FeatureFileOptions |
| Options for loading files containing features. More...
|
|
class | PeakFileOptions |
| Options for loading files containing peak data. More...
|
|
class | OSWFile |
| This class serves for reading in and writing OpenSWATH OSW files. More...
|
|
struct | ToolInfo |
| A struct to pass information about the tool as one parameter. More...
|
|
class | ParamCTDFile |
| Serializes a Param class in paramCTD file format. Note: only storing is currently possible. More...
|
|
class | ParamCWLFile |
| Exports .cwl files. More...
|
|
class | ParamJSONFile |
| Load from JSON (in a Common Workflow Language (CWL) compatible way) into the Param class. More...
|
|
class | ParamXMLFile |
| The file pendant of the Param class used to load and store the param datastructure as paramXML. More...
|
|
class | PeakTypeEstimator |
| Estimates if the data of a spectrum is raw data or peak data. More...
|
|
class | PepNovoInfile |
|
class | PepNovoOutfile |
| Representation of a PepNovo output file. More...
|
|
class | PepXMLFile |
| Used to load and store PepXML files. More...
|
|
class | PepXMLFileMascot |
| Used to load Mascot PepXML files. More...
|
|
class | PercolatorInfile |
| Class for storing Percolator tab-delimited input files. More...
|
|
class | PercolatorOutfile |
| Class for reading Percolator tab-delimited output files. More...
|
|
class | ProtXMLFile |
| Used to load (storing not supported, yet) ProtXML files. More...
|
|
class | PTMXMLFile |
| Used to load and store PTMXML files. More...
|
|
class | QcMLFile |
| File adapter for QcML files used to load and store QcML files. More...
|
|
class | SequestInfile |
|
class | SequestOutfile |
| Representation of a Sequest output file. More...
|
|
class | SpecArrayFile |
| File adapter for SpecArray (.pepList) files. More...
|
|
class | SqliteConnector |
| File adapter for Sqlite files. More...
|
|
class | SqMassFile |
| An class that uses on-disk SQLite database to read and write spectra and chromatograms. More...
|
|
class | SVOutStream |
| Stream class for writing to comma/tab/...-separated values files. More...
|
|
class | SwathFile |
| File adapter for Swath files. More...
|
|
class | TextFile |
|
class | ToolDescriptionFile |
| File adapter for ToolDescriptor files. More...
|
|
class | TraMLFile |
| File adapter for HUPO PSI TraML files. More...
|
|
class | TransformationXMLFile |
| Used to load and store TransformationXML files. More...
|
|
class | TriqlerFile |
| File adapter for Triqler files. More...
|
|
class | UnimodXMLFile |
| Used to load XML files from unimod.org files. More...
|
|
class | XMLValidator |
| Validator for XML files. More...
|
|
class | XMassFile |
|
class | XQuestResultXMLFile |
| Used to load and store xQuest result files. More...
|
|
class | XTandemInfile |
| XTandem input file. More...
|
|
class | XTandemXMLFile |
| Used to load XTandemXML files. More...
|
|
class | ZlibCompression |
| Compresses and uncompresses data using zlib. More...
|
|
class | FAIMSHelper |
| Helper functions for FAIMS data. More...
|
|
class | IMDataConverter |
| This class converts PeakMaps and MSSpectra from/to different IM/FAIMS storage models. More...
|
|
class | IMTypes |
|
class | BaseFeature |
| A basic LC-MS feature. More...
|
|
class | BinnedSpectrum |
| This is a binned representation of a PeakSpectrum. More...
|
|
class | ChromatogramPeak |
| A 1-dimensional raw data point or peak for chromatograms. More...
|
|
class | ChromatogramTools |
| Conversion class to convert chromatograms. More...
|
|
class | ConsensusFeature |
| A consensus feature spanning multiple LC-MS/MS experiments. More...
|
|
class | ConsensusMap |
| A container for consensus elements. More...
|
|
class | MapConversion |
|
class | DimBase |
| A base class for a dimension which represents a certain unit (e.g. RT or m/z). Derived classes implement virtual functions, which receive a well-defined data type, e.g. a Feature, and return the appropriate value for their dimension (the DimRT class would return the RT of the feature). This makes it possible to extract dimensions using a runtime configuration of DimBase instances. Very useful when mapping units (RT, m/z) to axis when plotting etc. More...
|
|
class | DimRT |
|
class | DimMZ |
|
class | DimINT |
|
class | DimIM |
|
class | DimMapper |
| Allows dynamical switching (at runtime) between a dimension (RT, m/z, int, IM, etc) and X,Y,Z coordinates. You can set either of them, and query the other. The Mapping is stored internally. The unit to which the X,Y,Z coordinates currently mapped onto can also be queried (useful for axis labels etc). More...
|
|
class | Area |
|
struct | DPeak |
| Metafunction to choose among Peak1D respectively Peak2D through a template argument. More...
|
|
class | Feature |
| An LC-MS feature. More...
|
|
class | FeatureHandle |
| Representation of a Peak2D, RichPeak2D or Feature . More...
|
|
struct | AnnotationStatistics |
|
class | FeatureMap |
| A container for features. More...
|
|
class | MassTrace |
| A container type that gathers peaks similar in m/z and moving along retention time. More...
|
|
class | MobilityPeak1D |
| A 1-dimensional raw data mobility point or peak. The unit (ms, 1/K_0, etc) is implicit. More...
|
|
class | MobilityPeak2D |
| A 2-dimensional raw data point or peak. More...
|
|
class | Mobilogram |
| The representation of a 1D ion mobilogram. More...
|
|
class | MRMFeature |
| A multi-chromatogram MRM feature. More...
|
|
class | MRMTransitionGroup |
| The representation of a group of transitions in a targeted proteomics experiment. More...
|
|
class | MSChromatogram |
| The representation of a chromatogram. More...
|
|
class | MSExperiment |
| In-Memory representation of a mass spectrometry run. More...
|
|
class | MSSpectrum |
| The representation of a 1D spectrum. More...
|
|
class | OnDiscMSExperiment |
| Representation of a mass spectrometry experiment on disk. More...
|
|
class | Peak1D |
| A 1-dimensional raw data point or peak. More...
|
|
class | Peak2D |
| A 2-dimensional raw data point or peak. More...
|
|
struct | PeakIndex |
| Index of a peak or feature. More...
|
|
struct | RangeBase |
| Base class for a simple range with minimum and maximum. More...
|
|
struct | RangeRT |
|
struct | RangeMZ |
|
struct | RangeIntensity |
|
struct | RangeMobility |
|
class | RangeManager |
| Handles the management of a multidimensional range, e.g. RangeMZ and RangeIntensity for spectra. More...
|
|
class | RangeManagerContainer |
|
class | HasMetaValue |
| Predicate that determines if a class has a certain metavalue. More...
|
|
class | InRTRange |
| Predicate that determines if a spectrum lies inside/outside a specific retention time range. More...
|
|
class | InMSLevelRange |
| Predicate that determines if a spectrum lies inside/outside a specific MS level set. More...
|
|
class | HasScanMode |
| Predicate that determines if a spectrum has a certain scan mode. More...
|
|
class | HasScanPolarity |
| Predicate that determines if a spectrum has a certain scan polarity. More...
|
|
class | IsEmptySpectrum |
| Predicate that determines if a spectrum is empty. More...
|
|
class | IsZoomSpectrum |
| Predicate that determines if a spectrum is a zoom (enhanced resolution) spectrum. More...
|
|
class | HasActivationMethod |
| Predicate that determines if a spectrum was generated using any activation method given in the constructor list. More...
|
|
class | InPrecursorMZRange |
| Predicate that determines if a spectrum's precursor is within a certain m/z range. More...
|
|
class | HasPrecursorCharge |
| Predicate that determines if a spectrum has a certain precursor charge as given in the constructor list. More...
|
|
class | InMzRange |
| Predicate that determines if a peak lies inside/outside a specific m/z range. More...
|
|
class | InIntensityRange |
| Predicate that determines if a peak lies inside/outside a specific intensity range. More...
|
|
class | IsInCollisionEnergyRange |
| Predicate that determines if an MSn spectrum was generated with a collision energy in the given range. More...
|
|
class | IsInIsolationWindowSizeRange |
| Predicate that determines if the width of the isolation window of an MSn spectrum is in the given range. More...
|
|
class | IsInIsolationWindow |
| Predicate that determines if the isolation window covers ANY of the given m/z values. More...
|
|
class | RichPeak2D |
| A 2-dimensional raw data point or peak with meta information. More...
|
|
class | BSpline2d |
| b spline interpolation More...
|
|
class | CubicSpline2d |
| cubic spline interpolation as described in R.L. Burden, J.D. Faires, Numerical Analysis, 4th ed. PWS-Kent, 1989, ISBN 0-53491-585-X, pp. 126-131. More...
|
|
class | EmgGradientDescent |
| Compute the area, background and shape metrics of a peak. More...
|
|
class | EmgGradientDescent_friend |
|
class | AbsoluteQuantitationStandards |
| AbsoluteQuantitationStandards is a class to handle the relationship between runs, components, and their actual concentrations. More...
|
|
class | Acquisition |
| Information about one raw data spectrum that was combined with several other raw data spectra. More...
|
|
class | AcquisitionInfo |
| Description of the combination of raw data to a single spectrum. More...
|
|
class | ChromatogramSettings |
| Representation of chromatogram settings, e.g. SRM/MRM chromatograms. More...
|
|
class | ContactPerson |
| Contact person information. More...
|
|
class | CVTerm |
| Representation of controlled vocabulary term. More...
|
|
class | CVTermList |
| Representation of controlled vocabulary term list. More...
|
|
class | CVTermListInterface |
| Interface to the controlled vocabulary term list. More...
|
|
class | DataProcessing |
| Description of the applied preprocessing steps. More...
|
|
class | Digestion |
| Meta information about digestion of a sample. More...
|
|
class | DocumentIdentifier |
| Manage source document information. More...
|
|
class | ExperimentalDesign |
| Representation of an experimental design in OpenMS. Instances can be loaded with the ExperimentalDesignFile class. More...
|
|
class | ExperimentalSettings |
| Description of the experimental settings. More...
|
|
class | Gradient |
| Representation of a HPLC gradient. More...
|
|
class | HPLC |
| Representation of a HPLC experiment. More...
|
|
class | IdentificationData |
|
class | IdentificationDataConverter |
|
class | Instrument |
| Description of a MS instrument. More...
|
|
class | InstrumentSettings |
| Description of the settings a MS Instrument was run with. More...
|
|
class | IonDetector |
| Description of a ion detector (part of a MS Instrument) More...
|
|
class | IonSource |
| Description of an ion source (part of a MS Instrument) More...
|
|
class | MassAnalyzer |
| Description of a mass analyzer (part of a MS Instrument) More...
|
|
class | MetaInfo |
| A Type-Name-Value tuple class. More...
|
|
class | MetaInfoDescription |
| Description of the meta data arrays of MSSpectrum. More...
|
|
class | MetaInfoInterface |
| Interface for classes that can store arbitrary meta information (Type-Name-Value tuples). More...
|
|
class | MetaInfoInterfaceUtils |
| Utilities operating on containers inheriting from MetaInfoInterface. More...
|
|
class | MetaInfoRegistry |
| Registry which assigns unique integer indices to strings. More...
|
|
class | Modification |
| Meta information about chemical modification of a sample. More...
|
|
class | PeptideEvidence |
| Representation of a peptide evidence. More...
|
|
class | PeptideHit |
| Representation of a peptide hit. More...
|
|
class | PeptideIdentification |
| Represents the peptide hits for a spectrum. More...
|
|
class | Precursor |
| Precursor meta information. More...
|
|
class | Product |
| Product meta information. More...
|
|
class | ProteinHit |
| Representation of a protein hit. More...
|
|
class | ProteinIdentification |
| Representation of a protein identification run. More...
|
|
class | Sample |
| Meta information about the sample. More...
|
|
class | SampleTreatment |
| Base class for sample treatments (Digestion, Modification, Tagging, ...) More...
|
|
struct | ScanWindow |
| Scan window description. More...
|
|
class | Software |
| Description of the software used for processing. More...
|
|
class | SourceFile |
| Description of a file location, used to store the origin of (meta) data. More...
|
|
class | SpectrumLookup |
| Helper class for looking up spectra based on different attributes. More...
|
|
class | SpectrumMetaDataLookup |
| Helper class for looking up spectrum meta data. More...
|
|
class | SpectrumSettings |
| Representation of 1D spectrum settings. More...
|
|
class | Tagging |
| Meta information about tagging of a sample e.g. ICAT labeling. More...
|
|
class | AverageLinkage |
| AverageLinkage ClusterMethod. More...
|
|
class | ClusterAnalyzer |
| Bundles analyzing tools for a clustering (given as sequence of BinaryTreeNode's) More...
|
|
class | ClusterFunctor |
| Base class for cluster functors. More...
|
|
class | ClusterHierarchical |
| Hierarchical clustering with generic clustering functions. More...
|
|
class | UnnormalizedComparator |
| Exception thrown if clustering is attempted without a normalized compare functor. More...
|
|
class | ClusteringGrid |
| data structure to store 2D data to be clustered e.g. (m/z, retention time) coordinates from multiplex filtering More...
|
|
class | CompleteLinkage |
| CompleteLinkage ClusterMethod. More...
|
|
class | EuclideanSimilarity |
| CompareFunctor for 2Dpoints. More...
|
|
class | GridBasedCluster |
| basic data structure for clustering More...
|
|
class | MinimumDistance |
| basic data structure for distances between clusters More...
|
|
class | GridBasedClustering |
| 2D hierarchical clustering implementation optimized for large data sets containing many small clusters i.e. dimensions of clusters << dimension of entire dataset More...
|
|
class | HashGrid |
| Container for (2-dimensional coordinate, value) pairs. More...
|
|
class | SingleLinkage |
| SingleLinkage ClusterMethod. More...
|
|
class | GridSearch |
|
class | NonNegativeLeastSquaresSolver |
| Wrapper for a non-negative least squares (NNLS) solver. More...
|
|
class | SimpleSVM |
| Simple interface to support vector machines for classification and regression (via LIBSVM). More...
|
|
class | MorphologicalFilter |
| This class implements baseline filtering operations using methods from mathematical morphology. More...
|
|
class | InternalCalibration |
| A mass recalibration method using linear/quadratic interpolation (robust/weighted) of given reference masses. More...
|
|
class | MZTrafoModel |
| Create and apply models of a mass recalibration function. More...
|
|
class | PrecursorCorrection |
| This class provides methods for precursor correction. More...
|
|
class | PeakPickerHiRes |
| This class implements a fast peak-picking algorithm best suited for high resolution MS data (FT-ICR-MS, Orbitrap). In high resolution data, the signals of ions with similar mass-to-charge ratios (m/z) exhibit little or no overlapping and therefore allow for a clear separation. Furthermore, ion signals tend to show well-defined peak shapes with narrow peak width. More...
|
|
struct | PeakCandidate |
| A small structure to hold peak candidates. More...
|
|
class | PeakPickerIterative |
| This class implements a peak-picking algorithm for high-resolution MS data (specifically designed for TOF-MS data). More...
|
|
class | Deisotoper |
|
class | FeatureOverlapFilter |
|
class | NLargest |
| NLargest removes all but the n largest peaks. More...
|
|
class | ThresholdMower |
| Removes all peaks below an intensity threshold. More...
|
|
class | WindowMower |
| Retains the highest peaks in a sliding or jumping window. More...
|
|
class | IDFilter |
| Collection of functions for filtering peptide and protein identifications. More...
|
|
class | DataFilters |
| DataFilter array providing some convenience functions. More...
|
|
class | SplineInterpolatedPeaks |
| Data structure for spline interpolation of MS1 spectra and chromatograms. More...
|
|
class | SplinePackage |
| fundamental data structure for SplineInterpolatedPeaks More...
|
|
class | SignalToNoiseEstimator |
| This class represents the abstract base class of a signal to noise estimator. More...
|
|
class | SignalToNoiseEstimatorMeanIterative |
| Estimates the signal/noise (S/N) ratio of each data point in a scan based on an iterative scheme which discards high intensities. More...
|
|
class | SignalToNoiseEstimatorMedian |
| Estimates the signal/noise (S/N) ratio of each data point in a scan by using the median (histogram based) More...
|
|
class | SignalToNoiseEstimatorMedianRapid |
| Estimates the signal/noise (S/N) ratio of each data point in a scan by using the median (window based) More...
|
|
class | LinearResampler |
| Linear Resampling of raw data. More...
|
|
class | LinearResamplerAlign |
| Linear Resampling of raw data with alignment. More...
|
|
class | Normalizer |
| Normalizes the peak intensities spectrum-wise. More...
|
|
class | RankScaler |
| Scales each peak by ranking the peaks per spectrum and assigning intensity according to rank. More...
|
|
class | SqrtScaler |
| Scales the intensity of peaks to the sqrt. More...
|
|
class | GaussFilter |
| This class represents a Gaussian lowpass-filter which works on uniform as well as on non-uniform profile data. More...
|
|
class | GaussFilterAlgorithm |
| This class represents a Gaussian lowpass-filter which works on uniform as well as on non-uniform profile data. More...
|
|
class | LowessSmoothing |
| LOWESS (locally weighted scatterplot smoothing). More...
|
|
class | SavitzkyGolayFilter |
| Computes the Savitzky-Golay filter coefficients using QR decomposition. More...
|
|
class | SpectraMerger |
| Merges blocks of MS or MS2 spectra. More...
|
|
class | Contaminants |
| This class is a metric for the QualityControl TOPP tool. More...
|
|
class | DBSuitability |
| This class holds the functionality of calculating the database suitability. More...
|
|
class | DBSuitability_friend |
|
class | FeatureSummary |
|
class | FragmentMassError |
|
class | FWHM |
| QC metric calculating (un)calibrated m/z error. More...
|
|
class | IdentificationSummary |
|
class | MissedCleavages |
| This class is a metric for the QualityControl TOPP Tool. More...
|
|
class | Ms2IdentificationRate |
| This class is a metric for the QualityControl-ToppTool. More...
|
|
class | Ms2SpectrumStats |
| QC metric to determine the number of MS2 scans per MS1 scan over RT. More...
|
|
class | MzCalibration |
| QC metric calculating (un)calibrated m/z error. More...
|
|
class | PeptideMass |
| QC metric calculating theoretical mass of a peptide sequence. More...
|
|
class | PSMExplainedIonCurrent |
|
class | QCBase |
| This class serves as an abstract base class for all QC classes. More...
|
|
class | RTAlignment |
| Take the original retention time before map alignment and use the alignment's trafoXML for calculation of the new alignment retention times. More...
|
|
class | SpectrumCount |
|
class | TIC |
|
class | ExternalProcess |
| A wrapper around QProcess to conveniently start an external program and forward its outputs. More...
|
|
class | File |
| Basic file handling operations. More...
|
|
class | FileWatcher |
| Watcher that monitors file changes. More...
|
|
class | JavaInfo |
| Detect Java and retrieve information. More...
|
|
class | NetworkGetRequest |
|
class | PythonInfo |
| Detect Python and retrieve information. More...
|
|
class | RWrapper |
| R-Wrapper Class. More...
|
|
class | StopWatch |
| This class is used to determine the current process' CPU (user and/or kernel) and wall time. More...
|
|
class | SysInfo |
| Some functions to get system information. More...
|
|
class | UpdateCheck |
| Helper Functions to perform an update query to the OpenMS REST server. More...
|
|
class | Annotation1DCaret |
| An annotation item which paints a set of carets on the canvas. More...
|
|
class | Annotation1DDistanceItem |
| An annotation item which represents a measured distance between two peaks. More...
|
|
class | Annotation1DItem |
| An abstract class acting as an interface for the different 1D annotation items. More...
|
|
class | Annotation1DPeakItem |
| A peak annotation item. More...
|
|
class | Annotation1DTextItem |
| An annotation item which represents an arbitrary text on the canvas. More...
|
|
class | Annotation1DVerticalLineItem |
| An annotation item which represents a vertical line (or more precisely a line along the gravity axis, i.e. it could also be horizontal) and text label on top. More...
|
|
class | Annotations1DContainer |
| Container for annotations to content of Plot1DCanvas. More...
|
|
class | FLASHDeconvWizardBase |
| Main window of the FLASHDeconvWizard tool. More...
|
|
class | INIFileEditorWindow |
| shows the ParamEditor widget in a QMainWindow with a toolbar More...
|
|
class | QApplicationTOPP |
| Extension to the QApplication for running TOPPs GUI tools. More...
|
|
class | SwathWizardBase |
| Main window of the SwathWizard tool. More...
|
|
class | TOPPASBase |
| Main window of the TOPPAS tool. More...
|
|
class | TOPPViewBase |
| Main window of TOPPView tool. More...
|
|
class | AxisPainter |
| Draws a coordinate axis. It has only static methods, that's why the constructor is private. More...
|
|
class | AxisTickCalculator |
| Calculates ticks for a given value range. More...
|
|
class | AxisWidget |
| Widget that represents an axis of a graph. More...
|
|
class | ColorSelector |
| A widget for selecting a color. More...
|
|
class | DataTabBase |
| all tabs need to implement this interface More...
|
|
class | DataSelectionTabs |
| A tabbed view, to browse lists of spectra or identifications. More...
|
|
class | DataFilterDialog |
| Dialog for creating and changing a DataFilter. More...
|
|
class | FeatureEditDialog |
| Dialog for editing a feature. More...
|
|
class | HistogramDialog |
| Dialog that show a HistogramWidget. More...
|
|
class | LayerStatisticsDialog |
| Dialog showing statistics about the data of the current layer. More...
|
|
class | ListFilterDialog |
| Dialog for creating and changing a DataFilter. More...
|
|
class | Plot1DGoToDialog |
| simple goto/set visible area dialog for exact placement of the viewing window More...
|
|
class | Plot2DGoToDialog |
| GoTo dialog used to zoom to a m/z and retention time range or to a feature. More...
|
|
class | SaveImageDialog |
| Dialog for saving an image. More...
|
|
class | SpectrumAlignmentDialog |
| Lets the user select two spectra and set the parameters for the spectrum alignment. More...
|
|
class | TheoreticalSpectrumGenerationDialog |
| Dialog which allows to enter an AA or NA sequence and generates a theoretical spectrum for it. More...
|
|
class | ToolsDialog |
| TOPP tool selection dialog. More...
|
|
class | TOPPASInputFileDialog |
| Dialog which allows to specify an input file. More...
|
|
class | TOPPASInputFilesDialog |
| Dialog which allows to specify a list of input files. More...
|
|
class | TOPPASIOMappingDialog |
| Dialog which allows to configure the input/output parameter mapping of an edge. More...
|
|
class | TOPPASOutputFilesDialog |
| Dialog which allows to specify the directory for the output files. More...
|
|
class | TOPPASToolConfigDialog |
| TOPP tool configuration dialog. More...
|
|
class | TOPPASVertexNameDialog |
| Dialog which allows to change the name of an input/output vertex. More...
|
|
class | TOPPViewOpenDialog |
| Dataset opening options for TOPPView. More...
|
|
class | DIATreeTab |
| Hierarchical visualization and selection of spectra. More...
|
|
class | EnhancedTabBar |
| Convenience tab bar implementation. More...
|
|
class | SignalProvider |
| provides a signal mechanism (by deriving from QObject) for classes which are not allowed to have signals themselves. More...
|
|
class | EnhancedTabBarWidgetInterface |
| Widgets that are placed into an EnhancedTabBar must implement this interface. More...
|
|
class | EnhancedWorkspace |
|
class | GUIProgressLoggerImpl |
| Implements a GUI version of the ProgressLoggerImpl. More...
|
|
class | HistogramWidget |
|
class | InputFile |
| A simple widget with a line-edit and a browse button to choose filenames. More...
|
|
class | IPeptideIds |
| Abstract base class which defines an interface for PeptideIdentifications. More...
|
|
class | LayerData1DBase |
| Base class for all 1D layers, a special case of LayerData. More...
|
|
class | LayerData1DChrom |
|
class | LayerData1DIonMobility |
|
class | LayerData1DPeak |
|
struct | LayerDataDefs |
|
class | LayerDataBase |
| Class that stores the data for one layer. More...
|
|
class | LayerAnnotatorBase |
|
class | LayerAnnotatorPeptideID |
|
class | LayerAnnotatorAMS |
|
class | LayerAnnotatorOSW |
|
class | LayerDataChrom |
| Class that stores the data for one layer of type Chromatogram. More...
|
|
class | LayerDataConsensus |
| Class that stores the data for one layer of type ConsensusMap. More...
|
|
class | LayerDataFeature |
| Class that stores the data for one layer of type FeatureMap. More...
|
|
class | LayerDataIdent |
| Class that stores the data for one layer of type PeptideIdentifications. More...
|
|
class | LayerDataIonMobility |
| Class that stores the data for one layer of type IonMobility. More...
|
|
class | LayerDataPeak |
| Class that stores the data for one layer of type PeakMap. More...
|
|
class | LayerListView |
| Pimped QListView for Layers of a Canvas. More...
|
|
class | ListEditor |
| Editor for editing int, double and string lists (including output and input file lists) More...
|
|
class | LogWindow |
| A log window (QTextEdit) with convenience functions. More...
|
|
class | MetaDataBrowser |
| A meta data visualization widget. More...
|
|
class | ExternalProcessMBox |
| A wrapper around ExternalProcess to conveniently show a MessageBox when an error occurs. More...
|
|
class | MultiGradient |
| A gradient of multiple colors and arbitrary distances between colors. More...
|
|
class | MultiGradientSelector |
| A widget witch allows constructing gradients of multiple colors. More...
|
|
class | OutputDirectory |
| A simple widget with a line-edit and a browse button to choose filenames. More...
|
|
class | Painter1DBase |
| A base class for painting all items from a data layer (as supported by class derived from here) onto a 1D Canvas. More...
|
|
class | Painter1DPeak |
| Painter1D for spectra. More...
|
|
class | Painter1DChrom |
| Painter1D for chromatograms. More...
|
|
class | Painter1DIonMobility |
| Painter1D for mobilograms. More...
|
|
class | Painter2DBase |
| A base class for painting all items from a data layer (as supported by class derived from here) onto a 2D Canvas. More...
|
|
class | Painter2DPeak |
| Painter2D for spectra. More...
|
|
class | Painter2DChrom |
| Painter2D for chromatograms. More...
|
|
class | Painter2DIonMobility |
| Painter2D for ion mobilograms. More...
|
|
class | Painter2DFeature |
| Painter2D for Features. More...
|
|
class | Painter2DConsensus |
| Painter2D for ConsensusFeatures. More...
|
|
class | Painter2DIdent |
| Painter2D for Identifications. More...
|
|
class | PainterBase |
| An empty base class with some static convenience functions. More...
|
|
class | ParamEditor |
| A GUI for editing or viewing a Param object. More...
|
|
class | Gravitator |
| Manipulates X or Y component of points in the X-Y plane, by assuming one axis (either X or Y axis) has gravity acting upon it. More...
|
|
class | Plot1DCanvas |
| Canvas for visualization of one or several spectra. More...
|
|
class | Plot1DWidget |
| Widget for visualization of several spectra. More...
|
|
class | Plot2DCanvas |
| Canvas for 2D-visualization of peak map, feature map and consensus map data. More...
|
|
class | Plot2DWidget |
| Widget for 2D-visualization of peak map and feature map data. More...
|
|
class | Plot3DCanvas |
| Canvas for 3D-visualization of peak map data. More...
|
|
class | Plot3DOpenGLCanvas |
| OpenGL Canvas for 3D-visualization of map data. More...
|
|
class | Plot3DWidget |
| Widget for 3D-visualization of map data. More...
|
|
class | LayerStack |
|
class | PlotCanvas |
| Base class for visualization canvas classes. More...
|
|
class | PlotWidget |
| Base class for spectrum widgets. More...
|
|
class | RecentFilesMenu |
| Manages recent files opened by the user and provides a QMenu to go with it. More...
|
|
class | SpectraIDViewTab |
| Tabular visualization / selection of identified spectra. More...
|
|
class | SpectraTreeTab |
| Hierarchical visualization and selection of spectra. More...
|
|
class | SwathLibraryStats |
| A multi-tabbed widget for the SwathWizard offering setting of parameters, input-file specification and running Swath and more. More...
|
|
class | TableView |
| A better QTable for TOPPView, which supports exporting to TSV and conveniently adding data to cells and headers. More...
|
|
class | TOPPASEdge |
| An edge representing a data flow in TOPPAS. More...
|
|
class | TOPPASInputFileListVertex |
| A vertex representing an input file list. More...
|
|
class | TOPPASMergerVertex |
| A special vertex that allows to merge several inputs. More...
|
|
class | TOPPASOutputFileListVertex |
| A vertex representing an output file list. More...
|
|
class | TOPPASResource |
| Represents a data resource for TOPPAS workflows. More...
|
|
class | TOPPASResources |
| A dictionary mapping string keys to lists of TOPPASResource objects. More...
|
|
class | FakeProcess |
| A FakeProcess class. More...
|
|
class | TOPPASScene |
|
class | TOPPASSplitterVertex |
| A special vertex that allows to split a list of inputs. More...
|
|
class | TOPPASToolVertex |
| A vertex representing a TOPP tool. More...
|
|
class | TOPPASTreeView |
| Tree view implementation for the list of TOPP tools. More...
|
|
class | TOPPASVertex |
| The base class of the different vertex classes. More...
|
|
class | TOPPASWidget |
| Widget visualizing and allowing to edit TOPP pipelines. More...
|
|
class | TOPPViewMenu |
| The file menu items for TOPPView. More...
|
|
class | TreeView |
| A better QTreeWidget for TOPPView, which supports header context menu and conveniently adding/getting headers names. More...
|
|
class | TVControllerBase |
| Base behavior for different visualizaton modules in TOPPView. More...
|
|
class | TVDIATreeTabController |
| Behavior of TOPPView in spectra view mode. More...
|
|
class | TVIdentificationViewController |
| Behavior of TOPPView in identification mode. More...
|
|
class | TVSpectraViewController |
| Behavior of TOPPView in spectra view mode. More...
|
|
class | TVToolDiscovery |
| Scans for tools and generates a param for each asynchronously. More...
|
|
struct | RangeStats |
| Struct representing the statistics about a set of values. More...
|
|
struct | StatsCounter |
| a simple counting struct, for non-numerical occurrences of meta-values More...
|
|
struct | RangeStatsType |
| Origin and name of a statistic. More...
|
|
class | LayerStatistics |
| Compute summary statistics (count/min/max/avg) about a container, e.g. intensity, charge, meta values, ... More...
|
|
class | LayerStatisticsPeakMap |
| Computes statistics and distributions for a PeakMap
More...
|
|
class | LayerStatisticsFeatureMap |
| Computes statistics and distributions for a PeakMap. More...
|
|
class | LayerStatisticsConsensusMap |
| Computes statistics and distributions for a PeakMap. More...
|
|
class | LayerStatisticsIdent |
| Computes statistics and distributions for a vector<PeptideIdentifications> More...
|
|
class | LayerStoreData |
| Base class to store either the currently visible or all data of a canvas. More...
|
|
class | LayerStoreDataPeakMapVisible |
| Visitor which can save a visible piece of data; subsequently the data can be stored to a file. More...
|
|
class | LayerStoreDataPeakMapAll |
| Visitor which can save a full experiment; subsequently the data can be stored to a file. More...
|
|
class | LayerStoreDataFeatureMapVisible |
| Visitor which can save a visible piece of data; subsequently the data can be stored to a file. More...
|
|
class | LayerStoreDataFeatureMapAll |
| Visitor which can save a full FeatureMap; subsequently the data can be stored to a file. More...
|
|
class | LayerStoreDataConsensusMapVisible |
| Visitor which can save a visible piece of data; subsequently the data can be stored to a file. More...
|
|
class | LayerStoreDataConsensusMapAll |
| Visitor which can save a full ConsensusMap; subsequently the data can be stored to a file. More...
|
|
class | LayerStoreDataIdentVisible |
| Visitor which can save a visible piece of data; subsequently the data can be stored to a file. More...
|
|
class | LayerStoreDataIdentAll |
| Visitor which can save a full set of Identifications; subsequently the data can be stored to a file. More...
|
|
class | AcquisitionInfoVisualizer |
| Class that displays all meta information for AcquisitionInfo objects. More...
|
|
class | AcquisitionVisualizer |
| Class that displays all meta information for Acquisition objects. More...
|
|
class | BaseVisualizer |
| A base class for all visualizer classes. More...
|
|
class | BaseVisualizerGUI |
| A base class for all visualizer classes. More...
|
|
class | ContactPersonVisualizer |
| Class that displays all meta information for ContactPerson objects. More...
|
|
class | DataProcessingVisualizer |
| Class that displays all meta information for DataProcessing objects. More...
|
|
class | DigestionVisualizer |
| Class that displays all meta information of digestion objects. More...
|
|
class | DocumentIdentifierVisualizer |
| Class that displays all meta information for DocumentIdentifier objects. More...
|
|
class | ExperimentalSettingsVisualizer |
| Class that displays all meta information for ExperimentalSettings objects. More...
|
|
class | GradientVisualizer |
| GradientVisualizer is a visualizer class for objects of type gradient. More...
|
|
class | HPLCVisualizer |
| Class that displays all meta information for HPLC objects. More...
|
|
class | InstrumentSettingsVisualizer |
| Class that displays all meta information for InstrumentSettings objects. More...
|
|
class | InstrumentVisualizer |
| Class that displays all meta information for an MS instrument. More...
|
|
class | IonDetectorVisualizer |
| Class that displays all meta information for IonDetector objects. More...
|
|
class | IonSourceVisualizer |
| Class that displays all meta information for IonSource objects. More...
|
|
class | MassAnalyzerVisualizer |
| Class that displays all meta information for MassAnalyzer objects. More...
|
|
class | MetaInfoDescriptionVisualizer |
| Class that displays all meta information for MetaInfoDescription objects. More...
|
|
class | MetaInfoVisualizer |
| MetaInfoVisualizer is a visualizer class for all classes that use one MetaInfo object as member. More...
|
|
class | ModificationVisualizer |
| Class that displays all meta information of modification objects. More...
|
|
class | PeptideHitVisualizer |
| Class that displays all meta information for PeptideHit objects. More...
|
|
class | PeptideIdentificationVisualizer |
| Class that displays all meta information for PeptideIdentification objects. More...
|
|
class | PrecursorVisualizer |
| Class that displays all meta information for Precursor objects. More...
|
|
class | ProductVisualizer |
| Class that displays all meta information for Product objects. More...
|
|
class | ProteinHitVisualizer |
| Class that displays all meta information for ProteinHit objects. More...
|
|
class | ProteinIdentificationVisualizer |
| Class that displays all meta information for ProteinIdentification objects. More...
|
|
class | SampleVisualizer |
| Class that displays all meta information of sample objects. More...
|
|
class | ScanWindowVisualizer |
| Class that displays all meta information for ScanWindow objects. More...
|
|
class | SoftwareVisualizer |
| Class that displays all meta information for Software objects. More...
|
|
class | SourceFileVisualizer |
| Class that displays all meta information for SourceFile objects. More...
|
|
class | SpectrumSettingsVisualizer |
| Class that displays all meta information for SpectrumSettings objects. More...
|
|
class | TaggingVisualizer |
| Class that displays all meta information of tagging objects. More...
|
|
|
std::ostream & | operator<< (std::ostream &os, const AccurateMassSearchResult &amsr) |
|
AA | nextValidAA (const std::string::const_iterator end, std::string::const_iterator &it_q) |
|
template<> |
String | ChromatogramExtractor::extract_id_< OpenSwath::LightTargetedExperiment > (OpenSwath::LightTargetedExperiment &transition_exp_used, const String &id, int &prec_charge) |
|
template<> |
String | ChromatogramExtractor::extract_id_< OpenMS::TargetedExperiment > (OpenMS::TargetedExperiment &transition_exp_used, const String &id, int &prec_charge) |
|
std::ostream & | operator<< (std::ostream &os, const TargetedExperiment::SummaryStatistics &s) |
| prints out the summary statistics More...
|
|
std::ostream & | operator<< (std::ostream &os, const AASequence &peptide) |
|
std::istream & | operator>> (std::istream &os, const AASequence &peptide) |
|
std::ostream & | operator<< (std::ostream &os, const DigestionEnzyme &enzyme) |
|
std::ostream & | operator<< (std::ostream &os, const DigestionEnzymeProtein &enzyme) |
|
std::ostream & | operator<< (std::ostream &, const Element &) |
|
std::ostream & | operator<< (std::ostream &os, const EmpiricalFormula &formula) |
|
std::ostream & | operator<< (std::ostream &os, const Residue &residue) |
|
std::ostream & | operator<< (std::ostream &os, const Ribonucleotide &ribo) |
| Stream output operator. More...
|
|
std::ostream & | operator<< (std::ostream &o_stream, OpenMS::Colorizer &col) |
|
std::ostream & | operator<< (std::ostream &os, const Exception::BaseException &e) |
| Output operator for exceptions. More...
|
|
std::ostream & | operator<< (std::ostream &os, LogConfigHandler const &lch) |
| Overload for the insertion operator (operator<<) to have a formatted output of the LogConfigHandler. More...
|
|
template<typename FloatingPointType > |
const PrecisionWrapper< FloatingPointType > | precisionWrapper (const FloatingPointType rhs) |
| Wrapper function that sets the appropriate precision for output temporarily. The original precision is restored afterwards so that no side effects remain. This is a "make"-function that deduces the typename FloatingPointType from its argument and returns a PrecisionWrapper<FloatingPointType>. More...
|
|
template<typename FloatingPointType > |
std::ostream & | operator<< (std::ostream &os, const PrecisionWrapper< FloatingPointType > &rhs) |
| Output operator for a PrecisionWrapper. Specializations are defined for float, double, long double. More...
|
|
std::ostream & | operator<< (std::ostream &os, StreamHandler const &stream_handler) |
| Overload for the insertion operator (operator<<) to have a formatted output of the StreamHandler. More...
|
|
std::ostream & | operator<< (std::ostream &os, const ChargePair &cons) |
| Print the contents of a ChargePair to a stream. More...
|
|
template<UInt D> |
std::ostream & | operator<< (std::ostream &os, const DBoundingBox< D > &bounding_box) |
| Print the contents to a stream. More...
|
|
template<typename Value > |
std::ostream & | operator<< (std::ostream &os, const DistanceMatrix< Value > &matrix) |
| Print the contents to a stream (and colors the diagonal, if the stream is cout/cerr) More...
|
|
template<UInt D, typename TCoordinateType > |
DPosition< D, TCoordinateType > | operator* (DPosition< D, TCoordinateType > position, typename DPosition< D, TCoordinateType >::CoordinateType scalar) |
| Scalar multiplication (a bit inefficient) More...
|
|
template<UInt D, typename TCoordinateType > |
DPosition< D, TCoordinateType > | operator* (typename DPosition< D, TCoordinateType >::CoordinateType scalar, DPosition< D, TCoordinateType > position) |
| Scalar multiplication (a bit inefficient) More...
|
|
template<UInt D, typename TCoordinateType > |
DPosition< D, TCoordinateType > | operator/ (DPosition< D, TCoordinateType > position, typename DPosition< D, TCoordinateType >::CoordinateType scalar) |
| Scalar multiplication (a bit inefficient) More...
|
|
template<UInt D, typename TCoordinateType > |
std::ostream & | operator<< (std::ostream &os, const DPosition< D, TCoordinateType > &pos) |
| Print the contents to a stream. More...
|
|
template<UInt D> |
std::ostream & | operator<< (std::ostream &os, const DRange< D > &area) |
| Print the contents to a stream. More...
|
|
template<typename T > |
std::ostream & | operator<< (std::ostream &os, const std::vector< T > &v) |
| Output stream operator for std::vectors. More...
|
|
template<typename T > |
std::ostream & | operator<< (std::ostream &os, const VecLowPrecision< T > &val) |
|
template<typename TString > |
std::vector< String > & | operator<< (std::vector< String > &sl, const TString &string) |
| Operator for appending entries with less code. More...
|
|
std::ostream & | operator<< (std::ostream &os, const Param ¶m) |
| Output of Param to a stream. More...
|
|
::size_t | hash_value (OpenMS::String const &s) |
|
bool | operator< (const MultiplexDeltaMasses &dm1, const MultiplexDeltaMasses &dm2) |
|
UInt32 | endianize32 (const UInt32 &n) |
| Endianizes a 32 bit type from big endian to little endian and vice versa. More...
|
|
UInt64 | endianize64 (const UInt64 &n) |
| Endianizes a 64 bit type from big endian to little endian and vice versa. More...
|
|
template<int type_size> |
void | invertEndianess (void *byte_buffer, const size_t element_count) |
|
template<> |
void | invertEndianess< 4 > (void *byte_buffer, const size_t element_count) |
|
template<> |
void | invertEndianess< 8 > (void *byte_buffer, const size_t element_count) |
|
std::ostream & | operator<< (std::ostream &os, const ControlledVocabulary &cv) |
| Print the contents to a stream. More...
|
|
DriftTimeUnit | toDriftTimeUnit (const std::string &dtu_string) |
|
const std::string & | toString (const DriftTimeUnit value) |
|
IMFormat | toIMFormat (const std::string &IM_format) |
|
const std::string & | toString (const IMFormat value) |
|
std::ostream & | operator<< (std::ostream &os, const ChromatogramPeak &point) |
| Print the contents to a stream. More...
|
|
std::ostream & | operator<< (std::ostream &os, const ConsensusFeature &cons) |
| Print the contents of a ConsensusFeature to a stream. More...
|
|
std::ostream & | operator<< (std::ostream &os, const ConsensusMap &cons_map) |
| Print the contents of a ConsensusMap to a stream. More...
|
|
std::ostream & | operator<< (std::ostream &os, const FeatureHandle &cons) |
| Print the contents of a FeatureHandle to a stream. More...
|
|
std::ostream & | operator<< (std::ostream &os, const AnnotationStatistics &ann) |
| Print content of an AnnotationStatistics object to a stream. More...
|
|
std::ostream & | operator<< (std::ostream &os, const FeatureMap &map) |
|
std::ostream & | operator<< (std::ostream &os, const MobilityPeak1D &point) |
| Print the contents to a stream. More...
|
|
std::ostream & | operator<< (std::ostream &os, const MobilityPeak2D &point) |
| Print the contents to a stream. More...
|
|
std::ostream & | operator<< (std::ostream &os, const Mobilogram &mb) |
|
std::ostream & | operator<< (std::ostream &os, const MSChromatogram &chrom) |
| Print the contents to a stream. More...
|
|
std::ostream & | operator<< (std::ostream &os, const MSExperiment &exp) |
| Print the contents to a stream. More...
|
|
std::ostream & | operator<< (std::ostream &os, const MSSpectrum &spec) |
|
std::ostream & | operator<< (std::ostream &os, const Peak1D &point) |
| Print the contents to a stream. More...
|
|
std::ostream & | operator<< (std::ostream &os, const Peak2D &point) |
| Print the contents to a stream. More...
|
|
std::ostream & | operator<< (std::ostream &out, const RangeBase &b) |
|
std::ostream & | operator<< (std::ostream &out, const RangeRT &range) |
|
std::ostream & | operator<< (std::ostream &out, const RangeMZ &range) |
|
std::ostream & | operator<< (std::ostream &out, const RangeIntensity &range) |
|
std::ostream & | operator<< (std::ostream &out, const RangeMobility &range) |
|
template<typename... Range> |
std::ostream & | operator<< (std::ostream &out, const RangeManager< Range... > &me) |
|
template<class DataArrayT > |
DataArrayT::iterator | getDataArrayByName (DataArrayT &a, const String &name) |
| Helper functions for MSSpectrum and MSChromatogram. More...
|
|
template<class DataArrayT > |
DataArrayT::const_iterator | getDataArrayByName (const DataArrayT &a, const String &name) |
|
template<typename PeakContainerT > |
void | removePeaks (PeakContainerT &p, const double pos_start, const double pos_end, const bool ignore_data_arrays=false) |
| remove all peaks EXCEPT in the given range More...
|
|
template<typename PeakContainerT > |
void | subtractMinimumIntensity (PeakContainerT &p) |
|
template<typename PeakContainerT > |
void | makePeakPositionUnique (PeakContainerT &p, const IntensityAveragingMethod m=IntensityAveragingMethod::MEDIAN) |
| Make peak positions unique. More...
|
|
void | copySpectrumMeta (const MSSpectrum &input, MSSpectrum &output, bool clear_spectrum=true) |
| Copies only the meta data contained in the input spectrum to the output spectrum. More...
|
|
std::ostream & | operator<< (std::ostream &os, const ChromatogramSettings &spec) |
| Print the contents to a stream. More...
|
|
std::ostream & | operator<< (std::ostream &os, const ExperimentalSettings &exp) |
| Print the contents to a stream. More...
|
|
template<typename ContainerType , typename PredicateType > |
static void | removeFromSetIf_ (ContainerType &container, PredicateType predicate) |
| Representation of spectrum identification results and associated data. More...
|
|
std::ostream & | operator<< (std::ostream &stream, const PeptideHit &hit) |
| Stream operator. More...
|
|
std::ostream & | operator<< (std::ostream &stream, const ProteinHit &hit) |
| Stream operator. More...
|
|
std::ostream & | operator<< (std::ostream &os, const SpectrumSettings &spec) |
| Print the contents to a stream. More...
|
|
bool | compareBinaryTreeNode (const BinaryTreeNode &x, const BinaryTreeNode &y) |
| returns the value of (x.distance < y.distance) for use with sort More...
|
|
template<UInt N, typename T > |
std::size_t | hash_value (const DPosition< N, T > &b) |
|
bool | sort_peaks_by_intensity (const PeakCandidate &a, const PeakCandidate &b) |
|
float | estimateNoiseFromRandomScans (const MSExperiment &exp, const UInt ms_level, const UInt n_scans=10, const double percentile=80) |
|
std::string | bytesToHumanReadable (UInt64 bytes) |
| convert bytes to a human readable unit (TiB, GiB, MiB, KiB), e.g. "45.34 MiB" More...
|
|
std::ostream & | operator<< (std::ostream &os, const LayerDataBase &rhs) |
| Print the contents to a stream. More...
|
|
FS_TV | operator+ (const TV_STATUS left, const TV_STATUS right) |
| allow + operations on the enum, e.g. 'HAS_CANVAS + HAS_LAYER + IS_1D_VIEW' More...
|
|
FS_LAYER | operator+ (const LayerDataBase::DataType left, const LayerDataBase::DataType right) |
| allow + operations on the enum, e.g. 'DT_PEAK + DT_FEATURE' More...
|
|
|
These functions are provided to unify the handling of this issue throughout OpenMS. (So please don't use ad-hoc numbers ;-) )
If you want to avoid side effects you can use precisionWrapper() to write a floating point number with appropriate precision; in this case the original state of the stream is automatically restored afterwards. See precisionWrapper() for details.
In practice, the number of decimal digits that the type can represent without loss of precision are 6 digits for single precision and 15 digits for double precision. We have \(2^{24}/10^{6}=16.777216\) and \(2^{53}/10^{15}=9.007199254740992\), so rounding will remove the remaining difference.
Example: #define NUMBER 12345.67890123456789012345678901
std::cout << NUMBER << '\n';
double d = NUMBER;
std::cout << writtenDigits<double>(0.0) << ": " << d << '\n';
float r = NUMBER;
long double l = NUMBER;
double x = 88.99;
std::cout.precision(15);
std::cout << "15: " << x << '\n';
std::cout.precision(16);
std::cout << "16: " << x << '\n';
constexpr Int writtenDigits< double >(const double &) Number of digits commonly used for writing a double (a.k.a. precision). Definition: Types.h:189
constexpr Int writtenDigits(const FloatingPointType &=FloatingPointType()) Number of digits commonly used for writing a floating point type (a.k.a. precision).... Definition: Types.h:264
|
template<typename FloatingPointType > |
constexpr Int | writtenDigits (const FloatingPointType &=FloatingPointType()) |
| Number of digits commonly used for writing a floating point type (a.k.a. precision). Specializations are defined for float, double, long double. More...
|
|
template<> |
constexpr Int | writtenDigits< float > (const float &) |
| Number of digits commonly used for writing a float (a.k.a. precision). More...
|
|
template<> |
constexpr Int | writtenDigits< double > (const double &) |
| Number of digits commonly used for writing a double (a.k.a. precision). More...
|
|
template<> |
constexpr Int | writtenDigits< int > (const int &) |
| We do not want to bother people who unintentionally provide an int argument to this. More...
|
|
template<> |
constexpr Int | writtenDigits< unsigned int > (const unsigned int &) |
| We do not want to bother people who unintentionally provide an unsigned int argument to this. More...
|
|
template<> |
constexpr Int | writtenDigits< long int > (const long int &) |
| We do not want to bother people who unintentionally provide a long int argument to this. More...
|
|
template<> |
constexpr Int | writtenDigits< unsigned long int > (const unsigned long int &) |
| We do not want to bother people who unintentionally provide an unsigned long int argument to this. More...
|
|
template<> |
constexpr Int | writtenDigits< DataValue > (const DataValue &) |
| DataValue will be printed like double. More...
|
|
template<> |
constexpr Int | writtenDigits< long double > (const long double &) |
| Number of digits commonly used for writing a long double (a.k.a. precision). ... More...
|
|