CMS 3D CMS Logo

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

#include <ZdcSD.h>

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

Public Member Functions

bool ProcessHits (G4Step *step, G4TouchableHistory *tHistory) override
 
uint32_t setDetUnitId (const G4Step *step) override
 
 ZdcSD (const std::string &, const SensitiveDetectorCatalog &, edm::ParameterSet const &, const SimTrackManager *)
 
 ~ZdcSD () override=default
 
- Public Member Functions inherited from CaloSD
 CaloSD (const std::string &aSDname, const SensitiveDetectorCatalog &clg, edm::ParameterSet const &p, const SimTrackManager *, float timeSlice=1., bool ignoreTkID=false, const std::string &newcolname="")
 
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
 
bool isItFineCalo (const G4VTouchable *touch)
 
void newCollection (const std::string &name, edm::ParameterSet const &p)
 
void PrintAll () override
 
bool ProcessHits (G4GFlashSpot *aSpot, G4TouchableHistory *) override
 
void reset () override
 
 ~CaloSD () override
 
- Public Member Functions inherited from SensitiveCaloDetector
 SensitiveCaloDetector (const std::string &iname, const SensitiveDetectorCatalog &clg, const std::string &newcollname="")
 
- 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 SensitiveDetectorCatalog &, bool calo, const std::string &newcollname="")
 
 ~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 ()
 

Protected Member Functions

double calculateCherenkovDeposit (const G4Step *)
 
double calculateMeanNumberOfPhotons (double, double, double)
 
double calculateN2InvIntegral (double)
 
double convertEnergyToWavelength (double)
 
double evaluateFunction (const std::vector< double > &, const std::vector< double > &, double)
 
double generatePhotonEnergy (double, double, double)
 
double getEnergyDeposit (const G4Step *) override
 
bool getFromLibrary (const G4Step *) override
 
void initRun () override
 
double linearInterpolation (double, double, double, double, double)
 
double photonEnergyDist (double, double, double)
 
double pmtEfficiency (double)
 
int setTrackID (const G4Step *step) override
 
- Protected Member Functions inherited from CaloSD
bool checkHit (int k=0)
 
CaloG4HitcreateNewHit (const G4Step *, const G4Track *, int k)
 
virtual void endEvent ()
 
virtual double EnergyCorrected (const G4Step &step, const G4Track *)
 
virtual bool filterHit (CaloG4Hit *, double)
 
unsigned int findBoundaryCrossingParent (const G4Track *track, bool markParentAsSaveable=true)
 
double getAttenuation (const G4Step *aStep, double birk1, double birk2, double birk3) const
 
virtual uint16_t getDepth (const G4Step *)
 
int getNumberOfHits (int k=0)
 
double getResponseWt (const G4Track *, int k=0)
 
virtual int getTrackID (const G4Track *)
 
bool hitExists (const G4Step *, int k)
 
void ignoreRejection ()
 
virtual void initEvent (const BeginOfEvent *)
 
void printDetectorLevels (const G4VTouchable *) const
 
void processHit (const G4Step *step)
 
virtual void processSecondHit (const G4Step *, const G4Track *)
 
void resetForNewPrimary (const G4Step *)
 
void setNumberCheckedHits (int val, int k=0)
 
void setParameterized (bool val)
 
G4ThreeVector setToGlobal (const G4ThreeVector &, const G4VTouchable *) const
 
G4ThreeVector setToLocal (const G4ThreeVector &, const G4VTouchable *) const
 
void setUseMap (bool val)
 
std::string shortreprID (const CaloHitID &ID)
 
std::string shortreprID (const CaloG4Hit *hit)
 
void update (const BeginOfRun *) override
 This routine will be called when the appropriate signal arrives. More...
 
void update (const BeginOfEvent *) 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 update (const ::EndOfEvent *) override
 
void updateHit (CaloG4Hit *, int k)
 
- 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 Attributes

std::vector< ZdcShowerLibrary::Hithits
 
std::unique_ptr< ZdcNumberingSchemenumberingScheme
 
std::unique_ptr< ZdcShowerLibraryshowerLibrary
 
double thFibDir
 
bool useShowerHits
 
bool useShowerLibrary
 
int verbosity
 
double zdcHitEnergyCut
 

Additional Inherited Members

- Protected Types inherited from SensitiveDetector
enum  coordinates { WorldCoordinates, LocalCoordinates }
 
- Static Protected Member Functions inherited from CaloSD
static std::string printableDecayChain (const std::vector< unsigned int > &decayChain)
 
- Protected Attributes inherited from CaloSD
std::string collName_ [2]
 
CaloG4HitcurrentHit [2]
 
CaloHitID currentID [2]
 
std::string detName_
 
float edepositEM
 
float edepositHAD
 
double eminHit
 
double energyCut
 
G4ThreeVector entranceLocal
 
G4ThreeVector entrancePoint
 
bool forceSave
 
std::vector< std::string > hcn_
 
float incidentEnergy
 
double kmaxIon
 
double kmaxNeutron
 
double kmaxProton
 
int nHC_
 
G4ThreeVector posGlobal
 
CaloHitID previousID [2]
 
bool suppressHeavy
 
double tmaxHit
 
std::vector< int > useResMap_
 

Detailed Description

Definition at line 15 of file ZdcSD.h.

Constructor & Destructor Documentation

◆ ZdcSD()

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

Definition at line 34 of file ZdcSD.cc.

References edm::ParameterSet::getParameter(), Skims_PA_cff::name, numberingScheme, AlCaHLTBitMon_ParallelJobs::p, CaloSD::setParameterized(), showerLibrary, thFibDir, useShowerHits, useShowerLibrary, verbosity, and zdcHitEnergyCut.

