DomTools C++ API Reference¶
-
class HitTime_greater¶
Public Functions
-
inline explicit HitTime_greater(double time)¶
-
inline bool operator()(const HitDomPair &hdPair)¶
Private Members
-
double minTime_¶
-
inline explicit HitTime_greater(double time)¶
-
template<class responseClass>
class I3Coincify : public I3ConditionalModule¶ - #include <I3Coincify.h>
IceTray module to apply a Local Coincidence window to I3RecoPulse, I3RecoHit, I3MCHit, I3DOMLaunch.
Private Functions
-
I3Coincify()¶
-
I3Coincify(const I3Coincify &source)¶
-
I3Coincify &operator=(const I3Coincify &source)¶
- SET_LOGGER ("I3Coincify")
-
I3Coincify()¶
-
class I3DistanceMap¶
- #include <I3DistanceMap.h>
Creates a very large vector that contains a map of the distance squared between each OM.
This class trades memory for speed by creating ~300M vector. As distances are requested they are added to the vector. This generated an approximate 5 fold increase in speed.
- Author
Kevin J Meagher
- Date
March 2007
Public Functions
-
inline I3DistanceMap(const I3OMGeoMap &geo)¶
constructor
Gets the geometry to map and allocates the vector
- Parameters:
geo – the geomerty to map
-
inline const I3OMGeoMap &getGeo() const¶
- Returns:
the geometry being used by the distance map
Private Functions
-
inline int32_t getIndex(const OMKey &key1, const OMKey &key2) const¶
- Parameters:
key1 –
key2 –
- Returns:
the a index for a pair of keys
-
inline double setDistance(const OMKey &key1, const OMKey &key2)¶
- Parameters:
key1 –
key2 –
- Returns:
the distance squared between key1 and key2
- SET_LOGGER ("I3DistanceMap")
-
class I3DOMLaunchCleaning : public I3ConditionalModule¶
- #include <I3DOMLaunchCleaning.h>
-
class I3FirstPulsifier : public I3ConditionalModule¶
- #include <I3FirstPulsifier.h>
Returns a pulse series map containing only the first pulses, however each first pulse carrying the total charge of all pulses by default.
This module takes a regular pulse series map as input and returns a pulse series map that has only the first pulses in it. I.e. it converts all the pulse series to a vector of length one containing only the first pulse. This new first pulse has the time and width of the original first pulse, but by default carries the total charge of all pulses that are in the full pulse series. This behaviour can be modified though.
The module is motivated by the calculation of cut variables such as Ndir and Ldir that use the information of when the modules are hit. If not only the first pulse, but all pulses are used for calculation of hit-time-critical cut variables, then late hits on the same module can seriously disturb the result. It has been found that the cut variables effectively lose their cut efficiency if all pulses are used. Calculating Ndir, Ldir etc. using all pulses is more or less meaningless. So please make sure to first-pulsify your pulse series map first.
Keeping only the time and width of the first hit, but the total charge of all hits is meant to circumvent the problem mentioned above, however keeping as much information as possible. If you want to weight the DOMs with their charge, then this might be interesting. However, it may also turn out that keeping the charge of the later hits is not desirable. If you want to keep only the charge of the first pulse, then you can do so by setting the parameter ‘KeepOnlyFirstCharge’ to True.
-
template<class responseClass>
class I3IsolatedHitsCutModule : public I3ConditionalModule¶ - #include <I3IsolatedHitsCutModule.h>
Private Functions
-
I3IsolatedHitsCutModule()¶
-
I3IsolatedHitsCutModule(const I3IsolatedHitsCutModule &source)¶
-
I3IsolatedHitsCutModule &operator=(const I3IsolatedHitsCutModule &source)¶
-
void HitCleaning(I3FramePtr frame)¶
- SET_LOGGER ("I3IsolatedHitsCutModule")
-
template<>
void WriteToFrame(I3FramePtr frame, I3RecoPulseSeriesMapPtr output)¶
-
I3IsolatedHitsCutModule()¶
-
class I3LCCleaning : public I3ConditionalModule¶
- #include <I3LCCleaning.h>
This module splits an I3DOMLaunchSeriesMap into two maps. One of which contains only HLC launches, the other of which contains only SLC launches.
-
class I3LCPulseCleaning : public I3ConditionalModule¶
-
Private Static Functions
-
static inline bool IsHLC(const OMKey &key, unsigned idx, const I3RecoPulse &pulse)¶
-
static inline bool IsSLC(const OMKey &key, unsigned idx, const I3RecoPulse &pulse)¶
-
static inline bool IsHLC(const OMKey &key, unsigned idx, const I3RecoPulse &pulse)¶
-
template<class Selected>
class I3OMSelection : public I3ConditionalModule¶ - #include <I3OMSelection.h>
Public Functions
-
inline void Configure()¶
-
inline void Geometry(I3FramePtr frame)¶
-
inline void HitCleaning(I3FramePtr frame)¶
Private Functions
- SET_LOGGER ("DomTools")
-
inline void Configure()¶
-
template<class responseClass>
class I3ResponseIter¶ - #include <I3ResponseIter.h>
Public Functions
-
inline I3ResponseIter(const I3Map<OMKey, std::vector<responseClass>> &rsm)¶
-
inline void operator++(int)¶
-
inline void operator++()¶
-
inline bool End()¶
-
inline responseClass Get()¶
-
inline int GetSequencenumber()¶
-
inline double GetTime()¶
-
inline double GetAmplitude()¶
-
inline double GetWidth()¶
- SET_LOGGER ("I3ResponseIter")
Private Members
-
I3Map<OMKey, std::vector<responseClass>>::const_iterator response_series_map_iter_¶
-
I3Map<OMKey, std::vector<responseClass>>::const_iterator response_series_map_end_¶
-
std::vector<responseClass>::const_iterator response_series_iter_¶
-
bool valid_response_¶
-
int sequence_number_¶
-
inline I3ResponseIter(const I3Map<OMKey, std::vector<responseClass>> &rsm)¶
-
class I3ResponseMapSplitter : public I3ConditionalModule, private I3Splitter¶
- #include <I3ResponseMapSplitter.h>
hit set splitteer
- Todo:
docs
Public Types
Public Functions
-
inline ~I3ResponseMapSplitter()¶
destructor
-
void Configure()¶
configure (get & check configurables)
-
void Physics(I3FramePtr frame)¶
do a reconstruction
-
void DAQ(I3FramePtr frame)¶
monkey with entire readouts
-
void Finish()¶
say bye
Public Static Functions
New implementation of pulsemap splitting using mean/median time static method for convenience (unit test & external use) instantiated for ResponseMap=I3RecoPulseMap
Note that you really need to call this method with unsigned ints for nhits1 and nhits2, some or all compilers will not accept a call with signed ints here.
- Returns:
split time (useful for testing)
Implementation of geometric pulsemap splitting (using track & COG) static method for convenience (unit test & external use) instantiated for ResponseMap=I3RecoPulseMap
Implementation of geometric pulsemap splitting (using track & time residuals) static method for convenience (unit test & external use) instantiated for ResponseMap=I3RecoPulseMap
Implementation of pulsemap splitting (using pulse charges) static method for convenience (unit test & external use) instantiated for ResponseMap=I3RecoPulseMap
Implementation of k-means clustering algorithm in x and y can rotate into plane defined by a given track before splitting largest number of hit DOMs is in “1” pulse static method for convenience (unit test & external use) instantiated for ResponseMap=I3RecoPulseMap
Private Functions
-
I3ResponseMapSplitter()¶
-
I3ResponseMapSplitter(const I3ResponseMapSplitter &source)¶
inhibited
-
I3ResponseMapSplitter &operator=(const I3ResponseMapSplitter &source)¶
inhibited
-
template<class ResponseMap>
void SplitMap(I3FramePtr frame)¶ record maximum number of hits in set 2
type dependent implementation details
- SET_LOGGER ("I3ResponseMapSplitter")
-
template<>
void WriteOutput(I3FramePtr frame, I3RecoPulseSeriesMapPtr newmap1, I3RecoPulseSeriesMapPtr newmap2)¶
Private Members
-
int minNch_¶
name of I3Geometry object in the frame
-
bool doTRes_¶
minimum number of channels in the response map to be splitted
-
double minTRes_¶
sort hits according to time residual rel to inTrackName_
-
double maxTRes_¶
minimum time residual rel to inTrackName_
-
bool doBrightSt_¶
maximum time residual rel to inTrackName_
-
double maxDBrightSt_¶
sort hits according to proximity to brightest string
-
bool doKmeans_¶
maximum radial distance to brigthest string
-
bool wantRotated_¶
sort hits using k-means clustering
-
bool splitEvents_¶
rotated hits into plane of track before clustering search
-
bool doTMedian_¶
run as an event splitter
-
splitweight_t tSplitWeight_¶
option name for time based splitting strategy
-
unsigned int nEvents_¶
name of the other half of the response map
-
unsigned int nBadEvents_¶
count events with enough hits to split
-
unsigned int nHits1_¶
count events with too few hits
-
unsigned int nHits2_¶
count total number of hits in set 1
-
unsigned int nMinHits1_¶
count total number of hits in set 2
-
unsigned int nMinHits2_¶
record minimum number of hits in set 1
-
unsigned int nMaxHits1_¶
record minimum number of hits in set 2
-
unsigned int nMaxHits2_¶
record maximum number of hits in set 1
-
template<class SignalType>
class I3TimeWindowCleaning : public I3ConditionalModule¶ - #include <I3TimeWindowCleaning.h>
Public Functions
-
void Physics(I3FramePtr frame)¶
-
void Configure()¶
-
template<>
void Configure()¶
-
template<>
void Physics(I3FramePtr frame)¶
Private Functions
- SET_LOGGER ("I3TimeWindowCleaning")
-
void Physics(I3FramePtr frame)¶
-
namespace domtools¶
Functions
-
inline double GetTime(const I3RecoPulse &pulse)¶
-
inline double GetTime(const I3DOMLaunch &launch)¶
-
inline double GetWidth(const I3RecoPulse &pulse)¶
-
inline double GetWidth(const I3DOMLaunch &launch)¶
-
inline double GetAmplitude(const I3RecoPulse &pulse)¶
-
inline double GetAmplitude(const I3DOMLaunch &launch)¶
-
inline double GetTime(const I3RecoPulse &pulse)¶
-
namespace std
STL namespace.
- file I3Coincify.cxx
- #include “DomTools/I3Coincify.h”#include <dataclasses/physics/I3RecoPulse.h>#include <dataclasses/physics/I3RecoHit.h>#include <dataclasses/physics/I3MCHit.h>
Functions
-
I3_MODULE(I3Coincify<I3RecoPulse>)¶
copyright (C) 2005 the IceCube collaboration Version $Id$
-
I3_MODULE(I3Coincify<I3RecoHit>)¶
-
I3_MODULE(I3Coincify<I3MCHit>)¶
-
I3_MODULE(I3Coincify<I3DOMLaunch>)¶
-
I3_MODULE(I3Coincify<I3RecoPulse>)¶
- file I3Coincify.h
- #include “icetray/I3ConditionalModule.h”#include “icetray/I3Frame.h”#include “icetray/I3Units.h”#include “dataclasses/I3Map.h”#include “DomTools/I3ResponseIter.h”#include “DomTools/Utility.h”#include <string>#include <cmath>
copyright (C) 2005 the IceCube collaboration Version $Id$
- Version
$Revision:$
- Date
$Date$
- file I3DistanceMap.h
- #include <dataclasses/geometry/I3Geometry.h>#include <dataclasses/I3Position.h>#include <boost/foreach.hpp>#include <limits>#include <cmath>
- file I3DOMLaunchCleaning.cxx
- #include <algorithm>#include <boost/foreach.hpp>#include <dataclasses/physics/I3DOMLaunch.h>#include <dataclasses/I3Vector.h>#include <icetray/I3Frame.h>#include <DomTools/I3DOMLaunchCleaning.h>
Functions
-
I3_MODULE(I3DOMLaunchCleaning)¶
copyright (C) 2005 the IceCube collaboration Version $Id$
-
I3_MODULE(I3DOMLaunchCleaning)¶
- file I3DOMLaunchCleaning.h
- #include <icetray/I3ConditionalModule.h>#include <icetray/OMKey.h>
copyright (C) 2005 the IceCube collaboration Version $Id$
- Version
$Revision:$
- Date
$Date$
- file I3FirstPulsifier.cxx
- #include “DomTools/I3FirstPulsifier.h”#include <string>
Functions
-
I3_MODULE(I3FirstPulsifier)¶
-
I3RecoPulseSeriesMap GetFirstPulseSeriesMap(const I3RecoPulseSeriesMap&, bool)¶
-
I3RecoPulseSeriesMapMask GetFirstPulseSeriesMapMask(const I3Frame&, const std::string&)¶
-
bool compare(const I3RecoPulse &a, const I3RecoPulse &b)¶
-
I3_MODULE(I3FirstPulsifier)¶
- file I3FirstPulsifier.h
- #include “icetray/I3ConditionalModule.h”#include “icetray/I3Context.h”#include “dataclasses/physics/I3RecoPulse.h”#include “dataclasses/I3MapOMKeyMask.h”
This class takes a pulse series map, extracts only the first pulse of each pulse series and puts a new pulse series map with only the first pulses into the frame. The charge of the new pulse is by default the total charge of all pulses.
Definition of I3FirstPulsifier class
copyright (C) 2012 The IceCube collaboration $Id$
- Version
$Revision$
- Date
$Date$
- Author
Markus Voge voge@physik.uni-bonn.de
- file I3IsolatedHitsCutModule.cxx
- #include <cmath>#include <dataclasses/I3MapOMKeyMask.h>#include <dataclasses/physics/I3RecoPulse.h>#include <DomTools/I3IsolatedHitsCutModule.h>
copyright (C) 2005 the icecube collaboration Some functionalities of this module have been taken from the Sieglinde SLHitSel(ector) module $Id$
- Version
- Rcs
1.45
- Date
$Date$
- Author
Ralf Ehrlich
Functions
-
I3_MODULE(I3IsolatedHitsCutModule<I3RecoPulse>)¶
- file I3IsolatedHitsCutModule.h
- #include <string>#include <icetray/I3ConditionalModule.h>#include <icetray/I3Frame.h>#include <dataclasses/I3Map.h>#include <dataclasses/geometry/I3Geometry.h>#include <icetray/I3Units.h>#include <DomTools/I3ResponseIter.h>#include <DomTools/I3DistanceMap.h>
copyright (C) 2005 the icecube collaboration Some functionalities of this module have been taken from the Sieglinde SLHitSel(ector) module $Id$
- Version
- Rcs
1.45
- Date
$Date$
- Author
Ralf Ehrlich
- file I3LCCleaning.cxx
- #include “DomTools/I3LCCleaning.h”#include <icetray/I3Frame.h>#include <dataclasses/physics/I3DOMLaunch.h>#include <dataclasses/physics/I3RecoPulse.h>#include <dataclasses/I3MapOMKeyMask.h>
Functions
-
I3_MODULE(I3LCCleaning)¶
copyright (C) 2007 the IceCube collaboration Version
Author: wikstrom
- Rcs
-
I3_MODULE(I3LCCleaning)¶
- file I3LCCleaning.h
- #include <icetray/I3ConditionalModule.h>#include <icetray/OMKey.h>
copyright (C) 2007 the IceCube collaboration Version
- Rcs
- Version
$Revision:$
- Date
- Rcs
- Author
: wikstrom
- file I3OMSelection.cxx
- #include <DomTools/I3OMSelection.h>#include <dataclasses/physics/I3RecoPulse.h>#include <dataclasses/physics/I3DOMLaunch.h>
Functions
-
I3_MODULE(I3OMSelection<I3RecoPulseSeries>)¶
copyright (C) 2005 the IceCube collaboration Version $Id$
-
I3_MODULE(I3OMSelection<I3DOMLaunchSeries>)¶
-
I3_MODULE(I3OMSelection<I3RecoPulseSeries>)¶
- file I3OMSelection.h
- #include <icetray/I3ConditionalModule.h>#include <icetray/I3Frame.h>#include <icetray/OMKey.h>#include <dataclasses/I3Map.h>#include <dataclasses/I3Vector.h>#include <dataclasses/geometry/I3Geometry.h>#include <dataclasses/physics/I3DOMLaunch.h>#include <vector>#include <set>#include <fstream>#include <iostream>
copyright (C) 2005 the IceCube collaboration Version $Id$
- Version
$Revision:$
- Date
$Date$
- file I3ResponseIter.h
- #include “DomTools/Utility.h”#include “icetray/OMKey.h”#include “dataclasses/I3Map.h”#include “icetray/I3Logging.h”#include <string>#include <map>#include <vector>
copyright (C) 2005 the IceCube collaboration Version $Id$
- Version
$Revision:$
- Date
$Date$
- file I3ResponseMapSplitter.cxx
- #include “icetray/IcetrayFwd.h”#include <vector>#include <string>#include <utility>#include <list>#include <functional>#include <cmath>#include “DomTools/I3ResponseMapSplitter.h”#include “dataclasses/physics/I3RecoPulse.h”#include “dataclasses/I3MapOMKeyMask.h”#include “icetray/I3Context.h”#include “icetray/I3Frame.h”#include “dataclasses/geometry/I3Geometry.h”#include “phys-services/I3Cuts.h”#include “phys-services/I3Calculator.h”#include “phys-services/I3RandomService.h”#include “dataclasses/physics/I3EventHeader.h”
copyright (C) 2005 the icecube collaboration $Id$
- Version
$Revision$
- Date
$Date$
- Author
boersma
Functions
-
I3_MODULE(I3ResponseMapSplitter)¶
Variables
- file I3ResponseMapSplitter.h
- #include <vector>#include “icetray/I3ConditionalModule.h”#include “icetray/IcetrayFwd.h”#include “dataclasses/geometry/I3Geometry.h”#include “dataclasses/physics/I3Particle.h”#include “dataclasses/I3Map.h”#include “icetray/OMKey.h”#include “phys-services/I3Splitter.h”#include “phys-services/I3RandomService.h”
copyright (C) 2005 the icecube collaboration $Id$
- Version
$Revision$
- Date
$Date$
- Author
boersma
- file I3TimeWindowCleaning.cxx
- #include <dataclasses/physics/I3RecoHit.h>#include <dataclasses/physics/I3MCHit.h>#include <dataclasses/physics/I3RecoPulse.h>#include <dataclasses/physics/I3DOMLaunch.h>#include “DomTools/I3TimeWindowCleaning.h”
Functions
-
I3_MODULE(I3TimeWindowCleaning<I3RecoHit>)¶
copyright (C) 2005 the IceCube collaboration Version $Id$
-
I3_MODULE(I3TimeWindowCleaning<I3RecoPulse>)¶
-
I3_MODULE(I3TimeWindowCleaning<I3DOMLaunch>)¶
-
I3_MODULE(I3TimeWindowCleaning<I3RecoHit>)¶
- file I3TimeWindowCleaning.h
- #include <icetray/I3ConditionalModule.h>#include <icetray/OMKey.h>#include <icetray/I3Frame.h>#include <vector>#include <dataclasses/I3Map.h>#include <dataclasses/I3MapOMKeyMask.h>#include <sstream>#include <DomTools/Utility.h>
copyright (C) 2005 the IceCube collaboration Version $Id$
- Version
$Revision:$
- Date
$Date$
- file modules.dox
- file Utility.h
- #include <dataclasses/physics/I3RecoHit.h>#include <dataclasses/physics/I3RecoPulse.h>#include <dataclasses/physics/I3DOMLaunch.h>#include <dataclasses/physics/I3MCHit.h>#include <icetray/I3Units.h>#include <cmath>
copyright (C) 2005 the IceCube collaboration Version $Id$
- Version
$Revision:$
- Date
$Date$
- page DomTools-modules-and-params
Summary of I3Modules and I3ServiceFactories and their parameters
DomTools
http://code.icecube.wisc.edu/svn/projects/DomTools/trunk at revision 21318
Name
Description
Default
I3Coincify<I3DOMLaunch>
coincidenceneighbors
How far to look for neighbors
1
coincidencewindow
Time window for local coincidence
800
inputname
Name of the input response series map
outputname
Name of the output response series map
Coincified
IsolatedResponseName
Name of the output response series map containing all the responses that failed the given coincidence condition
I3Coincify<I3MCHit>
coincidenceneighbors
How far to look for neighbors
1
coincidencewindow
Time window for local coincidence
800
inputname
Name of the input response series map
outputname
Name of the output response series map
Coincified
IsolatedResponseName
Name of the output response series map containing all the responses that failed the given coincidence condition
I3Coincify<I3RecoHit>
coincidenceneighbors
How far to look for neighbors
1
coincidencewindow
Time window for local coincidence
800
inputname
Name of the input response series map
outputname
Name of the output response series map
Coincified
IsolatedResponseName
Name of the output response series map containing all the responses that failed the given coincidence condition
I3Coincify<I3RecoPulse>
coincidenceneighbors
How far to look for neighbors
1
coincidencewindow
Time window for local coincidence
800
inputname
Name of the input response series map
outputname
Name of the output response series map
Coincified
IsolatedResponseName
Name of the output response series map containing all the responses that failed the given coincidence condition
cleanedkeys
OMKeys to clean out of the launch map
[vector 0 ]
firstlaunchcleaning
True if you want to clean out all but the first DOM launch
0
icetopinput
input icetop DOMLaunches
IceTopRawData
icetopoutput
output icetop DOMLaunches
CleanIceTopRawData
iniceinput
input inice DOMLaunches
InIceRawData
iniceoutput
output inice DOMLaunches
CleanInIceRawData
I3IsolatedHitsCutModule<I3DOMLaunch>
inputresponse
Name of the input reco pulse series
outputresponse
Name of the output reco pulse series
rtmultiplicity
reject all pulses that have a smaller count (spacial/temporal) than RTMultiplicity
1
rtradius
count pulses within this radius towards multiplicity - NAN=no cut on spacial isolation
nan
rttime
count pulses within this time range towards multiplicity - NAN=no cut on temporal isolation
nan
I3IsolatedHitsCutModule<I3MCHit>
inputresponse
Name of the input reco pulse series
outputresponse
Name of the output reco pulse series
rtmultiplicity
reject all pulses that have a smaller count (spacial/temporal) than RTMultiplicity
1
rtradius
count pulses within this radius towards multiplicity - NAN=no cut on spacial isolation
nan
rttime
count pulses within this time range towards multiplicity - NAN=no cut on temporal isolation
nan
I3IsolatedHitsCutModule<I3RecoHit>
inputresponse
Name of the input reco pulse series
outputresponse
Name of the output reco pulse series
rtmultiplicity
reject all pulses that have a smaller count (spacial/temporal) than RTMultiplicity
1
rtradius
count pulses within this radius towards multiplicity - NAN=no cut on spacial isolation
nan
rttime
count pulses within this time range towards multiplicity - NAN=no cut on temporal isolation
nan
I3IsolatedHitsCutModule<I3RecoPulse>
inputresponse
Name of the input reco pulse series
outputresponse
Name of the output reco pulse series
rtmultiplicity
reject all pulses that have a smaller count (spacial/temporal) than RTMultiplicity
1
rtradius
count pulses within this radius towards multiplicity - NAN=no cut on spacial isolation
nan
rttime
count pulses within this time range towards multiplicity - NAN=no cut on temporal isolation
nan
I3MaxHitsCutModule<I3DOMLaunchSeries>
inputresponse
Name of the input response
input
maxhits
Maximum hits per OM
1
outputresponse
Name of the output response
output
I3MaxHitsCutModule<I3MCHitSeries>
inputresponse
Name of the input response
input
maxhits
Maximum hits per OM
1
outputresponse
Name of the output response
output
I3MaxHitsCutModule<I3RecoHitSeries>
inputresponse
Name of the input response
input
maxhits
Maximum hits per OM
1
outputresponse
Name of the output response
output
I3MaxHitsCutModule<I3RecoPulseSeries>
inputresponse
Name of the input response
input
maxhits
Maximum hits per OM
1
outputresponse
Name of the output response
output
I3OMSelection<I3AMANDAAnalogReadout>
badomfilename
Name of a file containing bad OMKeys
inputomselection
Name of a previously-existing OMSelection that you’d like to append to
inputresponse
Name of the input response
input
omittedkeys
OMKeys for OMs that we want to clean out
[vector 0 ]
omittedstrings
Strings for OMs that we want to clean out
[vector 0 ]
outputomselection
Name of the new OMSelection that will be created
BadOMSelection
outputresponse
Name of the output response
output
I3OMSelection<I3DOMLaunchSeries>
badomfilename
Name of a file containing bad OMKeys
inputomselection
Name of a previously-existing OMSelection that you’d like to append to
inputresponse
Name of the input response
input
omittedkeys
OMKeys for OMs that we want to clean out
[vector 0 ]
omittedstrings
Strings for OMs that we want to clean out
[vector 0 ]
outputomselection
Name of the new OMSelection that will be created
BadOMSelection
outputresponse
Name of the output response
output
I3OMSelection<I3RecoHitSeries>
badomfilename
Name of a file containing bad OMKeys
inputomselection
Name of a previously-existing OMSelection that you’d like to append to
inputresponse
Name of the input response
input
omittedkeys
OMKeys for OMs that we want to clean out
[vector 0 ]
omittedstrings
Strings for OMs that we want to clean out
[vector 0 ]
outputomselection
Name of the new OMSelection that will be created
BadOMSelection
outputresponse
Name of the output response
output
I3OMSelection<I3RecoPulseSeries>
badomfilename
Name of a file containing bad OMKeys
inputomselection
Name of a previously-existing OMSelection that you’d like to append to
inputresponse
Name of the input response
input
omittedkeys
OMKeys for OMs that we want to clean out
[vector 0 ]
omittedstrings
Strings for OMs that we want to clean out
[vector 0 ]
outputomselection
Name of the new OMSelection that will be created
BadOMSelection
outputresponse
Name of the output response
output
I3TimeWindowCleaning<I3DOMLaunch>
inputresponse
The detector response object to read in
hits
outputresponse
The detector response object to read in
hitsClean
timewindow
The window that is used in cleaning out DOMs.
4000
I3TimeWindowCleaning<I3MCHit>
inputresponse
The detector response object to read in
hits
outputresponse
The detector response object to read in
hitsClean
timewindow
The window that is used in cleaning out DOMs.
4000
I3TimeWindowCleaning<I3RecoHit>
inputresponse
The detector response object to read in
hits
outputresponse
The detector response object to read in
hitsClean
timewindow
The window that is used in cleaning out DOMs.
4000
I3TimeWindowCleaning<I3RecoPulse>
inputresponse
The detector response object to read in
hits
outputresponse
The detector response object to read in
hitsClean
timewindow
The window that is used in cleaning out DOMs.
4000
- page todo
- Class I3ResponseMapSplitter
docs
- dir DomTools
- dir DomTools
- dir DomTools
- dir icetray
- dir private
- dir public