ATLAS Offline Software
Loading...
Searching...
No Matches
TRTProcessingOfStraw Class Reference

TRT Digitization: Processing of a TRT Straws. More...

#include <TRTProcessingOfStraw.h>

Inheritance diagram for TRTProcessingOfStraw:

Classes

class  cluster
 Primary ionisation cluster. More...

Public Types

typedef TimedHitCollection< TRTUncompressedHit >::const_iterator hitCollConstIter

Public Member Functions

 TRTProcessingOfStraw (const TRTDigSettings *, const InDetDD::TRT_DetectorManager *, ITRT_PAITool *, ITRT_SimDriftTimeTool *, TRTElectronicsProcessing *ep, TRTNoise *noise, TRTDigCondBase *digcond, const HepPDT::ParticleDataTable *, const TRT_ID *, ITRT_PAITool *=nullptr, ITRT_PAITool *=nullptr, const ITRT_CalDbTool *=nullptr)
 Constructor: Calls Initialize method.
 ~TRTProcessingOfStraw ()
 Destructor.
void ProcessStraw (MagField::AtlasFieldCache &fieldCache, hitCollConstIter i, hitCollConstIter e, TRTDigit &outdigit, bool &m_alreadyPrintedPDGcodeWarning, double m_cosmicEventPhase, int strawGasType, bool emulationArflag, bool emulationKrflag, CLHEP::HepRandomEngine *rndmEngine, CLHEP::HepRandomEngine *elecProcRndmEngine, CLHEP::HepRandomEngine *elecNoiseRndmEngine, CLHEP::HepRandomEngine *paiRndmEngine)
 Process this straw all the way from Geant4 hit to output digit.
bool msgLvl (const MSG::Level lvl) const
 Test the output level.
MsgStream & msg () const
 The standard message stream.
MsgStream & msg (const MSG::Level lvl) const
 The standard message stream.
void setLevel (MSG::Level lvl)
 Change the current logging level.

Protected Attributes

const TRT_IDm_id_helper

Private Member Functions

 TRTProcessingOfStraw (const TRTProcessingOfStraw &)
TRTProcessingOfStrawoperator= (const TRTProcessingOfStraw &)
void Initialize (const ITRT_CalDbTool *)
 Initialize.
void addClustersFromStep (const double &scaledKineticEnergy, const double &particleCharge, const double &timeOfHit, const double &prex, const double &prey, const double &prez, const double &postx, const double &posty, const double &postz, std::vector< cluster > &clusterlist, int strawGasType, CLHEP::HepRandomEngine *rndmEngine, CLHEP::HepRandomEngine *paiRndmEngine)
 This is the main function for re-simulation of the ionisation in the active gas via the PAI model.
