 |
OpenMS
3.0.0
|
|
Go to the documentation of this file.
94 void getMultipleSpectra(std::map<Int, MSSpectrum>& spectra,
const NASequence& oligo,
const std::set<Int>& charges,
Int base_charge = 1)
const;
97 void updateMembers_()
override;
103 void addFragmentPeaks_(
MSSpectrum& spectrum,
const std::vector<double>& fragment_masses,
const String& ion_type,
double offset,
double intensity,
Size start = 0)
const;
106 void addAMinusBPeaks_(
MSSpectrum& spectrum,
const std::vector<double>& fragment_masses,
const NASequence& oligo,
Size start = 0)
const;
112 void addChargedSpectrum_(
MSSpectrum& spectrum,
const MSSpectrum& uncharged_spectrum,
Int charge,
bool add_precursor)
const;
double aB_intensity_
Definition: NucleicAcidSpectrumGenerator.h:135
Protease digestion_enzyme
The cleavage site information in details (from ProteaseDB)
Definition: ProteinIdentification.h:273
NASequence sequence
Definition: NucleicAcidSearchEngine.cpp:283
void setProgress(SignedSize value) const
Sets the current progress.
ParentSequenceRef registerParentSequence(const ParentSequence &parent)
Register a parent sequence (e.g. protein or intact RNA)
Base class for TOPP applications.
Definition: TOPPBase.h:147
static Int toInt(const String &this_s)
Definition: StringUtils.h:206
File adapter for MzTab files.
Definition: MzTabFile.h:55
double fragment_mass_tolerance
Definition: DBSearchParam.h:62
void getMultipleSpectra(std::map< Int, MSSpectrum > &spectra, const NASequence &oligo, const std::set< Int > &charges, Int base_charge=1) const
Generates spectra in multiple charge states for an oligonucleotide sequence.
Definition: NucleicAcidSearchEngine.cpp:265
IdentificationDataInternal::ScoreType ScoreType
Definition: IdentificationData.h:125
Normalizes the peak intensities spectrum-wise.
Definition: Normalizer.h:57
PrecursorInfo(Size scan_index, Int charge, Size isotope, const IdentificationData::AdductOpt &adduct=std::nullopt)
Definition: NucleicAcidSearchEngine.cpp:272
bool add_z_ions_
Definition: NucleicAcidSpectrumGenerator.h:121
This class supports reading and writing of OMS files.
Definition: OMSFile.h:48
double z_intensity_
Definition: NucleicAcidSpectrumGenerator.h:134
ScoreTypeRef findScoreType(const String &score_name) const
Look up a score type by name.
double d_intensity_
Definition: NucleicAcidSpectrumGenerator.h:130
void setValue(const std::string &key, const ParamValue &value, const std::string &description="", const std::vector< std::string > &tags=std::vector< std::string >())
Sets a value.
static double median(IteratorType begin, IteratorType end, bool sorted=false)
Calculates the median of a range of values.
Definition: StatisticFunctions.h:138
void store(const String &filename, const std::vector< ProteinIdentification > &protein_ids, const std::vector< PeptideIdentification > &peptide_ids, const String &document_id="")
Stores the data in an idXML file.
AdductRef registerAdduct(const AdductInfo &adduct)
Register an adduct.
Size findNearest(CoordinateType mz) const
Binary search for the peak nearest to a specific m/z.
Size scan_index
Definition: NucleicAcidSearchEngine.cpp:267
Representation of a nucleic acid sequence.
Definition: NASequence.h:61
const std::string PRECURSOR_ERROR_PPM_USERPARAM
Definition: Constants.h:275
bool modifyStrings(bool modify)
Switch modification of strings (quoting/replacing of separators) on/off.
static InstanceType * getInstance()
this member function serves as a replacement of the constructor
Definition: DigestionEnzymeDB.h:69
double a_intensity_
Definition: NucleicAcidSpectrumGenerator.h:127
static String basename(const String &file)
Invalid value exception.
Definition: Exception.h:327
void sortSpectra(bool sort_mz=true)
Sorts the data points by retention time.
String & substitute(char from, char to)
Replaces all occurrences of the character from by the character to.
This class serves for reading in and writing FASTA files If the protein/gene sequence contains unusua...
Definition: FASTAFile.h:60
bool fragment_tolerance_ppm
Definition: DBSearchParam.h:64
static QString toQString(const String &this_s)
Definition: StringUtils.h:201
WindowMower augments the highest peaks in a sliding or jumping window.
Definition: WindowMower.h:54
void store(const String &filename, const PeakMap &map) const
Stores a map in an MzML file.
Representation of a ribonucleotide (modified or unmodified)
Definition: Ribonucleotide.h:51
void setMZ(CoordinateType mz)
Mutable access to m/z.
Definition: Peak1D.h:119
ProcessingSoftwareRef registerProcessingSoftware(const ProcessingSoftware &software)
Register data processing software.
void preprocessSpectra_(PeakMap &exp, double fragment_mass_tolerance, bool fragment_mass_tolerance_unit_ppm, bool single_charge_spectra, bool negative_mode, Int min_charge, Int max_charge, bool include_unknown_charge)
Definition: NucleicAcidSearchEngine.cpp:532
static void filterObservationMatchesByScore(IdentificationData &id_data, IdentificationData::ScoreTypeRef score_ref, double cutoff)
Filter observation matches (e.g. PSMs) in IdentificationData by score.
const MzTabNucleicAcidSectionRows & getNucleicAcidSectionRows() const
File adapter for MzML files.
Definition: MzMLFile.h:57
A more convenient string class.
Definition: String.h:58
static void applyVariableModifications(const std::set< ConstRibonucleotidePtr > &var_mods, const NASequence &seq, Size max_variable_mods_per_NASequence, std::vector< NASequence > &all_modified_NASequences, bool keep_original=true)
Applies variable modifications to a single NASequence. If keep_original is set the original (e....
Iterator begin()
Definition: MSExperiment.h:150
void deisotopeAndSingleChargeMSSpectrum_(MSSpectrum &in, Int min_charge, Int max_charge, double fragment_tolerance, bool fragment_unit_ppm, bool keep_only_deisotoped=false, Size min_isopeaks=3, Size max_isopeaks=10, bool make_single_charged=true)
Definition: NucleicAcidSearchEngine.cpp:376
IdentificationData::IdentifiedOligoRef oligo_ref
Definition: NucleicAcidSearchEngine.cpp:282
void digest(const NASequence &rna, std::vector< NASequence > &output, Size min_length=0, Size max_length=0) const
Performs the enzymatic digestion of a (potentially modified) RNA.
void filterPeakSpectrum(PeakSpectrum &spectrum)
void setRT(double rt)
sets the RT of the MS2 spectrum where the identification occurred
In-Memory representation of a mass spectrometry run.
Definition: MSExperiment.h:70
const std::vector< Precursor > & getPrecursors() const
returns a const reference to the precursors
static void removeDecoys(IdentificationData &id_data)
Filter IdentificationData to remove parent sequences annotated as decoys.
void addMSLevel(int level)
adds a desired MS level for peaks to load
size_t Size
Size type e.g. used as variable which can hold result of size()
Definition: Types.h:127
bool add_c_ions_
Definition: NucleicAcidSpectrumGenerator.h:116
const double c
Definition: Constants.h:209
void setEnzyme(const DigestionEnzyme *enzyme) override
Sets the enzyme for the digestion.
static RibonucleotideDB * getInstance()
replacement for constructor (singleton pattern)
PeakAnnotationSteps peak_annotations
Definition: ObservationMatch.h:85
Int charge
Definition: NucleicAcidSearchEngine.cpp:268
enum MassType mass_type
Definition: DBSearchParam.h:50
Data model of MzTab files. Please see the official MzTab specification at https://code....
Definition: MzTab.h:477
Definition: ProteinIdentification.h:249
const ObservationMatches & getObservationMatches() const
Return the registered observation matches (immutable)
Definition: IdentificationData.h:479
AdductInfo parseAdduct_(const String &adduct)
Definition: NucleicAcidSearchEngine.cpp:348
bool precursor_tolerance_ppm
Definition: DBSearchParam.h:63
void startProgress(SignedSize begin, SignedSize end, const String &label) const
Initializes the progress display.
Size max_size_
Definition: NucleicAcidSearchEngine.cpp:337
Information about a score type.
Definition: ScoreType.h:45
std::vector< Int > IntList
Vector of signed integers.
Definition: ListUtils.h:55
const InputFiles & getInputFiles() const
Return the registered input files (immutable)
Definition: IdentificationData.h:401
bool add_first_prefix_ion_
Definition: NucleicAcidSpectrumGenerator.h:123
#define OPENMS_PRECONDITION(condition, message)
Precondition macro.
Definition: openms/include/OpenMS/CONCEPT/Macros.h:120
set< ConstRibonucleotidePtr > getModifications_(const set< String > &mod_names)
Definition: NucleicAcidSearchEngine.cpp:292
const double PROTON_MASS_U
Definition: Constants.h:116
#define OPENMS_LOG_WARN
Macro if a warning, a piece of information which should be read by the user, should be logged.
Definition: LogStream.h:460
void writeSpectrum(std::ostream &os, const PeakSpectrum &spec, const String &filename, const String &native_id_type_accession)
writes a spectrum in MGF format to an ostream
void endProgress() const
Ends the progress display.
IdentifiedOligoRef registerIdentifiedOligo(const IdentifiedOligo &oligo)
Register an identified RNA oligonucleotide.
String database
Definition: DBSearchParam.h:52
void setMissedCleavages(Size missed_cleavages)
Sets the number of missed cleavages for the digestion (default is 0). This setting is ignored when lo...
const MzTabOligonucleotideSectionRows & getOligonucleotideSectionRows() const
void setVersion(const String &version)
Sets the software version.
Size size() const
Definition: MSExperiment.h:120
NLargest removes all but the n largest peaks.
Definition: NLargest.h:54
const ParentSequences & getParentSequences() const
Return the registered parent sequences (immutable)
Definition: IdentificationData.h:443
A base class for all classes handling default parameters.
Definition: DefaultParamHandler.h:92
const std::vector< PeptideHit > & getHits() const
returns the peptide hits as const
bool fragment_mass_tolerance_ppm
Mass tolerance unit of fragment ions (true: ppm, false: Dalton)
Definition: ProteinIdentification.h:270
static DateTime now()
Returns the current date and time.
bool add_x_ions_
Definition: NucleicAcidSpectrumGenerator.h:119
Parameters specific to a database search step.
Definition: DBSearchParam.h:47
double precursor_error_ppm
Definition: NucleicAcidSearchEngine.cpp:284
std::vector< ScoreTypeRef > assigned_scores
Definition: ProcessingSoftware.h:56
static String concatenate(const std::vector< T > &container, const String &glue="")
Concatenates all elements of the container and puts the glue string between elements.
Definition: ListUtils.h:209
Precursor meta information.
Definition: Precursor.h:58
int Int
Signed integer type.
Definition: Types.h:102
static bool exists(const String &file)
Method used to test if a file exists.
void calculateAndFilterFDR_(IdentificationData &id_data, bool only_top_hits)
Definition: NucleicAcidSearchEngine.cpp:804
Main OpenMS namespace.
Definition: FeatureDeconvolution.h:47
const DBSearchParams & getDBSearchParams() const
Return the registered database search parameters (immutable)
Definition: IdentificationData.h:419
HasInvalidLength(Size min_size, Size max_size)
Definition: NucleicAcidSearchEngine.cpp:339
double getMassShift(bool use_avg_mass=false) const
returns the mass shift caused by this adduct if charges are compensated with protons
Information about software used for data processing.
Definition: ProcessingSoftware.h:48
void postProcessHits_(const PeakMap &exp, vector< HitsByScore > &annotated_hits, IdentificationData &id_data, bool negative_mode)
Definition: NucleicAcidSearchEngine.cpp:739
void filterPeakMap(PeakMap &exp) const
std::vector< String > variable_modifications
Allowed variable modifications.
Definition: ProteinIdentification.h:267
double calculatePrecursorMass_(double mz, Int charge, Int isotope, double adduct_mass, bool negative_mode)
Definition: NucleicAcidSearchEngine.cpp:657
const DigestionEnzyme * digestion_enzyme
Definition: DBSearchParam.h:67
PeakMassType mass_type
Mass type of the peaks.
Definition: ProteinIdentification.h:265
Base class for all classes that want to report their progress.
Definition: ProgressLogger.h:52
bool add_metainfo_
Definition: NucleicAcidSpectrumGenerator.h:124
ScoreTypeRef registerScoreType(const ScoreType &score)
Register a score type.
void load(const String &filename, PeakMap &map)
Loads a map from a MzML file. Spectra and chromatograms are sorted by default (this can be disabled u...
InputFileRef registerInputFile(const InputFile &file)
Register an input file.
Representation of an observation, e.g. a spectrum or feature, in an input data file.
Definition: Observation.h:53
bool add_b_ions_
Definition: NucleicAcidSpectrumGenerator.h:115
Stream class for writing to comma/tab/...-separated values files.
Definition: SVOutStream.h:56
vector< String > fragment_ion_codes_
Definition: NucleicAcidSearchEngine.cpp:155
void generateLFQInput_(IdentificationData &id_data, const String &out_file)
Definition: NucleicAcidSearchEngine.cpp:831
String db
The used database.
Definition: ProteinIdentification.h:261
Helper class for looking up spectra based on different attributes.
Definition: SpectrumLookup.h:67
Wrapper that adds operator< to iterators, so they can be used as (part of) keys in maps/sets or multi...
Definition: MetaData.h:45
IdentificationData::AdductOpt adduct
Definition: NucleicAcidSearchEngine.cpp:270
Definition: AdductInfo.h:42
const MzTabOSMSectionRows & getOSMSectionRows() const
map< String, String > ambiguous_mods_
Definition: NucleicAcidSearchEngine.cpp:156
void readSpectra(const SpectrumContainer &spectra, const String &scan_regexp=default_scan_regexp)
Read and index spectra for later look-up.
Definition: SpectrumLookup.h:103
CoordinateType getMZ() const
Non-mutable access to m/z.
Definition: Peak1D.h:113
bool add_precursor_peaks_
Definition: NucleicAcidSpectrumGenerator.h:125
const Observations & getObservations() const
Return the registered observations (immutable)
Definition: IdentificationData.h:437
bool isAmbiguous() const
Return whether this is an "ambiguous" modification (representing isobaric modifications on the base/r...
#define OPENMS_LOG_DEBUG
Macro for general debugging information.
Definition: LogStream.h:470
ObservationRef registerObservation(const Observation &obs)
Register an observation (e.g. MS2 spectrum or feature)
void setHigherScoreBetter(bool value)
sets the peptide score orientation
void store(const String &filename, const MzTab &mz_tab) const
void setCurrentProcessingStep(ProcessingStepRef step_ref)
Set a data processing step that will apply to all subsequent "register..." calls.
void store(const String &filename, const IdentificationData &id_data)
Write out an IdentificationData object to SQL-based OMS file.
void addProcessingStep(const AppliedProcessingStep &step)
Add an applied processing step.
Definition: ScoredProcessingResult.h:66
SearchParamRef registerDBSearchParam(const DBSearchParam ¶m)
Register database search parameters.
std::set< String > variable_mods
Definition: DBSearchParam.h:59
void setPrecursors(const std::vector< Precursor > &precursors)
sets the precursors
bool split(const char splitter, std::vector< String > &substrings, bool quote_protect=false) const
Splits a string into substrings using splitter as delimiter.
Definition: NucleicAcidSearchEngine.cpp:280
void clear(bool clear_meta_data)
Clears all data and meta data.
Representation of a parent sequence that is identified only indirectly (e.g. a protein).
Definition: ParentSequence.h:49
void setParameters(const Param ¶m)
Sets the parameters.
Size min_size_
Definition: NucleicAcidSearchEngine.cpp:336
const Param & getDefaults() const
Non-mutable access to the default parameters.
QString toQString() const
Conversion to Qt QString.
bool add_a_ions_
Definition: NucleicAcidSpectrumGenerator.h:114
static String path(const String &file)
void setCharge(Int charge)
sets the charge of the peptide
const Param & getParameters() const
Non-mutable access to the parameters.
Size max_length
Definition: DBSearchParam.h:71
Read/write Mascot generic files (MGF).
Definition: MascotGenericFile.h:62
void setFillData(bool only)
sets whether to fill the actual data into the container (spectrum/chromatogram)
std::set< Int > charges
Definition: DBSearchParam.h:56
double fragment_mass_tolerance
Mass tolerance of fragment ions (Dalton or ppm)
Definition: ProteinIdentification.h:269
bool operator()(const NASequence &s) const
Definition: NucleicAcidSearchEngine.cpp:343
bool add_aB_ions_
Definition: NucleicAcidSpectrumGenerator.h:122
A 1-dimensional raw data point or peak.
Definition: Peak1D.h:53
Stores Citations for individual TOPP tools.
Definition: TOPPBase.h:73
std::vector< String > StringList
Vector of String.
Definition: ListUtils.h:70
void sortByPosition()
Lexicographically sorts the peaks by their position.
Size min_length
Definition: DBSearchParam.h:70
double b_intensity_
Definition: NucleicAcidSpectrumGenerator.h:128
SeqType sequence
Definition: IdentifiedSequence.h:54
bool add_w_ions_
Definition: NucleicAcidSpectrumGenerator.h:118
void setSequence(const AASequence &sequence)
sets the peptide sequence
std::vector< String > fixed_modifications
Used fixed modifications.
Definition: ProteinIdentification.h:266
Definition: MetaData.h:69
const ScoreTypes & getScoreTypes() const
Return the registered score types (immutable)
Definition: IdentificationData.h:431
vector< PeptideHit::PeakAnnotation > annotations
Definition: NucleicAcidSearchEngine.cpp:285
ObservationMatchRef registerObservationMatch(const ObservationMatch &match)
Register an observation match (e.g. peptide-spectrum match)
This class handles csv files. Currently only loading is implemented.
Definition: CsvFile.h:49
const String & getNativeID() const
returns the native identifier for the spectrum, used by the acquisition software.
Calculates false discovery rates (FDR) from identifications.
Definition: FalseDiscoveryRate.h:77
int main(int argc, const char **argv)
Definition: INIFileEditor.cpp:71
double x_intensity_
Definition: NucleicAcidSpectrumGenerator.h:132
int main(int argc, const char **argv)
Definition: NucleicAcidSearchEngine.cpp:1450
double precursor_mass_tolerance
Mass tolerance of precursor ions (Dalton or ppm)
Definition: ProteinIdentification.h:271
Size missed_cleavages
Definition: DBSearchParam.h:69
ptrdiff_t SignedSize
Signed Size type e.g. used as pointer difference.
Definition: Types.h:134
static void exportIDs(const IdentificationData &id_data, std::vector< ProteinIdentification > &proteins, std::vector< PeptideIdentification > &peptides, bool export_ids_wo_scores=false)
Export to legacy peptide/protein identifications.
Representation of spectrum identification results and associated data.
Definition: IdentificationData.h:94
static double toDouble(const String &this_s)
Definition: StringUtils.h:216
#define OPENMS_LOG_ERROR
Macro to be used if non-fatal error are reported (processing continues)
Definition: LogStream.h:455
bool add_d_ions_
Definition: NucleicAcidSpectrumGenerator.h:117
double c_intensity_
Definition: NucleicAcidSpectrumGenerator.h:129
Class representing a temporary directory.
Definition: File.h:64
double precursor_mass_tolerance
Definition: DBSearchParam.h:61
Represents the peptide hits for a spectrum.
Definition: PeptideIdentification.h:63
String substr(size_t pos=0, size_t n=npos) const
Wrapper for the STL substr() method. Returns a String object with its contents initialized to a subst...
ProcessingStepRef getCurrentProcessingStep()
Return the current processing step (set via setCurrentProcessingStep()).
void filterPeakMap(PeakMap &exp)
Iterator end()
Definition: MSExperiment.h:160
Representation of controlled vocabulary term.
Definition: CVTerm.h:52
const PrecursorInfo * precursor_ref
Definition: NucleicAcidSearchEngine.cpp:286
void cleanup(bool require_observation_match=true, bool require_identified_sequence=true, bool require_parent_match=true, bool require_parent_group=false, bool require_match_group=false)
Clean up the data structure after filtering parts of it.
void load(const String &filename, std::vector< FASTAEntry > &data) const
loads a FASTA file given by 'filename' and stores the information in 'data' This uses more RAM than r...
Representation of an identified sequence (peptide or oligonucleotide)
Definition: IdentifiedSequence.h:52
ProcessingStepRef registerProcessingStep(const ProcessingStep &step)
Register a data processing step.
AdductOpt adduct_opt
optional reference to adduct
Definition: ObservationMatch.h:81
void transform(const String &filename_in, Interfaces::IMSDataConsumer *consumer, bool skip_full_count=false, bool skip_first_pass=false)
Transforms a map while loading using the supplied MSDataConsumer.
Options for loading files containing peak data.
Definition: PeakFileOptions.h:47
void getPrimaryMSRunPath(StringList &toFill) const
get the file path to the first MS run
Definition: MetaData.h:75
ThresholdMower removes all peaks below a threshold.
Definition: ThresholdMower.h:51
static MzTab exportMzTab(const IdentificationData &id_data)
Export to mzTab format.
static String number(double d, UInt n)
Definition: StringUtils.h:196
ExitCodes
Exit codes.
Definition: TOPPBase.h:152
Data processing step that is applied to the data (e.g. database search, PEP calculation,...
Definition: ProcessingStep.h:47
void addScore(ScoreTypeRef score_type, double score, const std::optional< ProcessingStepRef > &processing_step_opt=std::nullopt)
Add a score (possibly connected to a processing step)
Definition: ScoredProcessingResult.h:97
void setName(const String &name)
Sets the name.
std::string toString() const
Definition: MetaData.h:76
IdentificationDataInternal::AdductOpt AdductOpt
Definition: IdentificationData.h:168
ExitCodes main_(int, const char **) override
The actual "main" method. main_() is invoked by main().
Definition: NucleicAcidSearchEngine.cpp:886
void clearMSLevels()
clears the MS levels
bool precursor_mass_tolerance_ppm
Mass tolerance unit of precursor ions (true: ppm, false: Dalton)
Definition: ProteinIdentification.h:272
Management and storage of parameters / INI files.
Definition: Param.h:69
String & remove(char what)
Remove all occurrences of the character what.
Generates theoretical spectra for nucleic acid sequences.
Definition: NucleicAcidSpectrumGenerator.h:53
IdentificationData::ScoreTypeRef applyToObservationMatches(IdentificationData &id_data, IdentificationData::ScoreTypeRef score_ref) const
Calculate FDR on the level of observation matches (e.g. peptide-spectrum matches) for "general" ident...
const IdentifiedOligos & getIdentifiedOligos() const
Return the registered identified oligonucleotides (immutable)
Definition: IdentificationData.h:467
static void importSequences(IdentificationData &id_data, const std::vector< FASTAFile::FASTAEntry > &fasta, IdentificationData::MoleculeType type=IdentificationData::MoleculeType::PROTEIN, const String &decoy_pattern="")
Import FASTA sequences as parent sequences.
bool add_y_ions_
Definition: NucleicAcidSpectrumGenerator.h:120
Size isotope
Definition: NucleicAcidSearchEngine.cpp:269
bool add_all_precursor_charges_
Definition: NucleicAcidSpectrumGenerator.h:126
std::vector< SpectrumType >::const_iterator ConstIterator
Non-mutable iterator.
Definition: MSExperiment.h:106
static AASequence fromString(const String &s, bool permissive=true)
create AASequence object by parsing an OpenMS string
void setCharge(Int charge)
Mutable access to the charge.
void calculateCoverages(bool check_molecule_length=false)
Calculate sequence coverages of parent sequences.
#define OPENMS_LOG_INFO
Macro if a information, e.g. a status should be reported.
Definition: LogStream.h:465
void setMSLevels(const std::vector< Int > &levels)
sets the desired MS levels for peaks to load
double y_intensity_
Definition: NucleicAcidSpectrumGenerator.h:133
void resolveAmbiguousMods_(HitsByScore &hits)
Definition: NucleicAcidSearchEngine.cpp:678
Element could not be found exception.
Definition: Exception.h:674
const double C13C12_MASSDIFF_U
Definition: Constants.h:121
Class for the enzymatic digestion of RNAs.
Definition: RNaseDigestion.h:52
Representation of a search hit (e.g. peptide-spectrum match).
Definition: ObservationMatch.h:73
Size getNrSpectra() const
get the total number of spectra available
The representation of a 1D spectrum.
Definition: MSSpectrum.h:66
Search parameters of the DB search.
Definition: ProteinIdentification.h:258
double w_intensity_
Definition: NucleicAcidSpectrumGenerator.h:131
void setMZ(double mz)
sets the MZ of the MS2 spectrum
void setOptions(const PeakFileOptions &)
set options for loading/storing
enum MoleculeType molecule_type
Definition: DBSearchParam.h:49
ExitCodes main(int argc, const char **argv)
Main routine of all TOPP applications.
double precursor_intensity_
Definition: NucleicAcidSpectrumGenerator.h:136
void filterPeakSpectrum(PeakSpectrum &spectrum)
multimap< double, AnnotatedHit, greater< double > > HitsByScore
Definition: NucleicAcidSearchEngine.cpp:289
void load(const String &filename, IdentificationData &id_data)
Read in a OMS file and construct an IdentificationData object.
PeakFileOptions & getOptions()
Mutable access to the options for loading/storing.
void setLogType(LogType type) const
Sets the progress log that should be used. The default type is NONE!
Definition: NucleicAcidSearchEngine.cpp:334
void setScoreType(const String &type)
sets the peptide score type
Size findByScanNumber(Size scan_number) const
Look up spectrum by scan number (extracted from the native ID).
Used to load and store idXML files.
Definition: IdXMLFile.h:68
bool resolve_ambiguous_mods_
Definition: NucleicAcidSearchEngine.cpp:157
Definition: NucleicAcidSearchEngine.cpp:141
void registerOptionsAndFlags_() override
Sets the valid command line options (with argument) and flags (without argument).
Definition: NucleicAcidSearchEngine.cpp:160
void setScore(double score)
sets the PSM score
NucleicAcidSearchEngine()
Definition: NucleicAcidSearchEngine.cpp:147
Representation of a peptide hit.
Definition: PeptideHit.h:55