CMS 3D CMS Logo

List of all members | Public Member Functions | Protected Member Functions | Private Member Functions | Private Attributes
HGCScintSD Class Reference

#include <HGCScintSD.h>

Inheritance diagram for HGCScintSD:
CaloSD Observer< const BeginOfJob * > SensitiveCaloDetector Observer< const BeginOfRun * > Observer< const BeginOfEvent * > Observer< const BeginOfTrack * > Observer< const EndOfTrack * > Observer< const EndOfEvent * > SensitiveDetector

Public Member Functions

 HGCScintSD (const std::string &, const edm::EventSetup &, const SensitiveDetectorCatalog &, edm::ParameterSet const &, const SimTrackManager *)
 
uint32_t setDetUnitId (const G4Step *step) override
 
 ~HGCScintSD () override=default
 
- Public Member Functions inherited from CaloSD
 CaloSD (const std::string &aSDname, const edm::EventSetup &es, const SensitiveDetectorCatalog &clg, edm::ParameterSet const &p, const SimTrackManager *, float timeSlice=1., bool ignoreTkID=false)
 
void clear () override
 
void clearHits () override
 
void DrawAll () override
 
void EndOfEvent (G4HCofThisEvent *eventHC) override
 
void fillHits (edm::PCaloHitContainer &, const std::string &) override
 
void Initialize (G4HCofThisEvent *HCE) override
 
void PrintAll () override
 
bool ProcessHits (G4GFlashSpot *aSpot, G4TouchableHistory *) override
 
G4bool ProcessHits (G4Step *step, G4TouchableHistory *) override
 
void reset () override
 
 ~CaloSD () override
 
- Public Member Functions inherited from SensitiveCaloDetector
 SensitiveCaloDetector (const std::string &iname, const edm::EventSetup &es, const SensitiveDetectorCatalog &clg, edm::ParameterSet const &p)
 
- Public Member Functions inherited from SensitiveDetector
void EndOfEvent (G4HCofThisEvent *eventHC) override
 
const std::vector< std::string > & getNames () const
 
void Initialize (G4HCofThisEvent *eventHC) override
 
bool isCaloSD () const
 
 SensitiveDetector (const std::string &iname, const edm::EventSetup &es, const SensitiveDetectorCatalog &, edm::ParameterSet const &p, bool calo)
 
 ~SensitiveDetector () override
 
- Public Member Functions inherited from Observer< const BeginOfRun * >
 Observer ()
 
void slotForUpdate (const BeginOfRun * iT)
 
virtual ~Observer ()
 
- Public Member Functions inherited from Observer< const BeginOfEvent * >
 Observer ()
 
void slotForUpdate (const BeginOfEvent * iT)
 
virtual ~Observer ()
 
- Public Member Functions inherited from Observer< const BeginOfTrack * >
 Observer ()
 
void slotForUpdate (const BeginOfTrack * iT)
 
virtual ~Observer ()
 
- Public Member Functions inherited from Observer< const EndOfTrack * >
 Observer ()
 
void slotForUpdate (const EndOfTrack * iT)
 
virtual ~Observer ()
 
- Public Member Functions inherited from Observer< const EndOfEvent * >
 Observer ()
 
void slotForUpdate (const EndOfEvent * iT)
 
virtual ~Observer ()
 
- Public Member Functions inherited from Observer< const BeginOfJob * >
 Observer ()
 
void slotForUpdate (const BeginOfJob * iT)
 
virtual ~Observer ()
 

Protected Member Functions

bool filterHit (CaloG4Hit *, double) override
 
double getEnergyDeposit (const G4Step *) override
 
void initRun () override
 
void update (const ::EndOfEvent *) override
 
void update (const BeginOfEvent *) override
 
void update (const BeginOfJob *) override
 This routine will be called when the appropriate signal arrives. More...
 
void update (const BeginOfRun *) override
 
void update (const BeginOfTrack *trk) override
 
void update (const EndOfTrack *trk) override
 
- Protected Member Functions inherited from CaloSD
bool checkHit ()
 
CaloG4HitcreateNewHit (const G4Step *, const G4Track *)
 
virtual void endEvent ()
 
double getAttenuation (const G4Step *aStep, double birk1, double birk2, double birk3) const
 
virtual uint16_t getDepth (const G4Step *)
 
virtual bool getFromLibrary (const G4Step *step)
 
int getNumberOfHits ()
 
double getResponseWt (const G4Track *)
 
virtual int getTrackID (const G4Track *)
 
bool hitExists (const G4Step *)
 
virtual void initEvent (const BeginOfEvent *)
 
void processHit (const G4Step *step)
 
void resetForNewPrimary (const G4Step *)
 
void setNumberCheckedHits (int val)
 
void setParameterized (bool val)
 
G4ThreeVector setToGlobal (const G4ThreeVector &, const G4VTouchable *) const
 
G4ThreeVector setToLocal (const G4ThreeVector &, const G4VTouchable *) const
 
virtual int setTrackID (const G4Step *)
 
void setUseMap (bool val)
 
void update (const ::EndOfEvent *) override
 
void update (const BeginOfEvent *) override
 This routine will be called when the appropriate signal arrives. More...
 
void update (const BeginOfRun *) override
 This routine will be called when the appropriate signal arrives. More...
 
void update (const BeginOfTrack *trk) override
 This routine will be called when the appropriate signal arrives. More...
 
void update (const EndOfTrack *trk) override
 This routine will be called when the appropriate signal arrives. More...
 
void updateHit (CaloG4Hit *)
 
- Protected Member Functions inherited from SensitiveDetector
TrackInformationcmsTrackInformation (const G4Track *aTrack)
 
Local3DPoint ConvertToLocal3DPoint (const G4ThreeVector &point) const
 
Local3DPoint FinalStepPosition (const G4Step *step, coordinates) const
 
Local3DPoint InitialStepPosition (const G4Step *step, coordinates) const
 
Local3DPoint LocalPostStepPosition (const G4Step *step) const
 
Local3DPoint LocalPreStepPosition (const G4Step *step) const
 
void NaNTrap (const G4Step *step) const
 
void setNames (const std::vector< std::string > &)
 
- Protected Member Functions inherited from Observer< const EndOfEvent * >
virtual void update (const EndOfEvent *)=0
 This routine will be called when the appropriate signal arrives. More...
 

Private Member Functions

bool isItinFidVolume (const G4ThreeVector &)
 
uint32_t setDetUnitId (int, int, int, int, G4ThreeVector &)
 

Private Attributes

double birk1_
 
double birk2_
 
double birk3_
 
double distanceFromEdge_
 
double eminHit_
 
bool fiducialCut_
 
HGCalGeometryMode::GeometryMode geom_mode_
 
const HGCalDDDConstantshgcons_
 
int levelT1_
 
int levelT2_
 
DetId::Detector mydet_
 
std::string nameX_
 
std::unique_ptr< HGCalNumberingSchemenumberingScheme_
 
double slopeMin_
 
bool storeAllG4Hits_
 
bool useBirk_
 
double weight_
 

Additional Inherited Members

- Protected Types inherited from SensitiveDetector
enum  coordinates { WorldCoordinates, LocalCoordinates }
 
- Protected Attributes inherited from CaloSD
CaloG4HitcurrentHit
 
CaloHitID currentID
 
float edepositEM
 
float edepositHAD
 
double eminHit
 
double energyCut
 
G4ThreeVector entranceLocal
 
G4ThreeVector entrancePoint
 
bool forceSave
 
float incidentEnergy
 
double kmaxIon
 
double kmaxNeutron
 
double kmaxProton
 
G4ThreeVector posGlobal
 
CaloHitID previousID
 
bool suppressHeavy
 
double tmaxHit
 

Detailed Description

Definition at line 19 of file HGCScintSD.h.

Constructor & Destructor Documentation

◆ HGCScintSD()

HGCScintSD::HGCScintSD ( const std::string &  name,
const edm::EventSetup es,
const SensitiveDetectorCatalog clg,
edm::ParameterSet const &  p,
const SimTrackManager manager 
)

Definition at line 32 of file HGCScintSD.cc.