void ClustersToDeposits (MagField::AtlasFieldCache &fieldCache, const int &hitID, const std::vector< cluster > &clusters, std::vector< TRTElectronicsProcessing::Deposit > &deposits, Amg::Vector3D TRThitGlobalPos, double m_cosmicEventPhase, int strawGasType, CLHEP::HepRandomEngine *rndmEngine)
 Transform the ioniation clusters along the particle trajectory inside a straw to energy deposits (i.e.
double setClusterZ (double cluster_z_in, bool isLong, bool isShort, bool isEC) const
Amg::Vector3D getGlobalPosition (int hitID, const TimedHitPtr< TRTUncompressedHit > *theHit)
void initMessaging () const
 Initialize our message level and MessageSvc.

Private Attributes

const TRTDigSettingsm_settings
const InDetDD::TRT_DetectorManagerm_detmgr
ITRT_PAIToolm_pPAItoolXe
ITRT_PAIToolm_pPAItoolAr
ITRT_PAIToolm_pPAItoolKr
ITRT_SimDriftTimeToolm_pSimDriftTimeTool
bool m_timeCorrection = false
 Time to be corrected for flight and wire propagation delays false when beamType='cosmics'.
double m_signalPropagationSpeed = 0.0
double m_attenuationLength = 0.0
bool m_useAttenuation = false
bool m_useMagneticFieldMap = false
double m_maxCrossingTime = 0.0
double m_minCrossingTime = 0.0
double m_shiftOfZeroPoint = 0.0
double m_innerRadiusOfStraw = 0.0
double m_outerRadiusOfWire = 0.0
double m_solenoidFieldStrength = 0.0
TRTTimeCorrectionm_pTimeCorrection
TRTElectronicsProcessingm_pElectronicsProcessing
TRTNoisem_pNoise
TRTDigCondBasem_pDigConditions
const HepPDT::ParticleDataTable * m_pParticleTable
std::vector< clusterm_clusterlist
std::vector< TRTElectronicsProcessing::Depositm_depositList
std::vector< double > m_drifttimes
std::vector< double > m_expattenuation
unsigned int m_maxelectrons = 0U
bool m_alreadywarnedagainstpdg0
std::unique_ptr< CLHEP::RandBinomialFixedPm_randBinomialXe {}
std::unique_ptr< CLHEP::RandBinomialFixedPm_randBinomialKr {}
std::unique_ptr< CLHEP::RandBinomialFixedPm_randBinomialAr {}
std::string m_nm
 Message source name.
boost::thread_specific_ptr< MsgStream > m_msg_tls
 MsgStream instance (a std::cout like with print-out levels)
std::atomic< IMessageSvc * > m_imsg { nullptr }
 MessageSvc pointer.
std::atomic< MSG::Level > m_lvl { MSG::NIL }
 Current logging level.
std::atomic_flag m_initialized ATLAS_THREAD_SAFE = ATOMIC_FLAG_INIT
 Messaging initialized (initMessaging)

Detailed Description

TRT Digitization: Processing of a TRT Straws.


The main controlling function in ProcessStraw(). See detailed description of this.

Definition at line 54 of file TRTProcessingOfStraw.h.

Member Typedef Documentation

◆ hitCollConstIter

Constructor & Destructor Documentation

◆ TRTProcessingOfStraw() [1/2]

TRTProcessingOfStraw::TRTProcessingOfStraw ( const TRTDigSettings * digset,
const InDetDD::TRT_DetectorManager * detmgr,
ITRT_PAITool * paitoolXe,
ITRT_SimDriftTimeTool * simdrifttool,
TRTElectronicsProcessing * ep,
TRTNoise * noise,
TRTDigCondBase * digcond,
const HepPDT::ParticleDataTable * pdt,
const TRT_ID * trt_id,
ITRT_PAITool * paitoolAr = nullptr,
ITRT_PAITool * paitoolKr = nullptr,
const ITRT_CalDbTool * calDbTool = nullptr )

Constructor: Calls Initialize method.

Definition at line 48 of file TRTProcessingOfStraw.cxx.

61: AthMessaging("TRTProcessingOfStraw"),
62 m_settings(digset),
63 m_detmgr(detmgr),
64 m_pPAItoolXe(paitoolXe),
65 m_pPAItoolAr(paitoolAr),
66 m_pPAItoolKr(paitoolKr),
67 m_pSimDriftTimeTool(simdrifttool),
68// m_time_y_eq_zero(0.0),
69// m_ComTime(NULL),
70 m_pTimeCorrection(nullptr),
72 m_pNoise(noise),
73 m_pDigConditions(digcond),
76 m_id_helper(trt_id)
77
78{
79 Initialize(calDbTool);
80}
AthMessaging()
Default constructor:
const HepPDT::ParticleDataTable * m_pParticleTable
TRTDigCondBase * m_pDigConditions
TRTElectronicsProcessing * m_pElectronicsProcessing
void Initialize(const ITRT_CalDbTool *)
Initialize.
TRTTimeCorrection * m_pTimeCorrection
const TRTDigSettings * m_settings
ITRT_SimDriftTimeTool * m_pSimDriftTimeTool
const InDetDD::TRT_DetectorManager * m_detmgr

◆ ~TRTProcessingOfStraw()

TRTProcessingOfStraw::~TRTProcessingOfStraw ( )

Destructor.

Definition at line 83 of file TRTProcessingOfStraw.cxx.

84{
85 delete m_pTimeCorrection;
86}

◆ TRTProcessingOfStraw() [2/2]

TRTProcessingOfStraw::TRTProcessingOfStraw ( const TRTProcessingOfStraw & )
private

Member Function Documentation

◆ addClustersFromStep()

void TRTProcessingOfStraw::addClustersFromStep ( const double & scaledKineticEnergy,
const double & particleCharge,
const double & timeOfHit,
const double & prex,
const double & prey,
const double & prez,
const double & postx,
const double & posty,
const double & postz,
std::vector< cluster > & clusterlist,
int strawGasType,
CLHEP::HepRandomEngine * rndmEngine,
CLHEP::HepRandomEngine * paiRndmEngine )
private

This is the main function for re-simulation of the ionisation in the active gas via the PAI model.

From the given G4 step, ionisation clusters are distributed randomly (mean free path given by TRT_PAI_Process::GetMeanFreePath()) along path. Cluster energies are given by TRT_PAI_Process::GetEnergyTransfer().

Parameters
scaledKineticEnergyThe kinetic energy a proton would have had if it had the same Lorentz gamma factor as the particle in question.
particleChargeParticle charge
timeOfHitTime of hit
prexPreStepPoint x coordinate
preyPreStepPoint y coordinate
prezPreStepPoint z coordinate
postxPostStepPoint x coordinate
postyPostStepPoint y coordinate
postzPostStepPoint z coordinate
clusterlistList of ionisation clusters along step

Definition at line 204 of file TRTProcessingOfStraw.cxx.

211{
212
213 // Choose the appropriate ITRT_PAITool for this straw
214 ITRT_PAITool* activePAITool;
215 if (strawGasType==0) { activePAITool = m_pPAItoolXe; }
216 else if (strawGasType==1) { activePAITool = m_pPAItoolKr; }
217 else if (strawGasType==2) { activePAITool = m_pPAItoolAr; }
218 else { activePAITool = m_pPAItoolXe; } // should never happen
219
220 //Differences and steplength:
221 const double deltaX(postx - prex);
222 const double deltaY(posty - prey);
223 const double deltaZ(postz - prez);
224 const double stepLength(sqrt(deltaX * deltaX + deltaY * deltaY + deltaZ * deltaZ));
225
226 const double meanFreePath(activePAITool->GetMeanFreePath( scaledKineticEnergy, particleCharge*particleCharge ));
227
228 //How many clusters did we actually create:
229 const unsigned int numberOfClusters(CLHEP::RandPoisson::shoot(rndmEngine,stepLength / meanFreePath));
230 //fixme: use RandPoissionQ?
231
232 //Position each of those randomly along the step, and use PAI to get their energies:
233 for (unsigned int iclus(0); iclus<numberOfClusters; ++iclus)
234 {
235 //How far along the step did the cluster get produced:
236 const double lambda(CLHEP::RandFlat::shoot(rndmEngine));
237
238 //Append cluster (the energy is given by the PAI model):
239 double clusE(activePAITool->GetEnergyTransfer(scaledKineticEnergy, paiRndmEngine));
240 clusterlist.emplace_back(clusE, timeOfHit,
241 prex + lambda * deltaX,
242 prey + lambda * deltaY,
243 prez + lambda * deltaZ);
244 }
245
246
247}
virtual double GetMeanFreePath(double scaledKineticEnergy, double squaredCharge) const =0
GetMeanFreePath.
virtual double GetEnergyTransfer(double scaledKineticEnergy, CLHEP::HepRandomEngine *rndmEngine) const =0
GetEnergyTransfer.

◆ ClustersToDeposits()

void TRTProcessingOfStraw::ClustersToDeposits ( MagField::AtlasFieldCache & fieldCache,
const int & hitID,
const std::vector< cluster > & clusters,
std::vector< TRTElectronicsProcessing::Deposit > & deposits,
Amg::Vector3D TRThitGlobalPos,
double m_cosmicEventPhase,
int strawGasType,
CLHEP::HepRandomEngine * rndmEngine )
private

Transform the ioniation clusters along the particle trajectory inside a straw to energy deposits (i.e.

potential fluctuations) reaching the front-end electronics. Effects taken into effect are:

  • number of primary electrons from deposited energy
  • stocastic recapture of drift electrons
  • electron drift in the magnetic field (different direction end-cap/barrel). Optionally the drift time includes spread.
  • Optionally signal wire propagation dealys are included. Each drift electron then gives rise to two signal: direct and reflected.
Parameters
hitIDId of straw
clustersionisation clusters along particle trajectory
depositsenergy deposits on wire

Definition at line 521 of file TRTProcessingOfStraw.cxx.

528{
529
530 //
531 // Some initial work before looping over the cluster
532 //
533
534 deposits.clear();
535
536 unsigned int region(TRTDigiHelper::getRegion(hitID));
537 const bool isBarrel(region<3 );
538 const bool isEC (!isBarrel);
539 const bool isShort (region==1);
540 const bool isLong (region==2);
541 //const bool isECA (region==3);
542 //const bool isECB (region==4);
543
544 CLHEP::RandBinomialFixedP *randBinomial{};
545 if (strawGasType == 0) { randBinomial = m_randBinomialXe.get(); }
546 else if (strawGasType == 1) { randBinomial = m_randBinomialKr.get(); }
547 else if (strawGasType == 2) { randBinomial = m_randBinomialAr.get(); }
548 else { randBinomial = m_randBinomialXe.get(); } // should never happen
549
550 double ionisationPotential = m_settings->ionisationPotential(strawGasType);
551 double smearingFactor = m_settings->smearingFactor(strawGasType);
552
553 std::vector<cluster>::const_iterator currentClusterIter(clusters.begin());
554 const std::vector<cluster>::const_iterator endOfClusterList(clusters.end());
555
556 // if (m_settings->doCosmicTimingPit()) {
557 // if (m_ComTime) { m_time_y_eq_zero = m_ComTime->getTime(); }
558 // else { ATH_MSG_WARNING("Configured to use ComTime tool, but did not find tool. All hits will get the same t0"); }
559 // }
560
561 // The average drift time is affected by the magnetic field which is not uniform so we need to use the
562 // detailed magnetic field map to obtain an effective field for this straw (used in SimDriftTimeTool).
563 // This systematically affects O(ns) drift times in the end cap, but has a very small effect in the barrel.
564 Amg::Vector3D globalPosition;
565 Amg::Vector3D mField;
566 double map_x2(0.),map_y2(0.),map_z2(0.);
567 double effectiveField2(0.); // effective field squared.
568
569 // Magnetic field is the same for all clusters in the straw so this can be called before the cluster loop.
571 {
572 globalPosition[0]=TRThitGlobalPos[0]*CLHEP::mm;
573 globalPosition[1]=TRThitGlobalPos[1]*CLHEP::mm;
574 globalPosition[2]=TRThitGlobalPos[2]*CLHEP::mm;
575
576 // MT Field cache is stored in cache
577 fieldCache.getField (globalPosition.data(), mField.data());
578
579 map_x2 = mField.x()*mField.x(); // would be zero for a uniform field
580 map_y2 = mField.y()*mField.y(); // would be zero for a uniform field
581 map_z2 = mField.z()*mField.z(); // would be m_solenoidfieldstrength^2 for uniform field
582 }
583
584 // Now we are ready to loop over clusters and form timed energy deposits at the wire:
585 //
586 // 1. First determine the number of surviving drift electrons and the energy of their deposits.
587 // 2. Then determine the timing of these deposits.
588
589 // Notes
590 //
591 // 1) It turns out that the total energy deposited (Ed) is, on average, equal to the cluster energy (Ec):
592 // <Ed> = m_ionisationPotential/m_smearingFactor * Ec/m_ionisationPotential * m_smearingFactor = Ec.
593 // Actually it exceeds this *slightly* due to the +1 electron in the calculation of nprimaryelectrons below.
594 // The energy processing below therefore exists only to model the energy *fluctuations*.
595 //
596 // 2) Gaussian approximation (for photons, HIPs etc):
597 // For large Ec (actually nprimaryelectrons > 99) a much faster Gaussian shoot replaces
598 // the Binomial and many exponential shoots. The Gaussian pdf has a mean of Ec and variance
599 // given by sigma^2 = Ec*ionisationPotential*(2-smearingFactor)/smearingFactor. That expression
600 // comes from the sum of the variances from the Binomial and Exponential. In this scheme it is
601 // sufficient (for diffusion) to divided the energy equally amongst 100 (maxelectrons) electrons.
602
603 // straw radius
604 const double wire_r2 = m_outerRadiusOfWire*m_outerRadiusOfWire;
605 const double straw_r2 = m_innerRadiusOfStraw*m_innerRadiusOfStraw;
606
607 // Cluster loop
608 for (;currentClusterIter!=endOfClusterList;++currentClusterIter)
609 {
610 // Get the cluster radius and energy.
611 const double cluster_x(currentClusterIter->xpos);
612 const double cluster_y(currentClusterIter->ypos);
613 const double cluster_z(this->setClusterZ(currentClusterIter->zpos, isLong, isShort, isEC));
614 const double cluster_x2(cluster_x*cluster_x);
615 const double cluster_y2(cluster_y*cluster_y);
616 double cluster_r2(cluster_x2+cluster_y2);
617
618 // These may never occur, but could be very problematic for getAverageDriftTime(), so check and correct this now.
619 if (cluster_r2<wire_r2) cluster_r2=wire_r2; // Compression may (v. rarely) cause r to be smaller than the wire radius. If r=0 then NaN's later!
620 if (cluster_r2>straw_r2) cluster_r2=straw_r2; // Should never occur
621
622 const double cluster_r(std::sqrt(cluster_r2)); // cluster radius
623 const double cluster_E(currentClusterIter->energy); // cluster energy
624 const unsigned int nprimaryelectrons( static_cast<unsigned int>( cluster_E / ionisationPotential + 1.0 ) );
625
626 // Determine the number of surviving electrons and their energy sum.
627 // If nprimaryelectrons > 100 then a Gaussian approximation is good (and much quicker)
628
629 double depositEnergy(0.); // This will be the energy deposited at the wire.
630
631 if (nprimaryelectrons<m_maxelectrons) // Use the detailed Binomial and Exponential treatment at this low energy.
632 {
633 unsigned int nsurvivingprimaryelectrons = static_cast<unsigned int>(randBinomial->fire(rndmEngine,nprimaryelectrons) + 0.5);
634 if (nsurvivingprimaryelectrons==0) continue; // no electrons survived; move on to the next cluster.
635 const double meanElectronEnergy(ionisationPotential / smearingFactor);
636 for (unsigned int ielec(0); ielec<nsurvivingprimaryelectrons; ++ielec) {
637 depositEnergy += CLHEP::RandExpZiggurat::shoot(rndmEngine, meanElectronEnergy);
638 }
639 }
640 else // Use a Gaussian approximation
641 {
642 const double fluctSigma(sqrt(cluster_E * ionisationPotential * (2 - smearingFactor) / smearingFactor));
643 do {
644 depositEnergy = CLHEP::RandGaussZiggurat::shoot(rndmEngine, cluster_E, fluctSigma);
645 } while(depositEnergy<0.0); // very rare.
646 }
647
648 // Now we have the depositEnergy, we need to work out the timing and attenuation
649
650 // First calculate the "effective field" (it's never negative):
651 // Electron drift time is prolonged by the magnetic field according to an "effective field".
652 // For the endcap, the effective field is dependent on the relative (x,y) position of the cluster.
653 // It is assumed here (checked in initialize) that the local straw x-direction is parallel with
654 // the solenoid z-direction. After Garfield simulations and long thought it was found that only
655 // field perpendicular to the electron drift is of importance.
656
657 if (!isBarrel) // Endcap
658 {
659 if (m_useMagneticFieldMap) { // Using magnetic field map
660 effectiveField2 = map_z2*cluster_y2/cluster_r2 + map_x2 + map_y2;
661 }
662 else { // Not using magnetic field map (you really should not do this!):
663 effectiveField2 = m_solenoidFieldStrength*m_solenoidFieldStrength * cluster_y2 / cluster_r2;
664 }
665 }
666 else // Barrel
667 {
668 if (m_useMagneticFieldMap) { // Using magnetic field map (here bug #91830 is corrected)
669 effectiveField2 = map_z2 + (map_x2+map_y2)*cluster_y2/cluster_r2;
670 }
671 else { // Without the mag field map (very small change in digi output)
673 }
674 }
675
676 // If there is no field we might need to reset effectiveField2 to zero.
677 if (m_solenoidFieldStrength == 0. ) effectiveField2=0.;
678
679 // Now we need the deposit time which is the sum of three components:
680 // 1. Time of the hit(cluster): clusterTime.
681 // 2. Drift times: either commondrifttime, or diffused m_drifttimes
682 // 3. Wire propagation times: timedirect and timereflect.
683
684 // get the time of the hit(cluster)
685 double clusterTime(currentClusterIter->time);
686
687 if ( m_settings->doCosmicTimingPit() )
688 { // make (x,y) dependent? i.e: + f(x,y).
689 // clusterTime = clusterTime - m_time_y_eq_zero + m_settings->jitterTimeOffset()*( CLHEP::RandFlat::shoot(rndmEngine) );
690 clusterTime = clusterTime + cosmicEventPhase + m_settings->jitterTimeOffset()*( CLHEP::RandFlat::shoot(rndmEngine) );
691 // yes it is a '+' now. Ask Alex Alonso.
692 }
693
694 // get the wire propagation times (for direct and reflected signals)
695 double timedirect(0.), timereflect(0.);
696 m_pTimeCorrection->PropagationTime( hitID, cluster_z, timedirect, timereflect );
697
698 // While we have the propagation times, we can calculate the exponential attenuation factor
699 double expdirect(1.0), expreflect(1.0); // Initially set to "no attenuation".
701 {
702 //expdirect = exp( -timedirect *m_signalPropagationSpeed / m_attenuationLength);
703 //expreflect = exp( -timereflect*m_signalPropagationSpeed / m_attenuationLength);
704 // Tabulating exp(-dist/m_attenuationLength) with only 150 elements: index [0,149].
705 // > 99.9% of output digits are the same, saves 13% CPU time.
706 // Distances the signal propagate along the wire:
707 // * distdirect is rarely negative (<0.2%) by ~ mm. In such cases there is
708 // no attenuation, which is equivalent to distdirect=0 and so is good.
709 // * distreflect is always +ve and less than 1500, and so is good.
710 // The code is protected against out of bounds in anycase.
711 const double distdirect = timedirect *m_signalPropagationSpeed;
712 const double distreflect = timereflect*m_signalPropagationSpeed;
713 const unsigned int kdirect = static_cast<unsigned int>(distdirect/10);
714 const unsigned int kreflect = static_cast<unsigned int>(distreflect/10);
715 if (kdirect<150) expdirect = m_expattenuation[kdirect]; // otherwise there
716 if (kreflect<150) expreflect = m_expattenuation[kreflect]; // is no attenuation.
717 }
718
719 // Finally, deposit the energy on the wire using the drift-time tool (diffusion is no longer available).
720 double commondrifttime = m_pSimDriftTimeTool->getAverageDriftTime(cluster_r,effectiveField2,strawGasType);
721 double dt = clusterTime + commondrifttime;
722 deposits.emplace_back(0.5*depositEnergy*expdirect, timedirect+dt);
723 deposits.emplace_back(0.5*depositEnergy*expreflect, timereflect+dt);
724
725 } // end of cluster loop
726
727 }
void getField(const double *ATH_RESTRICT xyz, double *ATH_RESTRICT bxyz, double *ATH_RESTRICT deriv=nullptr)
get B field value at given position xyz[3] is in mm, bxyz[3] is in kT if deriv[9] is given,...
std::unique_ptr< CLHEP::RandBinomialFixedP > m_randBinomialXe
std::unique_ptr< CLHEP::RandBinomialFixedP > m_randBinomialKr
std::unique_ptr< CLHEP::RandBinomialFixedP > m_randBinomialAr
std::vector< double > m_expattenuation
double setClusterZ(double cluster_z_in, bool isLong, bool isShort, bool isEC) const
Eigen::Matrix< double, 3, 1 > Vector3D
unsigned int getRegion(int hitID)

◆ getGlobalPosition()

Amg::Vector3D TRTProcessingOfStraw::getGlobalPosition ( int hitID,
const TimedHitPtr< TRTUncompressedHit > * theHit )
private

Definition at line 730 of file TRTProcessingOfStraw.cxx.

730 {
731
732 const int mask(0x0000001F);
733 int word_shift(5);
734 int trtID, ringID, moduleID, layerID, strawID;
735 int wheelID, planeID, sectorID;
736
737 const InDetDD::TRT_BarrelElement *barrelElement;
738 const InDetDD::TRT_EndcapElement *endcapElement;
739
740 if ( !(hitID & 0x00200000) ) { // barrel
741
742 strawID = hitID & mask;
743 hitID >>= word_shift;
744 layerID = hitID & mask;
745 hitID >>= word_shift;
746 moduleID = hitID & mask;
747 hitID >>= word_shift;
748 ringID = hitID & mask;
749 trtID = hitID >> word_shift;
750
751 barrelElement = m_detmgr->getBarrelElement(trtID, ringID, moduleID, layerID);
752
753 if (barrelElement) {
754 const Amg::Vector3D v( (*theHit)->GetPreStepX(),(*theHit)->GetPreStepY(),(*theHit)->GetPreStepZ());
755 return barrelElement->strawTransform(strawID)*v;
756 }
757
758 } else { // endcap
759
760 strawID = hitID & mask;
761 hitID >>= word_shift;
762 planeID = hitID & mask;
763 hitID >>= word_shift;
764 sectorID = hitID & mask;
765 hitID >>= word_shift;
766 wheelID = hitID & mask;
767 trtID = hitID >> word_shift;
768
769 // change trtID (which is 2/3 for endcaps) to use 0/1 in getEndcapElement
770 if (trtID == 3) trtID = 0;
771 else trtID = 1;
772
773 endcapElement = m_detmgr->getEndcapElement(trtID, wheelID, planeID, sectorID);
774
775 if ( endcapElement ) {
776 const Amg::Vector3D v( (*theHit)->GetPreStepX(),(*theHit)->GetPreStepY(),(*theHit)->GetPreStepZ());
777 return endcapElement->strawTransform(strawID)*v;
778 }
779
780 }
781
782 ATH_MSG_WARNING ( "Could not find global coordinate of a straw - drifttime calculation will be inaccurate" );
783 return {0.0,0.0,0.0};
784
785}
#define ATH_MSG_WARNING(x)
const Amg::Transform3D & strawTransform(unsigned int straw) const
Straw transform - fast access in array, in Tracking frame: Amg.

◆ Initialize()

void TRTProcessingOfStraw::Initialize ( const ITRT_CalDbTool * calDbTool)
private

Initialize.

Definition at line 89 of file TRTProcessingOfStraw.cxx.

90{
91
92 m_useMagneticFieldMap = m_settings->useMagneticFieldMap();
93 m_signalPropagationSpeed = m_settings->signalPropagationSpeed() ;
94 m_attenuationLength = m_settings->attenuationLength();
95 m_useAttenuation = m_settings->useAttenuation();
96 m_innerRadiusOfStraw = m_settings->innerRadiusOfStraw();
97 m_outerRadiusOfWire = m_settings->outerRadiusOfWire();
98 m_timeCorrection = m_settings->timeCorrection(); // false for beamType='cosmics'
99 m_solenoidFieldStrength = m_settings->solenoidFieldStrength();
100
101 m_maxelectrons = 100; // 100 gives good Gaussian approximation
102
103 if (m_pPAItoolXe==nullptr) {
104 ATH_MSG_FATAL ( "TRT_PAITool for Xenon not defined! no point in continuing!" );
105 }
106 if (m_pPAItoolKr==nullptr) {
107 ATH_MSG_ERROR ( "TRT_PAITool for Krypton is not defined!!! Xenon TRT_PAITool will be used for Krypton straws!" );
109 }
110 if (m_pPAItoolAr==nullptr) {
111 ATH_MSG_ERROR ( "TRT_PAITool for Argon is not defined!!! Xenon TRT_PAITool will be used for Argon straws!" );
113 }
114
115 ATH_MSG_INFO ( "Xe barrel drift-time at r = 2 mm is " << m_pSimDriftTimeTool->getAverageDriftTime(2.0, 0.002*0.002, 0) << " ns." );
116 ATH_MSG_INFO ( "Kr barrel drift-time at r = 2 mm is " << m_pSimDriftTimeTool->getAverageDriftTime(2.0, 0.002*0.002, 1) << " ns." );
117 ATH_MSG_INFO ( "Ar barrel drift-time at r = 2 mm is " << m_pSimDriftTimeTool->getAverageDriftTime(2.0, 0.002*0.002, 2) << " ns." );
118
119 m_pTimeCorrection = new TRTTimeCorrection(m_settings, m_detmgr, m_id_helper, calDbTool);
120
121 const double intervalBetweenCrossings(m_settings->timeInterval() / 3.);
122 m_minCrossingTime = - (intervalBetweenCrossings * 2. + 1.*CLHEP::ns);
123 m_maxCrossingTime = intervalBetweenCrossings * 3. + 1.*CLHEP::ns;
124 m_shiftOfZeroPoint = static_cast<double>( m_settings->numberOfCrossingsBeforeMain() ) * intervalBetweenCrossings;
125
126 // Tabulate exp(-dist/m_attenuationLength) as a function of dist = time*m_signalPropagationSpeed [0.0 mm, 1500 mm)
127 // otherwise we are doing an exp() for every cluster! > 99.9% of output digits are the same, saves 13% CPU time.
128 m_expattenuation.reserve(150);
129 for (unsigned int k=0; k<150; k++) {
130 double dist = 10.0*(k+0.5); // [5mm, 1415mm] max 5 mm error (sigma = 3 mm)
131 m_expattenuation.push_back(exp(-dist/m_attenuationLength));
132 }
133
134 //For the field effect on drifttimes in this class we will assume that the local x,y coordinates of endcap straws are such that the
135 //local y-direction is parallel to the global z-direction. As a sanity check against future code developments we will test this
136 //assumption on one straw from each endcap layer.
137
139 {
140 const InDetDD::TRT_Numerology * num = m_detmgr->getNumerology();
141 for (unsigned int iwheel = 0; iwheel < num->getNEndcapWheels(); ++iwheel)
142 {
143 for (unsigned int iside = 0; iside < 2; ++iside)
144 { //positive and negative endcap
145 for (unsigned int ilayer = 0; ilayer < num->getNEndcapLayers(iwheel); ++ilayer)
146 {
147 const InDetDD::TRT_EndcapElement * ec_element
148 = m_detmgr->getEndcapElement(iside,//positive or negative endcap
149 iwheel,//wheelIndex,
150 ilayer,//strawLayerIndex,
151 0);//phiIndex
152 //Local straw center and local straw point one unit along x:
153 if (!ec_element)
154 {
155 ATH_MSG_VERBOSE ( "Failed to retrieve endcap element for (iside,iwheel,ilayer)=("
156 << iside<<", "<<iwheel<<", "<<ilayer<<")." );
157 continue;
158 }
159 Amg::Vector3D strawcenter(0.0,0.0,0.0);
160 Amg::Vector3D strawx(1.0,0.0,0.0);
161 //Transform to global coordinate (use first straw in element):
162 strawcenter = ec_element->strawTransform(0) * strawcenter;
163 strawx = ec_element->strawTransform(0) * strawx;
164 const Amg::Vector3D v(strawx-strawcenter);
165 const double zcoordfrac((v.z()>0?v.z():-v.z())/v.mag());
166 if (zcoordfrac<0.98 || zcoordfrac > 1.02)
167 {
168 ATH_MSG_WARNING ( "Found endcap straw where the assumption that local x-direction"
169 <<" is parallel to global z-direction is NOT valid."
170 <<" Drift times will be somewhat off." );
171 }
172 }
173 }
174 }
175
176 //check local barrel coordinates at four positions.
177 for (unsigned int phi_it = 0; phi_it < 32; phi_it++)
178 {
179 const InDetDD::TRT_BarrelElement * bar_element = m_detmgr->getBarrelElement(1,1,phi_it,1);
180
181 Amg::Vector3D strawcenter(0.0,0.0,0.0);
182 Amg::Vector3D straw(cos((double)phi_it*2*M_PI/32.),sin((double)phi_it*2*M_PI/32.),0.0);
183 strawcenter = bar_element->strawTransform(0) * strawcenter;
184 straw = bar_element->strawTransform(0) * straw;
185 const Amg::Vector3D v(straw-strawcenter);
186 const double coordfrac(atan2(v.x(),v.y()));
187 if (coordfrac>0.2 || coordfrac < -0.2)
188 {
189 ATH_MSG_WARNING ( "Found barrel straw where the assumption that local y-direction"
190 <<" is along the straw is NOT valid."
191 <<" Drift times will be somewhat off." );
192 }
193 }
194 }
195
196 m_randBinomialXe = std::make_unique<CLHEP::RandBinomialFixedP>(nullptr, 1, m_settings->smearingFactor(0), m_maxelectrons);
197 m_randBinomialKr = std::make_unique<CLHEP::RandBinomialFixedP>(nullptr, 1, m_settings->smearingFactor(1), m_maxelectrons);
198 m_randBinomialAr = std::make_unique<CLHEP::RandBinomialFixedP>(nullptr, 1, m_settings->smearingFactor(2), m_maxelectrons);
199
200 ATH_MSG_VERBOSE ( "Initialization done" );
201}
#define M_PI
#define ATH_MSG_ERROR(x)
#define ATH_MSG_FATAL(x)
#define ATH_MSG_INFO(x)
#define ATH_MSG_VERBOSE(x)
bool m_timeCorrection
Time to be corrected for flight and wire propagation delays false when beamType='cosmics'.
@ straw
Definition HitInfo.h:82

◆ initMessaging()

void AthMessaging::initMessaging ( ) const
privateinherited

Initialize our message level and MessageSvc.

This method should only be called once.

Definition at line 39 of file AthMessaging.cxx.

40{
42 // If user did not set an explicit level, set a default
43 if (m_lvl == MSG::NIL) {
44 m_lvl = m_imsg ?
45 static_cast<MSG::Level>( m_imsg.load()->outputLevel(m_nm) ) :
46 MSG::INFO;
47 }
48}
std::string m_nm
Message source name.
std::atomic< IMessageSvc * > m_imsg
MessageSvc pointer.
std::atomic< MSG::Level > m_lvl
Current logging level.
IMessageSvc * getMessageSvc(bool quiet=false)

◆ msg() [1/2]

MsgStream & AthMessaging::msg ( ) const
inlineinherited

The standard message stream.

Returns a reference to the default message stream May not be invoked before sysInitialize() has been invoked.

Definition at line 163 of file AthMessaging.h.

164{
165 MsgStream* ms = m_msg_tls.get();
166 if (!ms) {
167 if (!m_initialized.test_and_set()) initMessaging();
168 ms = new MsgStream(m_imsg,m_nm);
169 m_msg_tls.reset( ms );
170 }
171
172 ms->setLevel (m_lvl);
173 return *ms;
174}
boost::thread_specific_ptr< MsgStream > m_msg_tls
MsgStream instance (a std::cout like with print-out levels)
void initMessaging() const
Initialize our message level and MessageSvc.

◆ msg() [2/2]

MsgStream & AthMessaging::msg ( const MSG::Level lvl) const
inlineinherited

The standard message stream.

Returns a reference to the default message stream May not be invoked before sysInitialize() has been invoked.

Definition at line 178 of file AthMessaging.h.

179{ return msg() << lvl; }
MsgStream & msg() const
The standard message stream.

◆ msgLvl()

bool AthMessaging::msgLvl ( const MSG::Level lvl) const
inlineinherited

Test the output level.

Parameters
lvlThe message level to test against
Returns
boolean Indicating if messages at given level will be printed
Return values
trueMessages at level "lvl" will be printed

Definition at line 151 of file AthMessaging.h.

152{
153 if (m_lvl <= lvl) {
154 msg() << lvl;
155 return true;
156 } else {
157 return false;
158 }
159}

◆ operator=()

TRTProcessingOfStraw & TRTProcessingOfStraw::operator= ( const TRTProcessingOfStraw & )
private

◆ ProcessStraw()

void TRTProcessingOfStraw::ProcessStraw ( MagField::AtlasFieldCache & fieldCache,
hitCollConstIter i,
hitCollConstIter e,
TRTDigit & outdigit,
bool & m_alreadyPrintedPDGcodeWarning,
double m_cosmicEventPhase,
int strawGasType,
bool emulationArflag,
bool emulationKrflag,
CLHEP::HepRandomEngine * rndmEngine,
CLHEP::HepRandomEngine * elecProcRndmEngine,
CLHEP::HepRandomEngine * elecNoiseRndmEngine,
CLHEP::HepRandomEngine * paiRndmEngine )

Process this straw all the way from Geant4 hit to output digit.


Steps:

  1. Loop over the simhits in this straw and produce a list of primary ionisation clusters.
  2. Use the cluster list along with gas and wire properties, to create a list of energy deposits (i.e. potential fluctuations) reaching the frontend electronics.
  3. Simulate how the FE turns the results into an output digit. This includes the shaping/amplification and subsequent discrimination as well as addition of noise.
Parameters
iGeant4 hit collection iterator
elast hit in collection
outdigitThe 27 bit digit (bits: 8 low + 1 high + 8 low + 1 high + 8 low + 1 high)

Definition at line 250 of file TRTProcessingOfStraw.cxx.

263{
264
266 // We need the straw id several times in the following //
268 const int hitID((*i)->GetHitID());
269 unsigned int region(TRTDigiHelper::getRegion(hitID));
270 const bool isBarrel(region<3 );
271 //const bool isEC (!isBarrel);
272 //const bool isShort (region==1);
273 //const bool isLong (region==2);
274 const bool isECA (region==3);
275 const bool isECB (region==4);
276
278 //======================================================//
280 // First step is to loop over the simhits in this straw //
281 // and produce a list of primary ionisation clusters. //
282 // Each cluster needs the following information: //
283 // //
284 // * The total energy of the cluster. //
285 // * Its location in local straw (x,y,z) coordinates. //
286 // * The time the cluster was created. //
287 // //
289 //======================================================//
291 // TimeShift is the same for all the simhits in the straw.
292 const double timeShift(m_pTimeCorrection->TimeShift(hitID)); // rename hitID to strawID
293
294 m_clusterlist.clear();
295
296 //For magnetic field evaluation
297 Amg::Vector3D TRThitGlobalPos(0.0,0.0,0.0);
298
299 //Now we loop over all the simhits
300 for (hitCollConstIter hit_iter= i; hit_iter != e; ++hit_iter)
301 {
302 //Get the hit:
303 const TimedHitPtr<TRTUncompressedHit> *theHit = &(*hit_iter);
304
305 TRThitGlobalPos = getGlobalPosition(hitID, theHit);
306
307 //Figure out the global time of the hit (all clusters from the hit
308 //will get same timing).
309
310 double timeOfHit(0.0); // remains zero if timeCorrection is false (beamType='cosmics')
311 if (m_timeCorrection) {
312 const double globalHitTime(hitTime(*theHit));
313 const double globalTime = static_cast<double>((*theHit)->GetGlobalTime());
314 const double bunchCrossingTime(globalHitTime - globalTime);
315 if ( (bunchCrossingTime < m_minCrossingTime) || (bunchCrossingTime > m_maxCrossingTime) ) continue;
316 timeOfHit = m_shiftOfZeroPoint + globalHitTime - timeShift; //is this shiftofzeropoint correct pileup-wise?? [fixme]
317 }
318
319 //if (timeOfHit>125.0) continue; // Will give 3% speed up (but changes seeds!). Needs careful thought though.
320
321 //What kind of particle are we dealing with?
322 const int particleEncoding((*theHit)->GetParticleEncoding());
323
324 //Safeguard against pdgcode 0.
325 if (particleEncoding == 0)
326 {
327 //According to Andrea this is usually nuclear fragments from
328 //hadronic interactions. They therefore ought to be allowed to
329 //contribute, but we ignore them for now - until it can be studied
330 //that it is indeed safe to stop doing so
333 ATH_MSG_WARNING ( "Ignoring sim. particle with pdgcode 0. This warning is only shown once per job" );
334 }
335 continue;
336 }
337
338 // If it is a photon we assume it was absorbed entirely at the point of interaction.
339 // we simply deposit the entire energy into the last point of the sim. step.
340 if ( MC::isPhoton(particleEncoding) ) {
341
342 const double energyDeposit = (*theHit)->GetEnergyDeposit(); // keV (see comment below)
343 // Apply radiator efficiency "fudge factor" to ignore some TR photons (assuming they are over produced in the sim. step.
344 // The fraction removed is based on tuning pHT for electrons to data, after tuning pHT for muons (which do not produce TR).
345 // The efficiency is different for Xe, Kr and Ar. Avoid fudging non-TR photons (TR is < 30 keV).
346 // Also: for |eta|<0.5 apply parabolic scale; see "Parabolic Fudge" https://indico.cern.ch/event/304066/
347
348 if ( energyDeposit<30.0 ) {
349
350 // Improved Argon Emulation tuning October 2018 by Hassane Hamdaoui https://cds.cern.ch/record/2643784
351 // Previously 0.15, 0.28, 0.28
352 double ArEmulationScaling_BA = 0.05;
353 double ArEmulationScaling_ECA = 0.20;
354 double ArEmulationScaling_ECB = 0.20;
355
356 // ROUGH GUESSES RIGHT NOW
357 double KrEmulationScaling_BA = 0.20;
358 double KrEmulationScaling_ECA = 0.39;
359 double KrEmulationScaling_ECB = 0.39;
360
361 if (isBarrel) { // Barrel
362 double trEfficiencyBarrel = m_settings->trEfficiencyBarrel(strawGasType);
363 double hitx = TRThitGlobalPos[0];
364 double hity = TRThitGlobalPos[1];
365 double hitz = TRThitGlobalPos[2];
366 double hitEta = std::abs(log(tan(0.5*atan2(sqrt(hitx*hitx+hity*hity),hitz))));
367 if ( hitEta < 0.5 ) { trEfficiencyBarrel *= ( 0.833333+0.6666667*hitEta*hitEta ); }
368 // scale down the TR efficiency if we are emulating
369 if ( strawGasType == 0 && emulationArflag ) { trEfficiencyBarrel *= ArEmulationScaling_BA; }
370 if ( strawGasType == 0 && emulationKrflag ) { trEfficiencyBarrel *= KrEmulationScaling_BA; }
371 if ( CLHEP::RandFlat::shoot(rndmEngine) > trEfficiencyBarrel ) continue; // Skip this photon
372 } // close if barrel
373 else { // Endcap - no eta dependence here.
374 if (isECA) {
375 double trEfficiencyEndCapA = m_settings->trEfficiencyEndCapA(strawGasType);
376 // scale down the TR efficiency if we are emulating
377 if ( strawGasType == 0 && emulationArflag ) { trEfficiencyEndCapA *= ArEmulationScaling_ECA; }
378 if ( strawGasType == 0 && emulationKrflag ) { trEfficiencyEndCapA *= KrEmulationScaling_ECA; }
379 if ( CLHEP::RandFlat::shoot(rndmEngine) > trEfficiencyEndCapA ) continue; // Skip this photon
380 }
381 if (isECB) {
382 double trEfficiencyEndCapB = m_settings->trEfficiencyEndCapB(strawGasType);
383 // scale down the TR efficiency if we are emulating
384 if ( strawGasType == 0 && emulationArflag ) { trEfficiencyEndCapB *= ArEmulationScaling_ECB; }
385 if ( strawGasType == 0 && emulationKrflag ) { trEfficiencyEndCapB *= KrEmulationScaling_ECB; }
386 if ( CLHEP::RandFlat::shoot(rndmEngine) > trEfficiencyEndCapB ) continue; // Skip this photon
387 }
388 } // close else (end caps)
389 } // energyDeposit < 30.0
390
391 // Append this (usually highly energetic) cluster to the list:
392 m_clusterlist.emplace_back( energyDeposit*CLHEP::keV, timeOfHit, (*theHit)->GetPostStepX(), (*theHit)->GetPostStepY(), (*theHit)->GetPostStepZ() );
393
394 // Regarding the CLHEP::keV above: In TRT_G4_SD we converting the hits to keV,
395 // so here we convert them back to CLHEP units by multiplying by CLHEP::keV.
396 }
397 else if ( MC::isMonopole(particleEncoding)
398 || ( MC::isGenericMultichargedParticle(particleEncoding) && MC::charge(particleEncoding) > 10. )
399 ) {
400 //Special treatment of magnetic monopoles && highly charged Qballs (charge > 10)
401 m_clusterlist.emplace_back( (*theHit)->GetEnergyDeposit()*CLHEP::keV, timeOfHit, (*theHit)->GetPostStepX(), (*theHit)->GetPostStepY(), (*theHit)->GetPostStepZ() );
402 }
403 else { // It's not a photon, monopole or Qball with charge > 10, so we proceed with regular ionization using the PAI model
404
405 // Lookup mass and charge from the PDG info in CLHEP HepPDT:
406 const HepPDT::ParticleData *particle(m_pParticleTable->particle(HepPDT::ParticleID(abs(particleEncoding))));
407 double particleCharge(0.);
408 double particleMass(0.);
409
410 if (particle) {
411 particleCharge = particle->charge();
412 particleMass = particle->mass().value();
413 // Override ParticleData charge value for Qballs and similar exotic multi-charged particles
414 if (MC::isGenericMultichargedParticle(particleEncoding)) {
415 particleCharge =MC::charge(particleEncoding);
416 }
417 }
418 else {
419 // TODO Should we handle charged Geantinos gracefully here?
420 if (!MC::isNucleus(particleEncoding)) {
421 ATH_MSG_WARNING ( "Data for sim. particle with pdgcode "<<particleEncoding
422 <<" is not a nucleus and could not be retrieved from PartPropSvc. Assuming mass and charge as pion. Please investigate." );
423 particleCharge = 1.;
425 }
426 else {
427 particleCharge = MC::charge(particleEncoding);
428
429 const int A(static_cast<int>(MC::baryonNumber(particleEncoding)));
430 const int Z(static_cast<int>(std::abs(MC::numberOfProtons(particleEncoding))));
431 static constexpr double Mp(ParticleConstants::protonMassInMeV);
432 static constexpr double Mn(ParticleConstants::neutronMassInMeV);
433 particleMass = std::abs( Z*Mp+(A-Z)*Mn );
434
435 if (!alreadyPrintedPDGcodeWarning) {
436 ATH_MSG_WARNING ( "Data for sim. particle with pdgcode "<<particleEncoding
437 <<" could not be retrieved from PartPropSvc (unexpected ion)."
438 <<" Please Investigate the PDGTABLE.MeV file."
439 <<" Calculating mass and charge from pdg code."
440 <<" The result is: Charge = "<<particleCharge<<" Mass = "<<particleMass<<"MeV" );
441 alreadyPrintedPDGcodeWarning = true;
442 }
443 }
444 }
445 // Abort if uncharged particle.
446 if (!particleCharge) { continue; }
447 // Abort if weird massless charged particle.
448 if (!particleMass) {
449 ATH_MSG_WARNING ( "Ignoring ionization from particle with pdg code "<<particleEncoding
450 <<" since it appears to be a massless charged particle. Please investigate." );
451 continue;
452 }
453
454 //We are now in the most likely case: A normal ionizing
455 //particle. Using the PAI model we are going to distribute
456 //ionization clusters along the step taken by the sim particle.
457
458 const double scaledKineticEnergy( static_cast<double>((*theHit)->GetKineticEnergy()) * ( CLHEP::proton_mass_c2 / particleMass ));
459
460 addClustersFromStep ( scaledKineticEnergy, particleCharge, timeOfHit,
461 (*theHit)->GetPreStepX(),(*theHit)->GetPreStepY(),(*theHit)->GetPreStepZ(),
462 (*theHit)->GetPostStepX(),(*theHit)->GetPostStepY(),(*theHit)->GetPostStepZ(),
463 m_clusterlist, strawGasType, rndmEngine, paiRndmEngine);
464
465 }
466 }//end of hit loop
467
469 //======================================================//
471 // Second step is, using the cluster list along with //
472 // gas and wire properties, to create a list of energy //
473 // deposits (i.e. potential fluctuations) reaching the //
474 // frontend electronics. Each deposit needs: //
475 // //
476 // * The energy of the deposit. //
477 // * The time it arrives at the FE electronics //
478 // //
480 //======================================================//
482
483 m_depositList.clear();
484
485 ClustersToDeposits(fieldCache, hitID, m_clusterlist, m_depositList, TRThitGlobalPos, cosmicEventPhase, strawGasType, rndmEngine );
486
487
489 //======================================================//
491 // The third and final step is to simulate how the FE //
492 // turns the results into an output digit. This //
493 // includes the shaping/amplification and subsequent //
494 // discrimination as well as addition of noise. //
495 // //
497 //======================================================//
499
500 //If no deposits, and no electronics noise we might as well stop here:
501 if ( m_depositList.empty() && !m_pNoise )
502 {
503 outdigit = TRTDigit(hitID, 0);
504 return;
505 }
506
507 //Get straw conditions data:
508 double lowthreshold, noiseamplitude;
509 if (m_settings->noiseInSimhits()) {
510 m_pDigConditions->getStrawData( hitID, lowthreshold, noiseamplitude );
511 } else {
512 lowthreshold = isBarrel ? m_settings->lowThresholdBar(strawGasType) : m_settings->lowThresholdEC(strawGasType);
513 noiseamplitude = 0.0;
514 }
515
516 //Electronics processing:
517 m_pElectronicsProcessing->ProcessDeposits( m_depositList, hitID, outdigit, lowthreshold, noiseamplitude, strawGasType, elecProcRndmEngine, elecNoiseRndmEngine );
518}
float hitTime(const AFP_SIDSimHit &hit)
std::vector< cluster > m_clusterlist
void ClustersToDeposits(MagField::AtlasFieldCache &fieldCache, const int &hitID, const std::vector< cluster > &clusters, std::vector< TRTElectronicsProcessing::Deposit > &deposits, Amg::Vector3D TRThitGlobalPos, double m_cosmicEventPhase, int strawGasType, CLHEP::HepRandomEngine *rndmEngine)
Transform the ioniation clusters along the particle trajectory inside a straw to energy deposits (i....
void addClustersFromStep(const double &scaledKineticEnergy, const double &particleCharge, const double &timeOfHit, const double &prex, const double &prey, const double &prez, const double &postx, const double &posty, const double &postz, std::vector< cluster > &clusterlist, int strawGasType, CLHEP::HepRandomEngine *rndmEngine, CLHEP::HepRandomEngine *paiRndmEngine)
This is the main function for re-simulation of the ionisation in the active gas via the PAI model.
Amg::Vector3D getGlobalPosition(int hitID, const TimedHitPtr< TRTUncompressedHit > *theHit)
std::vector< TRTElectronicsProcessing::Deposit > m_depositList
TimedHitCollection< TRTUncompressedHit >::const_iterator hitCollConstIter
int numberOfProtons(const T &p)
bool isGenericMultichargedParticle(const T &p)
In addition, there is a need to identify ”Q-ball” and similar very exotic (multi-charged) particles w...
bool isPhoton(const T &p)
bool isMonopole(const T &p)
PDG rule 11i Magnetic monopoles and dyons are assumed to have one unit of Dirac monopole charge and a...
double charge(const T &p)
bool isNucleus(const T &p)
PDG rule 16 Nuclear codes are given as 10-digit numbers ±10LZZZAAAI.
double baryonNumber(const T &p)
constexpr double protonMassInMeV
the mass of the proton (in MeV)
constexpr double chargedPionMassInMeV
the mass of the charged pion (in MeV)
constexpr double neutronMassInMeV
the mass of the neutron (in MeV)
constexpr ParticleHypothesis particle[PARTICLEHYPOTHESES]
the array of masses
@ energyDeposit

◆ setClusterZ()

double TRTProcessingOfStraw::setClusterZ ( double cluster_z_in,
bool isLong,
bool isShort,
bool isEC ) const
private

Definition at line 788 of file TRTProcessingOfStraw.cxx.

788 {
789 double cluster_z(cluster_z_in);
790
791 // The active gas volume along the straw z-axis is: Barrel long +-349.315 mm; Barrel short +-153.375 mm; End caps +-177.150 mm.
792 // Here we give a warning for clusters that are outside of the straw gas volume in in z. Since T/P version 3 cluster z values
793 // can go several mm outside these ranges; 30 mm is plenty allowance in the checks below.
794 const double longBarrelStrawHalfLength(349.315*CLHEP::mm);
795 const double shortBarrelStrawHalfLength(153.375*CLHEP::mm);
796 const double EndcapStrawHalfLength(177.150*CLHEP::mm);
797 if ( isLong && std::abs(cluster_z)>longBarrelStrawHalfLength+30 ) {
798 double d = cluster_z<0 ? cluster_z+longBarrelStrawHalfLength : cluster_z-longBarrelStrawHalfLength;
799 ATH_MSG_WARNING ("Long barrel straw cluster is outside the active gas volume z = +- 349.315 mm by " << d << " mm.");
800 ATH_MSG_WARNING ("Setting cluster_z = 0.0");
801 cluster_z = 0.0;
802 }
803 if ( isShort && std::abs(cluster_z)>shortBarrelStrawHalfLength+30 ) {
804 double d = cluster_z<0 ? cluster_z+shortBarrelStrawHalfLength : cluster_z-shortBarrelStrawHalfLength;
805 ATH_MSG_WARNING ("Short barrel straw cluster is outside the active gas volume z = +- 153.375 mm by " << d << " mm.");
806 ATH_MSG_WARNING ("Setting cluster_z = 0.0");
807 cluster_z = 0.0;
808 }
809 if ( isEC && std::abs(cluster_z)>EndcapStrawHalfLength+30 ) {
810 double d = cluster_z<0 ? cluster_z+EndcapStrawHalfLength : cluster_z-EndcapStrawHalfLength;
811 ATH_MSG_WARNING ("End cap straw cluster is outside the active gas volume z = +- 177.150 mm by " << d << " mm.");
812 ATH_MSG_WARNING ("Setting cluster_z = 0.0");
813 cluster_z = 0.0;
814 }
815 return cluster_z;
816}

◆ setLevel()

void AthMessaging::setLevel ( MSG::Level lvl)
inherited

Change the current logging level.

Use this rather than msg().setLevel() for proper operation with MT.

Definition at line 28 of file AthMessaging.cxx.

29{
30 m_lvl = lvl;
31}

Member Data Documentation

◆ ATLAS_THREAD_SAFE

std::atomic_flag m_initialized AthMessaging::ATLAS_THREAD_SAFE = ATOMIC_FLAG_INIT
mutableprivateinherited

Messaging initialized (initMessaging)

Definition at line 141 of file AthMessaging.h.

◆ m_alreadywarnedagainstpdg0

bool TRTProcessingOfStraw::m_alreadywarnedagainstpdg0
private

Definition at line 228 of file TRTProcessingOfStraw.h.

◆ m_attenuationLength

double TRTProcessingOfStraw::m_attenuationLength = 0.0
private

Definition at line 128 of file TRTProcessingOfStraw.h.

◆ m_clusterlist

std::vector<cluster> TRTProcessingOfStraw::m_clusterlist
private

Definition at line 162 of file TRTProcessingOfStraw.h.

◆ m_depositList

std::vector<TRTElectronicsProcessing::Deposit> TRTProcessingOfStraw::m_depositList
private

Definition at line 163 of file TRTProcessingOfStraw.h.

◆ m_detmgr

const InDetDD::TRT_DetectorManager* TRTProcessingOfStraw::m_detmgr
private

Definition at line 118 of file TRTProcessingOfStraw.h.

◆ m_drifttimes

std::vector<double> TRTProcessingOfStraw::m_drifttimes
private

Definition at line 224 of file TRTProcessingOfStraw.h.

◆ m_expattenuation

std::vector<double> TRTProcessingOfStraw::m_expattenuation
private

Definition at line 225 of file TRTProcessingOfStraw.h.

◆ m_id_helper

const TRT_ID* TRTProcessingOfStraw::m_id_helper
protected

Definition at line 237 of file TRTProcessingOfStraw.h.

◆ m_imsg

std::atomic<IMessageSvc*> AthMessaging::m_imsg { nullptr }
mutableprivateinherited

MessageSvc pointer.

Definition at line 135 of file AthMessaging.h.

135{ nullptr };

◆ m_innerRadiusOfStraw

double TRTProcessingOfStraw::m_innerRadiusOfStraw = 0.0
private

Definition at line 137 of file TRTProcessingOfStraw.h.

◆ m_lvl

std::atomic<MSG::Level> AthMessaging::m_lvl { MSG::NIL }
mutableprivateinherited

Current logging level.

Definition at line 138 of file AthMessaging.h.

138{ MSG::NIL };

◆ m_maxCrossingTime

double TRTProcessingOfStraw::m_maxCrossingTime = 0.0
private

Definition at line 133 of file TRTProcessingOfStraw.h.

◆ m_maxelectrons

unsigned int TRTProcessingOfStraw::m_maxelectrons = 0U
private

Definition at line 226 of file TRTProcessingOfStraw.h.

◆ m_minCrossingTime

double TRTProcessingOfStraw::m_minCrossingTime = 0.0
private

Definition at line 134 of file TRTProcessingOfStraw.h.

◆ m_msg_tls

boost::thread_specific_ptr<MsgStream> AthMessaging::m_msg_tls
mutableprivateinherited

MsgStream instance (a std::cout like with print-out levels)

Definition at line 132 of file AthMessaging.h.

◆ m_nm

std::string AthMessaging::m_nm
privateinherited

Message source name.

Definition at line 129 of file AthMessaging.h.

◆ m_outerRadiusOfWire

double TRTProcessingOfStraw::m_outerRadiusOfWire = 0.0
private

Definition at line 138 of file TRTProcessingOfStraw.h.

◆ m_pDigConditions

TRTDigCondBase* TRTProcessingOfStraw::m_pDigConditions
private

Definition at line 146 of file TRTProcessingOfStraw.h.

◆ m_pElectronicsProcessing

TRTElectronicsProcessing* TRTProcessingOfStraw::m_pElectronicsProcessing
private

Definition at line 144 of file TRTProcessingOfStraw.h.

◆ m_pNoise

TRTNoise* TRTProcessingOfStraw::m_pNoise
private

Definition at line 145 of file TRTProcessingOfStraw.h.

◆ m_pPAItoolAr

ITRT_PAITool* TRTProcessingOfStraw::m_pPAItoolAr
private

Definition at line 120 of file TRTProcessingOfStraw.h.

◆ m_pPAItoolKr

ITRT_PAITool* TRTProcessingOfStraw::m_pPAItoolKr
private

Definition at line 121 of file TRTProcessingOfStraw.h.

◆ m_pPAItoolXe

ITRT_PAITool* TRTProcessingOfStraw::m_pPAItoolXe
private

Definition at line 119 of file TRTProcessingOfStraw.h.

◆ m_pParticleTable

const HepPDT::ParticleDataTable* TRTProcessingOfStraw::m_pParticleTable
private

Definition at line 148 of file TRTProcessingOfStraw.h.

◆ m_pSimDriftTimeTool

ITRT_SimDriftTimeTool* TRTProcessingOfStraw::m_pSimDriftTimeTool
private

Definition at line 122 of file TRTProcessingOfStraw.h.

◆ m_pTimeCorrection

TRTTimeCorrection* TRTProcessingOfStraw::m_pTimeCorrection
private

Definition at line 143 of file TRTProcessingOfStraw.h.

◆ m_randBinomialAr

std::unique_ptr<CLHEP::RandBinomialFixedP> TRTProcessingOfStraw::m_randBinomialAr {}
private

Definition at line 234 of file TRTProcessingOfStraw.h.

234{};

◆ m_randBinomialKr

std::unique_ptr<CLHEP::RandBinomialFixedP> TRTProcessingOfStraw::m_randBinomialKr {}
private

Definition at line 233 of file TRTProcessingOfStraw.h.

233{};

◆ m_randBinomialXe

std::unique_ptr<CLHEP::RandBinomialFixedP> TRTProcessingOfStraw::m_randBinomialXe {}
private

Definition at line 232 of file TRTProcessingOfStraw.h.

232{};

◆ m_settings

const TRTDigSettings* TRTProcessingOfStraw::m_settings
private

Definition at line 117 of file TRTProcessingOfStraw.h.

◆ m_shiftOfZeroPoint

double TRTProcessingOfStraw::m_shiftOfZeroPoint = 0.0
private

Definition at line 135 of file TRTProcessingOfStraw.h.

◆ m_signalPropagationSpeed

double TRTProcessingOfStraw::m_signalPropagationSpeed = 0.0
private

Definition at line 127 of file TRTProcessingOfStraw.h.

◆ m_solenoidFieldStrength

double TRTProcessingOfStraw::m_solenoidFieldStrength = 0.0
private

Definition at line 140 of file TRTProcessingOfStraw.h.

◆ m_timeCorrection

bool TRTProcessingOfStraw::m_timeCorrection = false
private

Time to be corrected for flight and wire propagation delays false when beamType='cosmics'.

Definition at line 125 of file TRTProcessingOfStraw.h.

◆ m_useAttenuation

bool TRTProcessingOfStraw::m_useAttenuation = false
private

Definition at line 130 of file TRTProcessingOfStraw.h.

◆ m_useMagneticFieldMap

bool TRTProcessingOfStraw::m_useMagneticFieldMap = false
private

Definition at line 131 of file TRTProcessingOfStraw.h.


The documentation for this class was generated from the following files: