20#include "GaudiKernel/PhysicalConstants.h"
22#include <unordered_map>
25 constexpr double c_inv = 1./Gaudi::Units::c_light;
35 ATH_MSG_ERROR(
"No simulated hit containers have been parsed to build the segments from ");
36 return StatusCode::FAILURE;
50 return StatusCode::SUCCESS;
54 switch (
const auto techIdx =
m_idHelperSvc->technologyIndex(hitId)) {
62 const double driftTime = rtCalib->tr()->driftTime(hit.
localPosition().perp()).value_or(rtCalib->tr()->maxRadius());
63 return rtCalib->rtRes()->resolution(driftTime);
65 const auto*
re =
m_detMgr->getRpcReadoutElement(hitId);
66 return re->stripEtaPitch() / std::sqrt(12.);
68 const auto*
re =
m_detMgr->getTgcReadoutElement(hitId);
70 const auto& design =
re->wireGangLayout(measHash);
71 return design.stripPitch() / std::sqrt(12.);
81 if (techIdx ==
STGC) {
96 return link->momentum().perp();
99 return std::sqrt(std::max(e*e - m*m, 0.f)) * std::sin(globDir.theta());
116 ATH_MSG_VERBOSE(
"Assemble segments from "<<simHits.size()<<
" background hits.");
117 std::vector<char> alreadyUsed(simHits.size(), 0);
118 for (std::size_t
h = 0 ;
h < simHits.size(); ++
h) {
119 if (alreadyUsed[
h]) {
122 const auto& [refHit, refPos, refDir] = simHits[
h];
126 <<
", pt: "<<
muonPt(*refHit, locToGlob.linear()* refDir)/ Gaudi::Units::GeV <<
" [GeV].");
127 std::vector<std::size_t> indicesOnSeg{
h};
128 for (std::size_t h1 =
h +1; h1 < simHits.size(); ++h1) {
129 if (alreadyUsed[h1]) {
132 const auto&[testHit, testPos, testDir] = simHits[h1];
135 if (std::abs(refHit->kineticEnergy() - testHit->kineticEnergy()) >
m_pileUpHitELoss) {
141 const double angleDir =
Amg::angle(testDir, refDir);
145 <<
", E: "<<testHit->kineticEnergy() / (Gaudi::Units::GeV)<<
", angle: "
146 <<(angleDir / Gaudi::Units::deg) <<
", distance: "<<hitSep<<
".");
151 indicesOnSeg.push_back(h1);
157 globPos, globDir).value_or(0.) * globDir;
158 ATH_MSG_VERBOSE(
"Found "<<indicesOnSeg.size()<<
" matching hits. Closest perigee "
161 std::ranges::transform(indicesOnSeg,
162 std::back_inserter(hitsOnSeg),
163 [&simHits](
const auto idx) {
168 std::ranges::for_each(indicesOnSeg,
169 [&alreadyUsed](
const auto idx) {
170 alreadyUsed[idx] = 1;
182 auto refHit_itr = std::ranges::min_element(simHits,
184 return std::abs(std::get<1>(
a).
z()) <std::abs(std::get<1>(b).
z());
187 const auto [simHit, localPos, chamberDir] = (*refHit_itr);
189 " pdgId: "<<simHit->pdgId()<<
", energy: "<<simHit->kineticEnergy()
190 <<
", genParticle: "<<simHit->genParticleLink().cptr());
194 const double distance =
Amg::intersect<3>(localPos, chamberDir, Amg::Vector3D::UnitZ(), 0.).value_or(0.);
195 const Amg::Vector3D chamberPos = localPos + distance*chamberDir;
198 const Amg::Vector3D globDir = locToGlob.linear() * chamberDir;
200 unsigned nMdt{0}, nRpcEta{0}, nRpcPhi{0}, nTgcEta{0}, nTgcPhi{0};
201 unsigned nMm{0}, nStgcEta{0}, nStgcPhi{0};
204 for (
const auto& [assocMe, pos, dir] : simHits) {
213 if (castRE->nEtaStrips()) ++nRpcEta;
214 if (castRE->nPhiStrips()) ++nRpcPhi;
219 if (castRE->numStrips(gapHash)){
222 if (castRE->numWireGangs(gapHash)) {
237 <<
" pdgId: "<<assocMe->pdgId()<<
", energy: "<<assocMe->kineticEnergy()
238 <<
", genParticle: "<<assocMe->genParticleLink().cptr()<<
", beta: "<<simHit->beta()
239 <<
" global time: "<<simHit->globalTime()<<
", pos: "<<
Amg::toString(pos)
242 associatedHits.push_back(std::move(link));
244 int nPrecisionHits = nMdt + nMm + nStgcEta;
245 int nPhiLayers = nTgcPhi + nRpcPhi + nStgcPhi;
247 if (nPrecisionHits < 3) {
251 xAOD::MuonSegment* truthSegment = out.segments.push_back(std::make_unique<xAOD::MuonSegment>());
252 out.ptDecor(*truthSegment) =
muonPt(*simHit, globDir);
253 out.chargeDecor(*truthSegment) =
MC::charge(simHit);
254 SegPars_t& locPars{out.paramDecor(*truthSegment)};
255 locPars[Acts::toUnderlying(ParamDefs::x0)] = chamberPos.x();
256 locPars[Acts::toUnderlying(ParamDefs::y0)] = chamberPos.y();
257 constexpr float betaLowLimit = 1.e-6;
258 locPars[Acts::toUnderlying(ParamDefs::t0)] = simHit->globalTime() + distance *c_inv / std::max(simHit->beta(), betaLowLimit);
259 locPars[Acts::toUnderlying(ParamDefs::theta)] = chamberDir.theta();
260 locPars[Acts::toUnderlying(ParamDefs::phi)] = chamberDir.phi();
262 truthSegment->
setPosition(globPos.x(), globPos.y(), globPos.z());
263 truthSegment->
setDirection(globDir.x(), globDir.y(), globDir.z());
264 truthSegment->
setT0Error(locPars[Acts::toUnderlying(ParamDefs::t0)], 0.);
266 truthSegment->
setNHits(nPrecisionHits, nPhiLayers, nTgcEta + nRpcEta);
272 if (nPhiLayers == 0){
275 truthSegment->
setFitQuality(
chi2, (nPrecisionHits + nPhiLayers + nTgcEta + nRpcEta - 5));
277 out.hitLinkDecor(*truthSegment) = std::move(associatedHits);
285 using HitsPerParticle = std::unordered_map<HepMC::ConstGenParticlePtr, SimHitVec_t>;
286 using HitCollector = std::unordered_map<const MuonGMR4::SpectrometerSector*, HitsPerParticle>;
287 HitCollector hitCollector{};
295 auto genLink = simHit->genParticleLink();
297 if (genLink.isValid()){
298 genParticle = genLink.cptr();
303 " pdgId: "<<simHit->pdgId()<<
", energy: "<<simHit->kineticEnergy()
304 <<
", genParticle: "<<genParticle);
308 hitCollector[id][genParticle].emplace_back(simHit,
309 toChTrf *xAOD::toEigen(simHit->localPosition()),
310 toChTrf.linear()* xAOD::toEigen(simHit->localDirection()));
315 ATH_CHECK(writeHandle.
record(std::make_unique<xAOD::MuonSegmentContainer>(),
316 std::make_unique<xAOD::MuonSegmentAuxContainer>()));
320 for (
auto& [chamber, collectedParts] : hitCollector) {
322 for (
auto& [particle, simHits]: collectedParts) {
325 return std::get<1>(
a).z() < std::get<1>(b).z();
334 ATH_MSG_DEBUG(
"Constructed "<<writeHandle->size()<<
" truth segments in total ");
335 return StatusCode::SUCCESS;
const boost::regex re(r_e)
#define ATH_CHECK
Evaluate an expression and check for errors.
#define ATH_MSG_VERBOSE(x)
#define ATH_MSG_WARNING(x)
ATLAS-specific HepMC functions.
virtual DetectorType detectorType() const =0
Returns the detector element type.
const ServiceHandle< StoreGateSvc > & detStore() const
Header file for AthHistogramAlgorithm.
This is a "hash" representation of an Identifier.
const MdtFullCalibData * getCalibData(const Identifier &measId, MsgStream &msg) const
Returns the calibration data associated with this station.
The MuonReadoutElement is an abstract class representing the geometry representing the muon detector.
const SpectrometerSector * msSector() const
Returns the pointer to the envelope volume enclosing all chambers in the sector.
const Amg::Transform3D & localToGlobalTrans(const ActsTrk::GeometryContext &ctx) const
Returns the local to global transformation into the ATLAS coordinate system.
virtual IdentifierHash measurementHash(const Identifier &measId) const =0
Constructs the identifier hash from the full measurement Identifier.
virtual IdentifierHash layerHash(const Identifier &measId) const =0
A spectrometer sector forms the envelope of all chambers that are placed in the same MS sector & laye...
Amg::Transform3D globalToLocalTrans(const ActsTrk::GeometryContext &gctx) const
Returns the global -> local transformation from the ATLAS global.
SG::WriteDecorHandleKey< xAOD::MuonSegmentContainer > m_locParKey
Decoration key of the local parameters.
std::vector< HitPosTuple_t > SimHitVec_t
Gaudi::Property< float > m_pileUpHitMinE
Minimum energy threshold for pile up hits to be converted.
SG::ReadHandleKey< ActsTrk::GeometryContext > m_geoCtxKey
Key to the geometry context.
StatusCode execute(const EventContext &ctx) const override
ServiceHandle< Muon::IMuonIdHelperSvc > m_idHelperSvc
IdHelperSvc to decode the Identifiers.
Gaudi::Property< float > m_pileUpHitAngleCone
Maximum scattering angle between two pile-up hits.
Gaudi::Property< float > m_idCylinderR
ID / ITk cylinder radius.
Amg::Transform3D toChamber(const ActsTrk::GeometryContext &gctx, const Identifier &chanId) const
Returns the transform from the local simHit frame -> chamber frame.
const MuonGMR4::MuonDetectorManager * m_detMgr
Pointer to the muon readout geometry.
StatusCode initialize() override final
SG::WriteDecorHandleKey< xAOD::MuonSegmentContainer > m_eleLinkKey
Decoration key of the associated sim hit links.
SG::ReadCondHandleKey< MuonCalib::MdtCalibDataContainer > m_mdtCalibKey
Data dependency on the Mdt calibration container to calculate the uncertainty.
ElementLink< xAOD::MuonSimHitContainer > EleLink_t
Gaudi::Property< float > m_pileUpHitELoss
Maximum energy loss between two pile-up hits.
std::vector< EleLink_t > HitLinkVec_t
Gaudi::Property< float > m_idCylinderHalfZ
ID / Itk cylinder half length.
SG::WriteDecorHandleKey< xAOD::MuonSegmentContainer > m_qKey
Decoration key of the muon charge.
xAOD::MuonSegment * constructSegmentFromHits(const EventContext &ctx, const Amg::Transform3D &locToGlob, const SimHitVec_t &hits, WriteDecorHolder &writeShip) const
Takes a list of related sim hits and transforms them into a truth segment.
SG::WriteDecorHandleKey< xAOD::MuonSegmentContainer > m_ptKey
Decoration key of the associated particle pt.
Gaudi::Property< bool > m_useOnlyMuonHits
Build segments from muon hits only.
void buildSegmentsFromBkg(const EventContext &ctx, const Amg::Transform3D &locToGlob, const SimHitVec_t &simHits, WriteDecorHolder &writeShip) const
Attempts to assemble truth segments from a list of loose sim hits, i.e., the hits are stemming from a...
std::tuple< const xAOD::MuonSimHit *, Amg::Vector3D, Amg::Vector3D > HitPosTuple_t
Tuple consisting out of pointer to the sim hit and the position & direction expressed in the chamber'...
xAOD::MeasVector< Acts::toUnderlying(SegmentFit::ParamDefs::nPars)> SegPars_t
SG::WriteHandleKey< xAOD::MuonSegmentContainer > m_segmentKey
Key under which the segment Container will be recorded in StoreGate.
SG::ReadCondHandleKey< NswErrorCalibData > m_nswUncertKey
Data dependency on the Nsw calibration container to estimate the uncertaintys.
Gaudi::Property< bool > m_includePileUpHits
Construct segments from pile-up hits without GenParticleLink.
Gaudi::Property< float > m_pileUpHitDistance
Maximum separation between two pile-up hits.
float hitUncertainty(const EventContext &ctx, const xAOD::MuonSimHit &hit) const
Evaluates the hit uncertainty.
float muonPt(const xAOD::MuonSimHit &hit, const Amg::Vector3D &globDir) const
Returns the muon pt from the sim hit.
SG::ReadHandleKeyArray< xAOD::MuonSimHitContainer > m_readKeys
List of sim hit containers from which the truth segments shall be retrieved.
double clusterUncertainty(const Input &clustInfo) const
Property holding a SG store/key/clid from which a ReadHandle is made.
StatusCode record(std::unique_ptr< T > data)
Record a const object to the store.
void setDirection(float px, float py, float pz)
Sets the direction.
void setFitQuality(float chiSquared, float numberDoF)
Set the 'Fit Quality' information.
void setNHits(int nPrecisionHits, int nPhiLayers, int nTrigEtaLayers)
Set the number of hits/layers.
void setT0Error(float t0, float t0Error)
Sets the time error.
void setIdentifier(int sector, ::Muon::MuonStationIndex::ChIndex chamberIndex, int etaIndex, ::Muon::MuonStationIndex::TechnologyIndex technology)
Set the identifier.
void setPosition(float x, float y, float z)
Sets the global position.
ConstVectorMap< 3 > localDirection() const
Returns the local direction of the traversing particle.
float mass() const
Returns the rest-mass of the traversing particle.
Identifier identify() const
Returns the global ATLAS identifier of the SimHit.
ConstVectorMap< 3 > localPosition() const
Returns the local postion of the traversing particle.
const HepMcParticleLink & genParticleLink() const
Returns the link to the HepMC particle producing this hit.
float kineticEnergy() const
Returns the kinetic energy of the traversing particle.
double chi2(TH1 *h0, TH1 *h1)
@ Mm
Maybe not needed in the migration.
@ Tgc
Resitive Plate Chambers.
@ Rpc
Monitored Drift Tubes.
std::optional< double > intersect(const AmgVector(N)&posA, const AmgVector(N)&dirA, const AmgVector(N)&posB, const AmgVector(N)&dirB)
Calculates the point B' along the line B that's closest to a second line A.
std::string toString(const Translation3D &translation, int precision=4)
GeoPrimitvesToStringConverter.
double signedDistance(const Amg::Vector3D &posA, const Amg::Vector3D &dirA, const Amg::Vector3D &posB, const Amg::Vector3D &dirB)
Calculates the signed distance between two lines in 3D space.
double angle(const Amg::Vector3D &v1, const Amg::Vector3D &v2)
calculates the opening angle between two vectors
Eigen::Affine3d Transform3D
Eigen::Matrix< double, 3, 1 > Vector3D
const GenParticle * ConstGenParticlePtr
double charge(const T &p)
This header ties the generic definitions in this package.
TechnologyIndex
enum to classify the different layers in the muon spectrometer
const T * get(const ReadCondHandleKey< T > &key, const EventContext &ctx)
Convenience function to retrieve an object given a ReadCondHandleKey.
MuonSimHit_v1 MuonSimHit
Defined the version of the MuonSimHit.
MuonSimHitContainer_v1 MuonSimHitContainer
Define the version of the pixel cluster container.
MuonSegment_v1 MuonSegment
Reference the current persistent version:
Helper struct to ship the write DecorHandles and the reference to the output segment container throug...
#define THROW_EXCEPTION(MESSAGE)