37  : CaloSD(name,
38  es,
39  clg,
40  p,
41  manager,
42  (float)(p.getParameter<edm::ParameterSet>("HGCSD").getParameter<double>("TimeSliceUnit")),
43  p.getParameter<edm::ParameterSet>("HGCSD").getParameter<bool>("IgnoreTrackID")),
44  hgcons_(nullptr),
45  slopeMin_(0),
46  levelT1_(99),
47  levelT2_(99) {
48  numberingScheme_.reset(nullptr);
49 
50  edm::ParameterSet m_HGC = p.getParameter<edm::ParameterSet>("HGCScintSD");
51  eminHit_ = m_HGC.getParameter<double>("EminHit") * CLHEP::MeV;
52  fiducialCut_ = m_HGC.getParameter<bool>("FiducialCut");
53  distanceFromEdge_ = m_HGC.getParameter<double>("DistanceFromEdge");
54  useBirk_ = m_HGC.getParameter<bool>("UseBirkLaw");
55  birk1_ = m_HGC.getParameter<double>("BirkC1") * (CLHEP::g / (CLHEP::MeV * CLHEP::cm2));
56  birk2_ = m_HGC.getParameter<double>("BirkC2");
57  birk3_ = m_HGC.getParameter<double>("BirkC3");
58  storeAllG4Hits_ = m_HGC.getParameter<bool>("StoreAllG4Hits");
59 
60  if (storeAllG4Hits_) {
61  setUseMap(false);
63  }
64 
65  //this is defined in the hgcsens.xml
66  G4String myName = name;
68  nameX_ = "HGCal";
69  if (myName.find("HitsHEback") != std::string::npos) {
71  nameX_ = "HGCalHEScintillatorSensitive";
72  }
73 
74 #ifdef EDM_ML_DEBUG
75  edm::LogVerbatim("HGCSim") << "**************************************************"
76  << "\n"
77  << "* *"
78  << "\n"
79  << "* Constructing a HGCScintSD with name " << name << "\n"
80  << "* *"
81  << "\n"
82  << "**************************************************";
83 #endif
84  edm::LogVerbatim("HGCSim") << "HGCScintSD:: Threshold for storing hits: " << eminHit_ << " for " << nameX_
85  << " detector " << mydet_;
86  edm::LogVerbatim("HGCSim") << "Flag for storing individual Geant4 Hits " << storeAllG4Hits_;
87  edm::LogVerbatim("HGCSim") << "Fiducial volume cut with cut from eta/phi "
88  << "boundary " << fiducialCut_ << " at " << distanceFromEdge_;
89  edm::LogVerbatim("HGCSim") << "Use of Birks law is set to " << useBirk_
90  << " with three constants kB = " << birk1_ << ", C1 = " << birk2_ << ", C2 = " << birk3_;
91 }

References birk1_, birk2_, birk3_, distanceFromEdge_, eminHit_, fiducialCut_, DetId::Forward, g, edm::ParameterSet::getParameter(), DetId::HGCalHSc, MeV, mydet_, Skims_PA_cff::name, nameX_, numberingScheme_, AlCaHLTBitMon_ParallelJobs::p, CaloSD::setNumberCheckedHits(), CaloSD::setUseMap(), storeAllG4Hits_, and useBirk_.

◆ ~HGCScintSD()

HGCScintSD::~HGCScintSD ( )
overridedefault

Member Function Documentation

◆ filterHit()

bool HGCScintSD::filterHit ( CaloG4Hit aHit,
double  time 
)
overrideprotectedvirtual

Reimplemented from CaloSD.

Definition at line 204 of file HGCScintSD.cc.

204  {
205  return ((time <= tmaxHit) && (aHit->getEnergyDeposit() > eminHit_));
206 }

References eminHit_, CaloG4Hit::getEnergyDeposit(), ntuplemaker::time, and CaloSD::tmaxHit.

◆ getEnergyDeposit()

double HGCScintSD::getEnergyDeposit ( const G4Step *  aStep)
overrideprotectedvirtual

Reimplemented from CaloSD.

Definition at line 93 of file HGCScintSD.cc.

93  {
94  double r = aStep->GetPreStepPoint()->GetPosition().perp();
95  double z = std::abs(aStep->GetPreStepPoint()->GetPosition().z());
96 #ifdef EDM_ML_DEBUG
97  G4int parCode = aStep->GetTrack()->GetDefinition()->GetPDGEncoding();
98  G4String parName = aStep->GetTrack()->GetDefinition()->GetParticleName();
99  G4LogicalVolume* lv = aStep->GetPreStepPoint()->GetPhysicalVolume()->GetLogicalVolume();
100  edm::LogVerbatim("HGCSim") << "HGCScintSD: Hit from standard path from " << lv->GetName() << " for Track "
101  << aStep->GetTrack()->GetTrackID() << " (" << parCode << ":" << parName << ") R = " << r
102  << " Z = " << z << " slope = " << r / z << ":" << slopeMin_;
103 #endif
104  // Apply fiducial cut
105  if (r < z * slopeMin_) {
106 #ifdef EDM_ML_DEBUG
107  edm::LogVerbatim("HGCSim") << "HGCScintSD: Fiducial Volume cut";
108 #endif
109  return 0.0;
110  }
111 
112  double wt1 = getResponseWt(aStep->GetTrack());
113  double wt2 = aStep->GetTrack()->GetWeight();
114  double wt3 = (useBirk_ ? getAttenuation(aStep, birk1_, birk2_, birk3_) : 1.0);
115  double destep = weight_ * wt1 * wt3 * (aStep->GetTotalEnergyDeposit());
116  if (wt2 > 0)
117  destep *= wt2;
118 #ifdef EDM_ML_DEBUG
119  edm::LogVerbatim("HGCalSim") << "HGCScintSD: weights= " << weight_ << ":" << wt1 << ":" << wt2 << ":" << wt3
120  << " Total weight " << weight_ * wt1 * wt2 * wt3
121  << " deStep: " << aStep->GetTotalEnergyDeposit() << ":" << destep;
122 #endif
123  return destep;
124 }

