CMS 3D CMS Logo

List of all members | Public Member Functions | Private Types | Private Member Functions | Private Attributes | Static Private Attributes
SSDigitizerAlgorithm Class Reference

#include <SSDigitizerAlgorithm.h>

Inheritance diagram for SSDigitizerAlgorithm:
Phase2TrackerDigitizerAlgorithm

Public Member Functions

void init (const edm::EventSetup &es) override
 
bool isAboveThreshold (const digitizerUtility::SimHitInfo *hitInfo, float charge, float thr) const override
 
bool select_hit (const PSimHit &hit, double tCorr, double &sigScale) const override
 
 SSDigitizerAlgorithm (const edm::ParameterSet &conf, edm::ConsumesCollector iC)
 
 ~SSDigitizerAlgorithm () override
 
- Public Member Functions inherited from Phase2TrackerDigitizerAlgorithm
virtual void accumulateSimHits (const std::vector< PSimHit >::const_iterator inputBegin, const std::vector< PSimHit >::const_iterator inputEnd, const size_t inputBeginGlobalIndex, const uint32_t tofBin, const Phase2TrackerGeomDetUnit *pixdet, const GlobalVector &bfield)
 
virtual void digitize (const Phase2TrackerGeomDetUnit *pixdet, std::map< int, digitizerUtility::DigiSimInfo > &digi_map, const TrackerTopology *tTopo)
 
virtual void initializeEvent (CLHEP::HepRandomEngine &eng)
 
void loadAccumulator (uint32_t detId, const std::map< int, float > &accumulator)
 
 Phase2TrackerDigitizerAlgorithm (const edm::ParameterSet &conf_common, const edm::ParameterSet &conf_specific, edm::ConsumesCollector iC)
 
virtual ~Phase2TrackerDigitizerAlgorithm ()
 

Private Types

enum  {
  SquareWindow, SampledMode, LatchedMode, SampledOrLachedMode,
  HIPFindingMode
}
 

Private Member Functions

double cbc3PulsePolarExpansion (double x) const
 
double getSignalScale (double xval) const
 
void module_killing_DB (const Phase2TrackerGeomDetUnit *pixdet) override
 
bool select_hit_latchedMode (const PSimHit &hit, double tCorr, double &sigScale) const
 
bool select_hit_sampledMode (const PSimHit &hit, double tCorr, double &sigScale) const
 
double signalShape (double x) const
 
void storeSignalShape ()
 

Private Attributes

const SiStripBadStripbadChannelPayload_
 
edm::ESGetToken< SiStripBadStrip, SiPhase2OuterTrackerBadStripRcdbadChannelToken_
 
float deadTime_
 
const edm::ESGetToken< TrackerGeometry, TrackerDigiGeometryRecordgeomToken_
 
int hitDetectionMode_
 
std::vector< double > pulseShapeParameters_
 
std::vector< double > pulseShapeVec_
 
edm::ESGetToken< SiPhase2OuterTrackerLorentzAngle, SiPhase2OuterTrackerLorentzAngleSimRcdsiPhase2OTLorentzAngleToken_
 

Static Private Attributes

static constexpr float bx_time {25}
 
static constexpr size_t interpolationPoints {1000}
 
static constexpr int interpolationStep {10}
 

Additional Inherited Members

- Protected Types inherited from Phase2TrackerDigitizerAlgorithm
using Frame = GloballyPositioned< double >
 
using Parameters = std::vector< edm::ParameterSet >
 
using signal_map_type = std::map< int, digitizerUtility::Ph2Amplitude, std::less< int > >
 
using signalMaps = std::map< uint32_t, signal_map_type >
 
- Protected Member Functions inherited from Phase2TrackerDigitizerAlgorithm
virtual void add_cross_talk (const Phase2TrackerGeomDetUnit *pixdet)
 
virtual void add_noise (const Phase2TrackerGeomDetUnit *pixdet)
 
virtual void add_noisy_cells (const Phase2TrackerGeomDetUnit *pixdet, float thePixelThreshold)
 
