CMS 3D CMS Logo

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

#include <HGCDigitizer.h>

Public Types

typedef std::tuple< int, uint32_t, float > HGCCaloHitTuple_t
 

Public Member Functions

void accumulate (edm::Event const &e, edm::EventSetup const &c, CLHEP::HepRandomEngine *hre)
 handle SimHit accumulation More...
 
void accumulate (PileUpEventPrincipal const &e, edm::EventSetup const &c, CLHEP::HepRandomEngine *hre)
 
void accumulate (edm::Handle< edm::PCaloHitContainer > const &hits, int bxCrossing, const HGCalGeometry *geom, CLHEP::HepRandomEngine *hre)
 
void accumulate_forPreMix (edm::Event const &e, edm::EventSetup const &c, CLHEP::HepRandomEngine *hre)
 
void accumulate_forPreMix (PileUpEventPrincipal const &e, edm::EventSetup const &c, CLHEP::HepRandomEngine *hre)
 
void accumulate_forPreMix (edm::Handle< edm::PCaloHitContainer > const &hits, int bxCrossing, const HGCalGeometry *geom, CLHEP::HepRandomEngine *hre)
 
void accumulate_forPreMix (const PHGCSimAccumulator &simAccumulator, const bool minbiasFlag)
 
std::string digiCollection ()
 
void finalizeEvent (edm::Event &e, edm::EventSetup const &c, CLHEP::HepRandomEngine *hre)
 
 HGCDigitizer (const edm::ParameterSet &ps, edm::ConsumesCollector &iC)
 
void initializeEvent (edm::Event const &e, edm::EventSetup const &c)
 actions at the start/end of event More...
 
 ~HGCDigitizer ()=default
 

Static Public Member Functions

static bool orderByDetIdThenTime (const HGCCaloHitTuple_t &a, const HGCCaloHitTuple_t &b)
 

Private Member Functions

void checkPosition (const HGCalDigiCollection *digis) const
 
uint32_t getType () const
 
void resetPUSimHitDataAccumulator ()
 
void resetSimHitDataAccumulator ()
 

Private Attributes

std::array< double, 4 > averageOccupancies_
 
const double bxTime_
 
std::vector< float > cce_
 
const std::string digiCollection_
 
const int digitizationType_
 
double ev_per_eh_pair_
 
const edm::ESGetToken< CaloGeometry, CaloGeometryRecordgeomToken_
 
edm::ESWatcher< CaloGeometryRecordgeomWatcher_
 
const HGCalGeometrygHGCal_ = nullptr
 
const std::string hitCollection_
 
std::unordered_map< uint32_t, bool > hitOrder_monitor
 
std::unordered_map< uint32_t, std::vector< std::pair< float, float > > > hitRefs_bx0
 
const std::string hitsProducer_
 
const edm::EDGetTokenT< std::vector< PCaloHit > > hitToken_
 
const int maxSimHitsAccTime_
 
uint32_t nEvents_
 
std::unordered_map< uint32_t, std::vector< std::tuple< float, float, float > > > PhitRefs_bx0
 
const bool premixStage1_
 
const double premixStage1MaxCharge_
 
const double premixStage1MinCharge_
 
std::unique_ptr< hgc::HGCPUSimHitDataAccumulatorpusimHitAccumulator_
 
std::unique_ptr< hgc::HGCSimHitDataAccumulatorsimHitAccumulator_
 
std::unique_ptr< HGCDigitizerBasetheDigitizer_
 
const float tofDelay_
 
std::unordered_set< DetIdvalidIds_
 
const uint32_t verbosity_
 

Static Private Attributes

static const unsigned int maxBx_ = 14
 
static const unsigned int thisBx_ = 9
 

Detailed Description

Definition at line 29 of file HGCDigitizer.h.

Member Typedef Documentation

◆ HGCCaloHitTuple_t

typedef std::tuple<int, uint32_t, float> HGCDigitizer::HGCCaloHitTuple_t

Definition at line 35 of file HGCDigitizer.h.

Constructor & Destructor Documentation

◆ HGCDigitizer()

HGCDigitizer::HGCDigitizer ( const edm::ParameterSet ps,
edm::ConsumesCollector iC 
)

Definition at line 227 of file HGCDigitizer.cc.

References cce_, get, edm::ParameterSet::getParameter(), crabTemplate::pluginName, AlCaHLTBitMon_QueryRunRegistry::string, edm::swap(), groupFilesInBlocks::temp, and theDigitizer_.

230  digiCollection_(ps.getParameter<std::string>("digiCollection")),
231  digitizationType_(ps.getParameter<uint32_t>("digitizationType")),
232  premixStage1_(ps.getParameter<bool>("premixStage1")),
233  premixStage1MinCharge_(ps.getParameter<double>("premixStage1MinCharge")),
234  premixStage1MaxCharge_(ps.getParameter<double>("premixStage1MaxCharge")),
235  maxSimHitsAccTime_(ps.getParameter<uint32_t>("maxSimHitsAccTime")),
236  bxTime_(ps.getParameter<double>("bxTime")),
237  hitsProducer_(ps.getParameter<std::string>("hitsProducer")),
238  hitCollection_(ps.getParameter<std::string>("hitCollection")),
239  hitToken_(iC.consumes<std::vector<PCaloHit>>(edm::InputTag(hitsProducer_, hitCollection_))),
240  geomToken_(iC.esConsumes()),
241  verbosity_(ps.getUntrackedParameter<uint32_t>("verbosity", 0)),
242  tofDelay_(ps.getParameter<double>("tofDelay")),
243  averageOccupancies_(occupancyGuesses),
244  nEvents_(1) {
245  //configure from cfg
246 
247  const auto& myCfg_ = ps.getParameter<edm::ParameterSet>("digiCfg");
248 
249  if (myCfg_.existsAs<edm::ParameterSet>("chargeCollectionEfficiencies")) {
250  cce_.clear();
251  const auto& temp = myCfg_.getParameter<edm::ParameterSet>("chargeCollectionEfficiencies")
252  .getParameter<std::vector<double>>("values");
253  for (double cce : temp) {
254  cce_.emplace_back(cce);
255  }
256  } else {
257  std::vector<float>().swap(cce_);
258  }
259 
260  auto const& pluginName = ps.getParameter<std::string>("digitizer");
262 }
const std::string hitsProducer_
Definition: HGCDigitizer.h:101
EDGetTokenT< ProductType > consumes(edm::InputTag const &tag)
uint32_t nEvents_
Definition: HGCDigitizer.h:126
T getParameter(std::string const &) const
Definition: ParameterSet.h:303
std::vector< float > cce_
Definition: HGCDigitizer.h:131
std::unique_ptr< HGCDigitizerBase > theDigitizer_
Definition: HGCDigitizer.h:110
const edm::ESGetToken< CaloGeometry, CaloGeometryRecord > geomToken_
Definition: HGCDigitizer.h:113
std::unordered_map< uint32_t, HGCCellInfo > HGCSimHitDataAccumulator
const std::string digiCollection_
Definition: HGCDigitizer.h:84
const double premixStage1MaxCharge_
Definition: HGCDigitizer.h:95
void swap(Association< C > &lhs, Association< C > &rhs)
Definition: Association.h:117
T getUntrackedParameter(std::string const &, T const &) const
const double premixStage1MinCharge_
Definition: HGCDigitizer.h:93
const uint32_t verbosity_
Definition: HGCDigitizer.h:119
const int maxSimHitsAccTime_
Definition: HGCDigitizer.h:98
const bool premixStage1_
Definition: HGCDigitizer.h:90
const edm::EDGetTokenT< std::vector< PCaloHit > > hitToken_
Definition: HGCDigitizer.h:103
std::array< double, 4 > averageOccupancies_
Definition: HGCDigitizer.h:125
const float tofDelay_
Definition: HGCDigitizer.h:122
const double bxTime_
Definition: HGCDigitizer.h:99
#define get
std::unique_ptr< hgc::HGCSimHitDataAccumulator > simHitAccumulator_
Definition: HGCDigitizer.h:81
std::unique_ptr< hgc::HGCPUSimHitDataAccumulator > pusimHitAccumulator_
Definition: HGCDigitizer.h:82
const int digitizationType_
Definition: HGCDigitizer.h:87
const std::string hitCollection_
Definition: HGCDigitizer.h:102
std::unordered_map< uint32_t, HGCCellHitInfo > HGCPUSimHitDataAccumulator