38  : CaloSD(name, clg, p, manager) {
39  edm::ParameterSet m_ZdcSD = p.getParameter<edm::ParameterSet>("ZdcSD");
40  useShowerLibrary = m_ZdcSD.getParameter<bool>("UseShowerLibrary");
41  useShowerHits = m_ZdcSD.getParameter<bool>("UseShowerHits");
42  zdcHitEnergyCut = m_ZdcSD.getParameter<double>("ZdcHitEnergyCut") * CLHEP::GeV;
43  thFibDir = m_ZdcSD.getParameter<double>("FiberDirection");
44  verbosity = m_ZdcSD.getParameter<int>("Verbosity");
45  int verbn = verbosity / 10;
46  verbosity %= 10;
47  numberingScheme = std::make_unique<ZdcNumberingScheme>(verbn);
48 
49  edm::LogVerbatim("ForwardSim") << "***************************************************\n"
50  << "* *\n"
51  << "* Constructing a ZdcSD with name " << name << " *\n"
52  << "* *\n"
53  << "***************************************************";
54 
55  edm::LogVerbatim("ForwardSim") << "\nUse of shower library is set to " << useShowerLibrary
56  << "\nUse of Shower hits method is set to " << useShowerHits;
57 
58  edm::LogVerbatim("ForwardSim") << "\nEnergy Threshold Cut set to " << zdcHitEnergyCut / CLHEP::GeV << " (GeV)";
59 
60  if (useShowerLibrary) {
61  showerLibrary = std::make_unique<ZdcShowerLibrary>(name, p);
62  setParameterized(true);
63  } else {
64  showerLibrary.reset(nullptr);
65  }
66 }
Log< level::Info, true > LogVerbatim
double thFibDir
Definition: ZdcSD.h:44
std::unique_ptr< ZdcNumberingScheme > numberingScheme
Definition: ZdcSD.h:47
T getParameter(std::string const &) const
Definition: ParameterSet.h:307
int verbosity
Definition: ZdcSD.h:42
bool useShowerHits
Definition: ZdcSD.h:43
CaloSD(const std::string &aSDname, const SensitiveDetectorCatalog &clg, edm::ParameterSet const &p, const SimTrackManager *, float timeSlice=1., bool ignoreTkID=false, const std::string &newcolname="")
Definition: CaloSD.cc:33
std::unique_ptr< ZdcShowerLibrary > showerLibrary
Definition: ZdcSD.h:46
double zdcHitEnergyCut
Definition: ZdcSD.h:45
bool useShowerLibrary
Definition: ZdcSD.h:43
void setParameterized(bool val)
Definition: CaloSD.h:114

◆ ~ZdcSD()

ZdcSD::~ZdcSD ( )
overridedefault

Member Function Documentation

◆ calculateCherenkovDeposit()

double ZdcSD::calculateCherenkovDeposit ( const G4Step *  aStep)
protected

Definition at line 360 of file ZdcSD.cc.

References a, b, HLT_2023v12_cff::beta, HltBtagPostValidation_cff::c, calculateMeanNumberOfPhotons(), ALCARECOTkAlJpsiMuMu_cff::charge, convertEnergyToWavelength(), funct::cos(), MillePedeFileConverter_cfg::e, EMAX, EMIN, mps_fire::i, SiStripPI::min, dqmiodumpmetadata::n, NAperRINDEX, run3scouting_cff::nPhotons, pmtEfficiency(), findAndChange::post, findAndChange::pre, multPhiCorr_741_25nsDY_cfi::px, multPhiCorr_741_25nsDY_cfi::py, dttmaxenums::R, RINDEX, CaloSD::setToLocal(), funct::sin(), mathSSE::sqrt(), submitPVValidationJobs::t, and V0Monitor_cff::v0.

Referenced by ProcessHits().

