ATLAS Offline Software
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 
18 namespace ActsTrk {
19 
20  SeedAnalysisAlg::SeedAnalysisAlg(const std::string& name, ISvcLocator* pSvcLocator)
21  : AthMonitorAlgorithm(name, pSvcLocator)
22  {}
23 
25  ATH_MSG_INFO("Initializing " << name() << " ...");
26 
29 
30  ATH_CHECK( m_inputSeedColletionKey.initialize() );
31 
34 
36 
37  if (not m_prdTruth.empty()) {
38  ATH_CHECK( m_paramEstimationTool.retrieve() );
39  ATH_CHECK( m_trackingGeometryTool.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 (const 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 
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* detEle = 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, &detEle] (const Acts::Seed<xAOD::SpacePoint>& seed) -> const Acts::Surface&
239  {
240  const auto& els = seed.sp().front()->measurements();
241  const auto* cluster = els[0];
242  const InDetDD::SiDetectorElement* Element = detEle->getDetectorElement(cluster->identifierHash());
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 (const auto* seed : seed_container) {
258  std::optional<Acts::BoundTrackParameters> optTrackParams =
259  m_paramEstimationTool->estimateTrackParameters(ctx,
260  *seed,
261  geo_context.context(),
262  magFieldContext,
263  retrieveSurfaceFunction);
264 
265  if ( not optTrackParams.has_value() ) continue;
266 
267  const auto param = optTrackParams.value();
268  estimated_pt.push_back( param.transverseMomentum() );
269  estimated_eta.push_back( -std::log( std::tan(0.5 * param.parameters()[Acts::eBoundTheta]) ) );
270 
271  std::map<int, int> truthHits;
272 
273  const auto& sps = seed->sp();
274  for (const auto* sp : sps) {
275  int number_of_clusters = m_usePixel ? 1 : 2;
276  for (int cluster_number(0); cluster_number < number_of_clusters; cluster_number++) {
277  const auto& els = sp->measurements();
278  const auto* cluster = els[cluster_number];
279  const xAOD::UncalibMeasType cluster_type = cluster->type();
280  const Identifier id = cluster_type == xAOD::UncalibMeasType::PixelClusterType
281  ? identify(*reinterpret_cast<const xAOD::PixelCluster*>(cluster))
282  : identify(*reinterpret_cast<const xAOD::StripCluster*>(cluster));
283  matchParticleToSeedClusters(prdTruth, id, truthHits);
284  }
285  }
286 
287  auto [barcode, prob] = findSeedMajorityTruthParticle(truthHits);
288  truthBarCodeVec.push_back(barcode);
289  truthProbVec.push_back(prob);
290  vec_pass.push_back( barcode != 0 and prob > 0.5 );
291  }
292 
293  auto monitor_estimated_pt = Monitored::Collection("estimated_pt", estimated_pt);
294  auto monitor_estimated_eta = Monitored::Collection("estimated_eta", estimated_eta);
295  auto monitor_pass = Monitored::Collection("passed", vec_pass);
296 
297  fill(m_monGroupName.value(),
298  monitor_pass,
299  monitor_estimated_pt, monitor_estimated_eta);
300 
301  return StatusCode::SUCCESS;
302  }
303 
305  {
306  static const SG::ConstAccessor< ElementLink< InDet::PixelClusterCollection > > pixelLinkAcc("pixelClusterLink");
307 
308  // TO-DO -- AODs will not have this decoration, we'll need to provide a function for recomputing
309  // the identifier from local position
310  if (not pixelLinkAcc.isAvailable (cluster))
311  return Identifier();
312 
313  ElementLink<InDet::PixelClusterCollection> pixelLink = pixelLinkAcc(cluster);
314  return (*pixelLink)->identify();
315  }
316 
318  {
319  static const SG::ConstAccessor< ElementLink< InDet::SCT_ClusterCollection > > stripLinkAcc("sctClusterLink");
320 
321  // TO-DO -- AODs will not have this decoration, we'll need to provide a function for recomputing
322  // the identifier from local position
323  if (not stripLinkAcc.isAvailable (cluster))
324  return Identifier();
325 
326  ElementLink<InDet::SCT_ClusterCollection> stripLink = stripLinkAcc(cluster);
327  return (*stripLink)->identify();
328  }
329 
330 
332  const Identifier& id,
333  std::map<int, int>& countMap) const {
334  auto n1 = prdTruth->count(id);
335  if (n1 == 0) {
336  int bc = 0;
337  auto nBC = countMap.count(bc);
338  if (nBC == 0) {
339  countMap[bc] = 1;
340  } else {
341  countMap[bc] += 1;
342  }
343  } else {
344  using iprdt = PRD_MultiTruthCollection::const_iterator;
345  std::pair<iprdt, iprdt> range = prdTruth->equal_range(id);
346  for (iprdt itr = range.first; itr != range.second; ++itr) {
347  auto bc = itr->second.barcode();
348  auto nBC = countMap.count(bc);
349  if (nBC == 0) {
350  countMap[bc] = 1;
351  } else {
352  countMap[bc] += 1;
353  }
354  }
355  }
356  }
357 
358 
359 
360  std::pair<int, double> SeedAnalysisAlg::findSeedMajorityTruthParticle(const std::map<int, int>& countMap) const {
361  int bestCount = 0;
362  int bestBarcode = std::numeric_limits<int>::min();
363 
364  for (auto const& [barcode, count] : countMap) {
365  if (count > bestCount) {
366  bestCount = count;
367  bestBarcode = barcode;
368  }
369  }
370 
371  // 3 spacepoints per seed, 1 (2) clusters per spacepoint for pixel (strip)
372  double nTotal = m_usePixel ? 3. : 6.;
373  double prob = bestCount / nTotal;
374 
375  return std::make_pair(bestBarcode, prob);
376  }
377 
378  // Same computation as in ActsTrk::SiSpacePointsSeedMaker
379  std::array<float, 7> SeedAnalysisAlg::estimateParameters(const ActsTrk::Seed& seed,
380  float pTPerHelixRadius) const
381  {
382  auto extractCoordinates =
383  [] (const xAOD::SpacePoint* sp) -> std::array<float,4>
384  {
385  std::array<float, 4> coordinates {static_cast<float>(sp->x()),
386  static_cast<float>(sp->y()),
387  static_cast<float>(sp->z()),
388  static_cast<float>(std::sqrt(sp->x()*sp->x() + sp->y()*sp->y()))};
389  return coordinates;
390  };
391 
392  auto extractQuantities =
393  [] (const std::array<float, 4>& sp,
394  const std::array<float, 4>& spM,
395  bool isBottom) -> std::array<float, 5>
396  {
397  auto& [xM, yM, zM, rM] = spM;
398  auto& [xO, yO, zO, rO] = sp;
399 
400  float cosPhiM = xM / rM;
401  float sinPhiM = yM / rM;
402  float deltaX = xO - xM;
403  float deltaY = yO - yM;
404  float deltaZ = zO - zM;
405  float x = deltaX * cosPhiM + deltaY * sinPhiM;
406  float y = deltaY * cosPhiM - deltaX * sinPhiM;
407  float iDeltaR2 = 1. / (deltaX * deltaX + deltaY * deltaY);
408  float iDeltaR = std::sqrt(iDeltaR2);
409  int bottomFactor = int(not isBottom) - int(isBottom);
410  float cot_theta = deltaZ * iDeltaR * bottomFactor;
411 
412  // cotTheta, Zo, iDeltaR, U, V
413  std::array<float, 5> params =
414  {
415  cot_theta,
416  zM - rM * cot_theta,
417  iDeltaR,
418  x * iDeltaR2,
419  y * iDeltaR2
420  };
421 
422  return params;
423  };
424 
425  const auto& sps = seed.sp();
426  const auto* bottom = sps[0];
427  const auto* medium = sps[1];
428  const auto* top = sps[2];
429 
430  auto coo_b = extractCoordinates(bottom);
431  auto coo_m = extractCoordinates(medium);
432  auto coo_t = extractCoordinates(top);
433 
434  // Compute the variables we need
435  auto [cotThetaB, Zob, iDeltaRB, Ub, Vb] = extractQuantities(coo_b, coo_m, true);
436  auto [cotThetaT, Zot, iDeltaRT, Ut, Vt] = extractQuantities(coo_t, coo_m, false);
437 
438  float squarediDeltaR2B = iDeltaRB*iDeltaRB;
439  float squarediDeltaR2T = iDeltaRB*iDeltaRT;
440  float squarediDeltaR = std::min(squarediDeltaR2B, squarediDeltaR2T);
441 
442  auto& [xB, yB, zB, rB] = coo_b;
443  auto& [xM, yM, zM, rM] = coo_m;
444  auto& [xT, yT, zT, rT] = coo_t;
445 
446  float ax = xM / rM;
447  float ay = yM/ rM;
448 
449  float dxb = xM - xB;
450  float dyb = yM - yB;
451  float dzb = zM - zB;
452  float xb = dxb * ax + dyb *ay;
453  float yb = dyb * ax - dxb * ay;
454  float dxyb = xb * xb + yb * yb;
455  float dxt = xT - xM;
456  float dyt = yT - yM;
457  float dzt = zT - zM;
458  float xt = dxt * ax + dyt *ay;
459  float yt = dyt * ax - dxt * ay;
460  float dxyt = xt * xt + yt * yt;
461 
462  float tzb = dzb * std::sqrt( 1./dxyb );
463  float tzt = dzt * std::sqrt( 1./dxyt );
464 
465  float sTzb2 = std::sqrt(1 + tzb*tzb);
466 
467  float dU = Ut - Ub;
468  if (dU == 0.) {
469  return {-1, -1, -1, -1, -1, -1, -1};
470  }
471 
472  float A = (Vt - Vb) / dU;
473  float S2 = 1. + A * A;
474  float B = Vb - A * Ub;
475  float B2 = B * B;
476 
477  // dzdr
478  float dzdr_b = (zM - zB) / (rM - rB);
479  float dzdr_t = (zT - zM) / (rT - rM);
480 
481  // eta
482  float cotThetaAvg2 = cotThetaB * cotThetaT;
483  if (cotThetaAvg2 <= 0) {
484  return {-1, -1, -1, -1, -1, -1, -1};
485  }
486  float theta = std::atan(1. / std::sqrt(cotThetaAvg2));
487  float eta = -std::log(std::tan(0.5 * theta));
488 
489  // pt
490  float pt = pTPerHelixRadius * std::sqrt(S2 / B2) / 2.;
491 
492  // d0
493  float d0 = std::abs((A - B * rM) * rM);
494 
495  // curvature
496  // not used in current version of the code. We may want to use it later
497  // float curvature = B / std::sqrt(S2);
498  float penalty = std::abs((tzb - tzt) / (squarediDeltaR * sTzb2));
499 
500  return {pt, theta, eta, d0, dzdr_b, dzdr_t, penalty};
501  }
502 
503 }
PixelID.h
This is an Identifier helper class for the Pixel subdetector. This class is a factory for creating co...
ActsTrk::SeedAnalysisAlg::initialize
virtual StatusCode initialize() override
initialize
Definition: SeedAnalysisAlg.cxx:24
ActsTrk::SeedAnalysisAlg::m_prdTruth
SG::ReadHandleKey< PRD_MultiTruthCollection > m_prdTruth
Definition: SeedAnalysisAlg.h:70
ATLASMagneticFieldWrapper
Definition: ATLASMagneticFieldWrapper.h:15
top
TopConfig A simple configuration that is NOT a singleton.
Definition: AnalysisTrackingHelper.cxx:58
yt
#define yt
fitman.ax
ax
Definition: fitman.py:522
InDetDD::SiDetectorElementCollection
Definition: SiDetectorElementCollection.h:30
SG::ReadCondHandle
Definition: ReadCondHandle.h:44
ATH_MSG_INFO
#define ATH_MSG_INFO(x)
Definition: AthMsgStreamMacros.h:31
AtlasFieldCacheCondObj
Definition: AtlasFieldCacheCondObj.h:19
CaloCellPos2Ntuple.int
int
Definition: CaloCellPos2Ntuple.py:24
makeComparison.deltaY
int deltaY
Definition: makeComparison.py:44
ActsTrk::SeedAnalysisAlg::m_detEleCollKey
SG::ReadCondHandleKey< InDetDD::SiDetectorElementCollection > m_detEleCollKey
Definition: SeedAnalysisAlg.h:71
eta
Scalar eta() const
pseudorapidity method
Definition: AmgMatrixBasePlugin.h:79
SG::ReadHandle
Definition: StoreGate/StoreGate/ReadHandle.h:70
PRD_MultiTruthCollection
A PRD is mapped onto all contributing particles.
Definition: PRD_MultiTruthCollection.h:24
theta
Scalar theta() const
theta method
Definition: AmgMatrixBasePlugin.h:71
ActsTrk::Seed
Acts::Seed< xAOD::SpacePoint > Seed
Definition: Seed.h:13
ActsTrk::SeedAnalysisAlg::fillTruthHistograms
StatusCode fillTruthHistograms(const EventContext &ctx, const ActsTrk::SeedContainer &seed_container, std::vector< int > &, std::vector< double > &) const
Definition: SeedAnalysisAlg.cxx:209
Amg::y
@ y
Definition: GeoPrimitives.h:35
AthMonitorAlgorithm::m_EventInfoKey
SG::ReadHandleKey< xAOD::EventInfo > m_EventInfoKey
Key for retrieving EventInfo from StoreGate.
Definition: AthMonitorAlgorithm.h:362
test_pyathena.pt
pt
Definition: test_pyathena.py:11
InDetDD::SolidStateDetectorElementBase::surface
Trk::Surface & surface()
Element Surface.
SG::ReadCondHandle::isValid
bool isValid()
Definition: ReadCondHandle.h:205
ATLASMagneticFieldWrapper.h
ActsTrk::SeedAnalysisAlg::SeedAnalysisAlg
SeedAnalysisAlg(const std::string &name, ISvcLocator *pSvcLocator)
Definition: SeedAnalysisAlg.cxx:20
xAOD::SpacePoint_v1
Definition: SpacePoint_v1.h:29
SG::ConstAccessor
Helper class to provide constant type-safe access to aux data.
Definition: ConstAccessor.h:54
SG::VarHandleKey::empty
bool empty() const
Test if the key is blank.
Definition: AthToolSupport/AsgDataHandles/Root/VarHandleKey.cxx:150
covarianceTool.prob
prob
Definition: covarianceTool.py:678
x
#define x
XMLtoHeader.count
count
Definition: XMLtoHeader.py:85
drawFromPickle.atan
atan
Definition: drawFromPickle.py:36
ATLASMagneticFieldWrapper::makeCache
MagneticFieldProvider::Cache makeCache(const Acts::MagneticFieldContext &mctx) const override
Definition: ATLASMagneticFieldWrapper.h:34
Monitored::Collection
ValuesCollection< T > Collection(std::string name, const T &collection)
Declare a monitored (double-convertible) collection.
Definition: MonitoredCollection.h:38
AthMonitorAlgorithm
Base class for Athena Monitoring Algorithms.
Definition: AthMonitorAlgorithm.h:36
SG::makeHandle
SG::ReadCondHandle< T > makeHandle(const SG::ReadCondHandleKey< T > &key, const EventContext &ctx=Gaudi::Hive::currentContext())
Definition: ReadCondHandle.h:269
ActsTrk::SeedAnalysisAlg::findSeedMajorityTruthParticle
std::pair< int, double > findSeedMajorityTruthParticle(const std::map< int, int > &countMap) const
Definition: SeedAnalysisAlg.cxx:360
xt
#define xt
SG::ReadCondHandle::retrieve
const_pointer_type retrieve()
Definition: ReadCondHandle.h:161
ActsTrk::SeedAnalysisAlg::m_paramEstimationTool
ToolHandle< ActsTrk::ITrackParamsEstimationTool > m_paramEstimationTool
Definition: SeedAnalysisAlg.h:64
isBottom
bool isBottom(const T &p)
Definition: AtlasPID.h:123
z
#define z
Identifier
Definition: DetectorDescription/Identifier/Identifier/Identifier.h:32
EL::StatusCode
::StatusCode StatusCode
StatusCode definition for legacy code.
Definition: PhysicsAnalysis/D3PDTools/EventLoop/EventLoop/StatusCode.h:22
SG::ReadHandle::get
const_pointer_type get() const
Dereference the pointer, but don't cache anything.
ATH_MSG_DEBUG
#define ATH_MSG_DEBUG(x)
Definition: AthMsgStreamMacros.h:29
HepMC::barcode
int barcode(const T *p)
Definition: Barcode.h:16
Amg::x
@ x
Definition: GeoPrimitives.h:34
ActsTrk::SeedAnalysisAlg::m_ATLASConverterTool
ToolHandle< ActsTrk::IActsToTrkConverterTool > m_ATLASConverterTool
Definition: SeedAnalysisAlg.h:66
ActsTrk::SeedAnalysisAlg::m_fieldCondObjInputKey
SG::ReadCondHandleKey< AtlasFieldCacheCondObj > m_fieldCondObjInputKey
Definition: SeedAnalysisAlg.h:74
TRT::Track::d0
@ d0
Definition: InnerDetector/InDetCalibEvent/TRT_CalibData/TRT_CalibData/TrackInfo.h:62
plotBeamSpotVxVal.range
range
Definition: plotBeamSpotVxVal.py:195
ActsTrk::SeedAnalysisAlg::m_beamSpotKey
SG::ReadCondHandleKey< InDet::BeamSpotData > m_beamSpotKey
Definition: SeedAnalysisAlg.h:73
xAOD::StripCluster_v1
Definition: StripCluster_v1.h:17
ATH_CHECK
#define ATH_CHECK
Definition: AthCheckMacros.h:40
drawFromPickle.tan
tan
Definition: drawFromPickle.py:36
AthMonitorAlgorithm::fill
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.
SG::VarHandleKey::initialize
StatusCode initialize(bool used=true)
If this object is used as a property, then this should be called during the initialize phase.
Definition: AthToolSupport/AsgDataHandles/Root/VarHandleKey.cxx:103
DataVector
Derived DataVector<T>.
Definition: DataVector.h:581
SiLocalPosition.h
compareGeometries.deltaX
float deltaX
Definition: compareGeometries.py:32
ActsTrk::SeedAnalysisAlg::m_monGroupName
Gaudi::Property< std::string > m_monGroupName
Definition: SeedAnalysisAlg.h:78
ActsTrk::SeedAnalysisAlg::matchParticleToSeedClusters
void matchParticleToSeedClusters(const PRD_MultiTruthCollection *prdTruth, const Identifier &id, std::map< int, int > &countMap) const
Definition: SeedAnalysisAlg.cxx:331
SG::ReadHandle::isValid
virtual bool isValid() override final
Can the handle be successfully dereferenced?
min
#define min(a, b)
Definition: cfImp.cxx:40
ActsTrk::SeedAnalysisAlg::estimateParameters
std::array< float, 7 > estimateParameters(const ActsTrk::Seed &seed, float pTPerHelixRadius) const
Definition: SeedAnalysisAlg.cxx:379
name
std::string name
Definition: Control/AthContainers/Root/debug.cxx:195
InDetDD::SiDetectorElement
Definition: SiDetectorElement.h:109
SG::CondHandleKey::initialize
StatusCode initialize(bool used=true)
SiDetectorElement.h
DataModelTestDataCommonDict::xb
DMTest::CView::Pers_t xb
Definition: DataModelTestDataCommonDict.h:44
AthMonitorAlgorithm::initialize
virtual StatusCode initialize() override
initialize
Definition: AthMonitorAlgorithm.cxx:18
Rtt_histogram.n1
n1
Definition: Rtt_histogram.py:21
python.SystemOfUnits.mm
int mm
Definition: SystemOfUnits.py:83
ActsTrk::SeedAnalysisAlg::m_usePixel
Gaudi::Property< bool > m_usePixel
Definition: SeedAnalysisAlg.h:80
xAOD::PixelCluster_v1
Definition: PixelCluster_v1.h:17
y
#define y
ATLASMagneticFieldWrapper::getField
Acts::Result< Acts::Vector3 > getField(const Acts::Vector3 &position, Acts::MagneticFieldProvider::Cache &gcache) const override
Definition: ATLASMagneticFieldWrapper.h:39
ActsTrk::SeedAnalysisAlg::identify
const Identifier identify(const xAOD::PixelCluster &) const
Definition: SeedAnalysisAlg.cxx:304
ActsTrk::SeedAnalysisAlg::fillHistograms
virtual StatusCode fillHistograms(const EventContext &ctx) const override
adds event to the monitoring histograms
Definition: SeedAnalysisAlg.cxx:49
PixelModuleDesign.h
xAOD::UncalibMeasType
UncalibMeasType
Define the type of the uncalibrated measurement.
Definition: MeasurementDefs.h:24
python.CaloCondTools.log
log
Definition: CaloCondTools.py:20
S2
struct TBPatternUnitContext S2
SG::ConstAccessor::isAvailable
bool isAvailable(const ELT &e) const
Test to see if this variable exists in the store.
ActsTrk
The AlignStoreProviderAlg loads the rigid alignment corrections and pipes them through the readout ge...
Definition: MuonDetectorBuilderTool.cxx:34
ConstAccessor.h
Helper class to provide constant type-safe access to aux data.
Monitored::Scalar
Declare a monitored scalar variable.
Definition: MonitoredScalar.h:34
PowhegControl_ttFCNC_NLO.params
params
Definition: PowhegControl_ttFCNC_NLO.py:226
makeComparison.deltaZ
int deltaZ
Definition: makeComparison.py:46
ActsTrk::SeedAnalysisAlg::m_inputSeedColletionKey
SG::ReadHandleKey< ActsTrk::SeedContainer > m_inputSeedColletionKey
Definition: SeedAnalysisAlg.h:68
Trk::Surface
Definition: Tracking/TrkDetDescr/TrkSurfaces/TrkSurfaces/Surface.h:75
DataVector::size
size_type size() const noexcept
Returns the number of elements in the collection.
SeedAnalysisAlg.h
InDetDD::SiDetectorElementCollection::getDetectorElement
const SiDetectorElement * getDetectorElement(const IdentifierHash &hash) const
Definition: SiDetectorElementCollection.cxx:15
xAOD::UncalibMeasType::PixelClusterType
@ PixelClusterType
fitman.ay
ay
Definition: fitman.py:525
ActsTrk::SeedAnalysisAlg::m_trackingGeometryTool
PublicToolHandle< IActsTrackingGeometryTool > m_trackingGeometryTool
Definition: SeedAnalysisAlg.h:65