float calcQ (float x)
 
int convertSignalToAdc (uint32_t detID, float signal_in_elec, float threshold)
 
virtual std::vector< digitizerUtility::SignalPointdrift (const PSimHit &hit, const Phase2TrackerGeomDetUnit *pixdet, const GlobalVector &bfield, const std::vector< digitizerUtility::EnergyDepositUnit > &ionization_points) const
 
LocalVector driftDirection (const Phase2TrackerGeomDetUnit *pixdet, const GlobalVector &bfield, const DetId &detId) const
 
virtual std::vector< float > fluctuateEloss (int particleId, float momentum, float eloss, float length, int NumberOfSegments) const
 
virtual void induce_signal (std::vector< PSimHit >::const_iterator inputBegin, const PSimHit &hit, const size_t hitIndex, const size_t firstHitIndex, const uint32_t tofBin, const Phase2TrackerGeomDetUnit *pixdet, const std::vector< digitizerUtility::SignalPoint > &collection_points)
 
virtual void module_killing_conf (uint32_t detID)
 
virtual void pixel_inefficiency (const SubdetEfficiencies &eff, const Phase2TrackerGeomDetUnit *pixdet, const TrackerTopology *tTopo)
 
virtual void pixel_inefficiency_db (uint32_t detID)
 
virtual std::vector< digitizerUtility::EnergyDepositUnitprimary_ionization (const PSimHit &hit) const
 
- Protected Attributes inherited from Phase2TrackerDigitizerAlgorithm
signalMaps _signal
 
const bool addNoise_
 
const bool addNoisyPixels_
 
const bool addPixelInefficiency_
 
const bool addThresholdSmearing_
 
const bool addXtalk_
 
const bool alpha2Order_
 
Parameters badPixels_
 
const float clusterWidth_
 
const Parameters deadModules_
 
const std::unique_ptr< SiG4UniversalFluctuationfluctuate_
 
const bool fluctuateCharge_
 
std::unique_ptr< CLHEP::RandGaussQ > gaussDistribution_
 
const TrackerGeometrygeom_
 
const float GeVperElectron_
 
const float interstripCoupling_
 
const bool makeDigiSimLinks_
 
bool pixelFlag_
 
const double pseudoRadDamage_
 
const double pseudoRadDamageRadius_
 
CLHEP::HepRandomEngine * rengine_
 
const float Sigma0_
 
const float SigmaCoeff_
 
const SiPhase2OuterTrackerLorentzAnglesiPhase2OTLorentzAngle_
 
const SiPixelQualitysiPixelBadModule_
 
const SiPixelLorentzAnglesiPixelLorentzAngle_
 
std::unique_ptr< CLHEP::RandGaussQ > smearedThreshold_Barrel_
 
std::unique_ptr< CLHEP::RandGaussQ > smearedThreshold_Endcap_
 
const SubdetEfficiencies subdetEfficiencies_
 
const float tanLorentzAnglePerTesla_Barrel_
 
const float tanLorentzAnglePerTesla_Endcap_
 
const int theAdcFullScale_
 
const float theElectronPerADC_
 
const double theHIPThresholdInE_Barrel_
 
const double theHIPThresholdInE_Endcap_
 
const float theNoiseInElectrons_
 
const std::unique_ptr< GaussianTailNoiseGeneratortheNoiser_
 
const int thePhase2ReadoutMode_
 
const float theReadoutNoise_
 
const std::unique_ptr< SiPixelChargeReweightingAlgorithmtheSiPixelChargeReweightingAlgorithm_
 
const std::unique_ptr< SiPixelGainCalibrationOfflineSimServicetheSiPixelGainCalibrationService_
 
const float theThresholdInE_Barrel_
 
const float theThresholdInE_Endcap_
 
const double theThresholdSmearing_Barrel_
 
const double theThresholdSmearing_Endcap_
 
const float theTofLowerCut_
 
const float theTofUpperCut_
 
const double tMax_
 