360  {
361  const G4StepPoint* pPreStepPoint = aStep->GetPreStepPoint();
362  G4double charge = pPreStepPoint->GetCharge() / CLHEP::eplus;
363  if (charge == 0.0 || aStep->GetStepLength() < 1e-9 * CLHEP::mm)
364  return 0.0;
365 
366  const G4StepPoint* pPostStepPoint = aStep->GetPostStepPoint();
367 
368  G4ThreeVector pre = pPreStepPoint->GetPosition();
369  G4ThreeVector post = pPostStepPoint->GetPosition();
370 
371  //Convert step coordinates to local (fiber) coodinates
372  const G4ThreeVector localPre = setToLocal(pre, pPreStepPoint->GetTouchable());
373  const G4ThreeVector localPost = setToLocal(post, pPreStepPoint->GetTouchable());
374 
375  // Calculate the unit direction vector in local coordinates
376  const G4ThreeVector particleDirection = (localPost - localPre) / (localPost - localPre).mag();
377 
378  double beta = 0.5 * (pPreStepPoint->GetBeta() + pPostStepPoint->GetBeta());
379  double stepLength = aStep->GetStepLength() / 1000; // Geant4 stepLength is in "mm"
380 
381  int nPhotons; // Number of Cherenkov photons
382 
383  nPhotons = G4Poisson(calculateMeanNumberOfPhotons(charge, beta, stepLength));
384 
385  double totalE = 0.0;
386 
387  for (int i = 0; i < nPhotons; ++i) {
388  // uniform refractive index in PMT range -> uniform energy distribution
389  double photonE = EMIN + G4UniformRand() * (EMAX - EMIN);
390  // UPDATE: taking into account dispersion relation -> energy distribution
391 
392  if (G4UniformRand() > pmtEfficiency(convertEnergyToWavelength(photonE)))
393  continue;
394 
395  double omega = G4UniformRand() * twopi;
396  double cosTheta = std::min(1.0 / (beta * RINDEX), 1.0);
397  double sinTheta = std::sqrt((1. - cosTheta) * (1.0 + cosTheta));
398 
399 #ifdef EDM_ML_DEBUG
400  edm::LogVerbatim("ZdcSD") << "E_gamma: " << photonE << "\t omega: " << omega << "\t thetaC: " << cosTheta;
401 #endif
402  // Calculate momentum direction w.r.t primary particle (z-direction)
403  double px = photonE * sinTheta * std::cos(omega);
404  double py = photonE * sinTheta * std::sin(omega);
405  double pz = photonE * cosTheta;
406  G4ThreeVector photonMomentum(px, py, pz);
407 
408 #ifdef EDM_ML_DEBUG
409  edm::LogVerbatim("ZdcSD") << "pPR = (" << particleDirection.x() << "," << particleDirection.y() << ","
410  << particleDirection.z() << ")";
411  edm::LogVerbatim("ZdcSD") << "pCH = (" << px << "," << py << "," << pz << ")";
412 #endif
413  // Rotate to the fiber reference frame
414  photonMomentum.rotateUz(particleDirection);
415 
416 #ifdef EDM_ML_DEBUG
417  edm::LogVerbatim("ZdcSD") << "pLAB = (" << photonMomentum.x() << "," << photonMomentum.y() << ","
418  << photonMomentum.z() << ")";
419 #endif
420  // Get random position along G4Step
421  G4ThreeVector photonPosition = localPre + G4UniformRand() * (localPost - localPre);
422 
423  // 2D vectors to calculate impact position (x*,y*)
424  G4TwoVector r0(photonPosition);
425  G4TwoVector v0(photonMomentum);
426 
427  double R = 0.3; /*mm, fiber radius*/
428  double R2 = 0.3 * 0.3;
429 
430  if (r0.mag() < R && photonMomentum.z() < 0.0) {
431  // 2nd order polynomial coefficients
432  double a = v0.mag2();
433  double b = 2.0 * r0 * v0;
434  double c = r0.mag2() - R2;
435 
436  if (a < 1E-6)
437  totalE += 1; //photonE /*eV*/;
438  else {
439  // calculate intersection point - solving 2nd order polynomial
440  double t = (-b + sqrt(b * b - 4.0 * a * c)) / (2.0 * a);
441  G4ThreeVector n(r0.x() + v0.x() * t, r0.y() + v0.y() * t, 0.0); // surface normal
442  double cosTheta = (n * photonMomentum) / (n.mag() * photonE); // cosine of incident angle
443 
444  if (cosTheta >= NAperRINDEX) // lightguide condition
445  totalE += 1; //photonE /*eV*/;
446  }
447  }
448 
449 #ifdef EDM_ML_DEBUG
450  edm::LogVerbatim("ZdcSD") << "r = (" << photonPosition.x() << "," << photonPosition.y() << "," << photonPosition.z()
451  << ")" << std::endl;
452 #endif
453  }
454 
455 #ifdef EDM_ML_DEBUG
456  if (nPhotons > 30) {
457  edm::LogVerbatim("ZdcSD") << totalE;
458 
459  if (totalE > 0)
460  edm::LogVerbatim("ZdcSD") << pre.x() << " " << pre.y() << " " << pre.z() << " " << totalE;
461  }
462 #endif
463  return totalE;
464 }
double convertEnergyToWavelength(double)
Definition: ZdcSD.cc:575
Log< level::Info, true > LogVerbatim
Sin< T >::type sin(const T &t)
Definition: Sin.h:22
G4ThreeVector setToLocal(const G4ThreeVector &, const G4VTouchable *) const
Definition: CaloSD.cc:454
double calculateMeanNumberOfPhotons(double, double, double)
Definition: ZdcSD.cc:468
const double EMIN
Definition: ZdcSD.cc:355
T sqrt(T t)
Definition: SSEVec.h:19
Cos< T >::type cos(const T &t)
Definition: Cos.h:22
double b
Definition: hdecay.h:120
double pmtEfficiency(double)
Definition: ZdcSD.cc:517
double a
Definition: hdecay.h:121
const double RINDEX
Definition: ZdcSD.cc:351
const double NAperRINDEX
Definition: ZdcSD.cc:353
const double EMAX
Definition: ZdcSD.cc:354

◆ calculateMeanNumberOfPhotons()

double ZdcSD::calculateMeanNumberOfPhotons ( double  charge,
double  beta,
double  stepLength 
)
protected

Definition at line 468 of file ZdcSD.cc.

References ALPHA, HLT_2023v12_cff::beta, ALCARECOTkAlJpsiMuMu_cff::charge, EMAX, EMIN, HBARC, and RINDEX.

Referenced by calculateCherenkovDeposit().

468  {
469  // Return mean number of Cherenkov photons
470  return (ALPHA * charge * charge * stepLength) / HBARC * (EMAX - EMIN) * (1.0 - 1.0 / (beta * beta * RINDEX * RINDEX));
471 }
const double HBARC
Definition: ZdcSD.cc:357
const double EMIN
Definition: ZdcSD.cc:355
const double ALPHA
Definition: ZdcSD.cc:356
const double RINDEX
Definition: ZdcSD.cc:351
const double EMAX
Definition: ZdcSD.cc:354

◆ calculateN2InvIntegral()

double ZdcSD::calculateN2InvIntegral ( double  Emin)
protected

Definition at line 502 of file ZdcSD.cc.

References evaluateFunction().

502  {
503  // Hardcoded minimum photon energy table (eV)
504  const std::vector<double> EMIN_TAB{1.75715, 1.81902, 1.88311, 1.94944, 2.0183, 2.08939, 2.16302, 2.23919,
505  2.31789, 2.39954, 2.48416, 2.57175, 2.66232, 2.75643, 2.85349, 2.95411,
506  3.05756, 3.16528, 3.2774, 3.39218, 3.5123, 3.6359, 3.76394, 3.89642,
507  4.03332, 4.17596, 4.32302, 4.47596, 4.63319};
508 
509  // Hardcoded integral values
510  const std::vector<double> INTEGRAL_TAB{1.39756, 1.36835, 1.33812, 1.30686, 1.27443, 1.24099, 1.20638, 1.17061,
511  1.1337, 1.09545, 1.05586, 1.01493, 0.972664, 0.928815, 0.883664, 0.836938,
512  0.788988, 0.739157, 0.687404, 0.634547, 0.579368, 0.522743, 0.464256, 0.40393,
513  0.341808, 0.27732, 0.211101, 0.142536, 0.0723891};
514  return evaluateFunction(EMIN_TAB, INTEGRAL_TAB, Emin);
515 }
double evaluateFunction(const std::vector< double > &, const std::vector< double > &, double)
Definition: ZdcSD.cc:547