References funct::abs(), birk1_, birk2_, birk3_, CaloSD::getAttenuation(), CaloSD::getResponseWt(), alignCSCRings::r, slopeMin_, useBirk_, weight_, and z.

◆ initRun()

void HGCScintSD::initRun ( )
overrideprotectedvirtual

Reimplemented from CaloSD.

Definition at line 202 of file HGCScintSD.cc.

202 {}

◆ isItinFidVolume()

bool HGCScintSD::isItinFidVolume ( const G4ThreeVector &  pos)
private

Definition at line 213 of file HGCScintSD.cc.

213  {
214  if (fiducialCut_) {
215  return (hgcons_->distFromEdgeTrap(pos.x(), pos.y(), pos.z()) > distanceFromEdge_);
216  } else {
217  return true;
218  }
219 }

References distanceFromEdge_, HGCalDDDConstants::distFromEdgeTrap(), fiducialCut_, and hgcons_.

Referenced by setDetUnitId().

◆ setDetUnitId() [1/2]

uint32_t HGCScintSD::setDetUnitId ( const G4Step *  step)
overridevirtual

Implements CaloSD.

Definition at line 126 of file HGCScintSD.cc.

126  {
127  const G4StepPoint* preStepPoint = aStep->GetPreStepPoint();
128  const G4VTouchable* touch = preStepPoint->GetTouchable();
129 
130  //determine the exact position in global coordinates in the mass geometry
131  G4ThreeVector hitPoint = preStepPoint->GetPosition();
132  float globalZ = touch->GetTranslation(0).z();
133  int iz(globalZ > 0 ? 1 : -1);
134 
135  int layer, module, cell;
136  if ((touch->GetHistoryDepth() == levelT1_) || (touch->GetHistoryDepth() == levelT2_)) {
137  layer = touch->GetReplicaNumber(0);
138  module = -1;
139  cell = -1;
140 #ifdef EDM_ML_DEBUG
141  edm::LogVerbatim("HGCSim") << "DepthsTop: " << touch->GetHistoryDepth() << ":" << levelT1_ << ":" << levelT2_
142  << " name " << touch->GetVolume(0)->GetName() << " layer:module:cell " << layer << ":"
143  << module << ":" << cell;
144 #endif
145  } else {
146  layer = touch->GetReplicaNumber(3);
147  module = touch->GetReplicaNumber(2);
148  cell = touch->GetReplicaNumber(1);
149 #ifdef EDM_ML_DEBUG
150  edm::LogVerbatim("HGCSim") << "DepthsInside: " << touch->GetHistoryDepth() << " name "
151  << touch->GetVolume(0)->GetName() << " layer:module:cell " << layer << ":" << module
152  << ":" << cell;
153 #endif
154  }
155 #ifdef EDM_ML_DEBUG
156  G4Material* mat = aStep->GetPreStepPoint()->GetMaterial();
157  edm::LogVerbatim("HGCSim") << "Depths: " << touch->GetHistoryDepth() << " name " << touch->GetVolume(0)->GetName()
158  << ":" << touch->GetReplicaNumber(0) << " " << touch->GetVolume(1)->GetName() << ":"
159  << touch->GetReplicaNumber(1) << " " << touch->GetVolume(2)->GetName() << ":"
160  << touch->GetReplicaNumber(2) << " " << touch->GetVolume(3)->GetName() << ":"
161  << touch->GetReplicaNumber(3) << " " << touch->GetVolume(4)->GetName() << ":"
162  << touch->GetReplicaNumber(4) << " "
163  << " layer:module:cell " << layer << ":" << module << ":" << cell << " Material "
164  << mat->GetName() << ":" << mat->GetRadlen();
165 #endif
166  // The following statement should be examined later before elimination
167  if (aStep->GetPreStepPoint()->GetMaterial()->GetRadlen() > 100000.)
168  return 0;
169 
170  uint32_t id = setDetUnitId(layer, module, cell, iz, hitPoint);
171  if (!isItinFidVolume(hitPoint)) {
172 #ifdef EDM_ML_DEBUG
173  edm::LogVerbatim("HGCSim") << "ID " << std::hex << id << std::dec << " " << HGCScintillatorDetId(id)
174  << " is rejected by fiducilal volume cut";
175 #endif
176  id = 0;
177  }
178  return id;
179 }

References TauDecayModes::dec, triggerObjects_cff::id, isItinFidVolume(), levelT1_, and levelT2_.

◆ setDetUnitId() [2/2]

uint32_t HGCScintSD::setDetUnitId ( int  layer,
int  module,
int  cell,
int  iz,
G4ThreeVector &  pos 
)
private

Definition at line 208 of file HGCScintSD.cc.

