ATLAS Offline Software
Loading...
Searching...
No Matches
MuonR4::SpacePointMakerAlg Class Reference

Data preparation algorithm that transforms the uncalibrated measurements into muon space points. More...

#include <SpacePointMakerAlg.h>

Inheritance diagram for MuonR4::SpacePointMakerAlg:

Classes

struct  SpacePointsPerChamber
 : Helper struct to collect the space point per muon chamber, which are later sorted into the space point buckets. More...
class  SpacePointStatistics
 Helper class to keep track of how many eta+phi, eta and phi only space points are built in various detector regions. More...

Public Types

template<Acts::PointerConcept Prd_t>
using PrdVec_t = std::vector<Prd_t>
template<typename T>
using EtaPhi2DHits = std::array<PrdVec_t<T>, 3>
template<typename T>
using EtaPhi2DHitsVec = std::vector<EtaPhi2DHits<T>>

Public Member Functions

 ~SpacePointMakerAlg ()=default
StatusCode execute (const EventContext &ctx) const override
StatusCode initialize () override
StatusCode finalize () override
 ########################################## SpacePointMakerAlg #########################################
template<>
bool passOccupancy2D (const PrdVec_t< const xAOD::TgcStrip * > &etaHits, const PrdVec_t< const xAOD::TgcStrip * > &phiHits) const
template<>
bool passOccupancy2D (const PrdVec_t< const xAOD::RpcMeasurement * > &etaHits, const PrdVec_t< const xAOD::RpcMeasurement * > &phiHits) const
template<>
bool passOccupancy2D (const PrdVec_t< const xAOD::MMCluster * > &, const PrdVec_t< const xAOD::MMCluster * > &) const
template<>
StatusCode loadContainerAndSort (const EventContext &ctx, const SG::ReadHandleKey< xAOD::sTgcMeasContainer > &key, PreSortedSpacePointMap &fillContainer) const
virtual StatusCode sysInitialize () override
 Override sysInitialize.
virtual bool isClonable () const override
 Specify if the algorithm is clonable.
virtual unsigned int cardinality () const override
 Cardinality (Maximum number of clones that can exist) special value 0 means that algorithm is reentrant.
virtual StatusCode sysExecute (const EventContext &ctx) override
 Execute an algorithm.
virtual const DataObjIDColl & extraOutputDeps () const override
 Return the list of extra output dependencies.
virtual bool filterPassed (const EventContext &ctx) const
virtual void setFilterPassed (bool state, const EventContext &ctx) const
ServiceHandle< StoreGateSvc > & evtStore ()
 The standard StoreGateSvc (event store) Returns (kind of) a pointer to the StoreGateSvc.
const ServiceHandle< StoreGateSvc > & detStore () const
 The standard StoreGateSvc/DetectorStore Returns (kind of) a pointer to the StoreGateSvc.
virtual StatusCode sysStart () override
 Handle START transition.
virtual std::vector< Gaudi::DataHandle * > inputHandles () const override
 Return this algorithm's input handles.
virtual std::vector< Gaudi::DataHandle * > outputHandles () const override
 Return this algorithm's output handles.
Gaudi::Details::PropertyBase & declareProperty (Gaudi::Property< T, V, H > &t)
void updateVHKA (Gaudi::Details::PropertyBase &)
MsgStream & msg () const
bool msgLvl (const MSG::Level lvl) const

Protected Member Functions

void renounceArray (SG::VarHandleKeyArray &handlesArray)
 remove all handles from I/O resolution
std::enable_if_t< std::is_void_v< std::result_of_t< decltype(&T::renounce)(T)> > &&!std::is_base_of_v< SG::VarHandleKeyArray, T > &&std::is_base_of_v< Gaudi::DataHandle, T >, void > renounce (T &h)
void extraDeps_update_handler (Gaudi::Details::PropertyBase &ExtraDeps)
 Add StoreName to extra input/output deps as needed.

Private Types

using PreSortedSpacePointMap = std::unordered_map<const MuonGMR4::SpectrometerSector*, SpacePointsPerChamber>
 Container abrivation of the presorted space point container per MuonChambers.
using SpacePointBucketVec = std::vector<SpacePointBucket>
 Abrivation of a MuonSapcePoint bucket vector.
typedef ServiceHandle< StoreGateSvcStoreGateSvc_t

Private Member Functions

template<typename ContType>
StatusCode loadContainerAndSort (const EventContext &ctx, const SG::ReadHandleKey< ContType > &key, PreSortedSpacePointMap &fillContainer) const
 Retrieve an uncalibrated measurement container <ContType> and fill the hits into the presorted space point map.
template<typename PrdType>
bool passOccupancy2D (const PrdVec_t< PrdType > &etaHits, const PrdVec_t< PrdType > &phiHits) const
 : Check whether the occupancy cuts of hits in a gasGap are surpassed.
template<typename ContType>
EtaPhi2DHitsVec< typename ContType::const_value_type > splitHitsPerGasGap (xAOD::ChamberViewer< ContType > &viewer) const
 Splits the chamber hits of the viewer per gas gap.
template<typename PrdType>
void fillUncombinedSpacePoints (const ActsTrk::GeometryContext &gctx, const Amg::Transform3D &sectorTrans, const PrdVec_t< PrdType * > &prdsToFill, std::vector< SpacePoint > &outColl) const
 Transform the uncombined space prd measurements to space points.
void distributePointsAndStore (SpacePointsPerChamber &&hitsPerChamber, SpacePointContainer &finalContainer) const
 Distribute the premade spacepoints per chamber into their individual SpacePoint buckets.
void distributePrimaryPoints (std::vector< SpacePoint > &&spacePoints, SpacePointBucketVec &splittedContainer) const
 Distributes the vector of primary eta or eta + phi space points and fills them into the buckets.
void distributePhiPoints (std::vector< SpacePoint > &&spacePoints, SpacePointBucketVec &splittedContainer) const
 Distributs the vector phi space points into the buckets.
bool splitBucket (const SpacePoint &spacePoint, const double firstSpPos, const SpacePointBucketVec &sortedPoints) const
 Returns whether the space point is beyond the bucket boundary.
void newBucket (const SpacePoint &refSp, SpacePointBucketVec &sortedPoints) const
 Closes the current processed bucket and creates a new one.
Gaudi::Details::PropertyBase & declareGaudiProperty (Gaudi::Property< T, V, H > &hndl, const SG::VarHandleKeyType &)
 specialization for handling Gaudi::Property<SG::VarHandleKey>

Private Attributes

SG::ReadHandleKey< xAOD::MdtDriftCircleContainerm_mdtKey
SG::ReadHandleKey< xAOD::RpcMeasurementContainerm_rpcKey
SG::ReadHandleKey< xAOD::TgcStripContainerm_tgcKey
SG::ReadHandleKey< xAOD::MMClusterContainerm_mmKey
SG::ReadHandleKey< xAOD::sTgcMeasContainerm_stgcKey {this, "sTgcKey", "xAODsTgcMeasurements"}
SG::ReadHandleKey< ActsTrk::GeometryContextm_geoCtxKey {this, "AlignmentKey", "ActsAlignment", "cond handle key"}
ServiceHandle< Muon::IMuonIdHelperSvcm_idHelperSvc {this, "IdHelperSvc", "Muon::MuonIdHelperSvc/MuonIdHelperSvc"}
SG::WriteHandleKey< SpacePointContainerm_writeKey {this, "WriteKey", "MuonSpacePoints"}
Gaudi::Property< double > m_spacePointWindow
Gaudi::Property< double > m_maxBucketLength
Gaudi::Property< double > m_spacePointOverlap
Gaudi::Property< bool > m_doStat
Gaudi::Property< unsigned > m_capacityBucket {this,"CapacityBucket" , 50}
std::unique_ptr< SpacePointStatistics > m_statCounter ATLAS_THREAD_SAFE {}
Gaudi::Property< double > m_maxOccRpcEta
Gaudi::Property< double > m_maxOccRpcPhi
Gaudi::Property< double > m_maxOccTgcEta
Gaudi::Property< double > m_maxOccTgcPhi
DataObjIDColl m_extendedExtraObjects
 Extra output dependency collection, extended by AthAlgorithmDHUpdate to add symlinks.
StoreGateSvc_t m_evtStore
 Pointer to StoreGate (event store by default)
StoreGateSvc_t m_detStore
 Pointer to StoreGate (detector store by default)
std::vector< SG::VarHandleKeyArray * > m_vhka
bool m_varHandleArraysDeclared

Detailed Description

Data preparation algorithm that transforms the uncalibrated measurements into muon space points.

Mdt, Mm measurements are directly transformed. The remaining three technologies provide eta & phi measurements, each 1D. The measurements are sorted by gas gap and if the occupancy in the gas gap is low enough, then each eta measurement is combined with each phi measurement to a 2D space point. Otherwise, single 1D space points are produced. Space points in the same MS layer & phi-sector are expressed in the common sector frame.