const bool use_deadmodule_DB_
 
const bool use_ineff_from_db_
 
const bool use_LorentzAngle_DB_
 
const bool use_module_killing_
 
const bool useChargeReweighting_
 

Detailed Description

Definition at line 10 of file SSDigitizerAlgorithm.h.

Member Enumeration Documentation

◆ anonymous enum

anonymous enum
private

Constructor & Destructor Documentation

◆ SSDigitizerAlgorithm()

SSDigitizerAlgorithm::SSDigitizerAlgorithm ( const edm::ParameterSet conf,
edm::ConsumesCollector  iC 
)

Definition at line 40 of file SSDigitizerAlgorithm.cc.

References Phase2TrackerDigitizerAlgorithm::addPixelInefficiency_, badChannelToken_, edm::ConsumesCollector::esConsumes(), edm::ParameterSet::getParameter(), LogDebug, Phase2TrackerDigitizerAlgorithm::pixelFlag_, siPhase2OTLorentzAngleToken_, storeSignalShape(), AlCaHLTBitMon_QueryRunRegistry::string, Phase2TrackerDigitizerAlgorithm::theAdcFullScale_, Phase2TrackerDigitizerAlgorithm::theElectronPerADC_, Phase2TrackerDigitizerAlgorithm::theThresholdInE_Barrel_, Phase2TrackerDigitizerAlgorithm::theThresholdInE_Endcap_, Phase2TrackerDigitizerAlgorithm::tMax_, Phase2TrackerDigitizerAlgorithm::use_deadmodule_DB_, and Phase2TrackerDigitizerAlgorithm::use_LorentzAngle_DB_.

42  conf.getParameter<ParameterSet>("SSDigitizerAlgorithm"),
43  iC),
44  hitDetectionMode_(conf.getParameter<ParameterSet>("SSDigitizerAlgorithm").getParameter<int>("HitDetectionMode")),
45  pulseShapeParameters_(conf.getParameter<ParameterSet>("SSDigitizerAlgorithm")
46  .getParameter<std::vector<double> >("PulseShapeParameters")),
47  deadTime_(conf.getParameter<ParameterSet>("SSDigitizerAlgorithm").getParameter<double>("CBCDeadTime")),
48  geomToken_(iC.esConsumes()) {
51 
52  if (use_deadmodule_DB_) {
53  std::string badChannelLabel_ = conf.getParameter<ParameterSet>("SSDigitizerAlgorithm")
54  .getUntrackedParameter<std::string>("BadChannelLabel", "");
55  badChannelToken_ = iC.esConsumes(edm::ESInputTag{"", badChannelLabel_});
56  }
57 
58  pixelFlag_ = false;
59  LogDebug("SSDigitizerAlgorithm ") << "SSDigitizerAlgorithm constructed "
60  << "Configuration parameters:"
61  << "Threshold/Gain = "
62  << "threshold in electron Endcap = " << theThresholdInE_Endcap_
63  << "threshold in electron Barrel = " << theThresholdInE_Barrel_ << " "
64  << theElectronPerADC_ << " " << theAdcFullScale_ << " The delta cut-off is set to "
65  << tMax_ << " pix-inefficiency " << addPixelInefficiency_;
67 }
T getParameter(std::string const &) const
Definition: ParameterSet.h:307
const edm::ESGetToken< TrackerGeometry, TrackerDigiGeometryRecord > geomToken_
Phase2TrackerDigitizerAlgorithm(const edm::ParameterSet &conf_common, const edm::ParameterSet &conf_specific, edm::ConsumesCollector iC)
std::vector< double > pulseShapeParameters_
edm::ESGetToken< SiStripBadStrip, SiPhase2OuterTrackerBadStripRcd > badChannelToken_
edm::ESGetToken< SiPhase2OuterTrackerLorentzAngle, SiPhase2OuterTrackerLorentzAngleSimRcd > siPhase2OTLorentzAngleToken_
#define LogDebug(id)

◆ ~SSDigitizerAlgorithm()