208  {
209  uint32_t id = numberingScheme_ ? numberingScheme_->getUnitID(layer, module, cell, iz, pos, weight_) : 0;
210  return id;
211 }

References triggerObjects_cff::id, numberingScheme_, and weight_.

◆ update() [1/6]

void CaloSD::update
overrideprotected

Definition at line 493 of file CaloSD.cc.

493  {
494  endEvent();
495  slave.get()->ReserveMemory(theHC->entries());
496 
497  int count(0);
498  int wrong(0);
499  double eEM(0.0);
500  double eHAD(0.0);
501  double eEM2(0.0);
502  double eHAD2(0.0);
503  double tt(0.0);
504  double zloc(0.0);
505  double zglob(0.0);
506  double ee(0.0);
507  int hc_entries = theHC->entries();
508  for (int i = 0; i < hc_entries; ++i) {
509  if (!saveHit((*theHC)[i])) {
510  ++wrong;
511  }
512  ++count;
513  double x = (*theHC)[i]->getEM();
514  eEM += x;
515  eEM2 += x * x;
516  x = (*theHC)[i]->getHadr();
517  eHAD += x;
518  eHAD2 += x * x;
519  tt += (*theHC)[i]->getTimeSlice();
520  ee += (*theHC)[i]->getIncidentEnergy();
521  zglob += std::abs((*theHC)[i]->getEntry().z());
522  zloc += std::abs((*theHC)[i]->getEntryLocal().z());
523  }
524 
525  double norm = (count > 0) ? 1.0 / count : 0.0;
526  eEM *= norm;
527  eEM2 *= norm;
528  eHAD *= norm;
529  eHAD2 *= norm;
530  eEM2 = std::sqrt(eEM2 - eEM * eEM);
531  eHAD2 = std::sqrt(eHAD2 - eHAD * eHAD);
532  tt *= norm;
533  ee *= norm;
534  zglob *= norm;
535  zloc *= norm;
536 
537 #ifdef EDM_ML_DEBUG
538  edm::LogVerbatim("CaloSim") << "CaloSD: " << GetName() << " store " << count << " hits; " << wrong
539  << " track IDs not given properly and " << totalHits - count
540  << " hits not passing cuts\n EmeanEM= " << eEM << " ErmsEM= " << eEM2
541  << "\n EmeanHAD= " << eHAD << " ErmsHAD= " << eHAD2 << " TimeMean= " << tt
542  << " E0mean= " << ee << " Zglob= " << zglob << " Zloc= " << zloc << " ";
543 #endif
544  tkMap.erase(tkMap.begin(), tkMap.end());
545  std::vector<std::unique_ptr<CaloG4Hit>>().swap(reusehit);
546  if (useMap)
547  hitMap.erase(hitMap.begin(), hitMap.end());
548 }

Referenced by MatrixUtil.Matrix::__setitem__(), MatrixUtil.Steps::__setitem__(), and MatrixUtil.Steps::overwrite().

◆ update() [2/6]

void CaloSD::update
overrideprotected

Definition at line 459 of file CaloSD.cc.

459  {
460 #ifdef EDM_ML_DEBUG
461  edm::LogVerbatim("CaloSim") << "CaloSD: Dispatched BeginOfEvent for " << GetName() << " !";
462 #endif
463  clearHits();
464  initEvent(g4Event);
465 }

Referenced by MatrixUtil.Matrix::__setitem__(), MatrixUtil.Steps::__setitem__(), and MatrixUtil.Steps::overwrite().

◆ update() [3/6]

void HGCScintSD::update ( const BeginOfJob )
overrideprotectedvirtual

This routine will be called when the appropriate signal arrives.

Implements Observer< const BeginOfJob * >.

Definition at line 181 of file HGCScintSD.cc.

181  {
182  const edm::EventSetup* es = (*job)();
184  es->get<IdealGeometryRecord>().get(nameX_, hdc);
185  if (hdc.isValid()) {
186  hgcons_ = hdc.product();
189  levelT1_ = hgcons_->levelTop(0);
190  levelT2_ = hgcons_->levelTop(1);
191 #ifdef EDM_ML_DEBUG
192  edm::LogVerbatim("HGCSim") << "HGCScintSD::Initialized with mode " << geom_mode_ << " Slope cut " << slopeMin_
193  << " top Level " << levelT1_ << ":" << levelT2_;
194 #endif
195 
197  } else {
198  throw cms::Exception("Unknown", "HGCScintSD") << "Cannot find HGCalDDDConstants for " << nameX_ << "\n";
199  }
200 }

References Exception, geom_mode_, HGCalDDDConstants::geomMode(), edm::EventSetup::get(), get, hgcons_, levelT1_, levelT2_, HGCalDDDConstants::levelTop(), HGCalDDDConstants::minSlope(), mydet_, nameX_, numberingScheme_, and slopeMin_.