◆ ~HGCDigitizer()

HGCDigitizer::~HGCDigitizer ( )
default

Member Function Documentation

◆ accumulate() [1/3]

void HGCDigitizer::accumulate ( edm::Event const &  e,
edm::EventSetup const &  c,
CLHEP::HepRandomEngine *  hre 
)

handle SimHit accumulation

Definition at line 360 of file HGCDigitizer.cc.

References MillePedeFileConverter_cfg::e, Exception, gHGCal_, hitCollection_, hfClusterShapes_cfi::hits, hitsProducer_, and hitToken_.

Referenced by HGCDigiProducer::accumulate(), and accumulate().

360  {
361  //get inputs
363  if (!hits.isValid()) {
364  edm::LogError("HGCDigitizer") << " @ accumulate : can't find " << hitCollection_ << " collection of "
365  << hitsProducer_;
366  return;
367  }
368 
369  //accumulate in-time the main event
370  if (nullptr != gHGCal_) {
371  accumulate(hits, 0, gHGCal_, hre);
372  } else {
373  throw cms::Exception("BadConfiguration") << "HGCDigitizer is not producing EE, FH, or BH digis!";
374  }
375 }
const std::string hitsProducer_
Definition: HGCDigitizer.h:101
Log< level::Error, false > LogError
const HGCalGeometry * gHGCal_
Definition: HGCDigitizer.h:116
const edm::EDGetTokenT< std::vector< PCaloHit > > hitToken_
Definition: HGCDigitizer.h:103
void accumulate(edm::Event const &e, edm::EventSetup const &c, CLHEP::HepRandomEngine *hre)
handle SimHit accumulation
const std::string hitCollection_
Definition: HGCDigitizer.h:102

◆ accumulate() [2/3]

void HGCDigitizer::accumulate ( PileUpEventPrincipal const &  e,
edm::EventSetup const &  c,
CLHEP::HepRandomEngine *  hre 
)

Definition at line 399 of file HGCDigitizer.cc.

References accumulate(), MillePedeFileConverter_cfg::e, Exception, gHGCal_, hitCollection_, hfClusterShapes_cfi::hits, and hitsProducer_.

401  {
402  //get inputs
405  e.getByLabel(hitTag, hits);
406 
407  if (!hits.isValid()) {
408  edm::LogError("HGCDigitizer") << " @ accumulate : can't find " << hitCollection_ << " collection of "
409  << hitsProducer_;
410  return;
411  }
412 
413  //accumulate for the simulated bunch crossing
414  if (nullptr != gHGCal_) {
415  accumulate(hits, e.bunchCrossing(), gHGCal_, hre);
416  } else {
417  throw cms::Exception("BadConfiguration") << "HGCDigitizer is not producing EE, FH, or BH digis!";
418  }
419 }
const std::string hitsProducer_
Definition: HGCDigitizer.h:101
Log< level::Error, false > LogError
const HGCalGeometry * gHGCal_
Definition: HGCDigitizer.h:116
void accumulate(edm::Event const &e, edm::EventSetup const &c, CLHEP::HepRandomEngine *hre)
handle SimHit accumulation
const std::string hitCollection_
Definition: HGCDigitizer.h:102

◆ accumulate() [3/3]

void HGCDigitizer::accumulate ( edm::Handle< edm::PCaloHitContainer > const &  hits,
int  bxCrossing,
const HGCalGeometry geom,
CLHEP::HepRandomEngine *  hre 
)

Definition at line 543 of file HGCDigitizer.cc.

References bxTime_, ALCARECOTkAlJpsiMuMu_cff::charge, TauDecayModes::dec, relativeConstraints::empty, mps_fire::end, f, dqmdumpme::first, relativeConstraints::geom, hitRefs_bx0, hfClusterShapes_cfi::hits, mps_fire::i, l1ctLayer2EG_cff::id, createfilelist::int, dqmiolumiharvest::j, hgceeDigitizer_cfi::keV2fC, maxBx_, orderByDetIdThenTime(), edm::second(), simHitAccumulator_, findQualityFiles::size, jetUpdater_cfi::sort, theDigitizer_, thisBx_, tofDelay_, pfDeepBoostedJetPreprocessParams_cfi::upper_bound, validIds_, trackerHitRTTI::vector, and verbosity_.