SSDigitizerAlgorithm::~SSDigitizerAlgorithm ( )
override

Definition at line 68 of file SSDigitizerAlgorithm.cc.

References LogDebug.

68 { LogDebug("SSDigitizerAlgorithm") << "SSDigitizerAlgorithm deleted"; }
#define LogDebug(id)

Member Function Documentation

◆ cbc3PulsePolarExpansion()

double SSDigitizerAlgorithm::cbc3PulsePolarExpansion ( double  x) const
private

Definition at line 124 of file SSDigitizerAlgorithm.cc.

References ALPAKA_ACCELERATOR_NAMESPACE::brokenline::constexpr(), funct::cos(), hcaldqm::quantity::fN, mps_fire::i, dqmiolumiharvest::j, funct::pow(), pulseShapeParameters_, alignCSCRings::r, funct::sin(), theta(), x, and geometryCSVtoXML::xx.

Referenced by signalShape().

124  {
125  constexpr size_t max_par = 6;
126  if (pulseShapeParameters_.size() < max_par)
127  return -1;
128  double xOffset = pulseShapeParameters_[0];
129  double tau = pulseShapeParameters_[1];
130  double r = pulseShapeParameters_[2];
131  double theta = pulseShapeParameters_[3];
132  int nTerms = static_cast<int>(pulseShapeParameters_[4]);
133 
134  double fN = 0;
135  double xx = x - xOffset;
136  if (xx < 0)
137  return 0;
138 
139  for (int i = 0; i < nTerms; i++) {
140  double angularTerm = 0;
141  double temporalTerm = 0;
142  double rTerm = std::pow(r, i) / (std::pow(tau, 2. * i) * ::nFactorial(i + 2));
143  for (int j = 0; j <= i; j++) {
144  angularTerm += std::pow(std::cos(theta), (double)(i - j)) * std::pow(std::sin(theta), (double)j);
145  temporalTerm += ::aScalingConstant(i, j) * std::pow(xx, (double)(i - j)) * std::pow(tau, (double)j);
146  }
147  double fi = rTerm * angularTerm * temporalTerm;
148 
149  fN += fi;
150  }
151  return fN;
152 }
Sin< T >::type sin(const T &t)
Definition: Sin.h:22
Cos< T >::type cos(const T &t)
Definition: Cos.h:22
std::vector< double > pulseShapeParameters_
Geom::Theta< T > theta() const
Power< A, B >::type pow(const A &a, const B &b)
Definition: Power.h:29

◆ getSignalScale()

double SSDigitizerAlgorithm::getSignalScale ( double  xval) const
private

Definition at line 168 of file SSDigitizerAlgorithm.cc.

References reco::ceil(), mps_fire::i, interpolationStep, pulseShapeVec_, heppy_batch::val, and makeMEIFBenchmarkPlots::xval.

Referenced by select_hit_latchedMode(), and select_hit_sampledMode().

168  {
169  double res = 0.0;
170  int len = pulseShapeVec_.size();
171 
172  if (xval < 0.0 || xval * interpolationStep >= len)
173  return res;
174 
175  unsigned int lower = std::floor(xval) * interpolationStep;
176  unsigned int upper = std::ceil(xval) * interpolationStep;
177  for (size_t i = lower + 1; i < upper * interpolationStep; i++) {
178  float val = i * 0.1;
179  if (val > xval) {
180  res = pulseShapeVec_[i - 1];
181  break;
182  }
183  }
184  return res;
185 }
constexpr int32_t ceil(float num)
Definition: Electron.h:6
std::vector< double > pulseShapeVec_
static constexpr int interpolationStep

◆ init()

void SSDigitizerAlgorithm::init ( const edm::EventSetup es)
overridevirtual

Implements Phase2TrackerDigitizerAlgorithm.

Definition at line 30 of file SSDigitizerAlgorithm.cc.

References edm::EventSetup::getData().