◆ convertEnergyToWavelength()

double ZdcSD::convertEnergyToWavelength ( double  energy)
protected

Definition at line 575 of file ZdcSD.cc.

References hcalRecHitTable_cff::energy.

Referenced by calculateCherenkovDeposit().

575 { return (1240.0 / energy); }

◆ evaluateFunction()

double ZdcSD::evaluateFunction ( const std::vector< double > &  X,
const std::vector< double > &  Y,
double  x 
)
protected

Definition at line 547 of file ZdcSD.cc.

References mps_fire::i, linearInterpolation(), x, X, and beamSpotPI::Y.

Referenced by calculateN2InvIntegral(), and photonEnergyDist().

547  {
548  for (unsigned int i = 0; i < X.size() - 1; i++) {
549  if (x > X[i] && x < X[i + 1]) {
550 #ifdef EDM_ML_DEBUG
551  edm::LogVerbatim("ZdcSD") << X[i] << "\t" << Y[i] << "\t" << X[i + 1] << "\t" << Y[i + 1] << "\t" << x << "\t"
552  << linearInterpolation(X[i], Y[i], X[i + 1], Y[i + 1], x);
553 #endif
554  return linearInterpolation(X[i], Y[i], X[i + 1], Y[i + 1], x);
555  }
556  }
557 
558  if (fabs(X[0] - x) < 1E-8)
559  return Y[0];
560  else if (fabs(X[X.size() - 1] - x) < 1E-8)
561  return Y[X.size() - 1];
562  else
563  return NAN;
564 }
Log< level::Info, true > LogVerbatim
#define X(str)
Definition: MuonsGrabber.cc:38
double linearInterpolation(double, double, double, double, double)
Definition: ZdcSD.cc:567

◆ generatePhotonEnergy()

double ZdcSD::generatePhotonEnergy ( double  charge,
double  beta,
double  Emin 
)
protected

Definition at line 489 of file ZdcSD.cc.

References HLT_2023v12_cff::beta, ALCARECOTkAlJpsiMuMu_cff::charge, EMAX, and photonEnergyDist().

489  {
490  double photonE;
491 
492  // Use rejection method
493  do {
494  photonE = G4UniformRand() * (EMAX - Emin) + Emin;
495  } while (G4UniformRand() > photonEnergyDist(photonE, charge, beta) / photonEnergyDist(EMAX, charge, beta));
496 
497  return photonE;
498 }
double photonEnergyDist(double, double, double)
Definition: ZdcSD.cc:474
const double EMAX
Definition: ZdcSD.cc:354

◆ getEnergyDeposit()

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

Reimplemented from CaloSD.

Definition at line 178 of file ZdcSD.cc.

References a, funct::abs(), HLT_2023v12_cff::beta, ALCARECOTkAlJpsiMuMu_cff::charge, ztail::d, PVValHelper::eta, f, ForwardName::getName(), dqm-mbProfile::log, SiStripPI::max, SiStripPI::min, PbPb_ZMuSkimMuonDPG_cff::particleType, phi, pi, alignCSCRings::r, mathSSE::sqrt(), AlCaHLTBitMon_QueryRunRegistry::string, funct::tan(), theta(), and thFibDir.