546  {
547  if (nullptr == geom)
548  return;
549 
550  //configuration to apply for the computation of time-of-flight
551  auto weightToAbyEnergy = theDigitizer_->toaModeByEnergy();
552  auto tdcForToAOnset = theDigitizer_->tdcForToAOnset();
553  auto keV2fC = theDigitizer_->keV2fC();
554 
555  //create list of tuples (pos in container, RECO DetId, time) to be sorted first
556  int nchits = (int)hits->size();
557 
558  std::vector<HGCCaloHitTuple_t> hitRefs;
559  hitRefs.reserve(nchits);
560  for (int i = 0; i < nchits; ++i) {
561  const auto& the_hit = hits->at(i);
562  DetId id = simToReco(geom, the_hit.id());
563 
564  if (verbosity_ > 0) {
565  edm::LogVerbatim("HGCDigitizer") << "HGCDigitizer::i/p " << std::hex << the_hit.id() << " o/p " << id.rawId()
566  << std::dec;
567  }
568 
569  if (0 != id.rawId()) {
570  hitRefs.emplace_back(i, id.rawId(), (float)the_hit.time());
571  }
572  }
573 
574  std::sort(hitRefs.begin(), hitRefs.end(), this->orderByDetIdThenTime);
575  //loop over sorted hits
576  nchits = hitRefs.size();
577  for (int i = 0; i < nchits; ++i) {
578  const int hitidx = std::get<0>(hitRefs[i]);
579  const uint32_t id = std::get<1>(hitRefs[i]);
580 
581  //get the data for this cell, if not available then we skip it
582 
583  if (!validIds_.count(id))
584  continue;
585  HGCSimHitDataAccumulator::iterator simHitIt = simHitAccumulator_->emplace(id, HGCCellInfo()).first;
586 
587  if (id == 0)
588  continue; // to be ignored at RECO level
589 
590  const float toa = std::get<2>(hitRefs[i]);
591  const PCaloHit& hit = hits->at(hitidx);
592  const float charge = hit.energy() * 1e6 * keV2fC;
593 
594  //hit time: [time()]=ns + delay
595  //accumulate in 15 buckets of 25ns (9 pre-samples, 1 in-time, 5 post-samples)
596  const float tof = toa + tofDelay_;
597  const int itime = std::floor(tof / bxTime_) + 9;
598 
599  //no need to add bx crossing - tof comes already corrected from the mixing module
600  //itime += bxCrossing;
601  //itime += 9;
602 
603  if (itime < 0 || itime > (int)maxBx_)
604  continue;
605 
606  //check if time index is ok and store energy
607  if (itime >= (int)simHitIt->second.hit_info[0].size())
608  continue;
609 
610  (simHitIt->second).hit_info[0][itime] += charge;
611 
612  //for time-of-arrival: save the time-sorted list of timestamps with cumulative charge just above threshold
613  //working version with pileup only for in-time hits
614  int waferThickness = getCellThickness(geom, id);
615  bool orderChanged = false;
616  if (itime == (int)thisBx_) {
617  //if start empty => just add charge and time
618  if (hitRefs_bx0[id].empty()) {
619  hitRefs_bx0[id].emplace_back(charge, tof);
620 
621  } else if (tof <= hitRefs_bx0[id].back().second) {
622  //find position to insert new entry preserving time sorting
623  std::vector<std::pair<float, float>>::iterator findPos =
625  hitRefs_bx0[id].end(),
626  std::pair<float, float>(0.f, tof),
627  [](const auto& i, const auto& j) { return i.second <= j.second; });
628 
629  std::vector<std::pair<float, float>>::iterator insertedPos = findPos;
630  if (findPos->second == tof) {
631  //just merge timestamps with exact timing
632  findPos->first += charge;
633  } else {
634  //insert new element cumulating the charge
635  insertedPos = hitRefs_bx0[id].insert(findPos,
636  (findPos == hitRefs_bx0[id].begin())
637  ? std::pair<float, float>(charge, tof)
638  : std::pair<float, float>((findPos - 1)->first + charge, tof));
639  }
640 
641  //cumulate the charge of new entry for all elements that follow in the sorted list
642  //and resize list accounting for cases when the inserted element itself crosses the threshold
643  for (std::vector<std::pair<float, float>>::iterator step = insertedPos; step != hitRefs_bx0[id].end(); ++step) {
644  if (step != insertedPos)
645  step->first += charge;
646  // resize the list stopping with the first timeStamp with cumulative charge above threshold
647  if (step->first > tdcForToAOnset[waferThickness - 1] && step->second != hitRefs_bx0[id].back().second) {
649  hitRefs_bx0[id].end(),
650  std::pair<float, float>(0.f, step->second),
651  [](const auto& i, const auto& j) { return i.second < j.second; }) -
652  hitRefs_bx0[id].begin());
653  for (auto stepEnd = step + 1; stepEnd != hitRefs_bx0[id].end(); ++stepEnd)
654  stepEnd->first += charge;
655  break;
656  }
657  }
658 
659  orderChanged = true;
660  } else {
661  //add new entry at the end of the list
662  if (hitRefs_bx0[id].back().first <= tdcForToAOnset[waferThickness - 1]) {
663  hitRefs_bx0[id].emplace_back(hitRefs_bx0[id].back().first + charge, tof);
664  }
665  }
666  }
667  float accChargeForToA = hitRefs_bx0[id].empty() ? 0.f : hitRefs_bx0[id].back().first;
668  //now compute the firing ToA through the interpolation of the consecutive time-stamps at threshold
669  if (weightToAbyEnergy)
670  (simHitIt->second).hit_info[1][itime] += charge * tof;
671  else if (accChargeForToA > tdcForToAOnset[waferThickness - 1] &&
672  ((simHitIt->second).hit_info[1][itime] == 0 || orderChanged == true)) {
673  float fireTDC = hitRefs_bx0[id].back().second;
674  if (hitRefs_bx0[id].size() > 1) {
675  float chargeBeforeThr = (hitRefs_bx0[id].end() - 2)->first;
676  float tofchargeBeforeThr = (hitRefs_bx0[id].end() - 2)->second;
677 
678  float deltaQ = accChargeForToA - chargeBeforeThr;
679  float deltaTOF = fireTDC - tofchargeBeforeThr;
680  fireTDC = (tdcForToAOnset[waferThickness - 1] - chargeBeforeThr) * deltaTOF / deltaQ + tofchargeBeforeThr;
681  }
682  (simHitIt->second).hit_info[1][itime] = fireTDC;
683  }
684  }
685  hitRefs.clear();
686 }
size
Write out results.
Log< level::Info, true > LogVerbatim
std::unique_ptr< HGCDigitizerBase > theDigitizer_
Definition: HGCDigitizer.h:110
U second(std::pair< T, U > const &p)
static const unsigned int maxBx_
Definition: HGCDigitizer.h:129
const uint32_t verbosity_
Definition: HGCDigitizer.h:119
double f[11][100]
std::unordered_set< DetId > validIds_
Definition: HGCDigitizer.h:115
static const unsigned int thisBx_
Definition: HGCDigitizer.h:130
Definition: DetId.h:17
const float tofDelay_
Definition: HGCDigitizer.h:122
std::unordered_map< uint32_t, std::vector< std::pair< float, float > > > hitRefs_bx0
Definition: HGCDigitizer.h:132
const double bxTime_
Definition: HGCDigitizer.h:99
step
Definition: StallMonitor.cc:98
std::unique_ptr< hgc::HGCSimHitDataAccumulator > simHitAccumulator_
Definition: HGCDigitizer.h:81
static bool orderByDetIdThenTime(const HGCCaloHitTuple_t &a, const HGCCaloHitTuple_t &b)
Definition: HGCDigitizer.h:36