Definition at line 34 of file SpacePointMakerAlg.h.

Member Typedef Documentation

◆ EtaPhi2DHits

template<typename T>
using MuonR4::SpacePointMakerAlg::EtaPhi2DHits = std::array<PrdVec_t<T>, 3>

Definition at line 39 of file SpacePointMakerAlg.h.

◆ EtaPhi2DHitsVec

template<typename T>
using MuonR4::SpacePointMakerAlg::EtaPhi2DHitsVec = std::vector<EtaPhi2DHits<T>>

Definition at line 41 of file SpacePointMakerAlg.h.

◆ PrdVec_t

template<Acts::PointerConcept Prd_t>
using MuonR4::SpacePointMakerAlg::PrdVec_t = std::vector<Prd_t>

Definition at line 37 of file SpacePointMakerAlg.h.

◆ PreSortedSpacePointMap

Container abrivation of the presorted space point container per MuonChambers.

Definition at line 106 of file SpacePointMakerAlg.h.

◆ SpacePointBucketVec

Abrivation of a MuonSapcePoint bucket vector.

Definition at line 109 of file SpacePointMakerAlg.h.

◆ StoreGateSvc_t

typedef ServiceHandle<StoreGateSvc> AthCommonDataStore< AthCommonMsg< Gaudi::Algorithm > >::StoreGateSvc_t
privateinherited

Definition at line 388 of file AthCommonDataStore.h.

Constructor & Destructor Documentation

◆ ~SpacePointMakerAlg()

MuonR4::SpacePointMakerAlg::~SpacePointMakerAlg ( )
default

Member Function Documentation

◆ cardinality()

unsigned int AthCommonReentrantAlgorithm< Gaudi::Algorithm >::cardinality ( ) const
overridevirtualinherited

Cardinality (Maximum number of clones that can exist) special value 0 means that algorithm is reentrant.

Override this to return 0 for reentrant algorithms.

Definition at line 75 of file AthCommonReentrantAlgorithm.cxx.

64{
65 return 0;
66}

◆ declareGaudiProperty()

Gaudi::Details::PropertyBase & AthCommonDataStore< AthCommonMsg< Gaudi::Algorithm > >::declareGaudiProperty ( Gaudi::Property< T, V, H > & hndl,
const SG::VarHandleKeyType &  )
inlineprivateinherited

specialization for handling Gaudi::Property<SG::VarHandleKey>

Definition at line 156 of file AthCommonDataStore.h.

158 {
160 hndl.value(),
161 hndl.documentation());
162
163 }
Gaudi::Details::PropertyBase & declareProperty(Gaudi::Property< T, V, H > &t)

◆ declareProperty()

Gaudi::Details::PropertyBase & AthCommonDataStore< AthCommonMsg< Gaudi::Algorithm > >::declareProperty ( Gaudi::Property< T, V, H > & t)
inlineinherited

Definition at line 145 of file AthCommonDataStore.h.

145 {
146 typedef typename SG::HandleClassifier<T>::type htype;
148 }
Gaudi::Details::PropertyBase & declareGaudiProperty(Gaudi::Property< T, V, H > &hndl, const SG::VarHandleKeyType &)
specialization for handling Gaudi::Property<SG::VarHandleKey>

◆ detStore()

const ServiceHandle< StoreGateSvc > & AthCommonDataStore< AthCommonMsg< Gaudi::Algorithm > >::detStore ( ) const
inlineinherited

The standard StoreGateSvc/DetectorStore Returns (kind of) a pointer to the StoreGateSvc.

Definition at line 95 of file AthCommonDataStore.h.

◆ distributePhiPoints()

void MuonR4::SpacePointMakerAlg::distributePhiPoints ( std::vector< SpacePoint > && spacePoints,
SpacePointBucketVec & splittedContainer ) const
private

Distributs the vector phi space points into the buckets.

In contrast to the primary distribution no new buckets are created and the points are distributed into the existing ones instead.

Parameters
spacePointVecotr of phi space points to sort into the buckets
splittedContainerOutput vector containing all defined bucket

If maxY is smaller than the lower cov boundary or minY is bigger than the other boundary, there's definetely no overlap

Definition at line 618 of file SpacePointMakerAlg.cxx.

619 {
620 for (SpacePoint& sp : spacePoints) {
621 auto phiPoint = std::make_shared<SpacePoint>(std::move(sp));
622 const double dY = std::sqrt(phiPoint->covariance()[Acts::toUnderlying(CovIdx::etaCov)]);
623 const double minY = phiPoint->localPosition().y() - dY;
624 const double maxY = phiPoint->localPosition().y() + dY;
625 for (SpacePointBucket& bucket : splittedContainer){
628 if (! (maxY < bucket.coveredMin() || bucket.coveredMax() < minY) ) {
629 bucket.emplace_back(phiPoint);
630 }
631 }
632 }
633}
static Double_t sp

◆ distributePointsAndStore()

void MuonR4::SpacePointMakerAlg::distributePointsAndStore ( SpacePointsPerChamber && hitsPerChamber,
SpacePointContainer & finalContainer ) const
private

Distribute the premade spacepoints per chamber into their individual SpacePoint buckets.

A new bucket is created everytime if the hit to fill is along the z-axis farther away from the first point in the bucket than the <spacePointWindowSize>. Hit in the previous bucket which are <spacePointOverlap> away from the first hit in the new bucket are also mirrored. The bucket formation starts with the eta Muon space points and then consumes the phi hits.

Parameters
ctxEvent context of the current event
hitsPerChamberList of all premade space points which have to be sorted
finalContainerOutput SpacePoint bucket container.

Definition at line 586 of file SpacePointMakerAlg.cxx.

587 {
588 SpacePointBucketVec splittedHits{};
589 splittedHits.emplace_back();
590 if (m_statCounter){
591 m_statCounter->addToStat(hitsPerChamber.etaHits);
592 m_statCounter->addToStat(hitsPerChamber.phiHits);
593
594 }
595 distributePrimaryPoints(std::move(hitsPerChamber.etaHits), splittedHits);
596 splittedHits.erase(std::remove_if(splittedHits.begin(), splittedHits.end(),
597 [](const SpacePointBucket& bucket) {
598 return bucket.size() <= 1;
599 }), splittedHits.end());
600 distributePhiPoints(std::move(hitsPerChamber.phiHits), splittedHits);
601
602 for (SpacePointBucket& bucket : splittedHits) {
603
604 std::ranges::sort(bucket, MuonR4::SpacePointPerLayerSorter{});
605
606 if (msgLvl(MSG::VERBOSE)){
607 std::stringstream spStr{};
608 for (const std::shared_ptr<SpacePoint>& sp : bucket){
609 spStr<<"SpacePoint: PrimaryMeas: " <<(*sp)<<std::endl;
610 }
611 ATH_MSG_VERBOSE("Created a bucket, printing all spacepoints..."<<std::endl<<spStr.str());
612 }
613 bucket.populateChamberLocations();
614 finalContainer.push_back(std::make_unique<SpacePointBucket>(std::move(bucket)));
615 }
616
617}
#define ATH_MSG_VERBOSE(x)
bool msgLvl(const MSG::Level lvl) const
void distributePhiPoints(std::vector< SpacePoint > &&spacePoints, SpacePointBucketVec &splittedContainer) const
Distributs the vector phi space points into the buckets.
std::vector< SpacePointBucket > SpacePointBucketVec
Abrivation of a MuonSapcePoint bucket vector.
void distributePrimaryPoints(std::vector< SpacePoint > &&spacePoints, SpacePointBucketVec &splittedContainer) const
Distributes the vector of primary eta or eta + phi space points and fills them into the buckets.
DataModel_detail::iterator< DVL > remove_if(typename DataModel_detail::iterator< DVL > beg, typename DataModel_detail::iterator< DVL > end, Predicate pred)
Specialization of remove_if for DataVector/List.

◆ distributePrimaryPoints()

void MuonR4::SpacePointMakerAlg::distributePrimaryPoints ( std::vector< SpacePoint > && spacePoints,
SpacePointBucketVec & splittedContainer ) const
private

Distributes the vector of primary eta or eta + phi space points and fills them into the buckets.

The buckets are dynamically created based on the distance of the new space point to sort to the previous or the first space point in the bucket.

Parameters
spacePointsVector of space points to sort into the buckets
splittedContainerOutput vector containing all defined bucket

Order the space points by local chamber y which is along the tube-plane.

Definition at line 673 of file SpacePointMakerAlg.cxx.

