ProteoWizard
|
Classes | |
struct | analyzer_strings |
This auxilliary class should be specialized for MSDataAnalyzers whose instantiation is controlled by user-supplied strings (via command line, config file, etc.). More... | |
struct | analyzer_strings< MetadataReporter > |
struct | analyzer_strings< RegionSIC > |
struct | analyzer_strings< RegionSlice > |
struct | analyzer_strings< RegionTIC > |
struct | analyzer_strings< RunSummary > |
struct | analyzer_strings< SpectrumBinaryData > |
struct | analyzer_strings< SpectrumTable > |
struct | ChromatogramDataFilter |
class | ChromatogramList_Filter |
ChromatogramList filter, for creating Chromatogram sub-lists. More... | |
class | ChromatogramList_FilterPredicate_IndexSet |
class | ChromatogramList_LockmassRefiner |
ChromatogramList implementation to replace peak profiles with picked peaks. More... | |
class | ChromatogramList_SavitzkyGolaySmoother |
ChromatogramList implementation to return native centroided chromatogram data. More... | |
class | ChromatogramList_XICGenerator |
ChromatogramList implementation to return native centroided chromatogram data. More... | |
class | ChromatogramListFactory |
Factory for instantiating and wrapping ChromatogramLists. More... | |
class | ChromatogramListWrapper |
Inheritable pass-through implementation for wrapping a ChromatogramList. More... | |
class | CubicHermiteSpline |
An implementation of the IInterpolation interface that acts as a wrapper for a cSpline. More... | |
struct | CwtPeakDetector |
class | DemuxDebugReader |
A class for reading demux matrices from file. More... | |
class | DemuxDebugWriter |
A class for writing demux matrices to file. More... | |
class | DemuxSolver |
Interface for solver that can be used for demultiplexing. More... | |
struct | DemuxWindow |
A container for describing the isolation windows that are dedicated to columns of the design matrix for demultiplexing. More... | |
struct | ExtraZeroSamplesFilter |
removes (most) zero samples in signal profiles, except those flanking nonzero samples simply looks for runs of 0 values, removes all but start and end of run More... | |
class | FeatureDetector |
class | FeatureDetectorPeakel |
FeatureDetectorPeakel implements a 'template method', delegating to 'strategies' encapsulated by the following interfaces: PeakExtractor PeakelGrower PeakelPicker. More... | |
class | FeatureDetectorSimple |
FeatureDetectorSimple detects 'rectangular' features, ie number of peaks in isotope envelope is the same for each scan included in the feature. More... | |
class | FeatureModeler |
interface for fitting and scoring Feature data to a model More... | |
class | FeatureModeler_Gaussian |
Gaussian implementation. More... | |
class | IDemultiplexer |
Interface for calculating demultiplexing scheme. More... | |
class | IPrecursorMaskCodec |
Interface for generating and accessing precursor masks for a demultiplexing scheme. More... | |
struct | IsolationWindow |
A container that wraps DemuxWindow to preserve the full precision window boundaries. More... | |
class | IsolationWindowFilter |
class | IsoWindowHasher |
A method of hashing an isolation window to a unique long value mz is and m/z of a unique point in the isolation window, such as the lower bound, upper bound, or center. More... | |
struct | LocalMaximumPeakDetector |
class | MatrixIO |
Provides static methods for writing and reading matrices to/from files. More... | |
class | MetadataReporter |
writes file-level metadata to a file More... | |
struct | MS2Deisotoper |
struct | MS2NoiseFilter |
class | MSDataAnalyzer |
Interface for MSData analyzers. More... | |
class | MSDataAnalyzerContainer |
container of MSDataAnalyzer (composite pattern) More... | |
class | MSDataAnalyzerDriver |
event generator for MSDataAnalyzer More... | |
class | MSDataCache |
simple memory cache for common MSData info More... | |
class | MSXDemultiplexer |
Implementation of the IDemultiplexer interface that is able to handle both MSX experiments, including ones with overlap. More... | |
struct | MZRTField |
MZRTField is a std::set of boost::shared_ptrs, stored as a binary tree ordered by LessThan_MZRT. More... | |
class | NNLSSolver |
Implementation of the DemuxSolver interface as a non-negative least squares (NNLS) problem. More... | |
struct | Noise |
class | NoiseCalculator |
class | NoiseCalculator_2Pass |
class | NoVendorPeakPickingException |
class | OverlapDemultiplexer |
Implementation of the IDemultiplexer interface that is able to handle overlap experiments. More... | |
struct | Peak |
represents some generic metadata about a peak detected in a signal More... | |
struct | PeakDetector |
class | PeakelGrower |
interface for growing Peakels More... | |
class | PeakelGrower_Proximity |
simple PeakelGrower implementation, based on proximity of Peaks More... | |
class | PeakelPicker |
interface for picking Peakels and arranging into Features; note: Peakels are actually removed from the PeakelField More... | |
class | PeakelPicker_Basic |
basic implementation More... | |
class | PeakExtractor |
Class for extracting Peak objects from an array of ordered pairs; in design pattern lingo, this is a "template method" delegating peak finding and peak fitting to "strategies". More... | |
class | PeakFamilyDetector |
interface for peak family (isotope envelope) detection More... | |
class | PeakFamilyDetectorFT |
FT-specific implementation of PeakFamilyDetector. More... | |
class | PeakFinder |
interface for finding peaks in an array of ordered pairs More... | |
class | PeakFinder_SNR |
PeakFinder implementation based on signal-to-noise ratio. More... | |
class | PeakFitter |
interface for fitting peaks in an array of ordered pairs More... | |
class | PeakFitter_Parabola |
PeakFitter implementation based on fitting a parabola. More... | |
class | PepxmlRecordReader |
class | PrecursorMaskCodec |
Implementation of the IPrecursorMaskCodec interface that is able to handle both overlapping MSX experiments. More... | |
struct | PrecursorMassFilter |
class | PrecursorRecalculator |
class | PrecursorRecalculatorDefault |
class | ProteinList_DecoyGenerator |
ProteinList decoy generator for creating decoy proteins on the fly. More... | |
class | ProteinList_DecoyGeneratorPredicate_Reversed |
creates a reversed copy of every target protein with the specified decoy string prefixed to the id More... | |
class | ProteinList_DecoyGeneratorPredicate_Shuffled |
creates a randomly shuffled copy of every target protein with the specified decoy string prefixed to the id More... | |
class | ProteinList_Filter |
ProteinList filter, for creating Protein sub-lists. More... | |
class | ProteinList_FilterPredicate_IdSet |
class | ProteinList_FilterPredicate_IndexSet |
class | ProteinListFactory |
Factory for instantiating and wrapping ProteinLists. More... | |
class | RegionAnalyzer |
analyzes a rectangular region of m/z-time space More... | |
class | RegionSIC |
writes data samples from a single rectangular region More... | |
class | RegionSlice |
writes data samples from a single rectangular region More... | |
class | RegionTIC |
writes data samples from a single rectangular region More... | |
struct | RTMatches_Any |
predicate always returns true More... | |
struct | RTMatches_Contains |
predicate returns true iff the object's retention time range contains the specified retention time More... | |
struct | RTMatches_IsContainedIn |
predicate returns true iff the object's retention time range is completely contained within the range of the specified reference object, up to the specified tolerance More... | |
class | RunSummary |
writes table of spectrum metadata to a file More... | |
struct | SavitzkyGolaySmoother |
struct | Smoother |
interface for a one-dimensional smoothing algorithm More... | |
class | SpectrumBinaryData |
writes table of spectrum metadata to a file More... | |
struct | SpectrumDataFilter |
class | SpectrumList_3D |
SpectrumList implementation that can create 3D spectra of ion mobility drift time and m/z. More... | |
class | SpectrumList_ChargeFromIsotope |
SpectrumList implementation that assigns (probable) charge states to tandem mass spectra. More... | |
class | SpectrumList_ChargeStateCalculator |
SpectrumList implementation that assigns (probable) charge states to tandem mass spectra. More... | |
class | SpectrumList_Demux |
SpectrumList decorator implementation that can demultiplex spectra of several precursor windows acquired in the same scan. More... | |
class | SpectrumList_Filter |
SpectrumList filter, for creating Spectrum sub-lists. More... | |
class | SpectrumList_FilterPredicate_ActivationType |
class | SpectrumList_FilterPredicate_AnalyzerType |
class | SpectrumList_FilterPredicate_ChargeStateSet |
class | SpectrumList_FilterPredicate_DefaultArrayLengthSet |
class | SpectrumList_FilterPredicate_IdSet |
class | SpectrumList_FilterPredicate_IndexSet |
class | SpectrumList_FilterPredicate_MSLevelSet |
class | SpectrumList_FilterPredicate_MzPresent |
class | SpectrumList_FilterPredicate_Polarity |
class | SpectrumList_FilterPredicate_PrecursorMzSet |
class | SpectrumList_FilterPredicate_ScanEventSet |
class | SpectrumList_FilterPredicate_ScanNumberSet |
class | SpectrumList_FilterPredicate_ScanTimeRange |
class | SpectrumList_FilterPredicate_ThermoScanFilter |
class | SpectrumList_IonMobility |
SpectrumList implementation that provides access to vendor-specific ion mobility functions. More... | |
class | SpectrumList_LockmassRefiner |
SpectrumList implementation to replace peak profiles with picked peaks. More... | |
class | SpectrumList_MetadataFixer |
SpectrumList implementation to add (or replace) base peak and total ion metadata with new values calculated from the current binary data. More... | |
class | SpectrumList_MZRefiner |
class | SpectrumList_MZWindow |
SpectrumList filter, for creating Spectrum sub-lists. More... | |
class | SpectrumList_PeakFilter |
SpectrumList implementation that returns spectra with the specified SpectrumDataFilter operation applied. More... | |
class | SpectrumList_PeakPicker |
SpectrumList implementation to replace peak profiles with picked peaks. More... | |
class | SpectrumList_PrecursorRecalculator |
SpectrumList wrapper that recalculates precursor info on spectrum() requests. More... | |
class | SpectrumList_PrecursorRefine |
SpectrumList wrapper that recalculates precursor info on spectrum() requests. More... | |
class | SpectrumList_ScanSummer |
Provides a custom-sorted spectrum list. More... | |
class | SpectrumList_Smoother |
SpectrumList implementation to return smoothed spectral data. More... | |
class | SpectrumList_Sorter |
Provides a custom-sorted spectrum list. More... | |
class | SpectrumList_SorterPredicate_ScanStartTime |
class | SpectrumList_TitleMaker |
SpectrumList implementation to add (or replace) a spectrum title to each spectrum according to a user-specified format. More... | |
class | SpectrumList_ZeroSamplesFilter |
SpectrumList implementation to return spectra with or without extra zero samples. More... | |
class | SpectrumListFactory |
Factory for instantiating and wrapping SpectrumLists. More... | |
class | SpectrumPeakExtractor |
Extracts sets of centroided peaks from spectra using a user-defined list of peaks to extract. More... | |
class | SpectrumTable |
writes table of spectrum metadata to a file More... | |
struct | TabularConfig |
struct | ThresholdFilter |
struct | Version |
struct | WhittakerSmoother |
struct | ZeroSampleFiller |
fills in missing zero samples around signal profiles More... | |
Typedefs | |
typedef boost::shared_ptr< SpectrumDataFilter > | SpectrumDataFilterPtr |
typedef boost::shared_ptr< ChromatogramDataFilter > | ChromatogramDataFilterPtr |
typedef boost::shared_ptr< PeakDetector > | PeakDetectorPtr |
typedef boost::shared_ptr< Smoother > | SmootherPtr |
typedef boost::tokenizer< boost::char_separator< char > > | ScanIdTokenizer |
Tool for pulling each scan id attribute and its value from a scan id. More... | |
typedef uint64_t | MZHash |
typedef boost::shared_ptr< MSDataAnalyzer > | MSDataAnalyzerPtr |
typedef MZRTField< pwiz::data::peakdata::Peakel > | PeakelField |
typedef MZRTField< pwiz::data::peakdata::Feature > | FeatureField |
typedef boost::container::flat_map< double, boost::container::flat_map< double, float > > | Spectrum3D |
typedef boost::shared_ptr< Spectrum3D > | Spectrum3DPtr |
typedef SpectrumList_Demux::Params::Optimization | DemuxOptimization |
Functions | |
template<typename T > | |
const std::string & | enumToString (T e, std::map< T, std::string > m) |
Converts an enum to it's corresponding string in a prebuilt map. More... | |
template<typename T > | |
T | stringToEnum (const std::string &s, std::map< T, std::string > m) |
Converts a string to it's corresponding enum in a prebuilt map. More... | |
bool | TryGetScanIDToken (const msdata::SpectrumIdentity &spectrumIdentity, const std::string &tokenName, std::string &value) |
Tries to read the given token from a spectrum identity id. More... | |
bool | TryGetDemuxIndex (const msdata::SpectrumIdentity &spectrumIdentity, size_t &index) |
Tries to read the index of the demultiplexed spectrum relative to the multiplexed spectrum it was derived from. More... | |
bool | TryGetOriginalIndex (const msdata::SpectrumIdentity &spectrumIdentity, size_t &index) |
Tries to read the original index of the spectrum before demultiplexing using the SpectrumIdentity of a (demultiplexed) spectrum. More... | |
bool | TryGetMSLevel (const msdata::Spectrum &spectrum, int &msLevel) |
Tries to read MS level from spectrum. More... | |
bool | TryGetNumPrecursors (const msdata::Spectrum &spectrum, int &numPrecursors) |
Tries to get the number of precursors contributing to a multiplexed spectrum. More... | |
bool | TryGetStartTime (const msdata::Spectrum &spectrum, double &startTime) |
Tries to get the start time of the scan. More... | |
bool | FindNearbySpectra (std::vector< size_t > &spectraIndices, pwiz::msdata::SpectrumList_const_ptr slPtr, size_t centerIndex, size_t numSpectraToFind, size_t stride=1) |
Tries to find a given number of ms2 spectra near the given spectrum index. More... | |
double | precursor_upper_offset (const msdata::Precursor &p) |
double | precursor_lower_offset (const msdata::Precursor &p) |
double | precursor_target (const msdata::Precursor &p) |
double | precursor_mz_low (const msdata::Precursor &p) |
double | precursor_mz_high (const msdata::Precursor &p) |
double | precursor_iso_center (const msdata::Precursor &p) |
double | precursor_iso_width (const msdata::Precursor &p) |
std::string | prec_to_string (const msdata::Precursor &p) |
bool | stringToFloatCompare (std::string i, std::string j) |
template<typename value_type > | |
bool | parseRange (const std::string &desiredArg, const std::string &text, std::pair< value_type, value_type > &result, const std::string &callerName) |
template<typename value_type > | |
bool | parseValue (const std::string &desiredArg, const std::string &text, value_type &result, const std::string &callerName) |
PWIZ_API_DECL std::ostream & | operator<< (std::ostream &os, PepxmlRecordReader &prr) |
PWIZ_API_DECL std::ostream & | operator<< (std::ostream &os, const PeakelField &peakelField) |
PWIZ_API_DECL std::ostream & | operator<< (std::ostream &os, const SpectrumList_Filter::Predicate::FilterMode &mode) |
PWIZ_API_DECL std::istream & | operator>> (std::istream &is, SpectrumList_Filter::Predicate::FilterMode &mode) |
Variables | |
static const char * | defaultNeutralLossFormulae [] |
typedef boost::shared_ptr<SpectrumDataFilter> pwiz::analysis::SpectrumDataFilterPtr |
Definition at line 42 of file DataFilter.hpp.
typedef boost::shared_ptr<ChromatogramDataFilter> pwiz::analysis::ChromatogramDataFilterPtr |
Definition at line 52 of file DataFilter.hpp.
typedef boost::shared_ptr<PeakDetector> pwiz::analysis::PeakDetectorPtr |
Definition at line 57 of file PeakDetector.hpp.
typedef boost::shared_ptr<Smoother> pwiz::analysis::SmootherPtr |
Definition at line 53 of file Smoother.hpp.
typedef boost::tokenizer<boost::char_separator<char> > pwiz::analysis::ScanIdTokenizer |
Tool for pulling each scan id attribute and its value from a scan id.
Scan ids contain sets of attribute-value pairs. Each pair is separated from others by a space. Each attribute is separated from its value by an "=". E.g. "attribute1=value1 attribute2=value2 attribute3=value3"
Definition at line 69 of file DemuxHelpers.hpp.
typedef uint64_t pwiz::analysis::MZHash |
Definition at line 90 of file IPrecursorMaskCodec.hpp.
typedef boost::shared_ptr<MSDataAnalyzer> pwiz::analysis::MSDataAnalyzerPtr |
Definition at line 108 of file MSDataAnalyzer.hpp.
Definition at line 111 of file MZRTField.hpp.
Definition at line 112 of file MZRTField.hpp.
typedef boost::container::flat_map<double, boost::container::flat_map<double, float> > pwiz::analysis::Spectrum3D |
Definition at line 35 of file SpectrumList_3D.hpp.
typedef boost::shared_ptr<Spectrum3D> pwiz::analysis::Spectrum3DPtr |
Definition at line 36 of file SpectrumList_3D.hpp.
Definition at line 118 of file SpectrumList_Demux.hpp.
const std::string& pwiz::analysis::enumToString | ( | T | e, |
std::map< T, std::string > | m | ||
) |
Converts an enum to it's corresponding string in a prebuilt map.
Exception is thrown if map does not contain enum.
[in] | e | The enum |
[out] | m | The map pairing each enum to a string |
Definition at line 45 of file DemuxHelpers.hpp.
T pwiz::analysis::stringToEnum | ( | const std::string & | s, |
std::map< T, std::string > | m | ||
) |
Converts a string to it's corresponding enum in a prebuilt map.
Exception is thrown if map does not contain string.
[in] | s | The string |
[out] | m | The map pairing each enum to a string |
Definition at line 57 of file DemuxHelpers.hpp.
bool pwiz::analysis::TryGetScanIDToken | ( | const msdata::SpectrumIdentity & | spectrumIdentity, |
const std::string & | tokenName, | ||
std::string & | value | ||
) |
Tries to read the given token from a spectrum identity id.
The spectrum identity id is a set of pairs of attribute names (tokens) and their corresponding values.
[in] | spectrumIdentity | The SpectrumIdentity to search |
[in] | tokenName | attribute |
[out] | value | value |
Referenced by DemuxHelpersTest::TryGetScanIDTokenTest().
bool pwiz::analysis::TryGetDemuxIndex | ( | const msdata::SpectrumIdentity & | spectrumIdentity, |
size_t & | index | ||
) |
Tries to read the index of the demultiplexed spectrum relative to the multiplexed spectrum it was derived from.
For example, if a multiplexed spectrum is split into 3 demultiplexed spectra, the resulting spectra will have indices 0, 1, and 2.
[in] | spectrumIdentity | The SpectrumIdentity to search |
[out] | index | The demux index of the spectrum |
Referenced by DemuxHelpersTest::TryGetDemuxIndexTest().
bool pwiz::analysis::TryGetOriginalIndex | ( | const msdata::SpectrumIdentity & | spectrumIdentity, |
size_t & | index | ||
) |
Tries to read the original index of the spectrum before demultiplexing using the SpectrumIdentity of a (demultiplexed) spectrum.
Demultiplexing effectively splits each spectrum into multiple demultiplexed spectra. This method allows for retrieval of the original spectrum before this split.
[in] | spectrumIdentity | The SpectrumIdentity to search |
[out] | index | The original index of the spectrum |
Referenced by testMSXOnly(), testOverlapOnly(), and DemuxHelpersTest::TryGetOriginalIndexTest().
bool pwiz::analysis::TryGetMSLevel | ( | const msdata::Spectrum & | spectrum, |
int & | msLevel | ||
) |
Tries to read MS level from spectrum.
[in] | spectrum | The mass spectrum to read |
[out] | msLevel | The number of sequential MS analyses (e.g. MS = 1, MS/MS = 2) |
Referenced by DemuxHelpersTest::TryGetMSLevelTest().
bool pwiz::analysis::TryGetNumPrecursors | ( | const msdata::Spectrum & | spectrum, |
int & | numPrecursors | ||
) |
Tries to get the number of precursors contributing to a multiplexed spectrum.
This is only well defined for spectra of MS2 or greater. (Note: only parsing of MS2 is implemented currently)
[in] | spectrum | The mass spectrum to read |
[out] | numPrecursors | The number of precursor windows contributing to the given mass spectrum |
Referenced by DemuxHelpersTest::TryGetNumPrecursorsTest().
bool pwiz::analysis::TryGetStartTime | ( | const msdata::Spectrum & | spectrum, |
double & | startTime | ||
) |
Tries to get the start time of the scan.
[in] | spectrum | The mass spectrum to read |
[out] | startTime | The start time of the scan (may also be interpreted as retention time) |
Referenced by DemuxHelpersTest::TryGetStartTimeTest().
bool pwiz::analysis::FindNearbySpectra | ( | std::vector< size_t > & | spectraIndices, |
pwiz::msdata::SpectrumList_const_ptr | slPtr, | ||
size_t | centerIndex, | ||
size_t | numSpectraToFind, | ||
size_t | stride = 1 |
||
) |
Tries to find a given number of ms2 spectra near the given spectrum index.
This handles edge cases near the beginning and end of the SpectrumList and tries to distribute the spectra surrounding the centerIndex as evenly as possible. Throws std::out_of_range exception if center index is not in range of SpectrumList.
[out] | spectraIndices | The indices to the nearby spectra. |
[in] | slPtr | The spectrum list to search |
[in] | centerIndex | Index of spectrum in the given SpectrumList around which to search |
[in] | numSpectraToFind | Number of spectra to find |
[in] | stride | Number of ms2 spectra to step through to find a nearby spectrum. E.g. a stride of 2 would skip every other ms2 spectrum. This will still return the chosen total number of spectra. This is useful when ms2 spectra are collected cyclically and only a single index within that cycle is desired. |
Referenced by DemuxHelpersTest::FindNearbySpectraTest().
|
inline |
Definition at line 29 of file IPrecursorMaskCodec.hpp.
References pwiz::msdata::Precursor::isolationWindow, and MS_isolation_window_upper_offset.
Referenced by pwiz::analysis::DemuxWindow::DemuxWindow(), precursor_iso_center(), precursor_iso_width(), and precursor_mz_high().
|
inline |
Definition at line 40 of file IPrecursorMaskCodec.hpp.
References pwiz::msdata::Precursor::isolationWindow, and MS_isolation_window_lower_offset.
Referenced by pwiz::analysis::DemuxWindow::DemuxWindow(), precursor_iso_center(), precursor_iso_width(), and precursor_mz_low().
|
inline |
Definition at line 51 of file IPrecursorMaskCodec.hpp.
References pwiz::msdata::Precursor::isolationWindow, and MS_isolation_window_target_m_z.
Referenced by pwiz::analysis::DemuxWindow::DemuxWindow(), precursor_iso_center(), precursor_mz_high(), and precursor_mz_low().
|
inline |
Definition at line 59 of file IPrecursorMaskCodec.hpp.
References precursor_lower_offset(), and precursor_target().
|
inline |
Definition at line 64 of file IPrecursorMaskCodec.hpp.
References precursor_target(), and precursor_upper_offset().
|
inline |
Definition at line 69 of file IPrecursorMaskCodec.hpp.
References precursor_lower_offset(), precursor_target(), and precursor_upper_offset().
Referenced by prec_to_string().
|
inline |
Definition at line 77 of file IPrecursorMaskCodec.hpp.
References precursor_lower_offset(), and precursor_upper_offset().
|
inline |
Definition at line 82 of file IPrecursorMaskCodec.hpp.
References pwiz::msdata::detail::Bruker::format(), and precursor_iso_center().
|
inline |
Definition at line 87 of file IPrecursorMaskCodec.hpp.
bool pwiz::analysis::parseRange | ( | const std::string & | desiredArg, |
const std::string & | text, | ||
std::pair< value_type, value_type > & | result, | ||
const std::string & | callerName | ||
) |
Definition at line 193 of file MSDataAnalyzer.hpp.
References boost::lexical_cast().
bool pwiz::analysis::parseValue | ( | const std::string & | desiredArg, |
const std::string & | text, | ||
value_type & | result, | ||
const std::string & | callerName | ||
) |
Definition at line 243 of file MSDataAnalyzer.hpp.
References boost::lexical_cast().
PWIZ_API_DECL std::ostream& pwiz::analysis::operator<< | ( | std::ostream & | os, |
PepxmlRecordReader & | prr | ||
) |
PWIZ_API_DECL std::ostream & pwiz::analysis::operator<< | ( | std::ostream & | os, |
const PeakelField & | peakelField | ||
) |
PWIZ_API_DECL std::ostream& pwiz::analysis::operator<< | ( | std::ostream & | os, |
const SpectrumList_Filter::Predicate::FilterMode & | mode | ||
) |
PWIZ_API_DECL std::istream& pwiz::analysis::operator>> | ( | std::istream & | is, |
SpectrumList_Filter::Predicate::FilterMode & | mode | ||
) |
Referenced by pwiz::util::IntegerSet::Interval::contains().
|
static |
Definition at line 73 of file PrecursorMassFilter.hpp.