◆ accumulate_forPreMix() [1/4]

void HGCDigitizer::accumulate_forPreMix ( edm::Event const &  e,
edm::EventSetup const &  c,
CLHEP::HepRandomEngine *  hre 
)

Definition at line 339 of file HGCDigitizer.cc.

References MillePedeFileConverter_cfg::e, Exception, gHGCal_, hitCollection_, hfClusterShapes_cfi::hits, hitsProducer_, and hitToken_.

Referenced by HGCDigiProducer::accumulate(), accumulate_forPreMix(), PreMixingHGCalWorker::addPileups(), and PreMixingHGCalWorker::addSignals().

341  {
342  //get inputs
343 
345  if (!hits.isValid()) {
346  edm::LogError("HGCDigitizer") << " @ accumulate_minbias : can't find " << hitCollection_ << " collection of "
347  << hitsProducer_;
348  return;
349  }
350 
351  //accumulate in-time the main event
352  if (nullptr != gHGCal_) {
354  } else {
355  throw cms::Exception("BadConfiguration") << "HGCDigitizer is not producing EE, FH, or BH digis!";
356  }
357 }
const std::string hitsProducer_
Definition: HGCDigitizer.h:101
Log< level::Error, false > LogError
const HGCalGeometry * gHGCal_
Definition: HGCDigitizer.h:116
const edm::EDGetTokenT< std::vector< PCaloHit > > hitToken_
Definition: HGCDigitizer.h:103
void accumulate_forPreMix(edm::Event const &e, edm::EventSetup const &c, CLHEP::HepRandomEngine *hre)
const std::string hitCollection_
Definition: HGCDigitizer.h:102

◆ accumulate_forPreMix() [2/4]

void HGCDigitizer::accumulate_forPreMix ( PileUpEventPrincipal const &  e,
edm::EventSetup const &  c,
CLHEP::HepRandomEngine *  hre 
)

Definition at line 378 of file HGCDigitizer.cc.

References accumulate_forPreMix(), MillePedeFileConverter_cfg::e, Exception, gHGCal_, hitCollection_, hfClusterShapes_cfi::hits, and hitsProducer_.

380  {
383  e.getByLabel(hitTag, hits);
384 
385  if (!hits.isValid()) {
386  edm::LogError("HGCDigitizer") << " @ accumulate : can't find " << hitCollection_ << " collection of "
387  << hitsProducer_;
388  return;
389  }
390 
391  if (nullptr != gHGCal_) {
392  accumulate_forPreMix(hits, e.bunchCrossing(), gHGCal_, hre);
393  } else {
394  throw cms::Exception("BadConfiguration") << "HGCDigitizer is not producing EE, FH, or BH digis!";
395  }
396 }
const std::string hitsProducer_
Definition: HGCDigitizer.h:101
Log< level::Error, false > LogError
const HGCalGeometry * gHGCal_
Definition: HGCDigitizer.h:116
void accumulate_forPreMix(edm::Event const &e, edm::EventSetup const &c, CLHEP::HepRandomEngine *hre)
const std::string hitCollection_
Definition: HGCDigitizer.h:102

◆ accumulate_forPreMix() [3/4]

void HGCDigitizer::accumulate_forPreMix ( edm::Handle< edm::PCaloHitContainer > const &  hits,
int  bxCrossing,
const HGCalGeometry geom,
CLHEP::HepRandomEngine *  hre 
)

Definition at line 422 of file HGCDigitizer.cc.

References bxTime_, ALCARECOTkAlJpsiMuMu_cff::charge, relativeConstraints::empty, mps_fire::end, f, relativeConstraints::geom, hgceeDigitizer_cfi::hitCollection, hfClusterShapes_cfi::hits, mps_fire::i, l1ctLayer2EG_cff::id, createfilelist::int, dqmiolumiharvest::j, hgceeDigitizer_cfi::keV2fC, maxBx_, orderByDetIdThenTime(), PhitRefs_bx0, push_back(), pusimHitAccumulator_, jetUpdater_cfi::sort, theDigitizer_, thisBx_, tofDelay_, pfDeepBoostedJetPreprocessParams_cfi::upper_bound, and validIds_.