30  {
31  if (use_LorentzAngle_DB_) // Get Lorentz angle from DB record
33 
34  if (use_deadmodule_DB_) // Get Bad Channel (SiStripBadStrip) from DB
36 
37  geom_ = &es.getData(geomToken_);
38 }
T const & getData(const ESGetToken< T, R > &iToken) const noexcept(false)
Definition: EventSetup.h:119
const edm::ESGetToken< TrackerGeometry, TrackerDigiGeometryRecord > geomToken_
const SiPhase2OuterTrackerLorentzAngle * siPhase2OTLorentzAngle_
edm::ESGetToken< SiStripBadStrip, SiPhase2OuterTrackerBadStripRcd > badChannelToken_
const SiStripBadStrip * badChannelPayload_
edm::ESGetToken< SiPhase2OuterTrackerLorentzAngle, SiPhase2OuterTrackerLorentzAngleSimRcd > siPhase2OTLorentzAngleToken_

◆ isAboveThreshold()

bool SSDigitizerAlgorithm::isAboveThreshold ( const digitizerUtility::SimHitInfo hitInfo,
float  charge,
float  thr 
) const
overridevirtual

Reimplemented from Phase2TrackerDigitizerAlgorithm.

Definition at line 189 of file SSDigitizerAlgorithm.cc.

References ALCARECOTkAlJpsiMuMu_cff::charge.

191  {
192  return (charge >= thr);
193 }

◆ module_killing_DB()

void SSDigitizerAlgorithm::module_killing_DB ( const Phase2TrackerGeomDetUnit pixdet)
overrideprivatevirtual

Implements Phase2TrackerDigitizerAlgorithm.

Definition at line 197 of file SSDigitizerAlgorithm.cc.

References Phase2TrackerDigitizerAlgorithm::_signal, badChannelPayload_, SiStripBadStrip::decodePhase2(), hcalRecHitTable_cff::detId, SiStripBadStrip::data::firstStrip, cms::cuda::for(), GeomDet::geographicalId(), SiStripBadStrip::getRange(), FastTimerService_cff::range, SiStripBadStrip::data::range, DetId::rawId(), and alignCSCRings::s.

197  {
198  uint32_t detId = pixdet->geographicalId().rawId();
199 
200  signal_map_type& theSignal = _signal[detId];
201  signal_map_type signalNew;
202 
204  for (std::vector<unsigned int>::const_iterator badChannel = range.first; badChannel != range.second; ++badChannel) {
205  const auto& firstStrip = badChannelPayload_->decodePhase2(*badChannel).firstStrip;
206  const auto& channelRange = badChannelPayload_->decodePhase2(*badChannel).range;
207 
208  for (int index = 0; index < channelRange; index++) {
209  for (auto& s : theSignal) {
210  auto& channel = s.first;
211  if (channel == firstStrip + index)
212  s.second.set(0.);
213  }
214  }
215  }
216 }
unsigned short range
for(int i=first, nt=offsets[nh];i< nt;i+=gridDim.x *blockDim.x)
const Range getRange(const uint32_t detID) const
std::map< int, digitizerUtility::Ph2Amplitude, std::less< int > > signal_map_type
DetId geographicalId() const
The label of this GeomDet.
Definition: GeomDet.h:64
unsigned short firstStrip
constexpr uint32_t rawId() const
get the raw id
Definition: DetId.h:57
data decodePhase2(const unsigned int &value) const
std::pair< ContainerIterator, ContainerIterator > Range
const SiStripBadStrip * badChannelPayload_

◆ select_hit()

bool SSDigitizerAlgorithm::select_hit ( const PSimHit hit,
double  tCorr,
double &  sigScale 
) const
overridevirtual

Reimplemented from Phase2TrackerDigitizerAlgorithm.

Definition at line 72 of file SSDigitizerAlgorithm.cc.

References hitDetectionMode_, LatchedMode, mps_fire::result, SampledMode, select_hit_latchedMode(), select_hit_sampledMode(), Phase2TrackerDigitizerAlgorithm::theTofLowerCut_, and Phase2TrackerDigitizerAlgorithm::theTofUpperCut_.