178  {
179  double NCherPhot = 0.;
180 
181  // preStepPoint information
182  G4StepPoint* preStepPoint = aStep->GetPreStepPoint();
183 
184  const G4ThreeVector& hitPoint = preStepPoint->GetPosition();
185  const G4ThreeVector& hit_mom = preStepPoint->GetMomentumDirection();
186  G4double stepL = aStep->GetStepLength() / cm;
187  G4double beta = preStepPoint->GetBeta();
188  G4double charge = preStepPoint->GetCharge();
189  if (charge == 0.0)
190  return 0.0;
191 
192  // theTrack information
193  G4Track* theTrack = aStep->GetTrack();
194  G4String particleType = theTrack->GetDefinition()->GetParticleName();
195  G4ThreeVector localPoint = theTrack->GetTouchable()->GetHistory()->GetTopTransform().TransformPoint(hitPoint);
196 
197 #ifdef EDM_ML_DEBUG
198  const G4ThreeVector& vert_mom = theTrack->GetVertexMomentumDirection();
199 
200  // calculations
201  float costheta =
202  vert_mom.z() / sqrt(vert_mom.x() * vert_mom.x() + vert_mom.y() * vert_mom.y() + vert_mom.z() * vert_mom.z());
203  float theta = std::acos(std::min(std::max(costheta, -1.f), 1.f));
204  float eta = -std::log(std::tan(theta * 0.5f));
205  float phi = -100.;
206  if (vert_mom.x() != 0)
207  phi = std::atan2(vert_mom.y(), vert_mom.x());
208  if (phi < 0.)
209  phi += twopi;
210 
211  // Get the total energy deposit
212  double stepE = aStep->GetTotalEnergyDeposit();
213 
214  // postStepPoint information
215  G4StepPoint* postStepPoint = aStep->GetPostStepPoint();
216  G4VPhysicalVolume* postPV = postStepPoint->GetPhysicalVolume();
217  std::string postnameVolume = ForwardName::getName(postPV->GetName());
218  edm::LogVerbatim("ForwardSim") << "ZdcSD:: getEnergyDeposit: \n"
219  << " preStepPoint: " << nameVolume << "," << stepL << "," << stepE << "," << beta
220  << "," << charge << "\n"
221  << " postStepPoint: " << postnameVolume << "," << costheta << "," << theta << ","
222  << eta << "," << phi << "," << particleType << " id= " << theTrack->GetTrackID()
223  << " Etot(GeV)= " << theTrack->GetTotalEnergy() / CLHEP::GeV;
224 #endif
225  const double bThreshold = 0.67;
226  if (beta > bThreshold) {
227 #ifdef EDM_ML_DEBUG
228  edm::LogVerbatim("ForwardSim") << "ZdcSD:: getEnergyDeposit: pass ";
229 #endif
230  const float nMedium = 1.4925;
231  // float photEnSpectrDL = 10714.285714;
232  // photEnSpectrDL = (1./400.nm-1./700.nm)*10000000.cm/nm; /* cm-1 */
233 
234  const float photEnSpectrDE = 1.24;
235  // E = 2pi*(1./137.)*(eV*cm/370.)/lambda = 12.389184*(eV*cm)/lambda
236  // Emax = 12.389184*(eV*cm)/400nm*10-7cm/nm = 3.01 eV
237  // Emin = 12.389184*(eV*cm)/700nm*10-7cm/nm = 1.77 eV
238  // delE = Emax - Emin = 1.24 eV
239 
240  const float effPMTandTransport = 0.15;
241 
242  // Check these values
243  const float thFullRefl = 23.;
244  float thFullReflRad = thFullRefl * pi / 180.;
245 
246  float thFibDirRad = thFibDir * pi / 180.;
247 
248  // at which theta the point is located:
249  // float th1 = hitPoint.theta();
250 
251  // theta of charged particle in LabRF(hit momentum direction):
252  float costh = hit_mom.z() / sqrt(hit_mom.x() * hit_mom.x() + hit_mom.y() * hit_mom.y() + hit_mom.z() * hit_mom.z());
253  float th = acos(std::min(std::max(costh, -1.f), 1.f));
254  // just in case (can do both standard ranges of phi):
255  if (th < 0.)
256  th += CLHEP::twopi;
257 
258  // theta of cone with Cherenkov photons w.r.t.direction of charged part.:
259  float costhcher = 1. / (nMedium * beta);
260  float thcher = acos(std::min(std::max(costhcher, -1.f), 1.f));
261 
262  // diff thetas of charged part. and quartz direction in LabRF:
263  float DelFibPart = std::abs(th - thFibDirRad);
264 
265  // define real distances:
266  float d = std::abs(std::tan(th) - std::tan(thFibDirRad));
267 
268  float a = std::tan(thFibDirRad) + std::tan(std::abs(thFibDirRad - thFullReflRad));
269  float r = std::tan(th) + std::tan(std::abs(th - thcher));
270 
271  // define losses d_qz in cone of full reflection inside quartz direction
272  float d_qz = -1;
273 #ifdef EDM_ML_DEBUG
274  float variant = -1;
275 #endif
276  // if (d > (r+a))
277  if (DelFibPart > (thFullReflRad + thcher)) {
278 #ifdef EDM_ML_DEBUG
279  variant = 0.;
280 #endif
281  d_qz = 0.;
282  } else {
283  // if ((DelFibPart + thcher) < thFullReflRad ) [(d+r) < a]
284  if ((th + thcher) < (thFibDirRad + thFullReflRad) && (th - thcher) > (thFibDirRad - thFullReflRad)) {
285 #ifdef EDM_ML_DEBUG
286  variant = 1.;
287 #endif
288  d_qz = 1.;
289  } else {
290  // if ((thcher - DelFibPart ) > thFullReflRad ) [(r-d) > a]
291  if ((thFibDirRad + thFullReflRad) < (th + thcher) && (thFibDirRad - thFullReflRad) > (th - thcher)) {
292 #ifdef EDM_ML_DEBUG
293  variant = 2.;
294 #endif
295  d_qz = 0.;
296  } else {
297 #ifdef EDM_ML_DEBUG
298  variant = 3.; // d_qz is calculated below
299 #endif
300  // use crossed length of circles(cone projection) - dC1/dC2 :
301  float arg_arcos = 0.;
302  float tan_arcos = 2. * a * d;
303  if (tan_arcos != 0.)
304  arg_arcos = (r * r - a * a - d * d) / tan_arcos;
305  arg_arcos = std::abs(arg_arcos);
306  float th_arcos = acos(std::min(std::max(arg_arcos, -1.f), 1.f));
307  d_qz = th_arcos / CLHEP::twopi;
308  d_qz = std::abs(d_qz);
309 #ifdef EDM_ML_DEBUG
310  edm::LogVerbatim("ForwardSim") << " d_qz: " << r << "," << a << "," << d << " " << tan_arcos << " "
311  << arg_arcos;
312  edm::LogVerbatim("ForwardSim") << "," << arg_arcos;
313  edm::LogVerbatim("ForwardSim") << " " << d_qz;
314  edm::LogVerbatim("ForwardSim") << " " << th_arcos;
315  edm::LogVerbatim("ForwardSim") << "," << d_qz;
316 #endif
317  }
318  }
319  }
320  double meanNCherPhot = 0.;
321  int poissNCherPhot = 0;
322  if (d_qz > 0) {
323  meanNCherPhot = 370. * charge * charge * (1. - 1. / (nMedium * nMedium * beta * beta)) * photEnSpectrDE * stepL;
324 
325  poissNCherPhot = std::max((int)G4Poisson(meanNCherPhot), 0);
326  NCherPhot = poissNCherPhot * effPMTandTransport * d_qz;
327  }
328 
329 #ifdef EDM_ML_DEBUG
330  edm::LogVerbatim("ForwardSim") << "ZdcSD:: getEnergyDeposit: gED: " << stepE << "," << costh << "," << th << ","
331  << costhcher << "," << thcher << "," << DelFibPart << "," << d << "," << a << ","
332  << r << "," << hitPoint << "," << hit_mom << "," << vert_mom << "," << localPoint
333  << "," << charge << "," << beta << "," << stepL << "," << d_qz << "," << variant
334  << "," << meanNCherPhot << "," << poissNCherPhot << "," << NCherPhot;
335 #endif
336 
337  } else {
338  // determine failure mode: beta, charge, and/or nameVolume
339  if (beta <= bThreshold)
340  edm::LogVerbatim("ForwardSim") << "ZdcSD:: getEnergyDeposit: fail beta=" << beta;
341  }
342 
343  return NCherPhot;
344 }
Log< level::Info, true > LogVerbatim
double thFibDir
Definition: ZdcSD.h:44
const Double_t pi
T sqrt(T t)
Definition: SSEVec.h:19
Tan< T >::type tan(const T &t)
Definition: Tan.h:22
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
double f[11][100]
d
Definition: ztail.py:151
double a
Definition: hdecay.h:121
std::string getName(const G4String &)
Definition: ForwardName.cc:3
Geom::Theta< T > theta() const