425  {
426  if (nullptr == geom)
427  return;
428 
429  auto keV2fC = theDigitizer_->keV2fC();
430  auto tdcForToAOnset = theDigitizer_->tdcForToAOnset();
431 
432  int nchits = (int)hits->size();
433  int count_thisbx = 0;
434  std::vector<HGCCaloHitTuple_t> hitRefs;
435  hitRefs.reserve(nchits);
436  for (int i = 0; i < nchits; ++i) {
437  const auto& the_hit = hits->at(i);
438  DetId id = simToReco(geom, the_hit.id());
439  // to be written the verbosity block
440  if (id.rawId() != 0) {
441  hitRefs.emplace_back(i, id.rawId(), (float)the_hit.time());
442  }
443  }
444  std::sort(hitRefs.begin(), hitRefs.end(), this->orderByDetIdThenTime);
445 
446  nchits = hitRefs.size();
447  for (int i = 0; i < nchits; ++i) {
448  const int hitidx = std::get<0>(hitRefs[i]);
449  const uint32_t id = std::get<1>(hitRefs[i]);
450  if (!validIds_.count(id))
451  continue;
452 
453  if (id == 0)
454  continue;
455 
456  const float toa = std::get<2>(hitRefs[i]);
457  const PCaloHit& hit = hits->at(hitidx);
458  const float charge = hit.energy() * 1e6 * keV2fC; // * getCCE(geom, id, cce_);
459 
460  const float tof = toa + tofDelay_;
461  const int itime = std::floor(tof / bxTime_) + 9;
462 
463  if (itime < 0 || itime > (int)maxBx_)
464  continue;
465 
466  if (itime >= (int)(maxBx_ + 1))
467  continue;
468 
469  int waferThickness = getCellThickness(geom, id);
470  if (itime == (int)thisBx_) {
471  ++count_thisbx;
472  if (PhitRefs_bx0[id].empty()) {
473  PhitRefs_bx0[id].emplace_back(charge, charge, tof);
474  } else if (tof > std::get<2>(PhitRefs_bx0[id].back())) {
475  PhitRefs_bx0[id].emplace_back(charge, charge + std::get<1>(PhitRefs_bx0[id].back()), tof);
476  } else if (tof == std::get<2>(PhitRefs_bx0[id].back())) {
477  std::get<0>(PhitRefs_bx0[id].back()) += charge;
478  std::get<1>(PhitRefs_bx0[id].back()) += charge;
479  } else {
480  //find position to insert new entry preserving time sorting
481  auto findPos = std::upper_bound(PhitRefs_bx0[id].begin(),
482  PhitRefs_bx0[id].end(),
483  hit_timeStamp(charge, 0.f, tof),
484  [](const auto& i, const auto& j) { return std::get<2>(i) <= std::get<2>(j); });
485 
486  auto insertedPos = findPos;
487 
488  if (tof == std::get<2>(*(findPos - 1))) {
489  std::get<0>(*(findPos - 1)) += charge;
490  std::get<1>(*(findPos - 1)) += charge;
491 
492  } else {
493  insertedPos = PhitRefs_bx0[id].insert(findPos,
494  (findPos == PhitRefs_bx0[id].begin())
495  ? hit_timeStamp(charge, charge, tof)
496  : hit_timeStamp(charge, charge + std::get<1>(*(findPos - 1)), tof));
497  }
498  //cumulate the charge of new entry for all elements that follow in the sorted list
499  //and resize list accounting for cases when the inserted element itself crosses the threshold
500 
501  for (auto step = insertedPos; step != PhitRefs_bx0[id].end(); ++step) {
502  if (step != insertedPos)
503  std::get<1>(*(step)) += charge;
504 
505  // resize the list stopping with the first timeStamp with cumulative charge above threshold
506  if (std::get<1>(*step) > tdcForToAOnset[waferThickness - 1] &&
507  std::get<2>(*step) != std::get<2>(PhitRefs_bx0[id].back())) {
508  PhitRefs_bx0[id].resize(
510  PhitRefs_bx0[id].end(),
511  hit_timeStamp(charge, 0.f, std::get<2>(*step)),
512  [](const auto& i, const auto& j) { return std::get<2>(i) < std::get<2>(j); }) -
513  PhitRefs_bx0[id].begin());
514  for (auto stepEnd = step + 1; stepEnd != PhitRefs_bx0[id].end(); ++stepEnd)
515  std::get<1>(*stepEnd) += charge;
516  break;
517  }
518  }
519  }
520  }
521  }
522 
523  for (const auto& hitCollection : PhitRefs_bx0) {
524  const uint32_t detectorId = hitCollection.first;
525  auto simHitIt = pusimHitAccumulator_->emplace(detectorId, HGCCellHitInfo()).first;
526 
527  for (const auto& hit_timestamp : PhitRefs_bx0[detectorId]) {
528  (simHitIt->second).PUhit_info[1][thisBx_].push_back(std::get<2>(hit_timestamp));
529  (simHitIt->second).PUhit_info[0][thisBx_].push_back(std::get<0>(hit_timestamp));
530  }
531  }
532 
533  if (nchits == 0) {
534  HGCPUSimHitDataAccumulator::iterator simHitIt = pusimHitAccumulator_->emplace(0, HGCCellHitInfo()).first;
535  (simHitIt->second).PUhit_info[1][9].push_back(0.0);
536  (simHitIt->second).PUhit_info[0][9].push_back(0.0);
537  }
538  hitRefs.clear();
539  PhitRefs_bx0.clear();
540 }
std::unique_ptr< HGCDigitizerBase > theDigitizer_
Definition: HGCDigitizer.h:110
static const unsigned int maxBx_
Definition: HGCDigitizer.h:129
std::unordered_map< uint32_t, std::vector< std::tuple< float, float, float > > > PhitRefs_bx0
Definition: HGCDigitizer.h:133
double f[11][100]
std::unordered_set< DetId > validIds_
Definition: HGCDigitizer.h:115
static const unsigned int thisBx_
Definition: HGCDigitizer.h:130
Definition: DetId.h:17
deadvectors [0] push_back({0.0175431, 0.538005, 6.80997, 13.29})
const float tofDelay_
Definition: HGCDigitizer.h:122
const double bxTime_
Definition: HGCDigitizer.h:99
std::tuple< float, float, float > hit_timeStamp
Definition: HGCDigitizer.cc:27
step
Definition: StallMonitor.cc:98
static bool orderByDetIdThenTime(const HGCCaloHitTuple_t &a, const HGCCaloHitTuple_t &b)
Definition: HGCDigitizer.h:36
std::unique_ptr< hgc::HGCPUSimHitDataAccumulator > pusimHitAccumulator_
Definition: HGCDigitizer.h:82

◆ accumulate_forPreMix() [4/4]

void HGCDigitizer::accumulate_forPreMix ( const PHGCSimAccumulator simAccumulator,
const bool  minbiasFlag 
)

Definition at line 687 of file HGCDigitizer.cc.

References gHGCal_, hitOrder_monitor, hitRefs_bx0, premixStage1MaxCharge_, premixStage1MinCharge_, pusimHitAccumulator_, simHitAccumulator_, theDigitizer_, and thisBx_.

687  {
688  //configuration to apply for the computation of time-of-flight
689  auto weightToAbyEnergy = theDigitizer_->toaModeByEnergy();
690  auto tdcForToAOnset = theDigitizer_->tdcForToAOnset();
691 
692  if (nullptr != gHGCal_) {
693  loadSimHitAccumulator_forPreMix(*simHitAccumulator_,
695  gHGCal_,
696  hitRefs_bx0,
697  simAccumulator,
700  !weightToAbyEnergy,
701  tdcForToAOnset,
702  minbiasFlag,
704  thisBx_);
705  }
706 }
std::unique_ptr< HGCDigitizerBase > theDigitizer_
Definition: HGCDigitizer.h:110
const double premixStage1MaxCharge_
Definition: HGCDigitizer.h:95
const HGCalGeometry * gHGCal_
Definition: HGCDigitizer.h:116
const double premixStage1MinCharge_
Definition: HGCDigitizer.h:93
std::unordered_map< uint32_t, bool > hitOrder_monitor
Definition: HGCDigitizer.h:134
static const unsigned int thisBx_
Definition: HGCDigitizer.h:130
std::unordered_map< uint32_t, std::vector< std::pair< float, float > > > hitRefs_bx0
Definition: HGCDigitizer.h:132
std::unique_ptr< hgc::HGCSimHitDataAccumulator > simHitAccumulator_
Definition: HGCDigitizer.h:81
std::unique_ptr< hgc::HGCPUSimHitDataAccumulator > pusimHitAccumulator_
Definition: HGCDigitizer.h:82

◆ checkPosition()

void HGCDigitizer::checkPosition ( const HGCalDigiCollection digis) const
private

