 |
ATLAS Offline Software
|
Algorithm to handle the eta hough transform.
More...
#include <EtaHoughTransformAlg.h>
|
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, V, H > &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 |
|
|
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, V, H > &hndl, const SG::VarHandleKeyType &) |
| specialization for handling Gaudi::Property<SG::VarHandleKey> More...
|
|
Gaudi::Details::PropertyBase & | declareGaudiProperty (Gaudi::Property< T, V, H > &hndl, const SG::VarHandleKeyArrayType &) |
| specialization for handling Gaudi::Property<SG::VarHandleKeyArray> More...
|
|
Gaudi::Details::PropertyBase & | declareGaudiProperty (Gaudi::Property< T, V, H > &hndl, const SG::VarHandleType &) |
| specialization for handling Gaudi::Property<SG::VarHandleBase> More...
|
|
Gaudi::Details::PropertyBase & | declareGaudiProperty (Gaudi::Property< T, V, H > &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"} |
| Handle to the IdHelperSvc. More...
|
|
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 29 of file EtaHoughTransformAlg.h.
◆ HoughSetupForBucket
◆ StoreGateSvc_t
◆ ~EtaHoughTransformAlg()
virtual MuonR4::EtaHoughTransformAlg::~EtaHoughTransformAlg |
( |
| ) |
|
|
virtualdefault |
◆ cardinality()
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 75 of file AthCommonReentrantAlgorithm.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 72 of file EtaHoughTransformAlg.cxx.
80 ATH_CHECK(writeMaxima.record(std::make_unique<EtaHoughMaxContainer>()));
93 for (
auto& [station, stationHoughBuckets] :
data.houghSetups) {
95 for (
auto& bucket : stationHoughBuckets) {
98 for (HoughMaximum&
max :
data.maxima) {
99 writeMaxima->push_back(std::make_unique<HoughMaximum>(std::move(
max)));
104 [](
const HoughMaximum*
a,
const HoughMaximum*
b){
105 return (*a->parentBucket()) < (*b->parentBucket());
107 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 470 of file EtaHoughTransformAlg.cxx.
472 for (
const SpacePointBucket::value_type& hit : *bucket.bucket) {
473 if (!hit->measuresEta()) {
474 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()
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.
◆ fillFromSpacePoint()
fill the accumulator from a given space point.
- Parameters
-
data | event data object |
SP | space point to fill from
|
Definition at line 440 of file EtaHoughTransformAlg.cxx.
442 using namespace std::placeholders;
457 const unsigned precisionLayerIndex = (dc->readoutElement()->multilayer() * 10 + dc->tubeLayer());
◆ filterPassed()
◆ 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()
◆ isPrecisionHit()
Returns whether the hit is a precision hit or not.
Definition at line 152 of file EtaHoughTransformAlg.cxx.
153 switch (hit->type()){
159 return hit->measuresEta();
163 return meas->
channelType() == sTgcIdHelper::sTgcChannelTypes::Strip;
◆ 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
Determine the minimal & maximal possible position along the tube / strip
Calculate the width / tube length at the centre crossing point (maximum.x -> tanTheta, maximum.y -> y0)
Definition at line 182 of file EtaHoughTransformAlg.cxx.
185 int expectedPrecisionChambers{0}, seenPrecisionChambers{0};
186 bool hasTrig =
false;
188 std::unordered_set<const MuonGMR4::MuonReadoutElement*> seenChambers{};
189 std::set<std::pair<int,int>> seenLayers;
190 using enum Acts::TrapezoidVolumeBounds::BoundValues;
191 const double halfX = currentBucket.bucket->msSector()->bounds()->get(eHalfLengthXposY);
193 std::array<double, 2> tubeExtend{halfX, -halfX};
195 auto addSeenHit = [&tubeExtend, &seenLayers, &seenChambers](
const SpacePoint& sp,
197 const double sensorL,
198 const int mL,
const int layer){
200 seenChambers.insert(
re);
201 tubeExtend[0] =
std::min(tubeExtend[0], sp.positionInChamber().x() - sensorL);
202 tubeExtend[1] =
std::max(tubeExtend[1], sp.positionInChamber().x() + sensorL);
204 for (
const SpacePoint* SP : maximum.hitIdentifiers){
205 ATH_MSG_VERBOSE(__func__<<
"() - "<<__LINE__<<
" Maximum has associated hit in "
212 addSeenHit(*SP,
re, 0.5*
re->activeTubeLength(dc->measurementHash()),
213 re->multilayer(), dc->tubeLayer());
215 const auto* clust =
static_cast<const xAOD::MMCluster*
>(SP->primaryMeasurement());
217 addSeenHit(*SP,
re, 0.5*
re->stripLayer(clust->measurementHash()).design().stripLength(clust->channelNumber()),
218 re->multilayer(), clust->gasGap());
222 addSeenHit(*SP,
re, 0.5*
re->stripLayer(clust->measurementHash()).design().stripLength(clust->channelNumber()),
223 re->multilayer(), clust->gasGap());
230 for (
const auto & muonChamber : currentBucket.bucket->chamberLocations()){
233 ATH_MSG_VERBOSE(__func__<<
"() - "<<__LINE__<<
" maximum does not cross "
234 <<
m_idHelperSvc->toStringDetEl(muonChamber.readoutEle()->identify()));
238 <<
m_idHelperSvc->toStringDetEl(muonChamber.readoutEle()->identify())<<
", "
239 <<(*muonChamber.bounds())<<
", @: "<<
Amg::toString(muonChamber.location()));
244 const bool hasHit = seenChambers.count(muonChamber.readoutEle());
250 ++seenPrecisionChambers;
255 }
else if (precTech) {
258 const double lowL = muonChamber.width(maximum.y + muonChamber.location().z() * maximum.x);
259 const std::array<double, 2> chambEdges{muonChamber.location().x() - lowL,
260 muonChamber.location().x() + lowL};
263 if (coverage < 0.95){
264 ATH_MSG_VERBOSE(__func__<<
"() - "<<__LINE__<<
" Reject chamber due to partial coverage: "<<coverage
265 <<
", chamb extend: "<<chambEdges[0]<<
"-"<<chambEdges[1]
266 <<
", tube extend: "<<tubeExtend[0]<<
"-"<<tubeExtend[1]
267 <<
", "<<(*muonChamber.readoutEle()->msSector()->bounds()));
273 ++expectedPrecisionChambers;
277 int minLayers = seenLayers.size() / 2 + 1;
279 int minSeenPrecisionChambers = (expectedPrecisionChambers > 1) + 1;
283 minSeenPrecisionChambers = 1;
285 ATH_MSG_VERBOSE(__func__<<
"() - "<<__LINE__<<
": "<<currentBucket.bucket->msSector()->identString()<<
286 ", seen prec: "<<seenPrecisionChambers<<
", required: "<<minSeenPrecisionChambers
287 <<
" -- layers: "<<seenLayers.size()<<
", required: "<<
minLayers);
288 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 170 of file EtaHoughTransformAlg.cxx.
171 HoughPlaneConfig
cfg;
178 data.houghPlane = std::make_unique<HoughPlane>(
cfg);
179 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 109 of file EtaHoughTransformAlg.cxx.
115 for (
const SpacePointBucket* bucket :
spacePoints) {
119 std::vector<HoughSetupForBucket>& buckets =
data.houghSetups[bucket->front()->msSector()];
122 Amg::Vector3D leftSide = globToLoc.translation() - (
hs.bucket->coveredMin() * Amg::Vector3D::UnitY());
123 Amg::Vector3D rightSide = globToLoc.translation() - (
hs.bucket->coveredMax() * Amg::Vector3D::UnitY());
127 for (
const std::shared_ptr<MuonR4::SpacePoint> & sp : *bucket) {
136 hs.searchWindowTanAngle = {tanThetaLeft, tanThetaRight};
141 for (
const std::shared_ptr<MuonR4::SpacePoint> & hit : *bucket){
143 double y0l = hit->positionInChamber().y() - hit->positionInChamber().z() * tanThetaLeft;
144 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 292 of file EtaHoughTransformAlg.cxx.
297 double chamberCenter = 0.5 * (bucket.searchWindowIntercept.first +
298 bucket.searchWindowIntercept.second);
305 searchStart =
std::min(searchStart, bucket.searchWindowIntercept.first -
307 searchEnd =
std::max(searchEnd, bucket.searchWindowIntercept.second +
310 double tanThetaMean = 0.5 * (bucket.searchWindowTanAngle.first +
311 bucket.searchWindowTanAngle.second);
314 searchStartTanTheta =
std::min(searchStartTanTheta, bucket.searchWindowTanAngle.first -
316 searchEndTanTheta =
std::max(searchEndTanTheta, bucket.searchWindowTanAngle.second +
319 data.currAxisRanges = Acts::HoughTransformUtils::HoughAxisRanges{
320 searchStartTanTheta, searchEndTanTheta, searchStart, searchEnd};
322 data.houghPlane->reset();
323 for (
const SpacePointBucket::value_type& hit : *(bucket.bucket)) {
326 auto maxima =
data.peakFinder->findPeaks(*(
data.houghPlane),
data.currAxisRanges);
329 "#eta Hough accumulator");
331 if (maxima.empty()) {
332 ATH_MSG_DEBUG(
"Station "<<bucket.bucket->msSector()->identString()
333 <<
":\n Mean tanTheta was "<<tanThetaMean
334 <<
" and my intercept "<<chamberCenter
335 <<
", with hits in the bucket in "<< bucket.bucket->coveredMin()
336 <<
" - "<<bucket.bucket->coveredMax()
337 <<
". The bucket found a search range of ("
338 <<bucket.searchWindowTanAngle.first<<
" - "
339 <<bucket.searchWindowTanAngle.second<<
") and ("
340 <<bucket.searchWindowIntercept.first<<
" - "
341 <<bucket.searchWindowIntercept.second
342 <<
") , and my final search range is ["
343 <<searchStartTanTheta<<
" - "<<searchEndTanTheta
344 <<
"] and ["<<searchStart<<
" - "<<searchEnd
352 std::set<HoughHitType> seenHits;
355 for (
const auto&
max : maxima) {
358 unsigned int nPrec{0};
359 auto toBins = [&
data](
double x,
double y){
360 return std::make_pair(
365 auto accumulatorBins = toBins(
max.x,
max.y);
366 for (
const HoughHitType& hit :
data.houghPlane->hitIds(accumulatorBins.first, accumulatorBins.second)) {
367 auto res = seenHits.emplace(hit);
378 std::vector<HoughHitType> hitList{
max.hitIdentifiers.begin(),
max.hitIdentifiers.end()};
384 const HoughMaximum& houghMax{
max.x,
max.y, 1. *hitList.size(), std::move(hitList), bucket.bucket};
385 const SegmentSeed
seed{houghMax};
388 for (
auto &
chamber : bucket.bucket->chamberLocations()) {
394 std::abs(eta), eta > 0?
'A' :
'C',
m_idHelperSvc->stationPhi(detId));
395 switch (
chamber.readoutEle()->detectorType()) {
404 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));
406 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));
408 "MissedAccumulator", std::move(primitivesForAcc));
409 m_visionTool->visualizeSeed(ctx, seed,
"Missed seed",std::move(primitives));
415 size_t nHits = hitList.size();
419 const SpacePointPerLayerSorter
sorter{};
420 std::ranges::stable_sort(hitList,
sorter);
422 const HoughMaximum& houghMax{
data.maxima.emplace_back(
max.x,
max.y, nHits, std::move(hitList), bucket.bucket)};
426 const SegmentSeed
seed{houghMax};
429 for (
auto &
chamber : bucket.bucket->chamberLocations()){
432 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));
433 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));
435 m_visionTool->visualizeAccumulator(ctx, *
data.houghPlane,
data.currAxisRanges, {max},
"#eta Hough accumulator", std::move(primitivesForAcc));
436 m_visionTool->visualizeSeed(ctx, seed,
"#eta-HoughSeed", std::move(primitives));
◆ renounce()
◆ renounceArray()
◆ setFilterPassed()
◆ sysExecute()
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.
◆ sysInitialize()
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 61 of file AthCommonReentrantAlgorithm.cxx.
110 if (
sc.isFailure()) {
118 if ( cs.retrieve().isFailure() ) {
120 return StatusCode::SUCCESS;
122 if (cs->regHandle(
this,*
h).isFailure()) {
123 sc = StatusCode::FAILURE;
124 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
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
◆ 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:
constexpr unsigned int minLayers
char data[hepevt_bytes_allocation_ATLAS]
xAOD::UncalibMeasType type() const
DetectorType
Simple enum to Identify the Type of the ACTS sub detector.
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)
The MuonReadoutElement is an abstract class representing the geometry representing the muon detector.
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.
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
double houghWidthMdt(double tanTheta, const MuonR4::HoughHitType &dc, double targetReso)
uncertainty parametrisation for drift circles
Gaudi::Details::PropertyBase & declareGaudiProperty(Gaudi::Property< T, V, H > &hndl, const SG::VarHandleKeyType &)
specialization for handling Gaudi::Property<SG::VarHandleKey>
virtual const DataObjIDColl & extraOutputDeps() const override
Return the list of extra output dependencies.
std::string toString(const Translation3D &translation, int precision=4)
GeoPrimitvesToStringConverter.
virtual sTgcChannelTypes channelType() const =0
Returns the channel type of the measurement (Pad/Wire/Strip)
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.
const T * get(const ReadCondHandleKey< T > &key, const EventContext &ctx)
Convenience function to retrieve an object given a ReadCondHandleKey.
::StatusCode StatusCode
StatusCode definition for legacy code.
Gaudi::Details::PropertyBase & declareProperty(Gaudi::Property< T, V, H > &t)
virtual StatusCode sysExecute(const EventContext &ctx) override
Execute an algorithm.
Eigen::Affine3d Transform3D
std::pair< std::vector< unsigned int >, bool > res
bool passesThrough(const SpacePointBucket::chamberLocation &loc, double y0, double tanTheta)
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.
virtual void renounce()=0
std::conditional< std::is_base_of< SG::VarHandleKeyArray, T >::value, VarHandleKeyArrayType, type2 >::type type
constexpr double chamberCoverage(const std::array< double, 2 > &seedEdges, const std::array< double, 2 > &chambEdges)
Calculates how much of the unkknown coordinate along the tube range is covered by the chamber of inte...
Eigen::Matrix< double, 3, 1 > Vector3D
bool measuresEta() const
: Does the space point contain an eta measurement
#define ATH_MSG_WARNING(x)
const boost::regex re(r_e)
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
virtual StatusCode sysInitialize() override
Override sysInitialize.
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...
const MuonGMR4::MuonReadoutElement * muonReadoutElement(const UncalibratedMeasurement *meas)
Returns the associated readout element to the measurement.
DataObjIDColl m_extendedExtraObjects
Extra output dependency collection, extended by AthAlgorithmDHUpdate to add symlinks.