72  {
73  bool result = false;
75  result = select_hit_sampledMode(hit, tCorr, sigScale);
77  result = select_hit_latchedMode(hit, tCorr, sigScale);
78  else {
79  double toa = hit.tof() - tCorr;
80  result = (toa > theTofLowerCut_ && toa < theTofUpperCut_);
81  }
82  return result;
83 }
bool select_hit_latchedMode(const PSimHit &hit, double tCorr, double &sigScale) const
bool select_hit_sampledMode(const PSimHit &hit, double tCorr, double &sigScale) const

◆ select_hit_latchedMode()

bool SSDigitizerAlgorithm::select_hit_latchedMode ( const PSimHit hit,
double  tCorr,
double &  sigScale 
) const
private

Definition at line 101 of file SSDigitizerAlgorithm.cc.

References bx_time, deadTime_, getSignalScale(), Phase2TrackerDigitizerAlgorithm::GeVperElectron_, mps_fire::i, DetId::subdetId(), Phase2TrackerDigitizerAlgorithm::theThresholdInE_Barrel_, Phase2TrackerDigitizerAlgorithm::theThresholdInE_Endcap_, and StripSubdetector::TOB.

Referenced by select_hit().

101  {
102  float toa = hit.tof() - tCorr;
103  toa -= hit.eventId().bunchCrossing() * bx_time;
104 
105  float sampling_time = (-1) * (hit.eventId().bunchCrossing() + 1) * bx_time;
106 
107  DetId det_id = DetId(hit.detUnitId());
108  float theThresholdInE =
110 
111  bool lastPulse = true;
112  bool aboveThr = false;
113  for (float i = deadTime_; i <= bx_time; i++) {
114  sigScale = getSignalScale(sampling_time - toa + i);
115 
116  aboveThr = (sigScale * hit.energyLoss() / GeVperElectron_ > theThresholdInE);
117  if (!lastPulse && aboveThr)
118  return true;
119 
120  lastPulse = aboveThr;
121  }
122  return false;
123 }
double getSignalScale(double xval) const
constexpr int subdetId() const
get the contents of the subdetector field (not cast into any detector&#39;s numbering enum) ...
Definition: DetId.h:48
static constexpr auto TOB
Definition: DetId.h:17
static constexpr float bx_time

◆ select_hit_sampledMode()

bool SSDigitizerAlgorithm::select_hit_sampledMode ( const PSimHit hit,
double  tCorr,
double &  sigScale 
) const
private

Definition at line 87 of file SSDigitizerAlgorithm.cc.

References bx_time, getSignalScale(), Phase2TrackerDigitizerAlgorithm::GeVperElectron_, DetId::subdetId(), Phase2TrackerDigitizerAlgorithm::theThresholdInE_Barrel_, Phase2TrackerDigitizerAlgorithm::theThresholdInE_Endcap_, and StripSubdetector::TOB.

Referenced by select_hit().

87  {
88  double toa = hit.tof() - tCorr;
89  double sampling_time = bx_time;
90 
91  DetId det_id = DetId(hit.detUnitId());
92  float theThresholdInE =
94 
95  sigScale = getSignalScale(sampling_time - toa);
96  return (sigScale * hit.energyLoss() / GeVperElectron_ > theThresholdInE);
97 }
double getSignalScale(double xval) const
constexpr int subdetId() const
get the contents of the subdetector field (not cast into any detector&#39;s numbering enum) ...
Definition: DetId.h:48
static constexpr auto TOB
Definition: DetId.h:17
static constexpr float bx_time

◆ signalShape()

double SSDigitizerAlgorithm::signalShape ( double  x) const
private

Definition at line 153 of file SSDigitizerAlgorithm.cc.

References cbc3PulsePolarExpansion(), JetChargeProducer_cfi::exp, funct::pow(), pulseShapeParameters_, x, and geometryCSVtoXML::xx.

Referenced by storeSignalShape().

153  {
154  double xOffset = pulseShapeParameters_[0];
155  double tau = pulseShapeParameters_[1];
156  double maxCharge = pulseShapeParameters_[5];
157 
158  double xx = x - xOffset;
159  return maxCharge * (std::exp(-xx / tau) * std::pow(xx / tau, 2.) * cbc3PulsePolarExpansion(x));
160 }
std::vector< double > pulseShapeParameters_
double cbc3PulsePolarExpansion(double x) const
Power< A, B >::type pow(const A &a, const B &b)
Definition: Power.h:29

◆ storeSignalShape()

void SSDigitizerAlgorithm::storeSignalShape ( )
private

Definition at line 161 of file SSDigitizerAlgorithm.cc.

References mps_fire::i, interpolationPoints, interpolationStep, pulseShapeVec_, signalShape(), and heppy_batch::val.

Referenced by SSDigitizerAlgorithm().

161  {
162  for (size_t i = 0; i < interpolationPoints; i++) {
163  float val = i / interpolationStep;
164 
165  pulseShapeVec_.push_back(signalShape(val));
166  }
167 }
double signalShape(double x) const
static constexpr size_t interpolationPoints
std::vector< double > pulseShapeVec_
static constexpr int interpolationStep

Member Data Documentation

◆ badChannelPayload_

const SiStripBadStrip* SSDigitizerAlgorithm::badChannelPayload_
private

Definition at line 41 of file SSDigitizerAlgorithm.h.

Referenced by module_killing_DB().

◆ badChannelToken_

edm::ESGetToken<SiStripBadStrip, SiPhase2OuterTrackerBadStripRcd> SSDigitizerAlgorithm::badChannelToken_
private

Definition at line 40 of file SSDigitizerAlgorithm.h.

Referenced by SSDigitizerAlgorithm().

◆ bx_time

constexpr float SSDigitizerAlgorithm::bx_time {25}
staticprivate

Definition at line 37 of file SSDigitizerAlgorithm.h.

Referenced by select_hit_latchedMode(), and select_hit_sampledMode().

◆ deadTime_

float SSDigitizerAlgorithm::deadTime_
private

Definition at line 34 of file SSDigitizerAlgorithm.h.

Referenced by select_hit_latchedMode().

◆ geomToken_

const edm::ESGetToken<TrackerGeometry, TrackerDigiGeometryRecord> SSDigitizerAlgorithm::geomToken_
private

Definition at line 36 of file SSDigitizerAlgorithm.h.

◆ hitDetectionMode_

int SSDigitizerAlgorithm::hitDetectionMode_
private

Definition at line 31 of file SSDigitizerAlgorithm.h.

Referenced by select_hit().

◆ interpolationPoints

constexpr size_t SSDigitizerAlgorithm::interpolationPoints {1000}
staticprivate

Definition at line 38 of file SSDigitizerAlgorithm.h.

Referenced by storeSignalShape().

◆ interpolationStep

constexpr int SSDigitizerAlgorithm::interpolationStep {10}
staticprivate

Definition at line 39 of file SSDigitizerAlgorithm.h.

Referenced by getSignalScale(), and storeSignalShape().

◆ pulseShapeParameters_

std::vector<double> SSDigitizerAlgorithm::pulseShapeParameters_
private

Definition at line 33 of file SSDigitizerAlgorithm.h.

Referenced by cbc3PulsePolarExpansion(), and signalShape().

◆ pulseShapeVec_

std::vector<double> SSDigitizerAlgorithm::pulseShapeVec_
private

Definition at line 32 of file SSDigitizerAlgorithm.h.

Referenced by getSignalScale(), and storeSignalShape().

◆ siPhase2OTLorentzAngleToken_

edm::ESGetToken<SiPhase2OuterTrackerLorentzAngle, SiPhase2OuterTrackerLorentzAngleSimRcd> SSDigitizerAlgorithm::siPhase2OTLorentzAngleToken_
private

Definition at line 35 of file SSDigitizerAlgorithm.h.

Referenced by SSDigitizerAlgorithm().