Definition at line 737 of file HGCDigitizer.cc.

References funct::abs(), HGCalTopology::dddConstants(), TauDecayModes::dec, DetId::Forward, HGCalGeometry::getPosition(), gHGCal_, HFNose, DetId::HGCalEE, DetId::HGCalHSc, DetId::HGCalHSi, convertSQLiteXML::ok, PV3DBase< T, PVType, FrameType >::perp(), alignCSCRings::r, HGCalDDDConstants::rangeR(), HGCalDDDConstants::rangeZ(), AlCaHLTBitMon_QueryRunRegistry::string, HGCalGeometry::topology(), heppy_batch::val, HGCalTopology::valid(), z, PV3DBase< T, PVType, FrameType >::z(), and TkClusParameters_cff::zrange.

Referenced by finalizeEvent().

737  {
738  const double tol(0.5);
739  if (nullptr != gHGCal_) {
740  for (const auto& digi : *(digis)) {
741  const DetId& id = digi.id();
742  const GlobalPoint& global = gHGCal_->getPosition(id);
743  double r = global.perp();
744  double z = std::abs(global.z());
745  std::pair<double, double> zrange = gHGCal_->topology().dddConstants().rangeZ(true);
746  std::pair<double, double> rrange = gHGCal_->topology().dddConstants().rangeR(z, true);
747  bool ok = ((r >= rrange.first) && (r <= rrange.second) && (z >= zrange.first) && (z <= zrange.second));
748  std::string ck = (((r < rrange.first - tol) || (r > rrange.second + tol) || (z < zrange.first - tol) ||
749  (z > zrange.second + tol))
750  ? "***** ERROR *****"
751  : "");
752  bool val = gHGCal_->topology().valid(id);
753  if ((!ok) || (!val)) {
754  if (id.det() == DetId::HGCalEE || id.det() == DetId::HGCalHSi) {
755  edm::LogVerbatim("HGCDigitizer") << "Check " << HGCSiliconDetId(id) << " " << global << " R " << r << ":"
756  << rrange.first << ":" << rrange.second << " Z " << z << ":" << zrange.first
757  << ":" << zrange.second << " Flag " << ok << ":" << val << " " << ck;
758  } else if (id.det() == DetId::HGCalHSc) {
759  edm::LogVerbatim("HGCDigitizer") << "Check " << HGCScintillatorDetId(id) << " " << global << " R " << r << ":"
760  << rrange.first << ":" << rrange.second << " Z " << z << ":" << zrange.first
761  << ":" << zrange.second << " Flag " << ok << ":" << val << " " << ck;
762  } else if ((id.det() == DetId::Forward) && (id.subdetId() == static_cast<int>(HFNose))) {
763  edm::LogVerbatim("HGCDigitizer") << "Check " << HFNoseDetId(id) << " " << global << " R " << r << ":"
764  << rrange.first << ":" << rrange.second << " Z " << z << ":" << zrange.first
765  << ":" << zrange.second << " Flag " << ok << ":" << val << " " << ck;
766  } else {
767  edm::LogVerbatim("HGCDigitizer")
768  << "Check " << std::hex << id.rawId() << std::dec << " " << id.det() << ":" << id.subdetId() << " "
769  << global << " R " << r << ":" << rrange.first << ":" << rrange.second << " Z " << z << ":"
770  << zrange.first << ":" << zrange.second << " Flag " << ok << ":" << val << " " << ck;
771  }
772  }
773  }
774  }
775 }
Log< level::Info, true > LogVerbatim
std::pair< double, double > rangeZ(bool reco) const
T perp() const
Definition: PV3DBase.h:69
T z() const
Definition: PV3DBase.h:61
bool valid(const DetId &id) const override
Is this a valid cell id.
const HGCalGeometry * gHGCal_
Definition: HGCDigitizer.h:116
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
const HGCalTopology & topology() const
std::pair< double, double > rangeR(double z, bool reco) const
Definition: DetId.h:17
GlobalPoint getPosition(const DetId &id, bool debug=false) const
const HGCalDDDConstants & dddConstants() const
Definition: HGCalTopology.h:98

◆ digiCollection()

std::string HGCDigitizer::digiCollection ( )
inline

Definition at line 76 of file HGCDigitizer.h.

References digiCollection_.

Referenced by finalizeEvent(), HGCDigiProducer::HGCDigiProducer(), and PreMixingHGCalWorker::PreMixingHGCalWorker().

76 { return digiCollection_; }
const std::string digiCollection_
Definition: HGCDigitizer.h:84

◆ finalizeEvent()

void HGCDigitizer::finalizeEvent ( edm::Event e,
edm::EventSetup const &  c,
CLHEP::HepRandomEngine *  hre 
)

Definition at line 295 of file HGCDigitizer.cc.

References averageOccupancies_, checkPosition(), digiCollection(), digitizationType_, MillePedeFileConverter_cfg::e, getType(), gHGCal_, hitOrder_monitor, hitRefs_bx0, heavyIonCSV_trainingSettings::idx, eostools::move(), nEvents_, PhitRefs_bx0, premixStage1_, premixStage1MaxCharge_, premixStage1MinCharge_, pusimHitAccumulator_, simHitAccumulator_, theDigitizer_, and validIds_.

Referenced by HGCDigiProducer::finalizeEvent(), and PreMixingHGCalWorker::put().