Referenced by progressbar.ProgressBar::__next__(), MatrixUtil.Matrix::__setitem__(), MatrixUtil.Steps::__setitem__(), progressbar.ProgressBar::finish(), and MatrixUtil.Steps::overwrite().

◆ update() [4/6]

void CaloSD::update
overrideprotected

◆ update() [5/6]

void CaloSD::update
overrideprotected

Definition at line 684 of file CaloSD.cc.

684  {
685  int primary = -1;
686  TrackInformation* trkInfo = cmsTrackInformation((*trk)());
687  if (trkInfo->isPrimary())
688  primary = (*trk)()->GetTrackID();
689 
690 #ifdef EDM_ML_DEBUG
691  edm::LogVerbatim("CaloSim") << "New track: isPrimary " << trkInfo->isPrimary() << " primary ID = " << primary
692  << " primary ancestor ID " << primAncestor;
693 #endif
694 
695  // update the information if a different primary track ID
696 
697  if (primary > 0 && primary != primAncestor) {
698  primAncestor = primary;
699 
700  // clean the hits information
701 
702  if (theHC->entries() > 0)
704  }
705 }

Referenced by MatrixUtil.Matrix::__setitem__(), MatrixUtil.Steps::__setitem__(), and MatrixUtil.Steps::overwrite().

◆ update() [6/6]

void CaloSD::update
overrideprotected

Definition at line 467 of file CaloSD.cc.

467  {
468  int id = (*trk)()->GetTrackID();
469  TrackInformation* trkI = cmsTrackInformation((*trk)());
470  int lastTrackID = -1;
471  if (trkI)
472  lastTrackID = trkI->getIDonCaloSurface();
473  if (id == lastTrackID) {
474  const TrackContainer* trksForThisEvent = m_trackManager->trackContainer();
475  if (trksForThisEvent != nullptr) {
476  int it = (int)(trksForThisEvent->size()) - 1;
477  if (it >= 0) {
478  TrackWithHistory* trkH = (*trksForThisEvent)[it];
479  if (trkH->trackID() == (unsigned int)(id))
480  tkMap[id] = trkH;
481 #ifdef EDM_ML_DEBUG
482  edm::LogVerbatim("CaloSim") << "CaloSD: get track " << it << " from Container of size "
483  << trksForThisEvent->size() << " with ID " << trkH->trackID();
484  } else {
485  edm::LogVerbatim("CaloSim") << "CaloSD: get track " << it << " from Container of size "
486  << trksForThisEvent->size() << " with no ID";
487 #endif
488  }
489  }
490  }
491 }

Referenced by MatrixUtil.Matrix::__setitem__(), MatrixUtil.Steps::__setitem__(), and MatrixUtil.Steps::overwrite().

Member Data Documentation

◆ birk1_

double HGCScintSD::birk1_
private

Definition at line 50 of file HGCScintSD.h.

Referenced by getEnergyDeposit(), and HGCScintSD().

◆ birk2_

double HGCScintSD::birk2_
private

Definition at line 50 of file HGCScintSD.h.

Referenced by getEnergyDeposit(), and HGCScintSD().

◆ birk3_

double HGCScintSD::birk3_
private

Definition at line 50 of file HGCScintSD.h.

Referenced by getEnergyDeposit(), and HGCScintSD().

◆ distanceFromEdge_

double HGCScintSD::distanceFromEdge_
private

Definition at line 46 of file HGCScintSD.h.

Referenced by HGCScintSD(), and isItinFidVolume().

◆ eminHit_

double HGCScintSD::eminHit_
private

Definition at line 46 of file HGCScintSD.h.

Referenced by filterHit(), and HGCScintSD().

◆ fiducialCut_

bool HGCScintSD::fiducialCut_
private

Definition at line 48 of file HGCScintSD.h.

Referenced by HGCScintSD(), and isItinFidVolume().

◆ geom_mode_

HGCalGeometryMode::GeometryMode HGCScintSD::geom_mode_
private

Definition at line 45 of file HGCScintSD.h.

Referenced by update().

◆ hgcons_

const HGCalDDDConstants* HGCScintSD::hgcons_
private

Definition at line 41 of file HGCScintSD.h.

Referenced by isItinFidVolume(), and update().

◆ levelT1_

int HGCScintSD::levelT1_
private

Definition at line 47 of file HGCScintSD.h.

Referenced by setDetUnitId(), and update().

◆ levelT2_

int HGCScintSD::levelT2_
private

Definition at line 47 of file HGCScintSD.h.

Referenced by setDetUnitId(), and update().

◆ mydet_

DetId::Detector HGCScintSD::mydet_
private

Definition at line 43 of file HGCScintSD.h.