◆ getFromLibrary()

bool ZdcSD::getFromLibrary ( const G4Step *  aStep)
overrideprotectedvirtual

Reimplemented from CaloSD.

Definition at line 124 of file ZdcSD.cc.

References CaloSD::currentHit, CaloSD::currentID, CaloSD::edepositEM, CaloSD::edepositHAD, CaloSD::entranceLocal, CaloSD::entrancePoint, CaloG4Hit::getEM(), CaloG4Hit::getEntryLocal(), CaloG4Hit::getHadr(), CaloG4Hit::getIncidentEnergy(), CaloG4Hit::getTrackID(), CaloG4Hit::getUnitID(), hits, mps_fire::i, CaloSD::incidentEnergy, convertSQLiteXML::ok, CaloSD::posGlobal, CaloSD::processHit(), CaloSD::resetForNewPrimary(), CaloHitID::setID(), setTrackID(), showerLibrary, hcalRecHitTable_cff::time, and zdcHitEnergyCut.

Referenced by ProcessHits().

124  {
125  bool ok = true;
126 
127  auto const preStepPoint = aStep->GetPreStepPoint();
128 
129  double etrack = preStepPoint->GetKineticEnergy();
130  int primaryID = setTrackID(aStep);
131 
132  hits.clear();
133 
134  // Reset entry point for new primary
135  resetForNewPrimary(aStep);
136 
137  if (etrack >= zdcHitEnergyCut) {
138  // create hits only if above threshold
139 
140 #ifdef EDM_ML_DEBUG
141  auto const theTrack = aStep->GetTrack();
142  edm::LogVerbatim("ForwardSim") << "----------------New track------------------------------\n"
143  << "Incident EnergyTrack: " << etrack << " MeV \n"
144  << "Zdc Cut Energy for Hits: " << zdcHitEnergyCut << " MeV \n"
145  << "ZdcSD::getFromLibrary " << hits.size() << " hits for " << GetName() << " of "
146  << primaryID << " with " << theTrack->GetDefinition()->GetParticleName() << " of "
147  << etrack << " MeV\n";
148 #endif
149  hits.swap(showerLibrary.get()->getHits(aStep, ok));
150  }
151 
152  incidentEnergy = etrack;
153  entrancePoint = preStepPoint->GetPosition();
154  for (unsigned int i = 0; i < hits.size(); i++) {
155  posGlobal = hits[i].position;
156  entranceLocal = hits[i].entryLocal;
157  double time = hits[i].time;
158  unsigned int unitID = hits[i].detID;
159  edepositHAD = hits[i].DeHad;
160  edepositEM = hits[i].DeEM;
161  currentID[0].setID(unitID, time, primaryID, 0);
162  processHit(aStep);
163 
164 #ifdef EDM_ML_DEBUG
165  edm::LogVerbatim("ForwardSim") << "ZdcSD: Final Hit number:" << i << "-->"
166  << "New HitID: " << currentHit[0]->getUnitID()
167  << " New Hit trackID: " << currentHit[0]->getTrackID()
168  << " New EM Energy: " << currentHit[0]->getEM() / CLHEP::GeV
169  << " New HAD Energy: " << currentHit[0]->getHadr() / CLHEP::GeV
170  << " New HitEntryPoint: " << currentHit[0]->getEntryLocal()
171  << " New IncidentEnergy: " << currentHit[0]->getIncidentEnergy() / CLHEP::GeV
172  << " New HitPosition: " << posGlobal;
173 #endif
174  }
175  return ok;
176 }
CaloG4Hit * currentHit[2]
Definition: CaloSD.h:152
float edepositEM
Definition: CaloSD.h:144
Log< level::Info, true > LogVerbatim
int getTrackID() const
Definition: CaloG4Hit.h:64
math::XYZPoint getEntryLocal() const
Definition: CaloG4Hit.h:49
double getEM() const
Definition: CaloG4Hit.h:55
std::vector< ZdcShowerLibrary::Hit > hits
Definition: ZdcSD.h:49
G4ThreeVector posGlobal
Definition: CaloSD.h:142
void processHit(const G4Step *step)
Definition: CaloSD.h:117
double getHadr() const
Definition: CaloG4Hit.h:58
float edepositHAD
Definition: CaloSD.h:144
void resetForNewPrimary(const G4Step *)
Definition: CaloSD.cc:713
int setTrackID(const G4Step *step) override
Definition: ZdcSD.cc:583
void setID(uint32_t unitID, double timeSlice, int trackID, uint16_t depth=0)
Definition: CaloHitID.cc:41
uint32_t getUnitID() const
Definition: CaloG4Hit.h:66
std::unique_ptr< ZdcShowerLibrary > showerLibrary
Definition: ZdcSD.h:46
float incidentEnergy
Definition: CaloSD.h:143
double zdcHitEnergyCut
Definition: ZdcSD.h:45
CaloHitID currentID[2]
Definition: CaloSD.h:146
double getIncidentEnergy() const
Definition: CaloG4Hit.h:61
G4ThreeVector entrancePoint
Definition: CaloSD.h:140
G4ThreeVector entranceLocal
Definition: CaloSD.h:141

◆ initRun()

void ZdcSD::initRun ( )
overrideprotectedvirtual

Reimplemented from CaloSD.

Definition at line 68 of file ZdcSD.cc.

References hits, showerLibrary, and useShowerLibrary.