295  {
296  hitRefs_bx0.clear();
297  PhitRefs_bx0.clear();
298  hitOrder_monitor.clear();
299 
300  const CaloSubdetectorGeometry* theGeom = static_cast<const CaloSubdetectorGeometry*>(gHGCal_);
301 
302  ++nEvents_;
303 
304  unsigned idx = getType();
305  // release memory for unfilled parts of hash table
306  if (validIds_.size() * averageOccupancies_[idx] > simHitAccumulator_->size()) {
307  simHitAccumulator_->reserve(simHitAccumulator_->size());
308  pusimHitAccumulator_->reserve(simHitAccumulator_->size());
309  }
310  //update occupancy guess
311  const double thisOcc = simHitAccumulator_->size() / ((double)validIds_.size());
313 
314  if (premixStage1_) {
315  auto simRecord = std::make_unique<PHGCSimAccumulator>();
316 
317  if (!pusimHitAccumulator_->empty()) {
318  saveSimHitAccumulator_forPreMix(
320  }
321 
322  e.put(std::move(simRecord), digiCollection());
323 
324  } else {
325  auto digiResult = std::make_unique<HGCalDigiCollection>();
326  theDigitizer_->run(digiResult, *simHitAccumulator_, theGeom, validIds_, digitizationType_, hre);
327  edm::LogVerbatim("HGCDigitizer") << "HGCDigitizer:: finalize event - produced " << digiResult->size()
328  << " hits in det/subdet " << theDigitizer_->det() << "/"
329  << theDigitizer_->subdet();
330 #ifdef EDM_ML_DEBUG
331  checkPosition(&(*digiResult));
332 #endif
333  e.put(std::move(digiResult), digiCollection());
334  }
335 
338 }
Log< level::Info, true > LogVerbatim
uint32_t nEvents_
Definition: HGCDigitizer.h:126
void checkPosition(const HGCalDigiCollection *digis) const
std::unique_ptr< HGCDigitizerBase > theDigitizer_
Definition: HGCDigitizer.h:110
std::unordered_map< uint32_t, HGCCellInfo > HGCSimHitDataAccumulator
const double premixStage1MaxCharge_
Definition: HGCDigitizer.h:95
const HGCalGeometry * gHGCal_
Definition: HGCDigitizer.h:116
uint32_t getType() const
const double premixStage1MinCharge_
Definition: HGCDigitizer.h:93
std::unordered_map< uint32_t, std::vector< std::tuple< float, float, float > > > PhitRefs_bx0
Definition: HGCDigitizer.h:133
std::unordered_map< uint32_t, bool > hitOrder_monitor
Definition: HGCDigitizer.h:134
std::unordered_set< DetId > validIds_
Definition: HGCDigitizer.h:115
const bool premixStage1_
Definition: HGCDigitizer.h:90
std::array< double, 4 > averageOccupancies_
Definition: HGCDigitizer.h:125
std::unordered_map< uint32_t, std::vector< std::pair< float, float > > > hitRefs_bx0
Definition: HGCDigitizer.h:132
std::unique_ptr< hgc::HGCSimHitDataAccumulator > simHitAccumulator_
Definition: HGCDigitizer.h:81
std::unique_ptr< hgc::HGCPUSimHitDataAccumulator > pusimHitAccumulator_
Definition: HGCDigitizer.h:82
std::string digiCollection()
Definition: HGCDigitizer.h:76
def move(src, dest)
Definition: eostools.py:511
const int digitizationType_
Definition: HGCDigitizer.h:87
std::unordered_map< uint32_t, HGCCellHitInfo > HGCPUSimHitDataAccumulator

◆ getType()

uint32_t HGCDigitizer::getType ( void  ) const
private

Definition at line 716 of file HGCDigitizer.cc.

References DetId::Forward, DetId::HGCalEE, DetId::HGCalHSc, DetId::HGCalHSi, heavyIonCSV_trainingSettings::idx, SiStripPI::max, and theDigitizer_.

Referenced by finalizeEvent(), and initializeEvent().

716  {
718  switch (theDigitizer_->det()) {
719  case DetId::HGCalEE:
720  idx = 0;
721  break;
722  case DetId::HGCalHSi:
723  idx = 1;
724  break;
725  case DetId::HGCalHSc:
726  idx = 2;
727  break;
728  case DetId::Forward:
729  idx = 3;
730  break;
731  default:
732  break;
733  }
734  return idx;
735 }
std::unique_ptr< HGCDigitizerBase > theDigitizer_
Definition: HGCDigitizer.h:110

◆ initializeEvent()

void HGCDigitizer::initializeEvent ( edm::Event const &  e,
edm::EventSetup const &  c 
)

actions at the start/end of event

Definition at line 265 of file HGCDigitizer.cc.

References averageOccupancies_, edm::ESWatcher< T >::check(), Exception, relativeConstraints::geom, geomToken_, geomWatcher_, edm::EventSetup::getData(), getType(), gHGCal_, hitCollection_, heavyIonCSV_trainingSettings::idx, pusimHitAccumulator_, simHitAccumulator_, edm::swap(), theDigitizer_, validIds_, and verbosity_.

Referenced by PreMixingHGCalWorker::initializeEvent(), and HGCDigiProducer::initializeEvent().

265  {
266  if (geomWatcher_.check(es)) {
267  std::unordered_set<DetId>().swap(validIds_);
268 
269  //get geometry
270  CaloGeometry const& geom = es.getData(geomToken_);
271 
272  gHGCal_ =
273  dynamic_cast<const HGCalGeometry*>(geom.getSubdetectorGeometry(theDigitizer_->det(), theDigitizer_->subdet()));
274 
275  int nadded(0);
276  //valid ID lists
277  if (nullptr != gHGCal_) {
278  getValidDetIds(gHGCal_, validIds_);
279  } else {
280  throw cms::Exception("BadConfiguration") << "HGCDigitizer is not producing EE, FH, or BH digis!";
281  }
282 
283  if (verbosity_ > 0)
284  edm::LogInfo("HGCDigitizer") << "Added " << nadded << ":" << validIds_.size() << " detIds without "
285  << hitCollection_ << " in first event processed" << std::endl;
286  }
287 
288  // reserve memory for a full detector
289  unsigned idx = getType();
292 }
std::unique_ptr< HGCDigitizerBase > theDigitizer_
Definition: HGCDigitizer.h:110
const edm::ESGetToken< CaloGeometry, CaloGeometryRecord > geomToken_
Definition: HGCDigitizer.h:113
const HGCalGeometry * gHGCal_
Definition: HGCDigitizer.h:116
void swap(Association< C > &lhs, Association< C > &rhs)
Definition: Association.h:117
uint32_t getType() const
edm::ESWatcher< CaloGeometryRecord > geomWatcher_
Definition: HGCDigitizer.h:114
const uint32_t verbosity_
Definition: HGCDigitizer.h:119
std::unordered_set< DetId > validIds_
Definition: HGCDigitizer.h:115
Log< level::Info, false > LogInfo
bool check(const edm::EventSetup &iSetup)
Definition: ESWatcher.h:57
std::array< double, 4 > averageOccupancies_
Definition: HGCDigitizer.h:125
std::unique_ptr< hgc::HGCSimHitDataAccumulator > simHitAccumulator_
Definition: HGCDigitizer.h:81
std::unique_ptr< hgc::HGCPUSimHitDataAccumulator > pusimHitAccumulator_
Definition: HGCDigitizer.h:82
const std::string hitCollection_
Definition: HGCDigitizer.h:102

◆ orderByDetIdThenTime()

static bool HGCDigitizer::orderByDetIdThenTime ( const HGCCaloHitTuple_t a,
const HGCCaloHitTuple_t b 
)
inlinestatic

Definition at line 36 of file HGCDigitizer.h.

References a, and b.

Referenced by accumulate(), and accumulate_forPreMix().

36  {
37  unsigned int detId_a(std::get<1>(a)), detId_b(std::get<1>(b));
38 
39  if (detId_a < detId_b)
40  return true;
41  if (detId_a > detId_b)
42  return false;
43 
44  double time_a(std::get<2>(a)), time_b(std::get<2>(b));
45  if (time_a < time_b)
46  return true;
47 
48  return false;
49  }
double b
Definition: hdecay.h:118
double a
Definition: hdecay.h:119

◆ resetPUSimHitDataAccumulator()

void HGCDigitizer::resetPUSimHitDataAccumulator ( )
private

◆ resetSimHitDataAccumulator()

void HGCDigitizer::resetSimHitDataAccumulator ( )
private

Definition at line 709 of file HGCDigitizer.cc.

References simHitAccumulator_.

709  {
710  for (HGCSimHitDataAccumulator::iterator it = simHitAccumulator_->begin(); it != simHitAccumulator_->end(); it++) {
711  it->second.hit_info[0].fill(0.);
712  it->second.hit_info[1].fill(0.);
713  }
714 }
std::unique_ptr< hgc::HGCSimHitDataAccumulator > simHitAccumulator_
Definition: HGCDigitizer.h:81

Member Data Documentation

◆ averageOccupancies_

std::array<double, 4> HGCDigitizer::averageOccupancies_
private

Definition at line 125 of file HGCDigitizer.h.

Referenced by finalizeEvent(), and initializeEvent().

◆ bxTime_

const double HGCDigitizer::bxTime_
private

Definition at line 99 of file HGCDigitizer.h.

Referenced by accumulate(), and accumulate_forPreMix().

◆ cce_

std::vector<float> HGCDigitizer::cce_
private

Definition at line 131 of file HGCDigitizer.h.

Referenced by HGCDigitizer().

◆ digiCollection_

const std::string HGCDigitizer::digiCollection_
private

Definition at line 84 of file HGCDigitizer.h.

Referenced by digiCollection().

◆ digitizationType_

const int HGCDigitizer::digitizationType_
private

Definition at line 87 of file HGCDigitizer.h.

Referenced by finalizeEvent().

◆ ev_per_eh_pair_

double HGCDigitizer::ev_per_eh_pair_
private

Definition at line 100 of file HGCDigitizer.h.

◆ geomToken_

const edm::ESGetToken<CaloGeometry, CaloGeometryRecord> HGCDigitizer::geomToken_
private

Definition at line 113 of file HGCDigitizer.h.

Referenced by initializeEvent().

◆ geomWatcher_

edm::ESWatcher<CaloGeometryRecord> HGCDigitizer::geomWatcher_
private

Definition at line 114 of file HGCDigitizer.h.

Referenced by initializeEvent().

◆ gHGCal_

const HGCalGeometry* HGCDigitizer::gHGCal_ = nullptr
private

◆ hitCollection_

const std::string HGCDigitizer::hitCollection_
private

Definition at line 102 of file HGCDigitizer.h.

Referenced by accumulate(), accumulate_forPreMix(), and initializeEvent().

◆ hitOrder_monitor

std::unordered_map<uint32_t, bool> HGCDigitizer::hitOrder_monitor
private

Definition at line 134 of file HGCDigitizer.h.

Referenced by accumulate_forPreMix(), and finalizeEvent().

◆ hitRefs_bx0

std::unordered_map<uint32_t, std::vector<std::pair<float, float> > > HGCDigitizer::hitRefs_bx0
private

Definition at line 132 of file HGCDigitizer.h.

Referenced by accumulate(), accumulate_forPreMix(), and finalizeEvent().

◆ hitsProducer_

const std::string HGCDigitizer::hitsProducer_
private

Definition at line 101 of file HGCDigitizer.h.

Referenced by accumulate(), and accumulate_forPreMix().

◆ hitToken_

const edm::EDGetTokenT<std::vector<PCaloHit> > HGCDigitizer::hitToken_
private

Definition at line 103 of file HGCDigitizer.h.

Referenced by accumulate(), and accumulate_forPreMix().

◆ maxBx_

const unsigned int HGCDigitizer::maxBx_ = 14
staticprivate

Definition at line 129 of file HGCDigitizer.h.

Referenced by accumulate(), and accumulate_forPreMix().

◆ maxSimHitsAccTime_

const int HGCDigitizer::maxSimHitsAccTime_
private

Definition at line 98 of file HGCDigitizer.h.

◆ nEvents_

uint32_t HGCDigitizer::nEvents_
private

Definition at line 126 of file HGCDigitizer.h.

Referenced by finalizeEvent().

◆ PhitRefs_bx0

std::unordered_map<uint32_t, std::vector<std::tuple<float, float, float> > > HGCDigitizer::PhitRefs_bx0
private

Definition at line 133 of file HGCDigitizer.h.

Referenced by accumulate_forPreMix(), and finalizeEvent().

◆ premixStage1_

const bool HGCDigitizer::premixStage1_
private

Definition at line 90 of file HGCDigitizer.h.

Referenced by finalizeEvent().

◆ premixStage1MaxCharge_

const double HGCDigitizer::premixStage1MaxCharge_
private

Definition at line 95 of file HGCDigitizer.h.

Referenced by accumulate_forPreMix(), and finalizeEvent().

◆ premixStage1MinCharge_

const double HGCDigitizer::premixStage1MinCharge_
private

Definition at line 93 of file HGCDigitizer.h.

Referenced by accumulate_forPreMix(), and finalizeEvent().

◆ pusimHitAccumulator_

std::unique_ptr<hgc::HGCPUSimHitDataAccumulator> HGCDigitizer::pusimHitAccumulator_
private

Definition at line 82 of file HGCDigitizer.h.

Referenced by accumulate_forPreMix(), finalizeEvent(), and initializeEvent().

◆ simHitAccumulator_

std::unique_ptr<hgc::HGCSimHitDataAccumulator> HGCDigitizer::simHitAccumulator_
private

◆ theDigitizer_

std::unique_ptr<HGCDigitizerBase> HGCDigitizer::theDigitizer_
private

◆ thisBx_

const unsigned int HGCDigitizer::thisBx_ = 9
staticprivate

Definition at line 130 of file HGCDigitizer.h.

Referenced by accumulate(), and accumulate_forPreMix().

◆ tofDelay_

const float HGCDigitizer::tofDelay_
private

Definition at line 122 of file HGCDigitizer.h.

Referenced by accumulate(), and accumulate_forPreMix().

◆ validIds_

std::unordered_set<DetId> HGCDigitizer::validIds_
private

Definition at line 115 of file HGCDigitizer.h.

Referenced by accumulate(), accumulate_forPreMix(), finalizeEvent(), and initializeEvent().

◆ verbosity_

const uint32_t HGCDigitizer::verbosity_
private

Definition at line 119 of file HGCDigitizer.h.

Referenced by accumulate(), and initializeEvent().