Referenced by HGCScintSD(), and update().

◆ nameX_

std::string HGCScintSD::nameX_
private

Definition at line 44 of file HGCScintSD.h.

Referenced by HGCScintSD(), and update().

◆ numberingScheme_

std::unique_ptr<HGCalNumberingScheme> HGCScintSD::numberingScheme_
private

Definition at line 42 of file HGCScintSD.h.

Referenced by HGCScintSD(), setDetUnitId(), and update().

◆ slopeMin_

double HGCScintSD::slopeMin_
private

Definition at line 46 of file HGCScintSD.h.

Referenced by getEnergyDeposit(), and update().

◆ storeAllG4Hits_

bool HGCScintSD::storeAllG4Hits_
private

Definition at line 48 of file HGCScintSD.h.

Referenced by HGCScintSD().

◆ useBirk_

bool HGCScintSD::useBirk_
private

Definition at line 49 of file HGCScintSD.h.

Referenced by getEnergyDeposit(), and HGCScintSD().

◆ weight_

double HGCScintSD::weight_
private

Definition at line 50 of file HGCScintSD.h.

Referenced by getEnergyDeposit(), and setDetUnitId().

CaloSD::tkMap
std::map< int, TrackWithHistory * > tkMap
Definition: CaloSD.h:168
HGCScintSD::eminHit_
double eminHit_
Definition: HGCScintSD.h:46
CaloSD::tmaxHit
double tmaxHit
Definition: CaloSD.h:133
mps_fire.i
i
Definition: mps_fire.py:355
TrackInformation::getIDonCaloSurface
int getIDonCaloSurface() const
Definition: TrackInformation.h:39
CaloSD::saveHit
bool saveHit(CaloG4Hit *)
Definition: CaloSD.cc:648
groupFilesInBlocks.tt
int tt
Definition: groupFilesInBlocks.py:144
HGCScintSD::weight_
double weight_
Definition: HGCScintSD.h:50
HGCScintSD::isItinFidVolume
bool isItinFidVolume(const G4ThreeVector &)
Definition: HGCScintSD.cc:213
HGCalDDDConstants::geomMode
HGCalGeometryMode::GeometryMode geomMode() const
Definition: HGCalDDDConstants.h:52
AlCaHLTBitMon_ParallelJobs.p
p
Definition: AlCaHLTBitMon_ParallelJobs.py:153
edm::swap
void swap(Association< C > &lhs, Association< C > &rhs)
Definition: Association.h:117
TrackWithHistory
Definition: TrackWithHistory.h:16
pos
Definition: PixelAliasList.h:18
HGCalDDDConstants::distFromEdgeTrap
double distFromEdgeTrap(double x, double y, double z) const
Definition: HGCalDDDConstants.cc:331
CaloSD::getAttenuation
double getAttenuation(const G4Step *aStep, double birk1, double birk2, double birk3) const
Definition: CaloSD.cc:435
MeV
const double MeV
DDAxes::x
HGCScintSD::slopeMin_
double slopeMin_
Definition: HGCScintSD.h:46
CaloSD::getResponseWt
double getResponseWt(const G4Track *)
Definition: CaloSD.cc:627
CaloSD::useMap
bool useMap
Definition: CaloSD.h:152
edm::EventSetup::get
T get() const
Definition: EventSetup.h:73
TrackInformation::isPrimary
bool isPrimary() const
Definition: TrackInformation.h:23
HGCScintSD::numberingScheme_
std::unique_ptr< HGCalNumberingScheme > numberingScheme_
Definition: HGCScintSD.h:42
mathSSE::sqrt
T sqrt(T t)
Definition: SSEVec.h:19
CaloG4Hit::getEnergyDeposit
double getEnergyDeposit() const
Definition: CaloG4Hit.h:77
DDAxes::z
HGCScintSD::mydet_
DetId::Detector mydet_
Definition: HGCScintSD.h:43
edm::ESHandle
Definition: DTSurvey.h:22
HGCScintSD::birk2_
double birk2_
Definition: HGCScintSD.h:50
HGCScintSD::nameX_
std::string nameX_
Definition: HGCScintSD.h:44
CaloSD::clearHits
void clearHits() override
Definition: CaloSD.cc:550
HGCScintSD::geom_mode_
HGCalGeometryMode::GeometryMode geom_mode_
Definition: HGCScintSD.h:45
HGCScintSD::birk3_
double birk3_
Definition: HGCScintSD.h:50
HGCScintSD::birk1_
double birk1_
Definition: HGCScintSD.h:50
HGCScintSD::storeAllG4Hits_
bool storeAllG4Hits_
Definition: HGCScintSD.h:48
edm::ParameterSet
Definition: ParameterSet.h:36
CaloSD::hitMap
std::map< CaloHitID, CaloG4Hit * > hitMap
Definition: CaloSD.h:167
CaloSD::theHC
CaloG4HitCollection * theHC
Definition: CaloSD.h:148
CaloSD::totalHits
int totalHits
Definition: CaloSD.h:158
KineDebug3::count
void count()
Definition: KinematicConstrainedVertexUpdatorT.h:21
HGCScintSD::distanceFromEdge_
double distanceFromEdge_
Definition: HGCScintSD.h:46
CaloSD::slave
std::unique_ptr< CaloSlaveSD > slave
Definition: CaloSD.h:145
TrackInformation
Definition: TrackInformation.h:8
createfilelist.int
int
Definition: createfilelist.py:10
CaloSD::CaloSD
CaloSD(const std::string &aSDname, const edm::EventSetup &es, const SensitiveDetectorCatalog &clg, edm::ParameterSet const &p, const SimTrackManager *, float timeSlice=1., bool ignoreTkID=false)
Definition: CaloSD.cc:27
edm::LogVerbatim
Definition: MessageLogger.h:297
CaloSD::setNumberCheckedHits
void setNumberCheckedHits(int val)
Definition: CaloSD.h:112
HGCScintSD::setDetUnitId
uint32_t setDetUnitId(const G4Step *step) override
Definition: HGCScintSD.cc:126
edm::EventSetup
Definition: EventSetup.h:57
CaloSD::reusehit
std::vector< std::unique_ptr< CaloG4Hit > > reusehit
Definition: CaloSD.h:169
module
Definition: vlib.h:198
get
#define get
HGCScintSD::levelT2_
int levelT2_
Definition: HGCScintSD.h:47
alignCSCRings.r
r
Definition: alignCSCRings.py:93
CaloSD::m_trackManager
const SimTrackManager * m_trackManager
Definition: CaloSD.h:143
edm::ParameterSet::getParameter
T getParameter(std::string const &) const
HGCalDDDConstants::minSlope
double minSlope() const
Definition: HGCalDDDConstants.h:95
TrackWithHistory::trackID
unsigned int trackID() const
Definition: TrackWithHistory.h:28
TrackContainer
std::vector< TrackWithHistory * > TrackContainer
Definition: TrackContainer.h:8
SensitiveDetector::cmsTrackInformation
TrackInformation * cmsTrackInformation(const G4Track *aTrack)
Definition: SensitiveDetector.cc:96
HGCScintSD::useBirk_
bool useBirk_
Definition: HGCScintSD.h:49
HGCScintSD::levelT1_
int levelT1_
Definition: HGCScintSD.h:47
CaloSD::cleanHitCollection
void cleanHitCollection()
Definition: CaloSD.cc:707
HGCScintillatorDetId
Definition: HGCScintillatorDetId.h:21
triggerObjects_cff.id
id
Definition: triggerObjects_cff.py:31
DetId::HGCalHSc
Definition: DetId.h:34
CaloSD::primAncestor
int primAncestor
Definition: CaloSD.h:156
HGCScintSD::hgcons_
const HGCalDDDConstants * hgcons_
Definition: HGCScintSD.h:41
Exception
Definition: hltDiff.cc:246
Skims_PA_cff.name
name
Definition: Skims_PA_cff.py:17
HGCalDDDConstants::levelTop
int levelTop(int ind=0) const
Definition: HGCalDDDConstants.h:85
CaloSD::setUseMap
void setUseMap(bool val)
Definition: CaloSD.h:101
funct::abs
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
edm::roottree::getEntry
Int_t getEntry(TBranch *branch, EntryNumber entryNumber)
Definition: RootTree.cc:496
HGCScintSD::initRun
void initRun() override
Definition: HGCScintSD.cc:202
CaloSD::initEvent
virtual void initEvent(const BeginOfEvent *)
Definition: CaloSD.cc:569
DetId::Forward
Definition: DetId.h:30
ntuplemaker.time
time
Definition: ntuplemaker.py:310
HGCalNumberingScheme
Definition: HGCalNumberingScheme.h:16
TauDecayModes.dec
dec
Definition: TauDecayModes.py:143
HGCScintSD::fiducialCut_
bool fiducialCut_
Definition: HGCScintSD.h:48
IdealGeometryRecord
Definition: IdealGeometryRecord.h:27
SimTrackManager::trackContainer
const TrackContainer * trackContainer() const
Definition: SimTrackManager.h:52
CaloSD::endEvent
virtual void endEvent()
Definition: CaloSD.cc:571
g
The Signals That Services Can Subscribe To This is based on ActivityRegistry and is current per Services can connect to the signals distributed by the ActivityRegistry in order to monitor the activity of the application Each possible callback has some defined which we here list in angle e g
Definition: Activities.doc:4