68  {
69  if (useShowerLibrary) {
70  G4ParticleTable* theParticleTable = G4ParticleTable::GetParticleTable();
71  showerLibrary->initRun(theParticleTable);
72  }
73  hits.clear();
74 }
std::vector< ZdcShowerLibrary::Hit > hits
Definition: ZdcSD.h:49
std::unique_ptr< ZdcShowerLibrary > showerLibrary
Definition: ZdcSD.h:46
bool useShowerLibrary
Definition: ZdcSD.h:43

◆ linearInterpolation()

double ZdcSD::linearInterpolation ( double  x1,
double  y1,
double  x2,
double  y2,
double  z 
)
protected

◆ photonEnergyDist()

double ZdcSD::photonEnergyDist ( double  charge,
double  beta,
double  E 
)
protected

Definition at line 474 of file ZdcSD.cc.

References ALPHA, HLT_2023v12_cff::beta, ALCARECOTkAlJpsiMuMu_cff::charge, evaluateFunction(), and HBARC.

Referenced by generatePhotonEnergy().

474  {
475  const std::vector<double> ENERGY_TAB{1.75715, 1.81902, 1.88311, 1.94944, 2.0183, 2.08939, 2.16302, 2.23919,
476  2.31789, 2.39954, 2.48416, 2.57175, 2.66232, 2.75643, 2.85349, 2.95411,
477  3.05756, 3.16528, 3.2774, 3.39218, 3.5123, 3.6359, 3.76394, 3.89642,
478  4.03332, 4.17596, 4.32302, 4.47596, 4.63319, 4.79629};
479 
480  const std::vector<double> RINDEX_TAB{1.45517, 1.45572, 1.45631, 1.45693, 1.45758, 1.45826, 1.45899, 1.45976,
481  1.46057, 1.46144, 1.46238, 1.46337, 1.46444, 1.46558, 1.4668, 1.46812,
482  1.46953, 1.47105, 1.4727, 1.47447, 1.4764, 1.47847, 1.48071, 1.48315,
483  1.48579, 1.48868, 1.49182, 1.49526, 1.499, 1.5031};
484  double rIndex = evaluateFunction(ENERGY_TAB, RINDEX_TAB, E);
485  return (ALPHA * charge * charge) / HBARC * (1.0 - 1.0 / (beta * beta * rIndex * rIndex));
486 }
const double HBARC
Definition: ZdcSD.cc:357
double evaluateFunction(const std::vector< double > &, const std::vector< double > &, double)
Definition: ZdcSD.cc:547
const double ALPHA
Definition: ZdcSD.cc:356

◆ pmtEfficiency()

double ZdcSD::pmtEfficiency ( double  lambda)
protected

Definition at line 517 of file ZdcSD.cc.

References a, b, and mps_fire::i.

Referenced by calculateCherenkovDeposit().

517  {
518  // Hardcoded wavelength values (nm)
519  const std::vector<double> LAMBDA_TAB{263.27, 265.98, 268.69, 271.39, 273.20, 275.90, 282.22, 282.22, 293.04,
520  308.38, 325.52, 346.26, 367.91, 392.27, 417.53, 440.98, 463.53, 484.28,
521  502.32, 516.75, 528.48, 539.30, 551.93, 564.56, 574.48, 584.41, 595.23,
522  606.96, 616.88, 625.00, 632.22, 637.63, 642.14, 647.55, 652.96, 656.57,
523  661.08, 666.49, 669.20, 673.71, 677.32, 680.93, 686.34, 692.65};
524 
525  // Hardcoded quantum efficiency values
526  const std::vector<double> EFF_TAB{2.215, 2.860, 3.659, 4.724, 5.989, 7.734, 9.806, 9.806, 12.322,
527  15.068, 17.929, 20.570, 22.963, 24.050, 23.847, 22.798, 20.445, 18.003,
528  15.007, 12.282, 9.869, 7.858, 6.373, 5.121, 4.077, 3.276, 2.562,
529  2.077, 1.669, 1.305, 1.030, 0.805, 0.629, 0.492, 0.388, 0.303,
530  0.239, 0.187, 0.144, 0.113, 0.088, 0.069, 0.054, 0.043};
531  //double efficiency = evaluateFunction(LAMBDA_TAB,EFF_TAB,lambda);
532 
533  // Using linear interpolation to calculate efficiency
534  for (int i = 0; i < 44 - 1; i++) {
535  if (lambda > LAMBDA_TAB[i] && lambda < LAMBDA_TAB[i + 1]) {
536  double a = (EFF_TAB[i] - EFF_TAB[i + 1]) / (LAMBDA_TAB[i] - LAMBDA_TAB[i + 1]);
537  double b = EFF_TAB[i] - a * LAMBDA_TAB[i];
538  return (a * lambda + b) / 100.0;
539  }
540  }
541 
542  return 0;
543 }
double b
Definition: hdecay.h:120
double a
Definition: hdecay.h:121

◆ ProcessHits()

bool ZdcSD::ProcessHits ( G4Step *  step,
G4TouchableHistory *  tHistory 
)
overridevirtual

Reimplemented from CaloSD.

Definition at line 76 of file ZdcSD.cc.

References calculateCherenkovDeposit(), CaloSD::createNewHit(), CaloSD::currentHit, CaloSD::currentID, hcalRecHitTable_cff::depth, CaloSD::edepositEM, CaloSD::edepositHAD, hcalRecHitTable_cff::energy, CaloSD::getDepth(), getFromLibrary(), CaloSD::getTrackID(), CaloSD::hitExists(), G4TrackToParticleID::isGammaElectronPositron(), findAndChange::pre, setDetUnitId(), CaloHitID::setID(), hcalRecHitTable_cff::time, useShowerHits, and useShowerLibrary.

76  {
77  if (useShowerLibrary)
78  getFromLibrary(aStep);
79 
80 #ifdef EDM_ML_DEBUG
81  edm::LogVerbatim("ZdcSD") << "ZdcSD::" << GetName() << " ID= " << aStep->GetTrack()->GetTrackID()
82  << " prID= " << aStep->GetTrack()->GetParentID()
83  << " Eprestep= " << aStep->GetPreStepPoint()->GetKineticEnergy()
84  << " step= " << aStep->GetStepLength() << " Edep= " << aStep->GetTotalEnergyDeposit();
85 #endif
86  if (useShowerHits) {
87  // check unitID
88  unsigned int unitID = setDetUnitId(aStep);
89  if (unitID == 0)
90  return false;
91 
92  auto const theTrack = aStep->GetTrack();
93  uint16_t depth = getDepth(aStep);
94 
95  double time = theTrack->GetGlobalTime() / nanosecond;
96  int primaryID = getTrackID(theTrack);
97  currentID[0].setID(unitID, time, primaryID, depth);
98  double energy = calculateCherenkovDeposit(aStep);
99 
100  // Russian Roulette
101  double wt2 = theTrack->GetWeight();
102  if (wt2 > 0.0) {
103  energy *= wt2;
104  }
105 
107  edepositEM = energy;
108  edepositHAD = 0;
109  } else {
110  edepositEM = 0;
112  }
113  if (!hitExists(aStep, 0) && energy > 0.) {
114 #ifdef EDM_ML_DEBUG
115  G4ThreeVector pre = aStep->GetPreStepPoint()->GetPosition();
116  edm::LogVerbatim("ZdcSD") << pre.x() << " " << pre.y() << " " << pre.z();
117 #endif
118  currentHit[0] = CaloSD::createNewHit(aStep, theTrack, 0);
119  }
120  }
121  return true;
122 }
CaloG4Hit * currentHit[2]
Definition: CaloSD.h:152
float edepositEM
Definition: CaloSD.h:144
Log< level::Info, true > LogVerbatim
virtual uint16_t getDepth(const G4Step *)
Definition: CaloSD.cc:912
bool useShowerHits
Definition: ZdcSD.h:43
virtual int getTrackID(const G4Track *)
Definition: CaloSD.cc:872
double calculateCherenkovDeposit(const G4Step *)
Definition: ZdcSD.cc:360
CaloG4Hit * createNewHit(const G4Step *, const G4Track *, int k)
Definition: CaloSD.cc:623
float edepositHAD
Definition: CaloSD.h:144
void setID(uint32_t unitID, double timeSlice, int trackID, uint16_t depth=0)
Definition: CaloHitID.cc:41
bool hitExists(const G4Step *, int k)
Definition: CaloSD.cc:462
static bool isGammaElectronPositron(int pdgCode)
CaloHitID currentID[2]
Definition: CaloSD.h:146
bool getFromLibrary(const G4Step *) override
Definition: ZdcSD.cc:124
uint32_t setDetUnitId(const G4Step *step) override
Definition: ZdcSD.cc:579
bool useShowerLibrary
Definition: ZdcSD.h:43

◆ setDetUnitId()

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

Implements CaloSD.

Definition at line 579 of file ZdcSD.cc.

References numberingScheme.

Referenced by ProcessHits().

579  {
580  return (numberingScheme == nullptr ? 0 : numberingScheme->getUnitID(aStep));
581 }
std::unique_ptr< ZdcNumberingScheme > numberingScheme
Definition: ZdcSD.h:47

◆ setTrackID()

int ZdcSD::setTrackID ( const G4Step *  step)
overrideprotectedvirtual

Reimplemented from CaloSD.

Definition at line 583 of file ZdcSD.cc.

References TrackInformation::getIDonCaloSurface(), CaloSD::previousID, and CaloSD::resetForNewPrimary().

Referenced by getFromLibrary().

583  {
584  auto const theTrack = aStep->GetTrack();
585  TrackInformation* trkInfo = (TrackInformation*)(theTrack->GetUserInformation());
586  int primaryID = trkInfo->getIDonCaloSurface();
587  if (primaryID == 0) {
588 #ifdef EDM_ML_DEBUG
589  auto const preStepPoint = aStep->GetPreStepPoint();
590  double etrack = preStepPoint->GetKineticEnergy();
591  edm::LogVerbatim("ZdcSD") << "ZdcSD: Problem with primaryID **** set by force to TkID **** "
592  << theTrack->GetTrackID() << " E " << etrack;
593 #endif
594  primaryID = theTrack->GetTrackID();
595  }
596  if (primaryID != previousID[0].trackID())
597  resetForNewPrimary(aStep);
598  return primaryID;
599 }
Log< level::Info, true > LogVerbatim
void resetForNewPrimary(const G4Step *)
Definition: CaloSD.cc:713
int getIDonCaloSurface() const
CaloHitID previousID[2]
Definition: CaloSD.h:146

Member Data Documentation

◆ hits

std::vector<ZdcShowerLibrary::Hit> ZdcSD::hits
private

Definition at line 49 of file ZdcSD.h.

Referenced by getFromLibrary(), and initRun().

◆ numberingScheme

std::unique_ptr<ZdcNumberingScheme> ZdcSD::numberingScheme
private

Definition at line 47 of file ZdcSD.h.

Referenced by setDetUnitId(), and ZdcSD().

◆ showerLibrary

std::unique_ptr<ZdcShowerLibrary> ZdcSD::showerLibrary
private

Definition at line 46 of file ZdcSD.h.

Referenced by getFromLibrary(), initRun(), and ZdcSD().

◆ thFibDir

double ZdcSD::thFibDir
private

Definition at line 44 of file ZdcSD.h.

Referenced by getEnergyDeposit(), and ZdcSD().

◆ useShowerHits

bool ZdcSD::useShowerHits
private

Definition at line 43 of file ZdcSD.h.

Referenced by ProcessHits(), and ZdcSD().

◆ useShowerLibrary

bool ZdcSD::useShowerLibrary
private

Definition at line 43 of file ZdcSD.h.

Referenced by initRun(), ProcessHits(), and ZdcSD().

◆ verbosity

int ZdcSD::verbosity
private

Definition at line 42 of file ZdcSD.h.

Referenced by ZdcSD().

◆ zdcHitEnergyCut

double ZdcSD::zdcHitEnergyCut
private

Definition at line 45 of file ZdcSD.h.

Referenced by getFromLibrary(), and ZdcSD().