ATLAS Offline Software
Loading...
Searching...
No Matches
SeedAnalysisAlg.cxx
Go to the documentation of this file.
1/*
2 Copyright (C) 2002-2024 CERN for the benefit of the ATLAS collaboration
3*/
4
5#include "SeedAnalysisAlg.h"
6
9
12
13#include "Acts/Definitions/Units.hpp"
14#include "Acts/MagneticField/MagneticFieldContext.hpp"
17
18namespace ActsTrk {
19
20 SeedAnalysisAlg::SeedAnalysisAlg(const std::string& name, ISvcLocator* pSvcLocator)
21 : AthMonitorAlgorithm(name, pSvcLocator)
22 {}
23
25 ATH_MSG_INFO("Initializing " << name() << " ...");
26
27 ATH_CHECK( m_beamSpotKey.initialize() );
28 ATH_CHECK( m_fieldCondObjInputKey.initialize() );
29
30 ATH_CHECK( m_inputSeedColletionKey.initialize() );
31
32 ATH_CHECK( m_prdTruth.initialize(not m_prdTruth.empty()));
33 ATH_CHECK( m_detEleCollKey.initialize(not m_detEleCollKey.empty()) );
34
35 ATH_CHECK( m_EventInfoKey.initialize() );
36
37 if (not m_prdTruth.empty()) {
38 ATH_CHECK( m_paramEstimationTool.retrieve() );
40 ATH_CHECK( m_ATLASConverterTool.retrieve() );
41 }
42
43 ATH_MSG_DEBUG("Monitoring settings ...");
45
47 }
48
49 StatusCode SeedAnalysisAlg::fillHistograms(const EventContext& ctx) const {
50 ATH_MSG_DEBUG( "Filling Histograms for " << name() << " ... " );
51
52 // CONDS
53 // Read the Beam Spot information
55 ATH_CHECK( beamSpotHandle.isValid() );
56 auto beamSpotData = beamSpotHandle.cptr();
57
58 // Read the b-field information
60 ATH_CHECK( readHandle.isValid() );
61 const AtlasFieldCacheCondObj* fieldCondObj{ *readHandle };
62
63 // Get the magnetic field
64 // Using ACTS classes in order to be sure we are consistent
65 Acts::MagneticFieldContext magFieldContext(fieldCondObj);
66 // Beam Spot Position
67 Acts::Vector2 beamPos( beamSpotData->beamPos()[ Amg::x ] * Acts::UnitConstants::mm,
68 beamSpotData->beamPos()[ Amg::y ] * Acts::UnitConstants::mm );
69
70 // Magnetic Field
71 ATLASMagneticFieldWrapper magneticField;
72 Acts::MagneticFieldProvider::Cache magFieldCache = magneticField.makeCache( magFieldContext );
73 Acts::Vector3 bField = *magneticField.getField( Acts::Vector3(beamPos.x(), beamPos.y(), 0),
74 magFieldCache );
75
76
77 // SEEDS
78 ATH_MSG_DEBUG( "Reading input collection with key " << m_inputSeedColletionKey.key() );
80 ATH_CHECK( handle.isValid() );
81 const ActsTrk::SeedContainer* seed_collection = handle.get();
82 ATH_MSG_DEBUG( "Retrieved " << seed_collection->size() << " input elements from key " << m_inputSeedColletionKey.key() );
83
84 auto monitor_nseed = Monitored::Scalar<int>("Nseed", seed_collection->size());
85 fill(m_monGroupName.value(), monitor_nseed);
86
87 // bottom
88 auto monitor_x1 =
89 Monitored::Collection("x1", *seed_collection,
90 [] (const auto& seed) -> double
91 { return seed.sp()[0]->x(); });
92 auto monitor_y1 =
93 Monitored::Collection("y1", *seed_collection,
94 [] (const auto& seed) -> double
95 { return seed.sp()[0]->y(); });
96 auto monitor_z1 =
97 Monitored::Collection("z1", *seed_collection,
98 [] (const auto& seed) -> double
99 { return seed.sp()[0]->z(); });
100 auto monitor_r1 =
101 Monitored::Collection("r1", *seed_collection,
102 [] (const auto& seed) -> double
103 {
104 const auto* sp = seed.sp()[0];
105 return std::sqrt(sp->x()*sp->x() + sp->y()*sp->y());
106 });
107
108 // middle
109 auto monitor_x2 =
110 Monitored::Collection("x2", *seed_collection,
111 [] (const auto& seed) -> double
112 { return seed.sp()[1]->x(); });
113 auto monitor_y2 =
114 Monitored::Collection("y2", *seed_collection,
115 [] (const auto& seed) -> double
116 { return seed.sp()[1]->y(); });
117 auto monitor_z2 =
118 Monitored::Collection("z2", *seed_collection,
119 [] (const auto& seed) -> double
120 { return seed.sp()[1]->z(); });
121 auto monitor_r2 =
122 Monitored::Collection("r2", *seed_collection,
123 [] (const auto& seed) -> double
124 {
125 const auto* sp = seed.sp()[1];
126 return std::sqrt(sp->x()*sp->x() + sp->y()*sp->y());
127 });
128
129 // top
130 auto monitor_x3 =
131 Monitored::Collection("x3", *seed_collection,
132 [] (const auto& seed) -> double
133 { return seed.sp()[2]->x(); });
134 auto monitor_y3 =
135 Monitored::Collection("y3", *seed_collection,
136 [] (const auto& seed) -> double
137 { return seed.sp()[2]->y(); });
138 auto monitor_z3 =
139 Monitored::Collection("z3", *seed_collection,
140 [] (const auto& seed) -> double
141 { return seed.sp()[2]->z(); });
142 auto monitor_r3 =
143 Monitored::Collection("r3", *seed_collection,
144 [] (const auto& seed) -> double
145 {
146 const auto* sp = seed.sp()[2];
147 return std::sqrt(sp->x()*sp->x() + sp->y()*sp->y());
148 });
149
150 std::vector< std::array<float, 7> > parametersCollection;
151 parametersCollection.reserve(seed_collection->size());
152
153 for (auto seed : *seed_collection) {
154 parametersCollection.push_back( estimateParameters(seed, 300. * bField[2] / 1000.) );
155 }
156
157 auto monitor_param_pt = Monitored::Collection("pt", parametersCollection,
158 [] (const auto& params) -> float
159 { return params[0]; });
160 auto monitor_param_theta = Monitored::Collection("theta", parametersCollection,
161 [] (const auto& params) -> float
162 { return params[1]; });
163 auto monitor_param_eta = Monitored::Collection("eta", parametersCollection,
164 [] (const auto& params) -> float
165 { return params[2]; });
166 auto monitor_param_d0 = Monitored::Collection("d0", parametersCollection,
167 [] (const auto& params) -> float
168 { return params[3]; });
169
170 auto monitor_param_dzdr_b = Monitored::Collection("dzdr_b", parametersCollection,
171 [] (const auto& params) -> float
172 { return params[4]; });
173 auto monitor_param_dzdr_t = Monitored::Collection("dzdr_t", parametersCollection,
174 [] (const auto& params) -> float
175 { return params[5]; });
176
177
178 auto monitor_param_penalty = Monitored::Collection("penalty", parametersCollection,
179 [] (const auto& params) -> float
180 { return params[6]; });
181
182
184 ATH_CHECK(eventInfo.isValid());
185
186 auto monitor_event_number = Monitored::Scalar<long>("event_number", static_cast<long>(eventInfo->eventNumber()));
187 auto monitor_actual_mu = Monitored::Scalar<float>("actual_mu", eventInfo->actualInteractionsPerCrossing());
188
189 std::vector<int> vec_truthBarcode;
190 std::vector<double> vec_truthProb;
191 if (not m_prdTruth.empty())
192 ATH_CHECK( fillTruthHistograms(ctx, *seed_collection, vec_truthBarcode, vec_truthProb) );
193 auto monitor_truth_barcode = Monitored::Collection("truth_barcode", vec_truthBarcode);
194 auto monitor_truth_prob = Monitored::Collection("truth_prob", vec_truthProb);
195
196 fill(m_monGroupName.value(),
197 monitor_x1, monitor_y1, monitor_z1, monitor_r1,
198 monitor_x2, monitor_y2, monitor_z2, monitor_r2,
199 monitor_x3, monitor_y3, monitor_z3, monitor_r3,
200 monitor_param_pt, monitor_param_theta, monitor_param_eta, monitor_param_d0,
201 monitor_param_dzdr_b, monitor_param_dzdr_t,
202 monitor_param_penalty,
203 monitor_event_number, monitor_actual_mu,
204 monitor_truth_barcode, monitor_truth_prob);
205
206 return StatusCode::SUCCESS;
207 }
208
209 StatusCode SeedAnalysisAlg::fillTruthHistograms(const EventContext& ctx,
210 const ActsTrk::SeedContainer& seed_container,
211 std::vector<int>& truthBarCodeVec,
212 std::vector<double>& truthProbVec) const
213 {
214 ATH_MSG_DEBUG( "Filling Truth Histograms for " << name() << " ... " );
215
217 ATH_CHECK(prdTruthHandle.isValid());
218 const PRD_MultiTruthCollection* prdTruth = prdTruthHandle.get();
219
221 ATH_CHECK( detEleHandle.isValid() );
222 const InDetDD::SiDetectorElementCollection& detElements = *detEleHandle.retrieve();
223
224 // Read the b-field information
226 ATH_CHECK( readHandle.isValid() );
227
228 const AtlasFieldCacheCondObj* fieldCondObj{ *readHandle };
229 ATH_CHECK( fieldCondObj != nullptr );
230
231 Acts::MagneticFieldContext magFieldContext(fieldCondObj);
232 auto geo_context = m_trackingGeometryTool->getNominalGeometryContext();
233
234
235 // utilities
236 // Used for param estimation
237 auto retrieveSurfaceFunction =
238 [this, &detElements] (const ActsTrk::Seed& seed, bool useTopSp) -> const Acts::Surface&
239 {
240 const xAOD::SpacePoint* sp = useTopSp ? seed.sp().back() : seed.sp().front();
241 const InDetDD::SiDetectorElement* element = detElements.getDetectorElement(
242 useTopSp ? sp->elementIdList().back() : sp->elementIdList().front());
243 const Trk::Surface& atlas_surface = element->surface();
244 return this->m_ATLASConverterTool->trkSurfaceToActsSurface(atlas_surface);
245 };
246
247
248 // computation
249 std::vector<bool> vec_pass;
250 vec_pass.reserve(seed_container.size());
251
252 std::vector<double> estimated_pt;
253 std::vector<double> estimated_eta;
254 estimated_pt.reserve(seed_container.size());
255 estimated_eta.reserve(seed_container.size());
256
257 for (auto seed : seed_container) {
258 std::optional<Acts::BoundTrackParameters> optTrackParams =
259 m_paramEstimationTool->estimateTrackParameters(
260 seed,
262 geo_context.context(),
263 magFieldContext,
264 retrieveSurfaceFunction);
265
266 if ( not optTrackParams.has_value() ) continue;
267
268 const auto param = optTrackParams.value();
269 estimated_pt.push_back( param.transverseMomentum() );
270 estimated_eta.push_back( -std::log( std::tan(0.5 * param.parameters()[Acts::eBoundTheta]) ) );
271
272 std::map<int, int> truthHits;
273
274 const auto& sps = seed.sp();
275 for (const auto* sp : sps) {
276 int number_of_clusters = m_usePixel ? 1 : 2;
277 for (int cluster_number(0); cluster_number < number_of_clusters; cluster_number++) {
278 const auto& els = sp->measurements();
279 const auto* cluster = els[cluster_number];
280 const xAOD::UncalibMeasType cluster_type = cluster->type();
281 const Identifier id = cluster_type == xAOD::UncalibMeasType::PixelClusterType
282 ? identify(*reinterpret_cast<const xAOD::PixelCluster*>(cluster))
283 : identify(*reinterpret_cast<const xAOD::StripCluster*>(cluster));
284 matchParticleToSeedClusters(prdTruth, id, truthHits);
285 }
286 }
287
288 auto [barcode, prob] = findSeedMajorityTruthParticle(truthHits);
289 truthBarCodeVec.push_back(barcode);
290 truthProbVec.push_back(prob);
291 vec_pass.push_back( barcode != 0 and prob > 0.5 );
292 }
293
294 auto monitor_estimated_pt = Monitored::Collection("estimated_pt", estimated_pt);
295 auto monitor_estimated_eta = Monitored::Collection("estimated_eta", estimated_eta);
296 auto monitor_pass = Monitored::Collection("passed", vec_pass);
297
298 fill(m_monGroupName.value(),
299 monitor_pass,
300 monitor_estimated_pt, monitor_estimated_eta);
301
302 return StatusCode::SUCCESS;
303 }
304
306 {
307 static const SG::ConstAccessor< ElementLink< InDet::PixelClusterCollection > > pixelLinkAcc("pixelClusterLink");
308
309 // TO-DO -- AODs will not have this decoration, we'll need to provide a function for recomputing
310 // the identifier from local position
311 if (not pixelLinkAcc.isAvailable (cluster))
312 return Identifier();
313
314 ElementLink<InDet::PixelClusterCollection> pixelLink = pixelLinkAcc(cluster);
315 return (*pixelLink)->identify();
316 }
317
319 {
320 static const SG::ConstAccessor< ElementLink< InDet::SCT_ClusterCollection > > stripLinkAcc("sctClusterLink");
321
322 // TO-DO -- AODs will not have this decoration, we'll need to provide a function for recomputing
323 // the identifier from local position
324 if (not stripLinkAcc.isAvailable (cluster))
325 return Identifier();
326
327 ElementLink<InDet::SCT_ClusterCollection> stripLink = stripLinkAcc(cluster);
328 return (*stripLink)->identify();
329 }
330
331
333 const Identifier& id,
334 std::map<int, int>& countMap) const {
335 auto n1 = prdTruth->count(id);
336 if (n1 == 0) {
337 int bc = 0;
338 auto nBC = countMap.count(bc);
339 if (nBC == 0) {
340 countMap[bc] = 1;
341 } else {
342 countMap[bc] += 1;
343 }
344 } else {
345 using iprdt = PRD_MultiTruthCollection::const_iterator;
346 std::pair<iprdt, iprdt> range = prdTruth->equal_range(id);
347 for (iprdt itr = range.first; itr != range.second; ++itr) {
348 auto bc = itr->second.barcode();
349 auto nBC = countMap.count(bc);
350 if (nBC == 0) {
351 countMap[bc] = 1;
352 } else {
353 countMap[bc] += 1;
354 }
355 }
356 }
357 }
358
359
360
361 std::pair<int, double> SeedAnalysisAlg::findSeedMajorityTruthParticle(const std::map<int, int>& countMap) const {
362 int bestCount = 0;
363 int bestBarcode = std::numeric_limits<int>::min();
364
365 for (auto const& [barcode, count] : countMap) {
366 if (count > bestCount) {
367 bestCount = count;
368 bestBarcode = barcode;
369 }
370 }
371
372 // 3 spacepoints per seed, 1 (2) clusters per spacepoint for pixel (strip)
373 double nTotal = m_usePixel ? 3. : 6.;
374 double prob = bestCount / nTotal;
375
376 return std::make_pair(bestBarcode, prob);
377 }
378
379 // Same computation as in ActsTrk::SiSpacePointsSeedMaker
380 std::array<float, 7> SeedAnalysisAlg::estimateParameters(const ActsTrk::Seed& seed,
381 float pTPerHelixRadius) const
382 {
383 auto extractCoordinates =
384 [] (const xAOD::SpacePoint* sp) -> std::array<float,4>
385 {
386 std::array<float, 4> coordinates {static_cast<float>(sp->x()),
387 static_cast<float>(sp->y()),
388 static_cast<float>(sp->z()),
389 static_cast<float>(std::sqrt(sp->x()*sp->x() + sp->y()*sp->y()))};
390 return coordinates;
391 };
392
393 auto extractQuantities =
394 [] (const std::array<float, 4>& sp,
395 const std::array<float, 4>& spM,
396 bool isBottom) -> std::array<float, 5>
397 {
398 auto& [xM, yM, zM, rM] = spM;
399 auto& [xO, yO, zO, rO] = sp;
400
401 float cosPhiM = xM / rM;
402 float sinPhiM = yM / rM;
403 float deltaX = xO - xM;
404 float deltaY = yO - yM;
405 float deltaZ = zO - zM;
406 float x = deltaX * cosPhiM + deltaY * sinPhiM;
407 float y = deltaY * cosPhiM - deltaX * sinPhiM;
408 float iDeltaR2 = 1.f / (deltaX * deltaX + deltaY * deltaY);
409 float iDeltaR = std::sqrt(iDeltaR2);
410 int bottomFactor = int(not isBottom) - int(isBottom);
411 float cot_theta = deltaZ * iDeltaR * bottomFactor;
412
413 // cotTheta, Zo, iDeltaR, U, V
414 std::array<float, 5> params =
415 {
416 cot_theta,
417 zM - rM * cot_theta,
418 iDeltaR,
419 x * iDeltaR2,
420 y * iDeltaR2
421 };
422
423 return params;
424 };
425
426 const auto& sps = seed.sp();
427 const auto* bottom = sps[0];
428 const auto* medium = sps[1];
429 const auto* top = sps[2];
430
431 auto coo_b = extractCoordinates(bottom);
432 auto coo_m = extractCoordinates(medium);
433 auto coo_t = extractCoordinates(top);
434
435 // Compute the variables we need
436 auto [cotThetaB, Zob, iDeltaRB, Ub, Vb] = extractQuantities(coo_b, coo_m, true);
437 auto [cotThetaT, Zot, iDeltaRT, Ut, Vt] = extractQuantities(coo_t, coo_m, false);
438
439 float squarediDeltaR2B = iDeltaRB*iDeltaRB;
440 float squarediDeltaR2T = iDeltaRB*iDeltaRT;
441 float squarediDeltaR = std::min(squarediDeltaR2B, squarediDeltaR2T);
442
443 auto& [xB, yB, zB, rB] = coo_b;
444 auto& [xM, yM, zM, rM] = coo_m;
445 auto& [xT, yT, zT, rT] = coo_t;
446
447 float ax = xM / rM;
448 float ay = yM/ rM;
449
450 float dxb = xM - xB;
451 float dyb = yM - yB;
452 float dzb = zM - zB;
453 float xb = dxb * ax + dyb *ay;
454 float yb = dyb * ax - dxb * ay;
455 float dxyb = xb * xb + yb * yb;
456 float dxt = xT - xM;
457 float dyt = yT - yM;
458 float dzt = zT - zM;
459 float xt = dxt * ax + dyt *ay;
460 float yt = dyt * ax - dxt * ay;
461 float dxyt = xt * xt + yt * yt;
462
463 float tzb = dzb * std::sqrt( 1.f/dxyb );
464 float tzt = dzt * std::sqrt( 1.f/dxyt );
465
466 float sTzb2 = std::sqrt(1.f + tzb*tzb);
467
468 float dU = Ut - Ub;
469 if (dU == 0.) {
470 return {-1, -1, -1, -1, -1, -1, -1};
471 }
472
473 float A = (Vt - Vb) / dU;
474 float S2 = 1.f + A * A;
475 float B = Vb - A * Ub;
476 float B2 = B * B;
477 if (B2 == 0) B2 = 1e-8;
478
479 // dzdr
480 float dzdr_b = (zM - zB) / (rM - rB);
481 float dzdr_t = (zT - zM) / (rT - rM);
482
483 // eta
484 float cotThetaAvg2 = cotThetaB * cotThetaT;
485 if (cotThetaAvg2 <= 0) {
486 return {-1, -1, -1, -1, -1, -1, -1};
487 }
488 float theta = std::atan(1.f / std::sqrt(cotThetaAvg2));
489 float eta = -std::log(std::tan(0.5f * theta));
490
491 // pt
492 float pt = pTPerHelixRadius * std::sqrt(S2 / B2) / 2.f;
493
494 // d0
495 float d0 = std::abs((A - B * rM) * rM);
496
497 // curvature
498 // not used in current version of the code. We may want to use it later
499 // float curvature = B / std::sqrt(S2);
500 float penalty = std::abs((tzb - tzt) / (squarediDeltaR * sTzb2));
501
502 return {pt, theta, eta, d0, dzdr_b, dzdr_t, penalty};
503 }
504
505}
Scalar eta() const
pseudorapidity method
Scalar theta() const
theta method
#define ATH_CHECK
Evaluate an expression and check for errors.
#define ATH_MSG_INFO(x)
#define ATH_MSG_DEBUG(x)
bool isBottom(const T &p)
Definition AtlasPID.h:182
Helper class to provide constant type-safe access to aux data.
static Double_t sp
This is an Identifier helper class for the Pixel subdetector.
struct TBPatternUnitContext S2
@ top
#define y
#define xt
#define yt
#define x
Acts::Result< Acts::Vector3 > getField(const Acts::Vector3 &position, Acts::MagneticFieldProvider::Cache &gcache) const override
MagneticFieldProvider::Cache makeCache(const Acts::MagneticFieldContext &mctx) const override
virtual StatusCode fillHistograms(const EventContext &ctx) const override
adds event to the monitoring histograms
std::pair< int, double > findSeedMajorityTruthParticle(const std::map< int, int > &countMap) const
SeedAnalysisAlg(const std::string &name, ISvcLocator *pSvcLocator)
Gaudi::Property< bool > m_usePixel
StatusCode fillTruthHistograms(const EventContext &ctx, const ActsTrk::SeedContainer &seed_container, std::vector< int > &, std::vector< double > &) const
ToolHandle< ActsTrk::IActsToTrkConverterTool > m_ATLASConverterTool
ToolHandle< ActsTrk::ITrackParamsEstimationTool > m_paramEstimationTool
const Identifier identify(const xAOD::PixelCluster &) const
void matchParticleToSeedClusters(const PRD_MultiTruthCollection *prdTruth, const Identifier &id, std::map< int, int > &countMap) const
std::array< float, 7 > estimateParameters(const ActsTrk::Seed &seed, float pTPerHelixRadius) const
SG::ReadHandleKey< PRD_MultiTruthCollection > m_prdTruth
virtual StatusCode initialize() override
initialize
Gaudi::Property< std::string > m_monGroupName
SG::ReadCondHandleKey< AtlasFieldCacheCondObj > m_fieldCondObjInputKey
SG::ReadHandleKey< ActsTrk::SeedContainer > m_inputSeedColletionKey
SG::ReadCondHandleKey< InDet::BeamSpotData > m_beamSpotKey
PublicToolHandle< ActsTrk::ITrackingGeometryTool > m_trackingGeometryTool
SG::ReadCondHandleKey< InDetDD::SiDetectorElementCollection > m_detEleCollKey
Gaudi::Property< bool > m_useTopSp
virtual StatusCode initialize() override
initialize
AthMonitorAlgorithm(const std::string &name, ISvcLocator *pSvcLocator)
Constructor.
SG::ReadHandleKey< xAOD::EventInfo > m_EventInfoKey
Key for retrieving EventInfo from StoreGate.
Class to hold the SiDetectorElement objects to be put in the detector store.
const SiDetectorElement * getDetectorElement(const IdentifierHash &hash) const
Class to hold geometrical description of a silicon detector element.
Trk::Surface & surface()
Element Surface.
Declare a monitored scalar variable.
A PRD is mapped onto all contributing particles.
Helper class to provide constant type-safe access to aux data.
bool isAvailable(const ELT &e) const
Test to see if this variable exists in the store.
const_pointer_type retrieve()
const_pointer_type cptr()
virtual bool isValid() override final
Can the handle be successfully dereferenced?
const_pointer_type get() const
Dereference the pointer, but don't cache anything.
Abstract Base Class for tracking surfaces.
void fill(const ToolHandle< GenericMonitoringTool > &groupHandle, std::vector< std::reference_wrapper< Monitored::IMonitoredVariable > > &&variables) const
Fills a vector of variables to a group by reference.
int count(std::string s, const std::string &regx)
count how many occurances of a regx are in a string
Definition hcg.cxx:146
The AlignStoreProviderAlg loads the rigid alignment corrections and pipes them through the readout ge...
ValuesCollection< T > Collection(std::string name, const T &collection)
Declare a monitored (double-convertible) collection.
SG::ReadCondHandle< T > makeHandle(const SG::ReadCondHandleKey< T > &key, const EventContext &ctx=Gaudi::Hive::currentContext())
StripCluster_v1 StripCluster
Define the version of the strip cluster class.
PixelCluster_v1 PixelCluster
Define the version of the pixel cluster class.
UncalibMeasType
Define the type of the uncalibrated measurement.
hold the test vectors and ease the comparison