674 {
675
676 if (spacePoints.empty()) return;
677
679 std::ranges::sort(spacePoints,
680 [] (const SpacePoint& a, const SpacePoint& b) {
681 return a.localPosition().y() < b.localPosition().y();
682 });
683
684 double firstPointPos = spacePoints.front().localPosition().y();
685
686 for (SpacePoint& toSort : spacePoints) {
687 ATH_MSG_VERBOSE("Add new primary space point "<<toSort);
688
689 if (splitBucket(toSort, firstPointPos, splittedHits)){
690 newBucket(toSort, splittedHits);
691 firstPointPos = splittedHits.back().empty() ? toSort.localPosition().y() : splittedHits.back().front()->localPosition().y();
692 ATH_MSG_VERBOSE("New bucket: id " << splittedHits.back().bucketId() << " Coverage: " << firstPointPos);
693 }
694 std::shared_ptr<SpacePoint> spacePoint = std::make_shared<SpacePoint>(std::move(toSort));
695 splittedHits.back().emplace_back(spacePoint);
696 }
697 SpacePointBucket& lastBucket{splittedHits.back()};
698 lastBucket.setCoveredRange(lastBucket.front()->localPosition().y(),
699 lastBucket.back()->localPosition().y());
700}
static Double_t a
void newBucket(const SpacePoint &refSp, SpacePointBucketVec &sortedPoints) const
Closes the current processed bucket and creates a new one.
bool splitBucket(const SpacePoint &spacePoint, const double firstSpPos, const SpacePointBucketVec &sortedPoints) const
Returns whether the space point is beyond the bucket boundary.

◆ evtStore()

ServiceHandle< StoreGateSvc > & AthCommonDataStore< AthCommonMsg< Gaudi::Algorithm > >::evtStore ( )
inlineinherited

The standard StoreGateSvc (event store) Returns (kind of) a pointer to the StoreGateSvc.

Definition at line 85 of file AthCommonDataStore.h.

◆ execute()

StatusCode MuonR4::SpacePointMakerAlg::execute ( const EventContext & ctx) const
override

Definition at line 567 of file SpacePointMakerAlg.cxx.

567 {
568 PreSortedSpacePointMap preSortedContainer{};
569 ATH_CHECK(loadContainerAndSort(ctx, m_mdtKey, preSortedContainer));
570 ATH_CHECK(loadContainerAndSort(ctx, m_rpcKey, preSortedContainer));
571 ATH_CHECK(loadContainerAndSort(ctx, m_tgcKey, preSortedContainer));
572 ATH_CHECK(loadContainerAndSort(ctx, m_mmKey, preSortedContainer));
573 ATH_CHECK(loadContainerAndSort(ctx, m_stgcKey, preSortedContainer));
574 std::unique_ptr<SpacePointContainer> outContainer = std::make_unique<SpacePointContainer>();
575
576 for (auto &[chamber, hitsPerChamber] : preSortedContainer){
577 ATH_MSG_DEBUG("Fill space points for chamber "<<chamber->identString() << " with "<<hitsPerChamber.etaHits.size()
578 <<" primary and "<<hitsPerChamber.phiHits.size()<<" phi space points.");
579 distributePointsAndStore(std::move(hitsPerChamber), *outContainer);
580 }
581 SG::WriteHandle writeHandle{m_writeKey, ctx};
582 ATH_CHECK(writeHandle.record(std::move(outContainer)));
583 return StatusCode::SUCCESS;
584}
#define ATH_CHECK
Evaluate an expression and check for errors.
#define ATH_MSG_DEBUG(x)
SG::ReadHandleKey< xAOD::TgcStripContainer > m_tgcKey
SG::ReadHandleKey< xAOD::MMClusterContainer > m_mmKey
SG::WriteHandleKey< SpacePointContainer > m_writeKey
StatusCode loadContainerAndSort(const EventContext &ctx, const SG::ReadHandleKey< ContType > &key, PreSortedSpacePointMap &fillContainer) const
Retrieve an uncalibrated measurement container <ContType> and fill the hits into the presorted space ...
SG::ReadHandleKey< xAOD::RpcMeasurementContainer > m_rpcKey
SG::ReadHandleKey< xAOD::sTgcMeasContainer > m_stgcKey
void distributePointsAndStore(SpacePointsPerChamber &&hitsPerChamber, SpacePointContainer &finalContainer) const
Distribute the premade spacepoints per chamber into their individual SpacePoint buckets.
std::unordered_map< const MuonGMR4::SpectrometerSector *, SpacePointsPerChamber > PreSortedSpacePointMap
Container abrivation of the presorted space point container per MuonChambers.
SG::ReadHandleKey< xAOD::MdtDriftCircleContainer > m_mdtKey
StatusCode record(std::unique_ptr< T > data)
Record a const object to the store.

◆ extraDeps_update_handler()

void AthCommonDataStore< AthCommonMsg< Gaudi::Algorithm > >::extraDeps_update_handler ( Gaudi::Details::PropertyBase & ExtraDeps)
protectedinherited

Add StoreName to extra input/output deps as needed.

use the logic of the VarHandleKey to parse the DataObjID keys supplied via the ExtraInputs and ExtraOuputs Properties to add the StoreName if it's not explicitly given

◆ extraOutputDeps()

const DataObjIDColl & AthCommonReentrantAlgorithm< Gaudi::Algorithm >::extraOutputDeps ( ) const
overridevirtualinherited

Return the list of extra output dependencies.

This list is extended to include symlinks implied by inheritance relations.

Definition at line 94 of file AthCommonReentrantAlgorithm.cxx.

90{
91 // If we didn't find any symlinks to add, just return the collection
92 // from the base class. Otherwise, return the extended collection.
93 if (!m_extendedExtraObjects.empty()) {
95 }
97}
An algorithm that can be simultaneously executed in multiple threads.

◆ fillUncombinedSpacePoints()

template<typename PrdType>
void MuonR4::SpacePointMakerAlg::fillUncombinedSpacePoints ( const ActsTrk::GeometryContext & gctx,
const Amg::Transform3D & sectorTrans,
const PrdVec_t< PrdType * > & prdsToFill,
std::vector< SpacePoint > & outColl ) const
private

Transform the uncombined space prd measurements to space points.

Parameters
gctxGeometry context to fetch the transformation of the measurements
sectorTransTransformation to go from the global -> sector frame
prdsToFillList of uncombined measurements to transform
outCollReference to the mutable output collection to which the 1D space points are appended.

Local coordinate system aligned such that the strips point along local y

The measurement is a phi measurement

Definition at line 202 of file SpacePointMakerAlg.cxx.

205 {
206 if (prdsToFill.empty()) {
207 return;
208 }
209 const PrdType* refMeas = prdsToFill.front();
210 bool allSpArePhi{false};
211
212 const Amg::Transform3D toSectorTrans = toChamberTransform(gctx, sectorTrans, *refMeas);
214 Amg::Vector3D sensorDir{Amg::Vector3D::Zero()}, toNextSen{Amg::Vector3D::Zero()};
216 if constexpr(std::is_same_v<PrdType, xAOD::RpcMeasurement> ||
217 std::is_same_v<PrdType, xAOD::TgcStrip>) {
218 allSpArePhi = refMeas->measuresPhi();
219 const auto& stripLayout = refMeas->readoutElement()->sensorLayout(refMeas->layerHash());
220 const auto& design = stripLayout->design(allSpArePhi);
221 sensorDir = toSectorTrans.rotation() * stripLayout->to3D(design.stripDir(), allSpArePhi);
222 toNextSen = toSectorTrans.rotation() * stripLayout->to3D(design.stripNormal(), allSpArePhi);
223 } else {
224 sensorDir = toSectorTrans.rotation().col(Amg::y);
225 toNextSen = toSectorTrans.rotation().col(Amg::x);
226 }
227 outColl.reserve(outColl.size() + prdsToFill.size());
228 for (const PrdType* prd: prdsToFill) {
229 SpacePoint& newSp = outColl.emplace_back(prd);
230 if constexpr (std::is_same_v<PrdType, xAOD::TgcStrip>) {
231 if (allSpArePhi) {
232 const auto& stripLayout = refMeas->readoutElement()->sensorLayout(refMeas->layerHash());
233 const auto& radialDesign = static_cast<const MuonGMR4::RadialStripDesign&>(stripLayout->design(allSpArePhi));
234 toNextSen = toSectorTrans.rotation() * stripLayout->to3D(radialDesign.stripNormal(prd->channelNumber()), allSpArePhi);
235 sensorDir = toSectorTrans.rotation() * stripLayout->to3D(radialDesign.stripDir(prd->channelNumber()), allSpArePhi);
236 }
237 }
238 newSp.setPosition(toSectorTrans * prd->localMeasurementPos());
239 newSp.setDirection(sensorDir, toNextSen);
240 auto cov = Acts::filledArray<double,3>(0.);
241 if (prd->numDimensions() == 2) {
242 cov[Acts::toUnderlying(CovIdx::etaCov)] = prd->template localCovariance<2>()(0,0);
243 cov[Acts::toUnderlying(CovIdx::phiCov)] = prd->template localCovariance<2>()(1,1);
244 } else {
246 auto covIdx{Acts::toUnderlying(CovIdx::etaCov)},
247 lenIdx{Acts::toUnderlying(CovIdx::phiCov)};
248 if (!newSp.measuresEta()) {
249 std::swap(covIdx, lenIdx);
250 }
251 cov[covIdx] = prd->template localCovariance<1>()[0];
252 cov[lenIdx] = Acts::square(sensorHalfLength(*prd));
253 }
254 newSp.setCovariance(std::move(cov));
255 }
256}
Eigen::Affine3d Transform3D
Eigen::Matrix< double, 3, 1 > Vector3D
void swap(ElementLinkVector< DOBJ > &lhs, ElementLinkVector< DOBJ > &rhs)

◆ filterPassed()

virtual bool AthCommonReentrantAlgorithm< Gaudi::Algorithm >::filterPassed ( const EventContext & ctx) const
inlinevirtualinherited

Definition at line 96 of file AthCommonReentrantAlgorithm.h.

96 {
97 return execState( ctx ).filterPassed();
98 }
virtual bool filterPassed(const EventContext &ctx) const

◆ finalize()

StatusCode MuonR4::SpacePointMakerAlg::finalize ( )
override

########################################## SpacePointMakerAlg #########################################

Definition at line 152 of file SpacePointMakerAlg.cxx.

152 {
153 if (m_statCounter) {
154 m_statCounter->dumpStatisics(msgStream());
155 }
156 return StatusCode::SUCCESS;
157}

◆ initialize()

StatusCode MuonR4::SpacePointMakerAlg::initialize ( )
override

Definition at line 158 of file SpacePointMakerAlg.cxx.

158 {
159 ATH_CHECK(m_geoCtxKey.initialize());
160 ATH_CHECK(m_mdtKey.initialize(!m_mdtKey.empty()));
161 ATH_CHECK(m_rpcKey.initialize(!m_rpcKey.empty()));
162 ATH_CHECK(m_tgcKey.initialize(!m_tgcKey.empty()));
163 ATH_CHECK(m_mmKey.initialize(!m_mmKey.empty()));
164 ATH_CHECK(m_stgcKey.initialize(!m_stgcKey.empty()));
165 ATH_CHECK(m_idHelperSvc.retrieve());
166 ATH_CHECK(m_writeKey.initialize());
167 if (m_doStat) {
168 m_statCounter = std::make_unique<SpacePointStatistics>(m_idHelperSvc.get());
169 }
170 return StatusCode::SUCCESS;
171}
Gaudi::Property< bool > m_doStat
SG::ReadHandleKey< ActsTrk::GeometryContext > m_geoCtxKey
ServiceHandle< Muon::IMuonIdHelperSvc > m_idHelperSvc

◆ inputHandles()

virtual std::vector< Gaudi::DataHandle * > AthCommonDataStore< AthCommonMsg< Gaudi::Algorithm > >::inputHandles ( ) const
overridevirtualinherited

Return this algorithm's input handles.

We override this to include handle instances from key arrays if they have not yet been declared. See comments on updateVHKA.

◆ isClonable()

◆ loadContainerAndSort() [1/2]

template<typename ContType>
StatusCode MuonR4::SpacePointMakerAlg::loadContainerAndSort ( const EventContext & ctx,
const SG::ReadHandleKey< ContType > & key,
PreSortedSpacePointMap & fillContainer ) const
private

Retrieve an uncalibrated measurement container <ContType> and fill the hits into the presorted space point map.

Per associated MuonChamber, hits from Tgc, Rpc, sTgcs are grouped by their gasGap location and then divided into eta & phi measurements. If both are found, each eta measurement is combined with phi measurement into a SpacePoint. In any other case, the measurements are just transformed into a SpacePoint.

Parameters
ctxEvent context of the current event
keyReadHandleKey to access the container of data type <ContType>
fillContainerGlobal container into which all space points are filled.

Loop over the chamber hits to split the hits per gasGap

Fill in the 2D measurements BIL Rpc

Only one dimensional space points can be built

Simple combination by taking the cross-product

There's no valid combination with another phi hit

Tgc measurements with different bunch crossing tags cannot be combined

Definition at line 298 of file SpacePointMakerAlg.cxx.

300 {
301 const ContType* measurementCont{nullptr};
302 ATH_CHECK(SG::get(measurementCont, key, ctx));
303 if (!measurementCont || measurementCont->empty()){
304 ATH_MSG_DEBUG("nothing to do");
305 return StatusCode::SUCCESS;
306 }
307 const ActsTrk::GeometryContext* gctx{nullptr};
308 ATH_CHECK(SG::get(gctx, m_geoCtxKey, ctx));
309
310 xAOD::ChamberViewer viewer{*measurementCont};
311
312 do {
313 SpacePointsPerChamber& pointsInChamb = fillContainer[viewer.at(0)->readoutElement()->msSector()];
314 const Amg::Transform3D sectorTrans = viewer.at(0)->readoutElement()->msSector()->globalToLocalTransform(*gctx);
315 ATH_MSG_DEBUG("Fill space points for chamber "<<m_idHelperSvc->toStringDetEl(viewer.at(0)->identify()));
316 if constexpr( std::is_same_v<ContType, xAOD::MdtDriftCircleContainer>) {
317 pointsInChamb.etaHits.reserve(pointsInChamb.etaHits.capacity() + viewer.size());
318 for (const auto& prd : viewer) {
319 Amg::Transform3D toChamberTrans{toChamberTransform(*gctx, sectorTrans, *prd)};
320 SpacePoint& sp{pointsInChamb.etaHits.emplace_back(prd)};
321 sp.setPosition(toChamberTrans*prd->localMeasurementPos());
322 sp.setDirection(toChamberTrans.rotation().col(Amg::z),
323 toChamberTrans.rotation().col(Amg::y));
324 std::array<double, 3> cov{Acts::filledArray<double,3>(0.)};
325 cov[Acts::toUnderlying(CovIdx::etaCov)] = prd->driftRadiusCov();
326 cov[Acts::toUnderlying(CovIdx::phiCov)] = Acts::square(sensorHalfLength(*prd));
327 if (ATH_UNLIKELY(prd->numDimensions() == 2)){
328 cov[Acts::toUnderlying(CovIdx::phiCov)] = static_cast<const xAOD::MdtTwinDriftCircle*>(prd)->posAlongWireCov();
329 }
330 sp.setCovariance(std::move(cov));
331 }
332 } else {
334 for (auto& [etaHits, phiHits, two2DHits] : splitHitsPerGasGap(viewer)) {
335 ATH_MSG_DEBUG("Found "<<etaHits.size()<<"/"<<phiHits.size()
336 <<" 1D and "<<two2DHits.size()<<" 2D hits in chamber "
337 <<m_idHelperSvc->toStringDetEl(viewer.at(0)->identify()));
339 fillUncombinedSpacePoints(*gctx, sectorTrans, two2DHits, pointsInChamb.etaHits);
341 // Check if we do not have 2D occupancy (missing phi or eta hits)
342 if (!passOccupancy2D(etaHits, phiHits)) {
343 fillUncombinedSpacePoints(*gctx, sectorTrans, etaHits, pointsInChamb.etaHits);
344 fillUncombinedSpacePoints(*gctx, sectorTrans, phiHits, pointsInChamb.phiHits);
345 continue;
346 }
347
348 std::vector<std::shared_ptr<unsigned>> etaCounts{matchCountVec(etaHits.size())},
349 phiCounts{matchCountVec(phiHits.size())};
350
351 pointsInChamb.etaHits.reserve(pointsInChamb.etaHits.size() + etaHits.size()*phiHits.size());
353 const auto& firstEta{etaHits.front()};
354 const Amg::Transform3D toSectorTrans = toChamberTransform(*gctx, sectorTrans, *firstEta);
355
356 Amg::Vector3D toNextDir{Amg::Vector3D::Zero()}, sensorDir{Amg::Vector3D::Zero()};
357 if constexpr (std::is_same_v<xAOD::RpcMeasurementContainer, ContType> ||
358 std::is_same_v<xAOD::TgcStripContainer, ContType>) {
359 const auto& stripLayout = firstEta->readoutElement()->sensorLayout(firstEta->layerHash());
360 const auto& design = stripLayout->design();
361 sensorDir = toSectorTrans.rotation() * stripLayout->to3D(design.stripDir(), false);
362 toNextDir = toSectorTrans.rotation() * stripLayout->to3D(design.stripNormal(), false);
363 } else {
364 toNextDir = toSectorTrans.rotation().col(Amg::x);
365 sensorDir = toSectorTrans.rotation().col(Amg::y);
366 }
367
368 using namespace Acts::detail::LineHelper;
369 for (unsigned etaP = 0; etaP < etaHits.size(); ++etaP) {
371 for (unsigned phiP = 0; phiP < phiHits.size(); ++ phiP) {
373 if constexpr(std::is_same_v<xAOD::TgcStripContainer, ContType>) {
374 if (!(etaHits[etaP]->bcBitMap() & phiHits[phiP]->bcBitMap())){
375 continue;
376 }
377 const auto& stripLay = phiHits[phiP]->readoutElement()->sensorLayout(phiHits[phiP]->layerHash());
378 const auto& radialDesign = static_cast<const MuonGMR4::RadialStripDesign&>(stripLay->design(true));
379 toNextDir = toSectorTrans.rotation() * stripLay->to3D(radialDesign.stripDir(phiHits[phiP]->channelNumber()), true);
380 }
381
382 SpacePoint& newSp = pointsInChamb.etaHits.emplace_back(etaHits[etaP], phiHits[phiP]);
383 newSp.setInstanceCounts(etaCounts[etaP], phiCounts[phiP]);
384
385 auto spIsect = lineIntersect(toSectorTrans*etaHits[etaP]->localMeasurementPos(), sensorDir,
386 toSectorTrans*phiHits[phiP]->localMeasurementPos(), toNextDir);
387 newSp.setPosition(spIsect.position());
388 newSp.setDirection(sensorDir, toNextDir);
389 auto cov = Acts::filledArray<double, 3>(0.);
390 cov[Acts::toUnderlying(CovIdx::etaCov)] = etaHits[etaP]->template localCovariance<1>()[0];
391 cov[Acts::toUnderlying(CovIdx::phiCov)] = phiHits[phiP]->template localCovariance<1>()[0];
392 newSp.setCovariance(std::move(cov));
393 ATH_MSG_VERBOSE("Created new space point "<<newSp);
394 }
395 }
396 }
397 }
398 } while (viewer.next());
399 return StatusCode::SUCCESS;
400}
#define ATH_UNLIKELY(x)
void fillUncombinedSpacePoints(const ActsTrk::GeometryContext &gctx, const Amg::Transform3D &sectorTrans, const PrdVec_t< PrdType * > &prdsToFill, std::vector< SpacePoint > &outColl) const
Transform the uncombined space prd measurements to space points.
bool passOccupancy2D(const PrdVec_t< PrdType > &etaHits, const PrdVec_t< PrdType > &phiHits) const
: Check whether the occupancy cuts of hits in a gasGap are surpassed.
EtaPhi2DHitsVec< typename ContType::const_value_type > splitHitsPerGasGap(xAOD::ChamberViewer< ContType > &viewer) const
Splits the chamber hits of the viewer per gas gap.
const_ref at(const std::size_t idx) const
Returns the i-the measurement from the current chamber.
std::size_t size() const noexcept
Returns how many hits are in the current chamber.
const T * get(const ReadCondHandleKey< T > &key, const EventContext &ctx)
Convenience function to retrieve an object given a ReadCondHandleKey.
MdtTwinDriftCircle_v1 MdtTwinDriftCircle
IdentifierHash layerHash(const UncalibratedMeasurement *meas)
Returns the layer hash from an uncalibrated meaurement.
: Helper struct to collect the space point per muon chamber, which are later sorted into the space po...

◆ loadContainerAndSort() [2/2]

template<>
StatusCode MuonR4::SpacePointMakerAlg::loadContainerAndSort ( const EventContext & ctx,
const SG::ReadHandleKey< xAOD::sTgcMeasContainer > & key,
PreSortedSpacePointMap & fillContainer ) const

Helper function combine an eta and a phi collection. The function takes two indices referrring to the indices of the hit vector inside HitColls

Parameters
collIdxAIndex of the collection to put as phi
collIdxBIndex of the collection to put as eta
combFuncLambda function that rejects hits which cannot be combined due to geometry reasons.

Skip if one of collections are empty

Get first hit from the first collection

The hit in the collection has already been used

Definition at line 403 of file SpacePointMakerAlg.cxx.

405 {
406
407 const xAOD::sTgcMeasContainer* measurementCont{nullptr};
408 ATH_CHECK(SG::get(measurementCont, key, ctx));
409 if (!measurementCont || measurementCont->empty()){
410 ATH_MSG_DEBUG("nothing to do");
411 return StatusCode::SUCCESS;
412 }
413 const ActsTrk::GeometryContext* gctx{nullptr};
414 ATH_CHECK(SG::get(gctx, m_geoCtxKey, ctx));
415 xAOD::ChamberViewer viewer{*measurementCont};
416 using namespace Acts::detail::LineHelper;
417 do {
418 SpacePointsPerChamber& pointsInChamb = fillContainer[viewer.at(0)->readoutElement()->msSector()];
419 const Amg::Transform3D sectorTrans = viewer.at(0)->readoutElement()->msSector()->globalToLocalTransform(*gctx);
420 ATH_MSG_DEBUG(__func__<<"() "<<__LINE__<<" - Fill space points for multiplet "<<m_idHelperSvc->toStringDetEl(viewer.at(0)->identify()));
421 for(auto& HitColls: splitHitsPerGasGap(viewer)){
422 auto& [etaHits, phiHits, two2DHits] = HitColls;
423 std::array<std::vector<std::shared_ptr<unsigned>>, 3> instanceCounts{matchCountVec(etaHits.size()),
424 matchCountVec(phiHits.size()),
425 matchCountVec(two2DHits.size())};
426
427 //loop through the Prds and try to combine according` to the hierarchy
428 // Strip+Wire
429 // Strip+Pad
430 // Wire+Pad
431 // Pad
439 auto combineMe = [&](const std::size_t collIdxA,
440 const std::size_t collIdxB,
441 const std::function<bool(const xAOD::sTgcMeasurement*,
442 const xAOD::sTgcMeasurement*)>& combFunc) {
443 std::vector<char> combinedFlagsA{}, combinedFlagsB{};
444 std::ranges::transform(instanceCounts[collIdxA], std::back_inserter(combinedFlagsA),
445 [](const std::shared_ptr<unsigned>& countPtr){
446 return (*countPtr) == 0;
447 });
448 std::ranges::transform(instanceCounts[collIdxB], std::back_inserter(combinedFlagsB),
449 [](const std::shared_ptr<unsigned>& countPtr){
450 return (*countPtr) == 0;
451 });
452
453 const auto& collA = HitColls[collIdxA];
454 const auto& collB = HitColls[collIdxB];
455
457 if(collA.empty() || collB.empty()) {
458 ATH_MSG_DEBUG(__func__<<"() "<<__LINE__<<" - Skipping combination: both collections empty");
459 return;
460 }
461
463 const xAOD::sTgcMeasurement* firstHit = collB.front();
464 const Amg::Transform3D toSectorTrans = toChamberTransform(*gctx, sectorTrans, *firstHit);
465
466 for(std::size_t idxA = 0; idxA < collA.size(); ++idxA) {
468 if(!combinedFlagsA[idxA]) {
469 ATH_MSG_VERBOSE(__func__<<"() "<<__LINE__<<" - Hit "<<m_idHelperSvc->toString(collA[idxA]->identify())
470 <<" has been used in previous iteration");
471 continue;
472 }
473 for(std::size_t idxB = 0; idxB < collB.size(); ++idxB) {
474 if(!combinedFlagsB[idxB] || !combFunc(collA[idxA], collB[idxB])){
475 ATH_MSG_VERBOSE(__func__<<"() "<<__LINE__<<" - Hit "<<m_idHelperSvc->toString(collB[idxB]->identify())
476 <<" has been used in previous iteration. Or is incompatible with "
477 <<m_idHelperSvc->toString(collA[idxA]->identify()));
478 continue;
479 }
480 //create space point
481 ATH_MSG_VERBOSE(__func__<<"() "<<__LINE__<<" - Combine sTgc measurements "
482 <<m_idHelperSvc->toString(collA[idxA]->identify())<<" and "
483 <<m_idHelperSvc->toString(collB[idxB]->identify())<< "with local positions"
484 << Amg::toString(collA[idxA]->localMeasurementPos()) << " and "
485 << Amg::toString(collB[idxB]->localMeasurementPos())
486 <<" to new space point");
487
488 SpacePoint& newSp = pointsInChamb.etaHits.emplace_back(collB[idxB], collA[idxA]);
489 auto crossPoint = lineIntersect<3>(collA[idxA]->localMeasurementPos(),
490 Amg::Vector3D::UnitX(),
491 collB[idxB]->localMeasurementPos(),
492 Amg::Vector3D::UnitY());
493
494 newSp.setPosition(toSectorTrans*crossPoint.position());
495 newSp.setDirection(Amg::Vector3D::UnitX(), Amg::Vector3D::UnitY());
496 auto cov = Acts::filledArray<double, 3>(0.);
497 cov[Acts::toUnderlying(CovIdx::phiCov)] = covElement(*collA[idxA], CovIdx::phiCov);
498 cov[Acts::toUnderlying(CovIdx::etaCov)] = covElement(*collB[idxB], CovIdx::etaCov);
499 newSp.setCovariance(std::move(cov));
500 newSp.setInstanceCounts(instanceCounts[collIdxB][idxB], instanceCounts[collIdxA][idxA]);
501 ATH_MSG_VERBOSE("Created new space point "<<newSp);
502 }
503 }
504 };
505
506 //try to combine strip with wire measurements first
507 combineMe(1, 0, [&](const xAOD::sTgcMeasurement* wire,
509 // do not combine the strips with the wire that are in the etaZero region
510 const MuonGMR4::sTgcReadoutElement* readoutElement = strip->readoutElement();
511 if(readoutElement->isEtaZero(strip->measurementHash(),
512 strip->localMeasurementPos().block<2,1>(0,0))){
513 return false;
514 }
515 //ignore combinations where the wire and the strip are not crossing
516 //check if the projection of the crossing point is within the bounds of the layer
517 auto crossPoint = strip->localMeasurementPos() + wire->localMeasurementPos();
518 const Acts::Surface& surf = readoutElement->surface(strip->layerHash());
519 return surf.insideBounds(crossPoint.block<2,1>(0,0));
520 });
521
522 //combine strip and pad measurements
523 combineMe(2, 0, [&](const xAOD::sTgcMeasurement* pad,
525 // do not combine the strips with the pads that are not overlayed
526 const MuonGMR4::sTgcReadoutElement* readoutElement = pad ->readoutElement();
527 const MuonGMR4::PadDesign& padDesign = readoutElement->padDesign(pad->measurementHash());
528 double padHeight = padDesign.padHeight();
529 const Amg::Vector3D padCenter = pad->localMeasurementPos();
530
531 return std::abs(strip->localMeasurementPos().x() - padCenter.x()) < 0.5*padHeight;
532 });
533
534 //finally combine wire and pad measurements
535 combineMe(1, 2, [&](const xAOD::sTgcMeasurement* wire,
536 const xAOD::sTgcMeasurement* pad){
537 // do not combine the wires with the pads that are not overlayed
538 const MuonGMR4::sTgcReadoutElement* readoutElement = pad ->readoutElement();
539 const std::array<Amg::Vector2D, 4> localPadCorners = readoutElement->localPadCorners(pad->measurementHash());
540 auto [min,max] = std::ranges::minmax_element(localPadCorners.begin(), localPadCorners.end(),
541 [](const Amg::Vector2D& a, const Amg::Vector2D& b){
542 return a.y() < b.y();
543 });
544 return (wire->localMeasurementPos().y() > min->y() || wire->localMeasurementPos().y() < max->y());
545
546 });
547
548 //fill uncombined strip, wire and pad measurements that have not been used in combination
549 for(std::size_t collIdx = 0; collIdx < HitColls.size(); ++collIdx){
550 const auto& hits = HitColls[collIdx];
551 std::vector<const xAOD::sTgcMeasurement*> unusedHits{};
552 unusedHits.reserve(hits.size());
553
554 for(std::size_t idx = 0; idx < hits.size(); ++idx){
555 if((*instanceCounts[collIdx][idx]) == 0){
556 unusedHits.push_back(hits[idx]);
557 }
558 }
559 fillUncombinedSpacePoints(*gctx, sectorTrans, unusedHits, pointsInChamb.etaHits);
560 }
561 }
562 } while (viewer.next());
563 return StatusCode::SUCCESS;
564}
#define min(a, b)
Definition cfImp.cxx:40
#define max(a, b)
Definition cfImp.cxx:41
bool empty() const noexcept
Returns true if the collection is empty.
const Acts::Surface & surface() const override final
Returns the surface associated with the readout element.
double padHeight() const
Returns the height of all the pads that are not adjacent to the bottom edge of the trapezoid active a...
const PadDesign & padDesign(const IdentifierHash &measHash) const
Retrieves the readoutElement Layer given the Identifier/Hash.
localCornerArray localPadCorners(const IdentifierHash &measHash) const
bool isEtaZero(const IdentifierHash &measurementHash, const Amg::Vector2D &localPosition) const
bool next() noexcept
Loads the hits from the next chamber.
IdentifierHash measurementHash() const
Returns the hash of the measurement channel w.r.t ReadoutElement.
Amg::Vector3D localMeasurementPos() const
Returns the local measurement position as 3-vector.
const MuonGMR4::sTgcReadoutElement * readoutElement() const
Retrieve the associated sTgcReadoutElement.
std::string toString(const Translation3D &translation, int precision=4)
GeoPrimitvesToStringConverter.
Eigen::Matrix< double, 2, 1 > Vector2D
sTgcMeasContainer_v1 sTgcMeasContainer
setBGCode setTAP setLVL2ErrorBits bool
sTgcMeasurement_v1 sTgcMeasurement

◆ msg()

MsgStream & AthCommonMsg< Gaudi::Algorithm >::msg ( ) const
inlineinherited

Definition at line 24 of file AthCommonMsg.h.

24 {
25 return this->msgStream();
26 }

◆ msgLvl()

bool AthCommonMsg< Gaudi::Algorithm >::msgLvl ( const MSG::Level lvl) const
inlineinherited

Definition at line 30 of file AthCommonMsg.h.

30 {
31 return this->msgLevel(lvl);
32 }

◆ newBucket()

void MuonR4::SpacePointMakerAlg::newBucket ( const SpacePoint & refSp,
SpacePointBucketVec & sortedPoints ) const
private

Closes the current processed bucket and creates a new one.

Space points of the previous bucket within the overlap region to the first space point of the new bucket are copied over

Parameters
refSpFirst new space point which will be added to the new bucket.
sortedPointsList of all processed buckets in the chamber. The list is augmented by 1 element

Set the boundaries from the previous bucket

Copy space points that could be within the overlap region to the next bucket

Definition at line 648 of file SpacePointMakerAlg.cxx.

649 {
650 SpacePointBucket& newContainer = sortedPoints.emplace_back();
651 newContainer.setBucketId(sortedPoints.size() -1);
652
654 SpacePointBucket& overlap{sortedPoints[sortedPoints.size() - 2]};
655 overlap.setCoveredRange(overlap.front()->localPosition().y(),
656 overlap.back()->localPosition().y());
657
658 const double refBound = refSpacePoint.localPosition().y();
659
661 for (const std::shared_ptr<SpacePoint>& pointInBucket : overlap | std::views::reverse) {
662 const double overlapPos = pointInBucket->localPosition().y() +
663 std::sqrt(pointInBucket->covariance()[Acts::toUnderlying(CovIdx::etaCov)]);
664 if (refBound - overlapPos < m_spacePointOverlap) {
665 newContainer.insert(newContainer.begin(), pointInBucket);
666 } else {
667 break;
668 }
669 }
670
671}
Gaudi::Property< double > m_spacePointOverlap

◆ outputHandles()

virtual std::vector< Gaudi::DataHandle * > AthCommonDataStore< AthCommonMsg< Gaudi::Algorithm > >::outputHandles ( ) const
overridevirtualinherited

Return this algorithm's output handles.

We override this to include handle instances from key arrays if they have not yet been declared. See comments on updateVHKA.

◆ passOccupancy2D() [1/4]

template<>
bool MuonR4::SpacePointMakerAlg::passOccupancy2D ( const PrdVec_t< const xAOD::MMCluster * > & ,
const PrdVec_t< const xAOD::MMCluster * > &  ) const

Definition at line 197 of file SpacePointMakerAlg.cxx.

198 {
199 return false;
200 }

◆ passOccupancy2D() [2/4]

template<>
bool MuonR4::SpacePointMakerAlg::passOccupancy2D ( const PrdVec_t< const xAOD::RpcMeasurement * > & etaHits,
const PrdVec_t< const xAOD::RpcMeasurement * > & phiHits ) const

Definition at line 185 of file SpacePointMakerAlg.cxx.

186 {
187 if (etaHits.empty() || phiHits.empty()) {
188 return false;
189 }
190 const MuonGMR4::RpcReadoutElement* re = etaHits[0]->readoutElement();
191 ATH_MSG_VERBOSE("Collected "<<etaHits.size()<<"/"<<phiHits.size()<<" hits in "<<m_idHelperSvc->toStringGasGap(etaHits[0]->identify()));
192 return ((1.*etaHits.size()) / (1.*re->nEtaStrips())) < m_maxOccRpcEta &&
193 ((1.*phiHits.size()) / (1.*re->nPhiStrips())) < m_maxOccRpcPhi;
194 }
const boost::regex re(r_e)
Gaudi::Property< double > m_maxOccRpcEta
Gaudi::Property< double > m_maxOccRpcPhi

◆ passOccupancy2D() [3/4]

template<>
bool MuonR4::SpacePointMakerAlg::passOccupancy2D ( const PrdVec_t< const xAOD::TgcStrip * > & etaHits,
const PrdVec_t< const xAOD::TgcStrip * > & phiHits ) const

Definition at line 174 of file SpacePointMakerAlg.cxx.

175 {
176 if (etaHits.empty() || phiHits.empty()) {
177 return false;
178 }
179 const MuonGMR4::TgcReadoutElement* re = etaHits[0]->readoutElement();
180 ATH_MSG_VERBOSE("Collected "<<etaHits.size()<<"/"<<phiHits.size()<<" hits in "<<m_idHelperSvc->toStringGasGap(etaHits[0]->identify()));
181 return ((1.*etaHits.size()) / ((1.*re->numChannels(etaHits[0]->measurementHash())))) < m_maxOccTgcEta &&
182 ((1.*phiHits.size()) / ((1.*re->numChannels(phiHits[0]->measurementHash())))) < m_maxOccTgcPhi;
183 }
Gaudi::Property< double > m_maxOccTgcEta
Gaudi::Property< double > m_maxOccTgcPhi

◆ passOccupancy2D() [4/4]

template<typename PrdType>
bool MuonR4::SpacePointMakerAlg::passOccupancy2D ( const PrdVec_t< PrdType > & etaHits,
const PrdVec_t< PrdType > & phiHits ) const
private

: Check whether the occupancy cuts of hits in a gasGap are surpassed.

The method is specified for each of the 3 strip technologies, Rpc, Tgc, sTgc and applies a technology-dependent upper bound on the number of phi & eta hits. If the threshold is surpassed, only 1D space points are built intsead of 2D ones

Parameters
etaHitsList of all presorted eta measurements in a gas gap
phiHitsList of all presorted phi measurements in a gas gap

◆ renounce()

std::enable_if_t< std::is_void_v< std::result_of_t< decltype(&T::renounce)(T)> > &&!std::is_base_of_v< SG::VarHandleKeyArray, T > &&std::is_base_of_v< Gaudi::DataHandle, T >, void > AthCommonDataStore< AthCommonMsg< Gaudi::Algorithm > >::renounce ( T & h)
inlineprotectedinherited

Definition at line 380 of file AthCommonDataStore.h.

381 {
382 h.renounce();
384 }
std::enable_if_t< std::is_void_v< std::result_of_t< decltype(&T::renounce)(T)> > &&!std::is_base_of_v< SG::VarHandleKeyArray, T > &&std::is_base_of_v< Gaudi::DataHandle, T >, void > renounce(T &h)

◆ renounceArray()

void AthCommonDataStore< AthCommonMsg< Gaudi::Algorithm > >::renounceArray ( SG::VarHandleKeyArray & handlesArray)
inlineprotectedinherited

remove all handles from I/O resolution

Definition at line 364 of file AthCommonDataStore.h.

364 {
366 }

◆ setFilterPassed()

virtual void AthCommonReentrantAlgorithm< Gaudi::Algorithm >::setFilterPassed ( bool state,
const EventContext & ctx ) const
inlinevirtualinherited

Definition at line 100 of file AthCommonReentrantAlgorithm.h.

100 {
102 }
virtual void setFilterPassed(bool state, const EventContext &ctx) const

◆ splitBucket()

bool MuonR4::SpacePointMakerAlg::splitBucket ( const SpacePoint & spacePoint,
const double firstSpPos,
const SpacePointBucketVec & sortedPoints ) const
private

Returns whether the space point is beyond the bucket boundary.

Parameters
spacePointSpace point candidate to add to the bucket
sortedPointsContainer of all defined buckets in the chamber

Distance between this point and the first one exceeds the maximum length

Definition at line 634 of file SpacePointMakerAlg.cxx.

636 {
638 const double spY = spacePoint.localPosition().y();
639 if (spY - firstSpPos > m_maxBucketLength){
640 return true;
641 }
642
643 if (sortedPoints.empty() || sortedPoints.back().empty()) {
644 return false;
645 }
646 return spY - sortedPoints.back().back()->localPosition().y() > m_spacePointWindow;
647}
Gaudi::Property< double > m_spacePointWindow
Gaudi::Property< double > m_maxBucketLength

◆ splitHitsPerGasGap()

template<typename ContType>
SpacePointMakerAlg::EtaPhi2DHitsVec< typename ContType::const_value_type > MuonR4::SpacePointMakerAlg::splitHitsPerGasGap ( xAOD::ChamberViewer< ContType > & viewer) const
private

Splits the chamber hits of the viewer per gas gap.

Parameters
viewerChamber viewer containing all hits in the chamber
Returns
Vector of gas gap hit collections. Each entry contains 3 vectors:
  • eta hits
  • phi hits
  • 2D hits

Wires measure the phi coordinate

Tgc & Rpcs have the measuresPhi property

Sort in the hit

Definition at line 261 of file SpacePointMakerAlg.cxx.

261 {
262 std::vector<EtaPhi2DHits<typename ContType::const_value_type>> hitsPerGasGap{};
263 for (const auto& prd : viewer) {
264 ATH_MSG_VERBOSE("Create space point from "<<m_idHelperSvc->toString(prd->identify())
265 <<", hash: "<<prd->identifierHash());
266
267 unsigned gapIdx = prd->gasGap() -1;
268 if constexpr (std::is_same_v<ContType, xAOD::RpcMeasurementContainer>) {
269 gapIdx = prd->readoutElement()->createHash(0, prd->gasGap(), prd->doubletPhi(), false);
270 }
271 if (hitsPerGasGap.size() <= gapIdx) {
272 hitsPerGasGap.resize(gapIdx + 1);
273 }
274 bool measPhi{false};
275 if constexpr(std::is_same_v<ContType, xAOD::sTgcMeasContainer>) {
277 measPhi = prd->channelType() == sTgcIdHelper::sTgcChannelTypes::Wire;
278 } else if constexpr(!std::is_same_v<ContType, xAOD::MMClusterContainer>) {
280 measPhi = prd->measuresPhi();
281 }
282
283 if (prd->numDimensions() == 2) {
284 hitsPerGasGap[gapIdx][2].push_back(prd);
285 continue;
286 }
288 auto& toPush = hitsPerGasGap[gapIdx][measPhi];
289 if (toPush.capacity() == toPush.size()) {
290 toPush.reserve(toPush.size() + m_capacityBucket);
291 }
292 toPush.push_back(prd);
293 }
294 return hitsPerGasGap;
295}
Gaudi::Property< unsigned > m_capacityBucket

◆ sysExecute()

StatusCode AthCommonReentrantAlgorithm< Gaudi::Algorithm >::sysExecute ( const EventContext & ctx)
overridevirtualinherited

Execute an algorithm.

We override this in order to work around an issue with the Algorithm base class storing the event context in a member variable that can cause crashes in MT jobs.

Definition at line 85 of file AthCommonReentrantAlgorithm.cxx.

77{
78 return BaseAlg::sysExecute (ctx);
79}

◆ sysInitialize()

StatusCode AthCommonReentrantAlgorithm< Gaudi::Algorithm >::sysInitialize ( )
overridevirtualinherited

Override sysInitialize.

Override sysInitialize from the base class.

Loop through all output handles, and if they're WriteCondHandles, automatically register them and this Algorithm with the CondSvc

Scan through all outputHandles, and if they're WriteCondHandles, register them with the CondSvc

Reimplemented from AthCommonDataStore< AthCommonMsg< Gaudi::Algorithm > >.

Reimplemented in HypoBase, and InputMakerBase.

Definition at line 61 of file AthCommonReentrantAlgorithm.cxx.

107 {
109
110 if (sc.isFailure()) {
111 return sc;
112 }
113
114 ServiceHandle<ICondSvc> cs("CondSvc",name());
115 for (auto h : outputHandles()) {
116 if (h->isCondition() && h->mode() == Gaudi::DataHandle::Writer) {
117 // do this inside the loop so we don't create the CondSvc until needed
118 if ( cs.retrieve().isFailure() ) {
119 ATH_MSG_WARNING("no CondSvc found: won't autoreg WriteCondHandles");
120 return StatusCode::SUCCESS;
121 }
122 if (cs->regHandle(this,*h).isFailure()) {
124 ATH_MSG_ERROR("unable to register WriteCondHandle " << h->fullKey()
125 << " with CondSvc");
126 }
127 }
128 }
129 return sc;
130}
#define ATH_MSG_ERROR(x)
#define ATH_MSG_WARNING(x)
virtual std::vector< Gaudi::DataHandle * > outputHandles() const override

◆ sysStart()

virtual StatusCode AthCommonDataStore< AthCommonMsg< Gaudi::Algorithm > >::sysStart ( )
overridevirtualinherited

Handle START transition.

We override this in order to make sure that conditions handle keys can cache a pointer to the conditions container.

◆ updateVHKA()

void AthCommonDataStore< AthCommonMsg< Gaudi::Algorithm > >::updateVHKA ( Gaudi::Details::PropertyBase & )
inlineinherited

Definition at line 308 of file AthCommonDataStore.h.

308 {
309 // debug() << "updateVHKA for property " << p.name() << " " << p.toString()
310 // << " size: " << m_vhka.size() << endmsg;
311 for (auto &a : m_vhka) {
313 for (auto k : keys) {
314 k->setOwner(this);
315 }
316 }
317 }

Member Data Documentation

◆ ATLAS_THREAD_SAFE

std::unique_ptr<SpacePointStatistics> m_statCounter MuonR4::SpacePointMakerAlg::ATLAS_THREAD_SAFE {}
private

Definition at line 225 of file SpacePointMakerAlg.h.

225{};

◆ m_capacityBucket

Gaudi::Property<unsigned> MuonR4::SpacePointMakerAlg::m_capacityBucket {this,"CapacityBucket" , 50}
private

Definition at line 224 of file SpacePointMakerAlg.h.

224{this,"CapacityBucket" , 50};

◆ m_detStore

StoreGateSvc_t AthCommonDataStore< AthCommonMsg< Gaudi::Algorithm > >::m_detStore
privateinherited

Pointer to StoreGate (detector store by default)

Definition at line 393 of file AthCommonDataStore.h.

◆ m_doStat

Gaudi::Property<bool> MuonR4::SpacePointMakerAlg::m_doStat
private
Initial value:
{this, "doStats", false,
"If enabled the algorithm keeps track how many hits have been made" }

Definition at line 221 of file SpacePointMakerAlg.h.

221 {this, "doStats", false,
222 "If enabled the algorithm keeps track how many hits have been made" };

◆ m_evtStore

StoreGateSvc_t AthCommonDataStore< AthCommonMsg< Gaudi::Algorithm > >::m_evtStore
privateinherited

Pointer to StoreGate (event store by default)

Definition at line 390 of file AthCommonDataStore.h.

◆ m_extendedExtraObjects

DataObjIDColl AthCommonReentrantAlgorithm< Gaudi::Algorithm >::m_extendedExtraObjects
privateinherited

Extra output dependency collection, extended by AthAlgorithmDHUpdate to add symlinks.

Empty if no symlinks were found.

Definition at line 114 of file AthCommonReentrantAlgorithm.h.

◆ m_geoCtxKey

SG::ReadHandleKey<ActsTrk::GeometryContext> MuonR4::SpacePointMakerAlg::m_geoCtxKey {this, "AlignmentKey", "ActsAlignment", "cond handle key"}
private

Definition at line 205 of file SpacePointMakerAlg.h.

205{this, "AlignmentKey", "ActsAlignment", "cond handle key"};

◆ m_idHelperSvc

ServiceHandle<Muon::IMuonIdHelperSvc> MuonR4::SpacePointMakerAlg::m_idHelperSvc {this, "IdHelperSvc", "Muon::MuonIdHelperSvc/MuonIdHelperSvc"}
private

Definition at line 207 of file SpacePointMakerAlg.h.

207{this, "IdHelperSvc", "Muon::MuonIdHelperSvc/MuonIdHelperSvc"};

◆ m_maxBucketLength

Gaudi::Property<double> MuonR4::SpacePointMakerAlg::m_maxBucketLength
private
Initial value:
{this, "maxBucketLength", 2.*Gaudi::Units::m,
"Maximal size of a space point bucket"}

Definition at line 214 of file SpacePointMakerAlg.h.

214 {this, "maxBucketLength", 2.*Gaudi::Units::m,
215 "Maximal size of a space point bucket"};

◆ m_maxOccRpcEta

Gaudi::Property<double> MuonR4::SpacePointMakerAlg::m_maxOccRpcEta
private
Initial value:
{this, "maxRpcEtaOccupancy", 0.1,
"Maximum occpancy of Rpc eta hits in a gasGap"}

Definition at line 227 of file SpacePointMakerAlg.h.

227 {this, "maxRpcEtaOccupancy", 0.1,
228 "Maximum occpancy of Rpc eta hits in a gasGap"};

◆ m_maxOccRpcPhi

Gaudi::Property<double> MuonR4::SpacePointMakerAlg::m_maxOccRpcPhi
private
Initial value:
{this, "maxRpcPhiOccupancy", 0.1,
"Maximum occpancy of Rpc phi hits in a gasGap"}

Definition at line 229 of file SpacePointMakerAlg.h.

229 {this, "maxRpcPhiOccupancy", 0.1,
230 "Maximum occpancy of Rpc phi hits in a gasGap"};

◆ m_maxOccTgcEta

Gaudi::Property<double> MuonR4::SpacePointMakerAlg::m_maxOccTgcEta
private
Initial value:
{this, "maxTgcEtaOccupancy", 0.1,
"Maximum occpancy of Tgc eta hits in a gasGap"}

Definition at line 232 of file SpacePointMakerAlg.h.

232 {this, "maxTgcEtaOccupancy", 0.1,
233 "Maximum occpancy of Tgc eta hits in a gasGap"};

◆ m_maxOccTgcPhi

Gaudi::Property<double> MuonR4::SpacePointMakerAlg::m_maxOccTgcPhi
private
Initial value:
{this, "maxTgcPhiOccupancy", 0.1,
"Maximum occpancy of Tgc phi hits in a gasGap"}

Definition at line 234 of file SpacePointMakerAlg.h.

234 {this, "maxTgcPhiOccupancy", 0.1,
235 "Maximum occpancy of Tgc phi hits in a gasGap"};

◆ m_mdtKey

SG::ReadHandleKey<xAOD::MdtDriftCircleContainer> MuonR4::SpacePointMakerAlg::m_mdtKey
private
Initial value:
{this, "MdtKey", "xMdtMeasurements",
"Key to the uncalibrated Drift circle measurements"}

Definition at line 190 of file SpacePointMakerAlg.h.

190 {this, "MdtKey", "xMdtMeasurements",
191 "Key to the uncalibrated Drift circle measurements"};

◆ m_mmKey

SG::ReadHandleKey<xAOD::MMClusterContainer> MuonR4::SpacePointMakerAlg::m_mmKey
private
Initial value:
{this, "MmKey", "xAODMMClusters",
"Key to the uncalibrated 1D Mm hits"}

Definition at line 199 of file SpacePointMakerAlg.h.

199 {this, "MmKey", "xAODMMClusters",
200 "Key to the uncalibrated 1D Mm hits"};

◆ m_rpcKey

SG::ReadHandleKey<xAOD::RpcMeasurementContainer> MuonR4::SpacePointMakerAlg::m_rpcKey
private
Initial value:
{this, "RpcKey", "xRpcMeasurements",
"Key to the uncalibrated 1D rpc hits"}

Definition at line 193 of file SpacePointMakerAlg.h.

193 {this, "RpcKey", "xRpcMeasurements",
194 "Key to the uncalibrated 1D rpc hits"};

◆ m_spacePointOverlap

Gaudi::Property<double> MuonR4::SpacePointMakerAlg::m_spacePointOverlap
private
Initial value:
{this, "spacePointOverlap", 25.*Gaudi::Units::cm,
"Hits that are within <spacePointOverlap> of the bucket margin. "
"Are copied to the next bucket"}

Definition at line 217 of file SpacePointMakerAlg.h.

217 {this, "spacePointOverlap", 25.*Gaudi::Units::cm,
218 "Hits that are within <spacePointOverlap> of the bucket margin. "
219 "Are copied to the next bucket"};

◆ m_spacePointWindow

Gaudi::Property<double> MuonR4::SpacePointMakerAlg::m_spacePointWindow
private
Initial value:
{this, "spacePointWindowSize", 0.8*Gaudi::Units::m,
"Maximal distance between consecutive hits in a bucket"}

Definition at line 211 of file SpacePointMakerAlg.h.

211 {this, "spacePointWindowSize", 0.8*Gaudi::Units::m,
212 "Maximal distance between consecutive hits in a bucket"};

◆ m_stgcKey

SG::ReadHandleKey<xAOD::sTgcMeasContainer> MuonR4::SpacePointMakerAlg::m_stgcKey {this, "sTgcKey", "xAODsTgcMeasurements"}
private

Definition at line 202 of file SpacePointMakerAlg.h.

202{this, "sTgcKey", "xAODsTgcMeasurements"};

◆ m_tgcKey

SG::ReadHandleKey<xAOD::TgcStripContainer> MuonR4::SpacePointMakerAlg::m_tgcKey
private
Initial value:
{this, "TgcKey", "xTgcStrips",
"Key to the uncalibrated 1D tgc hits"}

Definition at line 196 of file SpacePointMakerAlg.h.

196 {this, "TgcKey", "xTgcStrips",
197 "Key to the uncalibrated 1D tgc hits"};

◆ m_varHandleArraysDeclared

bool AthCommonDataStore< AthCommonMsg< Gaudi::Algorithm > >::m_varHandleArraysDeclared
privateinherited

Definition at line 399 of file AthCommonDataStore.h.

◆ m_vhka

std::vector<SG::VarHandleKeyArray*> AthCommonDataStore< AthCommonMsg< Gaudi::Algorithm > >::m_vhka
privateinherited

Definition at line 398 of file AthCommonDataStore.h.

◆ m_writeKey

SG::WriteHandleKey<SpacePointContainer> MuonR4::SpacePointMakerAlg::m_writeKey {this, "WriteKey", "MuonSpacePoints"}
private

Definition at line 209 of file SpacePointMakerAlg.h.

209{this, "WriteKey", "MuonSpacePoints"};

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