 |
ATLAS Offline Software
|
Algorithm to handle the eta hough transform.
More...
#include <EtaHoughTransformAlg.h>
|
| EtaHoughTransformAlg (const std::string &name, ISvcLocator *pSvcLocator) |
|
virtual | ~EtaHoughTransformAlg ()=default |
|
virtual StatusCode | initialize () override |
|
virtual StatusCode | execute (const EventContext &ctx) const override |
|
virtual StatusCode | sysInitialize () override |
| Override sysInitialize. More...
|
|
virtual bool | isClonable () const override |
| Specify if the algorithm is clonable. More...
|
|
virtual unsigned int | cardinality () const override |
| Cardinality (Maximum number of clones that can exist) special value 0 means that algorithm is reentrant. More...
|
|
virtual StatusCode | sysExecute (const EventContext &ctx) override |
| Execute an algorithm. More...
|
|
virtual const DataObjIDColl & | extraOutputDeps () const override |
| Return the list of extra output dependencies. More...
|
|
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 . More...
|
|
const ServiceHandle< StoreGateSvc > & | evtStore () const |
| The standard StoreGateSvc (event store) Returns (kind of) a pointer to the StoreGateSvc . More...
|
|
const ServiceHandle< StoreGateSvc > & | detStore () const |
| The standard StoreGateSvc/DetectorStore Returns (kind of) a pointer to the StoreGateSvc . More...
|
|
virtual StatusCode | sysStart () override |
| Handle START transition. More...
|
|
virtual std::vector< Gaudi::DataHandle * > | inputHandles () const override |
| Return this algorithm's input handles. More...
|
|
virtual std::vector< Gaudi::DataHandle * > | outputHandles () const override |
| Return this algorithm's output handles. More...
|
|
Gaudi::Details::PropertyBase & | declareProperty (Gaudi::Property< T > &t) |
|
Gaudi::Details::PropertyBase * | declareProperty (const std::string &name, SG::VarHandleKey &hndl, const std::string &doc, const SG::VarHandleKeyType &) |
| Declare a new Gaudi property. More...
|
|
Gaudi::Details::PropertyBase * | declareProperty (const std::string &name, SG::VarHandleBase &hndl, const std::string &doc, const SG::VarHandleType &) |
| Declare a new Gaudi property. More...
|
|
Gaudi::Details::PropertyBase * | declareProperty (const std::string &name, SG::VarHandleKeyArray &hndArr, const std::string &doc, const SG::VarHandleKeyArrayType &) |
|
Gaudi::Details::PropertyBase * | declareProperty (const std::string &name, T &property, const std::string &doc, const SG::NotHandleType &) |
| Declare a new Gaudi property. More...
|
|
Gaudi::Details::PropertyBase * | declareProperty (const std::string &name, T &property, const std::string &doc="none") |
| Declare a new Gaudi property. More...
|
|
void | updateVHKA (Gaudi::Details::PropertyBase &) |
|
MsgStream & | msg () const |
|
MsgStream & | msg (const MSG::Level lvl) const |
|
bool | msgLvl (const MSG::Level lvl) const |
|
|
template<class ContainerType > |
StatusCode | retrieveContainer (const EventContext &ctx, const SG::ReadHandleKey< ContainerType > &key, const ContainerType *&contToPush) const |
| Helper method to fetch data from StoreGate. More...
|
|
void | preProcess (const EventContext &ctx, const ActsGeometryContext &gctx, const SpacePointContainer &spacePoints, HoughEventData &data) const |
| pre-processing method called once per event. More...
|
|
void | prepareHoughPlane (HoughEventData &data) const |
| prepare the accumulator and the peak finder once per event More...
|
|
void | processBucket (const EventContext &ctx, HoughEventData &data, HoughSetupForBucket ¤tBucket) const |
| process a bucket. More...
|
|
void | fillFromSpacePoint (HoughEventData &data, const MuonR4::HoughHitType &SP) const |
| fill the accumulator from a given space point. More...
|
|
bool | passSeedQuality (const HoughSetupForBucket ¤tBucket, const MuonR4::ActsPeakFinderForMuon::Maximum &maximum) const |
| apply quality cuts on a given maximum More...
|
|
void | extendWithPhiHits (std::vector< HoughHitType > &hitList, HoughSetupForBucket &bucket) const |
| extend a maximum with all compatible (pure) phi hits. More...
|
|
Gaudi::Details::PropertyBase & | declareGaudiProperty (Gaudi::Property< T > &hndl, const SG::VarHandleKeyType &) |
| specialization for handling Gaudi::Property<SG::VarHandleKey> More...
|
|
Gaudi::Details::PropertyBase & | declareGaudiProperty (Gaudi::Property< T > &hndl, const SG::VarHandleKeyArrayType &) |
| specialization for handling Gaudi::Property<SG::VarHandleKeyArray> More...
|
|
Gaudi::Details::PropertyBase & | declareGaudiProperty (Gaudi::Property< T > &hndl, const SG::VarHandleType &) |
| specialization for handling Gaudi::Property<SG::VarHandleBase> More...
|
|
Gaudi::Details::PropertyBase & | declareGaudiProperty (Gaudi::Property< T > &t, const SG::NotHandleType &) |
| specialization for handling everything that's not a Gaudi::Property<SG::VarHandleKey> or a <SG::VarHandleKeyArray> More...
|
|
|
DoubleProperty | m_targetResoTanTheta {this, "ResolutionTargetTanTheta", 0.05} |
|
DoubleProperty | m_targetResoIntercept {this, "ResolutionTargetIntercept", 10} |
|
DoubleProperty | m_minSigmasSearchTanTheta {this, "minSigmasSearchTanTheta", 2.0} |
|
DoubleProperty | m_minSigmasSearchIntercept {this, "minSigmasSearchIntercept", 2.0} |
|
DoubleProperty | m_peakThreshold {this, "peakThreshold", 2.5} |
|
DoubleProperty | m_minMaxDistTheta {this, "MaximumSeparationTheta", 0.} |
|
DoubleProperty | m_minMaxDistIntercept {this, "MaximumSeparationIntercept", 15.} |
|
DoubleProperty | m_peakFractionCutOff {this, "PeakFractionCutOff", 0.6} |
|
UnsignedIntegerProperty | m_nPrecHitCut {this, "nMinPrecHits", 3} |
|
IntegerProperty | m_nBinsTanTheta {this, "nBinsTanTheta", 7} |
|
IntegerProperty | m_nBinsIntercept {this, "nBinsIntercept", 15} |
|
BooleanProperty | m_downWeightMultiplePrd {this, "downWeightPrdMultiplicity", false} |
|
ServiceHandle< Muon::IMuonIdHelperSvc > | m_idHelperSvc {this, "MuonIdHelperSvc", "Muon::MuonIdHelperSvc/MuonIdHelperSvc"} |
|
SG::ReadHandleKey< SpacePointContainer > | m_spacePointKey {this, "SpacePointContainer", "MuonSpacePoints"} |
|
SG::WriteHandleKey< EtaHoughMaxContainer > | m_maxima {this, "EtaHoughMaxContainer", "MuonHoughStationMaxima"} |
|
SG::ReadHandleKey< ActsGeometryContext > | m_geoCtxKey {this, "AlignmentKey", "ActsAlignment", "cond handle key"} |
|
ToolHandle< MuonValR4::IPatternVisualizationTool > | m_visionTool {this, "VisualizationTool", ""} |
| Pattern visualization tool. More...
|
|
DataObjIDColl | m_extendedExtraObjects |
| Extra output dependency collection, extended by AthAlgorithmDHUpdate to add symlinks. More...
|
|
StoreGateSvc_t | m_evtStore |
| Pointer to StoreGate (event store by default) More...
|
|
StoreGateSvc_t | m_detStore |
| Pointer to StoreGate (detector store by default) More...
|
|
std::vector< SG::VarHandleKeyArray * > | m_vhka |
|
bool | m_varHandleArraysDeclared |
|
Algorithm to handle the eta hough transform.
This algorithm is responsible for the initial eta hough transform from space-points created in an upstream alg. It will write HoughMaxima into the event store for downstream use.
Definition at line 31 of file EtaHoughTransformAlg.h.
◆ HoughSetupForBucket
◆ StoreGateSvc_t
◆ EtaHoughTransformAlg()
MuonR4::EtaHoughTransformAlg::EtaHoughTransformAlg |
( |
const std::string & |
name, |
|
|
ISvcLocator * |
pSvcLocator |
|
) |
| |
◆ ~EtaHoughTransformAlg()
virtual MuonR4::EtaHoughTransformAlg::~EtaHoughTransformAlg |
( |
| ) |
|
|
virtualdefault |
◆ cardinality()
unsigned int AthReentrantAlgorithm::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.
Override this to return 0 for reentrant algorithms.
Definition at line 55 of file AthReentrantAlgorithm.cxx.
◆ declareGaudiProperty() [1/4]
specialization for handling Gaudi::Property<SG::VarHandleKeyArray>
Definition at line 170 of file AthCommonDataStore.h.
175 hndl.documentation());
◆ declareGaudiProperty() [2/4]
specialization for handling Gaudi::Property<SG::VarHandleKey>
Definition at line 156 of file AthCommonDataStore.h.
161 hndl.documentation());
◆ declareGaudiProperty() [3/4]
specialization for handling Gaudi::Property<SG::VarHandleBase>
Definition at line 184 of file AthCommonDataStore.h.
189 hndl.documentation());
◆ declareGaudiProperty() [4/4]
◆ declareProperty() [1/6]
Declare a new Gaudi property.
- Parameters
-
name | Name of the property. |
hndl | Object holding the property value. |
doc | Documentation string for the property. |
This is the version for types that derive from SG::VarHandleBase
. The property value object is put on the input and output lists as appropriate; then we forward to the base class.
Definition at line 245 of file AthCommonDataStore.h.
250 this->declare(hndl.
vhKey());
251 hndl.
vhKey().setOwner(
this);
◆ declareProperty() [2/6]
Declare a new Gaudi property.
- Parameters
-
name | Name of the property. |
hndl | Object holding the property value. |
doc | Documentation string for the property. |
This is the version for types that derive from SG::VarHandleKey
. The property value object is put on the input and output lists as appropriate; then we forward to the base class.
Definition at line 221 of file AthCommonDataStore.h.
◆ declareProperty() [3/6]
◆ declareProperty() [4/6]
Declare a new Gaudi property.
- Parameters
-
name | Name of the property. |
property | Object holding the property value. |
doc | Documentation string for the property. |
This is the generic version, for types that do not derive from SG::VarHandleKey
. It just forwards to the base class version of declareProperty
.
Definition at line 333 of file AthCommonDataStore.h.
◆ declareProperty() [5/6]
Declare a new Gaudi property.
- Parameters
-
name | Name of the property. |
property | Object holding the property value. |
doc | Documentation string for the property. |
This dispatches to either the generic declareProperty
or the one for VarHandle/Key/KeyArray.
Definition at line 352 of file AthCommonDataStore.h.
◆ declareProperty() [6/6]
◆ detStore()
◆ evtStore() [1/2]
◆ evtStore() [2/2]
◆ execute()
StatusCode MuonR4::EtaHoughTransformAlg::execute |
( |
const EventContext & |
ctx | ) |
const |
|
overridevirtual |
read the PRDs
pre-populate the event data - sort PRDs by station
book the hough plane
now perform the actual HT for each station
Definition at line 45 of file EtaHoughTransformAlg.cxx.
53 ATH_CHECK(writeMaxima.record(std::make_unique<EtaHoughMaxContainer>()));
66 for (
auto& [station, stationHoughBuckets] :
data.houghSetups) {
68 for (
auto& bucket : stationHoughBuckets) {
71 for (HoughMaximum&
max :
data.maxima) {
72 writeMaxima->push_back(std::make_unique<HoughMaximum>(std::move(
max)));
77 [](
const HoughMaximum*
a,
const HoughMaximum*
b){
78 return (*a->parentBucket()) < (*b->parentBucket());
80 return StatusCode::SUCCESS;
◆ extendWithPhiHits()
extend a maximum with all compatible (pure) phi hits.
- Parameters
-
hitList | list of hits to extend |
bucket | the bucket to take the phi hits from
|
Definition at line 416 of file EtaHoughTransformAlg.cxx.
418 for (
const SpacePointBucket::value_type& hit : *bucket.bucket) {
419 if (!hit->measuresEta()) {
420 hitList.push_back(hit.get());
◆ extraDeps_update_handler()
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 & AthReentrantAlgorithm::extraOutputDeps |
( |
| ) |
const |
|
overridevirtualinherited |
Return the list of extra output dependencies.
This list is extended to include symlinks implied by inheritance relations.
Definition at line 79 of file AthReentrantAlgorithm.cxx.
86 return Algorithm::extraOutputDeps();
◆ fillFromSpacePoint()
fill the accumulator from a given space point.
- Parameters
-
data | event data object |
SP | space point to fill from
|
Definition at line 388 of file EtaHoughTransformAlg.cxx.
390 using namespace std::placeholders;
403 const unsigned precisionLayerIndex = (dc->readoutElement()->multilayer() * 10 + dc->tubeLayer());
◆ filterPassed()
virtual bool AthReentrantAlgorithm::filterPassed |
( |
const EventContext & |
ctx | ) |
const |
|
inlinevirtualinherited |
◆ initialize()
StatusCode MuonR4::EtaHoughTransformAlg::initialize |
( |
| ) |
|
|
overridevirtual |
◆ inputHandles()
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()
bool AthReentrantAlgorithm::isClonable |
( |
| ) |
const |
|
overridevirtualinherited |
Specify if the algorithm is clonable.
Reentrant algorithms are clonable.
Reimplemented in Simulation::BeamEffectsAlg, InDet::SiTrackerSpacePointFinder, InDet::SCT_Clusterization, InDet::SiSPSeededTrackFinder, SCTRawDataProvider, InDet::GNNSeedingTrackMaker, SCT_PrepDataToxAOD, RoIBResultToxAOD, InDet::SiSPGNNTrackMaker, SCT_CablingCondAlgFromCoraCool, SCT_ReadCalibDataTestAlg, SCT_CablingCondAlgFromText, SCT_ReadCalibChipDataTestAlg, SCT_TestCablingAlg, SCT_ConfigurationConditionsTestAlg, ITkPixelCablingAlg, ITkStripCablingAlg, SCTEventFlagWriter, SCT_ConditionsSummaryTestAlg, SCT_ModuleVetoTestAlg, SCT_MonitorConditionsTestAlg, SCT_LinkMaskingTestAlg, SCT_MajorityConditionsTestAlg, SCT_RODVetoTestAlg, SCT_SensorsTestAlg, SCT_TdaqEnabledTestAlg, SCT_SiliconConditionsTestAlg, SCTSiLorentzAngleTestAlg, SCT_ByteStreamErrorsTestAlg, SCT_ConditionsParameterTestAlg, SCT_FlaggedConditionTestAlg, SCT_StripVetoTestAlg, SCT_RawDataToxAOD, and SCTSiPropertiesTestAlg.
Definition at line 44 of file AthReentrantAlgorithm.cxx.
◆ isPrecisionHit()
Returns whether the hit is a precision hit or not.
Definition at line 125 of file EtaHoughTransformAlg.cxx.
126 switch (hit->type()){
133 return hit->measuresEta();
137 return hit->measuresEta();
◆ msg() [1/2]
◆ msg() [2/2]
◆ msgLvl()
◆ outputHandles()
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.
◆ passSeedQuality()
bool MuonR4::EtaHoughTransformAlg::passSeedQuality |
( |
const HoughSetupForBucket & |
currentBucket, |
|
|
const MuonR4::ActsPeakFinderForMuon::Maximum & |
maximum |
|
) |
| const |
|
private |
apply quality cuts on a given maximum
Definition at line 157 of file EtaHoughTransformAlg.cxx.
161 return (loc.yLeft < SP.y() && SP.y() < loc.yRight && loc.zBottom < SP.z() && SP.z() < loc.zTop);
166 double yCross = (
y0 + 0.5 * (loc.zBottom+loc.zTop) * tanTheta);
167 return (loc.yLeft < yCross && yCross < loc.yRight);
171 auto proximity = [](
HoughHitType dc,
double y0,
double tanTheta){
176 int expectedPrecisionChambers = 0;
177 int seenPrecisionChambers = 0;
178 bool hasTrig =
false;
180 for (
auto & muonChamber : currentBucket.bucket->chamberLocations()){
182 if (!passesThrough(muonChamber, maximum.y, maximum.x))
continue;
187 ++expectedPrecisionChambers;
191 for (
auto & SP : maximum.hitIdentifiers){
194 if (isInside(muonChamber, SP->positionInChamber()) && proximity(SP,maximum.y,maximum.x) < 2. *
m_targetResoIntercept){
202 seenPrecisionChambers += (hasHit);
205 else hasTrig |= hasHit;
208 std::set<std::pair<int,int>> seenLayers;
209 for (
auto & SP : maximum.hitIdentifiers){
223 int minLayers = seenLayers.size() / 2 + 1;
225 int minSeenPrecisionChambers = (expectedPrecisionChambers > 1) + 1;
229 minSeenPrecisionChambers = 1;
232 return seenPrecisionChambers >= minSeenPrecisionChambers && (
int)seenLayers.size() >= minLayers;
◆ prepareHoughPlane()
void MuonR4::EtaHoughTransformAlg::prepareHoughPlane |
( |
HoughEventData & |
data | ) |
const |
|
private |
prepare the accumulator and the peak finder once per event
- Parameters
-
Definition at line 145 of file EtaHoughTransformAlg.cxx.
146 HoughPlaneConfig
cfg;
153 data.houghPlane = std::make_unique<HoughPlane>(
cfg);
154 data.peakFinder = std::make_unique<ActsPeakFinderForMuon>(peakFinderCfg);
◆ preProcess()
pre-processing method called once per event.
Populates the event data with the space points for each bucket and identifies the optimal search space in each bucket.
- Parameters
-
ctx | EventContext to parse to the visualization tool |
gctx | Geometry context to retrieve global positioning of the chambers |
spacePoints | point list from store gate |
data | event data object |
Project the hits onto the center (z=0) axis of the chamber, using our guesstimate of tan(theta)
Definition at line 82 of file EtaHoughTransformAlg.cxx.
88 for (
const SpacePointBucket* bucket :
spacePoints) {
92 std::vector<HoughSetupForBucket>& buckets =
data.houghSetups[bucket->front()->msSector()];
95 Amg::Vector3D leftSide = globToLoc.translation() - (
hs.bucket->coveredMin() * Amg::Vector3D::UnitY());
96 Amg::Vector3D rightSide = globToLoc.translation() - (
hs.bucket->coveredMax() * Amg::Vector3D::UnitY());
100 for (
const std::shared_ptr<MuonR4::SpacePoint> & sp : *bucket) {
109 hs.searchWindowTanAngle = {tanThetaLeft, tanThetaRight};
114 for (
const std::shared_ptr<MuonR4::SpacePoint> & hit : *bucket){
116 double y0l = hit->positionInChamber().y() - hit->positionInChamber().z() * tanThetaLeft;
117 double y0r = hit->positionInChamber().y() - hit->positionInChamber().z() * tanThetaRight;
◆ processBucket()
process a bucket.
Performs the hough transform in the given bucket and adds the maxima to the event data.
- Parameters
-
ctx | EventContext to parse to the visualization tool |
data | event data object |
currentBucket | bucket to process |
tune the search space
Definition at line 236 of file EtaHoughTransformAlg.cxx.
241 double chamberCenter = 0.5 * (bucket.searchWindowIntercept.first +
242 bucket.searchWindowIntercept.second);
249 searchStart =
std::min(searchStart, bucket.searchWindowIntercept.first -
251 searchEnd =
std::max(searchEnd, bucket.searchWindowIntercept.second +
254 double tanThetaMean = 0.5 * (bucket.searchWindowTanAngle.first +
255 bucket.searchWindowTanAngle.second);
258 searchStartTanTheta =
std::min(searchStartTanTheta, bucket.searchWindowTanAngle.first -
260 searchEndTanTheta =
std::max(searchEndTanTheta, bucket.searchWindowTanAngle.second +
263 data.currAxisRanges = Acts::HoughTransformUtils::HoughAxisRanges{
264 searchStartTanTheta, searchEndTanTheta, searchStart, searchEnd};
266 data.houghPlane->reset();
267 for (
const SpacePointBucket::value_type& hit : *(bucket.bucket)) {
270 auto maxima =
data.peakFinder->findPeaks(*(
data.houghPlane),
data.currAxisRanges);
273 "#eta Hough accumulator");
275 if (maxima.empty()) {
276 ATH_MSG_DEBUG(
"Station "<<bucket.bucket->msSector()->identString()
277 <<
":\n Mean tanTheta was "<<tanThetaMean
278 <<
" and my intercept "<<chamberCenter
279 <<
", with hits in the bucket in "<< bucket.bucket->coveredMin()
280 <<
" - "<<bucket.bucket->coveredMax()
281 <<
". The bucket found a search range of ("
282 <<bucket.searchWindowTanAngle.first<<
" - "
283 <<bucket.searchWindowTanAngle.second<<
") and ("
284 <<bucket.searchWindowIntercept.first<<
" - "
285 <<bucket.searchWindowIntercept.second
286 <<
") , and my final search range is ["
287 <<searchStartTanTheta<<
" - "<<searchEndTanTheta
288 <<
"] and ["<<searchStart<<
" - "<<searchEnd
296 std::set<HoughHitType> seenHits;
299 for (
const auto&
max : maxima) {
302 unsigned int nPrec{0};
303 auto toBins = [&
data](
double x,
double y){
304 return std::make_pair(
309 auto accumulatorBins = toBins(
max.x,
max.y);
310 for (
const HoughHitType& hit :
data.houghPlane->hitIds(accumulatorBins.first, accumulatorBins.second)) {
311 auto res = seenHits.emplace(hit);
322 std::vector<HoughHitType> hitList;
323 hitList.reserve(
max.hitIdentifiers.size());
324 for (
auto & hit :
max.hitIdentifiers){
325 hitList.push_back(hit);
332 const HoughMaximum& houghMax{
max.x,
max.y, (
double)hitList.size(), std::move(hitList), bucket.bucket};
333 const SegmentSeed
seed{houghMax};
336 for (
auto &
chamber : bucket.bucket->chamberLocations()) {
341 std::abs(eta), eta > 0?
'A' :
'C',
m_idHelperSvc->stationPhi(detId));
342 switch (
chamber.reEle->detectorType()) {
351 primitives.push_back(
MuonValR4::drawLabel(
std::format(
"Missed seed - score {}, layer score {}, comprising {} measurements ",
data.houghPlane->nHits(accumulatorBins.first, accumulatorBins.second),
data.houghPlane->nLayers(accumulatorBins.first, accumulatorBins.second),hitList.size()),0.05,0.03,12));
353 primitivesForAcc.push_back(
MuonValR4::drawLabel(
std::format(
"Missed seed - score {}, layer score {}, comprising {} measurements ",
data.houghPlane->nHits(accumulatorBins.first, accumulatorBins.second),
data.houghPlane->nLayers(accumulatorBins.first, accumulatorBins.second),hitList.size()),0.05,0.03,12));
355 "MissedAccumulator", std::move(primitivesForAcc));
356 m_visionTool->visualizeSeed(ctx, seed,
"Missed seed",std::move(primitives));
362 size_t nHits = hitList.size();
368 const HoughMaximum& houghMax{
data.maxima.emplace_back(
max.x,
max.y, nHits, std::move(hitList), bucket.bucket)};
372 const SegmentSeed
seed{houghMax};
375 for (
auto &
chamber : bucket.bucket->chamberLocations()){
379 primitives.push_back(
MuonValR4::drawLabel(
std::format(
"score {}, layer score {}, comprising {} measurements. wx = {:.2f}, wy = {:.1f} ",
data.houghPlane->nHits(accumulatorBins.first, accumulatorBins.second),
data.houghPlane->nLayers(accumulatorBins.first, accumulatorBins.second),hitList.size(),
max.wx,
max.wy),0.05,0.03,12));
381 primitivesForAcc.push_back(
MuonValR4::drawLabel(
std::format(
"score {}, layer score {}, comprising {} measurements. wx = {:.2f}, wy = {:.1f} ",
data.houghPlane->nHits(accumulatorBins.first, accumulatorBins.second),
data.houghPlane->nLayers(accumulatorBins.first, accumulatorBins.second),hitList.size(),
max.wx /
m_targetResoTanTheta,
max.wy /
m_targetResoIntercept),0.05,0.03,12));
383 m_visionTool->visualizeAccumulator(ctx, *
data.houghPlane,
data.currAxisRanges, {max},
"#eta Hough accumulator", std::move(primitivesForAcc));
384 m_visionTool->visualizeSeed(ctx, seed,
"#eta-HoughSeed", std::move(primitives));
◆ renounce()
◆ renounceArray()
◆ retrieveContainer()
template<class ContainerType >
StatusCode MuonR4::EtaHoughTransformAlg::retrieveContainer |
( |
const EventContext & |
ctx, |
|
|
const SG::ReadHandleKey< ContainerType > & |
key, |
|
|
const ContainerType *& |
contToPush |
|
) |
| const |
|
private |
Helper method to fetch data from StoreGate.
If the key is empty, a nullptr is assigned to the container ptr Failure is returned in cases, of non-empty keys and failed retrieval
Definition at line 30 of file EtaHoughTransformAlg.cxx.
36 <<
typeid(ContainerType).
name());
37 return StatusCode::SUCCESS;
41 contToPush = readHandle.cptr();
42 return StatusCode::SUCCESS;
◆ setFilterPassed()
virtual void AthReentrantAlgorithm::setFilterPassed |
( |
bool |
state, |
|
|
const EventContext & |
ctx |
|
) |
| const |
|
inlinevirtualinherited |
◆ sysExecute()
StatusCode AthReentrantAlgorithm::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 67 of file AthReentrantAlgorithm.cxx.
69 return Gaudi::Algorithm::sysExecute (ctx);
◆ sysInitialize()
StatusCode AthReentrantAlgorithm::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 InputMakerBase, and HypoBase.
Definition at line 96 of file AthReentrantAlgorithm.cxx.
107 if ( cs.retrieve().isFailure() ) {
109 return StatusCode::SUCCESS;
111 if (cs->regHandle(
this,*
h).isFailure()) {
112 sc = StatusCode::FAILURE;
113 ATH_MSG_ERROR(
"unable to register WriteCondHandle " <<
h->fullKey()
◆ sysStart()
Handle START transition.
We override this in order to make sure that conditions handle keys can cache a pointer to the conditions container.
◆ updateVHKA()
◆ m_detStore
◆ m_downWeightMultiplePrd
BooleanProperty MuonR4::EtaHoughTransformAlg::m_downWeightMultiplePrd {this, "downWeightPrdMultiplicity", false} |
|
private |
◆ m_evtStore
◆ m_extendedExtraObjects
DataObjIDColl AthReentrantAlgorithm::m_extendedExtraObjects |
|
privateinherited |
Extra output dependency collection, extended by AthAlgorithmDHUpdate to add symlinks.
Empty if no symlinks were found.
Definition at line 153 of file AthReentrantAlgorithm.h.
◆ m_geoCtxKey
◆ m_idHelperSvc
◆ m_maxima
◆ m_minMaxDistIntercept
DoubleProperty MuonR4::EtaHoughTransformAlg::m_minMaxDistIntercept {this, "MaximumSeparationIntercept", 15.} |
|
private |
◆ m_minMaxDistTheta
DoubleProperty MuonR4::EtaHoughTransformAlg::m_minMaxDistTheta {this, "MaximumSeparationTheta", 0.} |
|
private |
◆ m_minSigmasSearchIntercept
DoubleProperty MuonR4::EtaHoughTransformAlg::m_minSigmasSearchIntercept {this, "minSigmasSearchIntercept", 2.0} |
|
private |
◆ m_minSigmasSearchTanTheta
DoubleProperty MuonR4::EtaHoughTransformAlg::m_minSigmasSearchTanTheta {this, "minSigmasSearchTanTheta", 2.0} |
|
private |
◆ m_nBinsIntercept
IntegerProperty MuonR4::EtaHoughTransformAlg::m_nBinsIntercept {this, "nBinsIntercept", 15} |
|
private |
◆ m_nBinsTanTheta
IntegerProperty MuonR4::EtaHoughTransformAlg::m_nBinsTanTheta {this, "nBinsTanTheta", 7} |
|
private |
◆ m_nPrecHitCut
UnsignedIntegerProperty MuonR4::EtaHoughTransformAlg::m_nPrecHitCut {this, "nMinPrecHits", 3} |
|
private |
◆ m_peakFractionCutOff
DoubleProperty MuonR4::EtaHoughTransformAlg::m_peakFractionCutOff {this, "PeakFractionCutOff", 0.6} |
|
private |
◆ m_peakThreshold
DoubleProperty MuonR4::EtaHoughTransformAlg::m_peakThreshold {this, "peakThreshold", 2.5} |
|
private |
◆ m_spacePointKey
◆ m_targetResoIntercept
DoubleProperty MuonR4::EtaHoughTransformAlg::m_targetResoIntercept {this, "ResolutionTargetIntercept", 10} |
|
private |
◆ m_targetResoTanTheta
DoubleProperty MuonR4::EtaHoughTransformAlg::m_targetResoTanTheta {this, "ResolutionTargetTanTheta", 0.05} |
|
private |
◆ m_varHandleArraysDeclared
◆ m_vhka
◆ m_visionTool
The documentation for this class was generated from the following files:
char data[hepevt_bytes_allocation_ATLAS]
xAOD::UncalibMeasType type() const
DetectorType
Simple enum to Identify the Type of the ACTS sub detector.
Gaudi::Details::PropertyBase & declareProperty(Gaudi::Property< T > &t)
uint8_t gasGap() const
Returns the gas gap number to which the clsuter.
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)
const MuonGMR4::MmReadoutElement * readoutElement() const
Retrieve the associated MmReadoutElement.
std::unique_ptr< TBox > drawBox(const Amg::Vector3D &boxCenter, const double boxWidth, const double boxHeight, const int color=kGreen+2, const int fillStyle=hollowFilling, const int view=objViewEta)
Creates a box for drawing, e.g strip measurements.
StoreGateSvc_t m_evtStore
Pointer to StoreGate (event store by default)
std::vector< SG::VarHandleKeyArray * > m_vhka
Acts::HoughTransformUtils::PeakFinders::IslandsAroundMaxConfig ActsPeakFinderForMuonCfg
#define ATH_MSG_VERBOSE(x)
HoughMaximum::HitType HoughHitType
std::unique_ptr< TLatex > drawLabel(const std::string &text, const double xPos, const double yPos, const unsigned int fontSize=18)
Create a TLatex label,.
@ MdtStatusDriftTime
The tube produced a vaild measurement.
void stable_sort(std::reverse_iterator< DataModel_detail::iterator< DVL > > beg, std::reverse_iterator< DataModel_detail::iterator< DVL > > end, Compare comp)
Specialization of stable_sort for DataVector/List.
const MuonGMR4::MdtReadoutElement * readoutElement() const
Retrieve the associated MdtReadoutElement.
void sortByLayer(std::vector< const SpacePoint * > &spacePoints)
Sorts the space points in a vector by z.
virtual void setOwner(IDataHandleHolder *o)=0
HoughEventData_impl< ActsPeakFinderForMuon, ActsPeakFinderForMuonCfg > HoughEventData
double houghWidthStrip(double tanTheta, const MuonR4::HoughHitType &strip, double targetReso)
Uncertainty parametrisation for strip measurements.
const xAOD::UncalibratedMeasurement * primaryMeasurement() const
unsigned int multilayer() const
Returns the multi layer of the MdtReadoutElement.
double houghWidthMdt(double tanTheta, const MuonR4::HoughHitType &dc, double targetReso)
uncertainty parametrisation for drift circles
MuonGMR4::SpectrometerSector::chamberLocation chamberLocation
int multilayer() const
Returns the multi layer of the element [1-2].
AthReentrantAlgorithm()
Default constructor:
virtual std::vector< Gaudi::DataHandle * > outputHandles() const override
Return this algorithm's output handles.
@ Mm
Maybe not needed in the migration.
virtual xAOD::UncalibMeasType type() const =0
Returns the type of the measurement type as a simple enumeration.
::StatusCode StatusCode
StatusCode definition for legacy code.
Eigen::Affine3d Transform3D
std::pair< std::vector< unsigned int >, bool > res
unsigned int binIndex(const T &val, const std::vector< T > &partitions)
general utility function to return bin index given a value and the upper endpoints of each bin
StoreGateSvc_t m_detStore
Pointer to StoreGate (detector store by default)
StatusCode initialize(bool used=true)
If this object is used as a property, then this should be called during the initialize phase.
double houghParamMdtLeft(double tanTheta, const MuonR4::HoughHitType &dc)
left-side straight line parametrisation for drift circles
Include the GeoPrimitives which need to be put first.
DataObjIDColl m_extendedExtraObjects
Extra output dependency collection, extended by AthAlgorithmDHUpdate to add symlinks.
virtual void renounce()=0
std::conditional< std::is_base_of< SG::VarHandleKeyArray, T >::value, VarHandleKeyArrayType, type2 >::type type
virtual StatusCode sysInitialize() override
Override sysInitialize.
Eigen::Matrix< double, 3, 1 > Vector3D
bool measuresEta() const
: Does the space point contain an eta measurement
#define ATH_MSG_WARNING(x)
SG::VarHandleKey & vhKey()
Return a non-const reference to the HandleKey.
MdtDriftCircleStatus status() const
Returns the status of the measurement.
double houghParamMdtRight(double tanTheta, const MuonR4::HoughHitType &dc)
right-side straight line parametrisation for drift circles
uint8_t tubeLayer() const
Returns the layer number of the measurement (1-4)
double houghParamStrip(double tanTheta, const MuonR4::HoughHitType &strip)
straight line parametrisation for strip detector measurements
https://gitlab.cern.ch/atlas/athena/-/blob/master/MuonSpectrometer/MuonReconstruction/MuonRecEvent/Mu...
Gaudi::Details::PropertyBase & declareGaudiProperty(Gaudi::Property< T > &hndl, const SG::VarHandleKeyType &)
specialization for handling Gaudi::Property<SG::VarHandleKey>