Loading [MathJax]/extensions/tex2jax.js
ATLAS Offline Software
All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Properties Friends Macros Modules Pages
Namespaces | Classes | Typedefs | Functions
ActsTrk::detail Namespace Reference

Namespaces

 FitterHelperFunctions
 
 HitCategory
 
 MakeDerivedVariant
 

Classes

struct  accepted_decoration_types
 
class  AnalogueClusteringToolImpl
 
class  AtlasMeasurementContainerList
 
struct  CKF_config
 
struct  Decoration
 
class  DuplicateSeedDetector
 
class  GenMeasurementRangeList
 
class  GenUncalibSourceLinkAccessor
 Accessor for the above source link container. More...
 
class  HitSummaryData
 Helper class to gather hit summary information for e.g. More...
 
class  MeasurementCalibratorBase
 
class  MeasurementIndex
 
struct  MeasurementRange
 
struct  MeasurementSelectorData
 Struct holding objects required by the measurement selector. More...
 
class  OnTrackCalibrator
 
class  RefittingCalibrator
 
class  SharedHitCounter
 
class  SumOfValues
 Helper class to gather statistics and compute the biased variance. More...
 
class  TrackFindingMeasurements
 
class  TrkMeasurementCalibrator
 

Typedefs

using SetterType = std::function< std::any(SG::IAuxStore *, ActsTrk::IndexType, SG::auxid_t)>
 
using GetterType = std::function< const std::any(const SG::IConstAuxStore *, ActsTrk::IndexType, SG::auxid_t)>
 
using CopierType = std::function< void(SG::IAuxStore *, ActsTrk::IndexType, SG::auxid_t, const std::any &)>
 
using MeasurementRangeList = GenMeasurementRangeList< AtlasMeasurementContainerList >
 
using UncalibSourceLinkAccessor = GenUncalibSourceLinkAccessor< MeasurementRangeList >
 
using RecoTrackContainer = Acts::TrackContainer< Acts::VectorTrackContainer, Acts::VectorMultiTrajectory >
 
using RecoTrackContainerProxy = RecoTrackContainer::TrackProxy
 
using RecoTrackStateContainer = Acts::VectorMultiTrajectory
 
using RecoTrackStateContainerProxy = RecoTrackStateContainer::TrackStateProxy
 
using Stepper = Acts::SympyStepper
 Adapted from Acts Examples/Algorithms/TrackFinding/src/TrackFindingAlgorithmFunction.cpp. More...
 
using Navigator = Acts::Navigator
 
using Propagator = Acts::Propagator< Stepper, Navigator >
 
using CKF = Acts::CombinatorialKalmanFilter< Propagator, RecoTrackContainer >
 
using Extrapolator = Propagator
 

Functions

template<typename T >
const std::any constDecorationGetter (const SG::IConstAuxStore *container, ActsTrk::IndexType idx, SG::auxid_t decorationId)
 
template<typename T >
const std::any decorationGetter (const SG::IAuxStore *container, ActsTrk::IndexType idx, SG::auxid_t decorationId)
 
template<typename T >
std::any decorationSetter (SG::IAuxStore *container, ActsTrk::IndexType idx, SG::auxid_t decorationId)
 
template<typename T >
void decorationCopier (SG::IAuxStore *dst, ActsTrk::IndexType dst_idx, SG::auxid_t decorationId, const std::any &src_ptr)
 
std::vector< DecorationrestoreDecorations (const SG::IConstAuxStore *container, const std::set< std::string > &staticVariables)
 
std::unique_ptr< ActsTrk::IMeasurementSelectorgetMeasurementSelector (const ActsTrk::IOnBoundStateCalibratorTool *onTrackCalibratorTool, const ActsTrk::detail::MeasurementRangeList &measurementRanges, const std::vector< float > &etaBinsf, const std::vector< std::pair< float, float > > &chi2CutOffOutlier, const std::vector< size_t > &numMeasurementsCutOff)
 
double computeDtDs (const Acts::ParticleHypothesis &hypothesis, double qop)
 Helper function to compute dt/ds Helper function to compute the derivative of the time as function of the path length. More...
 
Acts::FreeToPathMatrix computeFreeToPathDerivatives (const Acts::Vector3 &direction, double qop, const Acts::Vector3 &bfield, const Acts::ParticleHypothesis &particle_hypothesis)
 Compute the path length derivatives for the free/bound to curvilinear paramter transform. More...
 
std::optional< Acts::BoundMatrix > convertActsBoundCovToCurvilinearParam (const Acts::GeometryContext &tgContext, const Acts::BoundTrackParameters &param, const Acts::Vector3 &magnFieldVect, const Acts::ParticleHypothesis &particle_hypothesis)
 Convert the covariance of the given Acts track parameters into curvilinear parameterisation. More...
 
std::array< unsigned int, 4 > expectedLayerPattern (const EventContext &ctx, const IActsExtrapolationTool &extrapolator, Acts::BoundTrackParameters perigee_parameters, double pathLimit)
 Extrapolate from the perigee outwards and gather information which detector layers should have hits. More...
 
void gatherTrackSummaryData (const ActsTrk::TrackContainer &tracksContainer, const typename ActsTrk::TrackContainer::ConstTrackProxy &track, const std::array< const InDetDD::SiDetectorElementCollection *, to_underlying(xAOD::UncalibMeasType::nTypes)> &siDetEleColl, const std::array< unsigned short, to_underlying(xAOD::UncalibMeasType::nTypes)> &measurement_to_summary_type, SumOfValues &chi2_stat_out, HitSummaryData &hit_info_out, std::vector< ActsTrk::TrackStateBackend::ConstTrackStateProxy::IndexType > &param_state_idx_out, std::array< std::array< uint8_t, to_underlying(HitCategory::N)>, to_underlying(xAOD::UncalibMeasType::nTypes)> &special_hit_counts_out)
 Helper to gather track summary information from the track states of the specified track. More...
 
template<typename T_EnumClass >
constexpr std::underlying_type< T_EnumClass >::type to_underlying (T_EnumClass an_enum)
 Helper to convert class enum into an integer. More...
 

Typedef Documentation

◆ CKF

using ActsTrk::detail::CKF = typedef Acts::CombinatorialKalmanFilter<Propagator, RecoTrackContainer>

◆ CopierType

using ActsTrk::detail::CopierType = typedef std::function<void(SG::IAuxStore*, ActsTrk::IndexType, SG::auxid_t, const std::any&)>

Definition at line 20 of file Decoration.h.

◆ Extrapolator

◆ GetterType

Definition at line 18 of file Decoration.h.

◆ MeasurementRangeList

Definition at line 204 of file AtlasUncalibSourceLinkAccessor.h.

◆ Navigator

using ActsTrk::detail::Navigator = typedef Acts::Navigator

◆ Propagator

using ActsTrk::detail::Propagator = typedef Acts::Propagator<Stepper, Navigator>

◆ RecoTrackContainer

using ActsTrk::detail::RecoTrackContainer = typedef Acts::TrackContainer<Acts::VectorTrackContainer, Acts::VectorMultiTrajectory>

◆ RecoTrackContainerProxy

using ActsTrk::detail::RecoTrackContainerProxy = typedef RecoTrackContainer::TrackProxy

◆ RecoTrackStateContainer

using ActsTrk::detail::RecoTrackStateContainer = typedef Acts::VectorMultiTrajectory

◆ RecoTrackStateContainerProxy

using ActsTrk::detail::RecoTrackStateContainerProxy = typedef RecoTrackStateContainer::TrackStateProxy

◆ SetterType

using ActsTrk::detail::SetterType = typedef std::function<std::any(SG::IAuxStore*, ActsTrk::IndexType, SG::auxid_t)>

Definition at line 16 of file Decoration.h.

◆ Stepper

using ActsTrk::detail::Stepper = typedef Acts::SympyStepper

Adapted from Acts Examples/Algorithms/TrackFinding/src/TrackFindingAlgorithmFunction.cpp.

Definition at line 30 of file Tracking/Acts/ActsTrackReconstruction/src/detail/Definitions.h.

◆ UncalibSourceLinkAccessor

Definition at line 205 of file AtlasUncalibSourceLinkAccessor.h.

Function Documentation

◆ computeDtDs()

double ActsTrk::detail::computeDtDs ( const Acts::ParticleHypothesis &  hypothesis,
double  qop 
)
inline

Helper function to compute dt/ds Helper function to compute the derivative of the time as function of the path length.

Definition at line 16 of file CurvilinearCovarianceHelper.h.

16  {
17  return std::hypot(1.,hypothesis.mass() / hypothesis.extractMomentum(qop));
18  }

◆ computeFreeToPathDerivatives()

Acts::FreeToPathMatrix ActsTrk::detail::computeFreeToPathDerivatives ( const Acts::Vector3 &  direction,
double  qop,
const Acts::Vector3 &  bfield,
const Acts::ParticleHypothesis &  particle_hypothesis 
)
inline

Compute the path length derivatives for the free/bound to curvilinear paramter transform.

Parameters
directionthe direction of trajectory at the location in question
qopq/p of the particle at the location in question in Acts units
bfieldthe magnetic field at the location in question in Acts units
particle_hypothesisthe particle hypothesis e.g. Acts::ParticleHypothesis::pion()
Returns
path length derivatives ( dr(...)/ds, dt/ds, dr(...)/ds2, d qop/ds [== 0] )

Definition at line 27 of file CurvilinearCovarianceHelper.h.

31  {
32  Acts::FreeToPathMatrix path_length_deriv;
33  static_assert(path_length_deriv.cols() == 8); // ensure that all elements are initialized
34  path_length_deriv.segment<3>(Acts::eFreePos0) = direction;
35  path_length_deriv(0,Acts::eFreeTime) = computeDtDs(particle_hypothesis,qop);
36  path_length_deriv.segment<3>(Acts::eFreeDir0) = (qop * direction.cross(bfield)).transpose();
37  path_length_deriv(0,Acts::eFreeQOverP) = 0.;
38  return path_length_deriv;
39  }

◆ constDecorationGetter()

template<typename T >
const std::any ActsTrk::detail::constDecorationGetter ( const SG::IConstAuxStore container,
ActsTrk::IndexType  idx,
SG::auxid_t  decorationId 
)

Definition at line 49 of file Decoration.h.

51  {
52  const void* data = container->getData(decorationId);
53  return &(static_cast<const T*>(data)[idx]);
54 }

◆ convertActsBoundCovToCurvilinearParam()

std::optional<Acts::BoundMatrix> ActsTrk::detail::convertActsBoundCovToCurvilinearParam ( const Acts::GeometryContext &  tgContext,
const Acts::BoundTrackParameters &  param,
const Acts::Vector3 &  magnFieldVect,
const Acts::ParticleHypothesis &  particle_hypothesis 
)
inline

Convert the covariance of the given Acts track parameters into curvilinear parameterisation.

Parameters
tgContextthe current geometry context
paramthe Acts track parameters
magnFieldVectthe vector of the magnetic field at the position of the track parameters in Acts units
particle_hypothesisthe particle hypothesis e.g. Acts::ParticleHypothesis::pion() Usage:
  
     using namespace Acts::UnitLiterals;
     MagField::AtlasFieldCache fieldCache;
     ...
     Amg::Vector3D magnFieldVect;
     fieldCache.getField(param.position(tgContext).data(), magnFieldVect.data());
     magnFieldVect *= 1000_T;
     auto cov = convertActsBoundCovToCurvilinearParam(tgContext, param, magnFieldVect);
     if (cov.has_value()) { ... }
  

Definition at line 61 of file CurvilinearCovarianceHelper.h.

65  {
66  if (param.covariance().has_value()) {
67  Acts::FreeVector freeParams = Acts::transformBoundToFreeParameters(
68  param.referenceSurface(), tgContext, param.parameters());
69  Acts::Vector3 position = freeParams.segment<3>(Acts::eFreePos0);
70  Acts::Vector3 direction = freeParams.segment<3>(Acts::eFreeDir0);
71  Acts::BoundMatrix b2c;
72  Acts::detail::boundToCurvilinearTransportJacobian(direction, // magnFieldVect.normalized(),
73  param.referenceSurface().boundToFreeJacobian(tgContext, position, direction),
74  Acts::FreeMatrix::Identity(),
76  param.parameters()[Acts::eBoundQOverP],
77  magnFieldVect,
78  particle_hypothesis),
79  b2c);
80 
81  return b2c * param.covariance().value() * b2c.transpose();
82  }
83  else {
84  return {};
85  }
86  }

◆ decorationCopier()

template<typename T >
void ActsTrk::detail::decorationCopier ( SG::IAuxStore dst,
ActsTrk::IndexType  dst_idx,
SG::auxid_t  decorationId,
const std::any &  src_ptr 
)

Definition at line 76 of file Decoration.h.

77  {
78  *std::any_cast<T*>(decorationSetter<T>(dst, dst_idx, decorationId)) =
79  *std::any_cast<const T*>(src_ptr);
80 }

◆ decorationGetter()

template<typename T >
const std::any ActsTrk::detail::decorationGetter ( const SG::IAuxStore container,
ActsTrk::IndexType  idx,
SG::auxid_t  decorationId 
)

Definition at line 57 of file Decoration.h.

59  {
60  const void* data = container->getData(decorationId);
61  return &(static_cast<T*>(data)[idx]);
62 }

◆ decorationSetter()

template<typename T >
std::any ActsTrk::detail::decorationSetter ( SG::IAuxStore container,
ActsTrk::IndexType  idx,
SG::auxid_t  decorationId 
)

Definition at line 67 of file Decoration.h.

68  {
69  assert (idx < container->size());
70  // The size requested for the decoration must match the size of the container.
71  void* data = container->getData(decorationId, container->size(), container->size());
72  return &(static_cast<T*>(data)[idx]);
73 }

◆ expectedLayerPattern()

std::array< unsigned int, 4 > ActsTrk::detail::expectedLayerPattern ( const EventContext &  ctx,
const IActsExtrapolationTool extrapolator,
Acts::BoundTrackParameters  perigee_parameters,
double  pathLimit 
)

Extrapolate from the perigee outwards and gather information which detector layers should have hits.

Parameters
ctxthe current athena EvetContext @paran extrapolator referece to the Acts extrapolation tool
perigee_parametersthe Acts defining track parameters (parameters at the perigee).
pathLimitthe maximum path length to extrapolate to.
Returns
array of layer pattern words: two pairs for pixel and strips containing the barrel and end caps bit pattern with one bit per detector layer. Will extrapolate from the perigee to the given cylinder volume surface and gather the layers which are crossed and on which hits are expected.

Definition at line 14 of file ExpectedHitUtils.cxx.

17  {
19  perigee_parameters,
20  Acts::Direction::Forward(),
21  pathLimit);
22  std::array<unsigned int,4> expected_layer_pattern {0u,0u,0u,0u};
23  for (const Acts::detail::Step &step : result.first ) {
24  // @TODO boundary check ?, does layer number match layer numbering in athena ?
25  // @TODO filter out dead modules
26  if (step.geoID.sensitive()) {
27  if (step.surface && step.surface->associatedDetectorElement()) {
28  const ActsDetectorElement *
29  actsDetEl = dynamic_cast<const ActsDetectorElement *>(step.surface->associatedDetectorElement());
30  if (actsDetEl) {
32  detEl = dynamic_cast<const InDetDD::SiDetectorElement *>(actsDetEl->upstreamDetectorElement());
33  if (detEl) {
34  if (detEl->isPixel()) {
36  unsigned int pattern_idx = type==InDetDD::PixelBarrel ? 0 : 1;
37  const PixelID* pixel_id = static_cast<const PixelID *>(detEl->getIdHelper());
38  expected_layer_pattern[pattern_idx] |= (1<< pixel_id->layer_disk(detEl->identify()) );
39  }
40  else if (detEl->isSCT()) {
41  // @TODO SCT/strip layer number should be shifted by total number of pixel layers ...
42  const SCT_ID* sct_id = static_cast<const SCT_ID *>(detEl->getIdHelper());
43  unsigned int pattern_idx = detEl->isBarrel() ? 2 : 3;
44  expected_layer_pattern[pattern_idx] |= (1<< sct_id->layer_disk(detEl->identify()) );
45  }
46  }
47  }
48  }
49  }
50  }
51  return expected_layer_pattern;
52  }

◆ gatherTrackSummaryData()

void ActsTrk::detail::gatherTrackSummaryData ( const ActsTrk::TrackContainer tracksContainer,
const typename ActsTrk::TrackContainer::ConstTrackProxy &  track,
const std::array< const InDetDD::SiDetectorElementCollection *, to_underlying(xAOD::UncalibMeasType::nTypes)> &  siDetEleColl,
const std::array< unsigned short, to_underlying(xAOD::UncalibMeasType::nTypes)> &  measurement_to_summary_type,
SumOfValues chi2_stat_out,
HitSummaryData hit_info_out,
std::vector< ActsTrk::TrackStateBackend::ConstTrackStateProxy::IndexType > &  param_state_idx_out,
std::array< std::array< uint8_t, to_underlying(HitCategory::N)>, to_underlying(xAOD::UncalibMeasType::nTypes)> &  special_hit_counts_out 
)

Helper to gather track summary information from the track states of the specified track.

Parameters
tracksContainerthe Acts track container
tracka track of the given acts track container for which the summary information is to be gathered
siDetEleCollarray of SiDetectorElement collections per measurement type.
measurement_to_summary_typea LUT to map measurement types to the corresponding summary type for the measurement counts
chi2_stat_outoutput of the per track state chi-squared sums and squared sums to compute the per state chi2 variance.
hit_info_outoutput of the gathered measurement statistics per detector region, layer, ... .
param_state_idx_outoutput vector to be filled with the state index of all track states which are not holes.
special_hit_counts_outarrays to count holes (and @TODO dead sensors) per measurement type.

Definition at line 14 of file HitSummaryDataUtils.cxx.

25  {
26  chi2_stat_out.reset();
27 
28  hit_info_out.reset();
29  param_state_idx_out.clear();
30 
31  const auto lastMeasurementIndex = track.tipIndex();
32  tracksContainer.trackStateContainer().visitBackwards(
33  lastMeasurementIndex,
34  [&siDetEleColl,
35  &measurement_to_summary_type,
36  &chi2_stat_out,
37  &hit_info_out,
38  &param_state_idx_out,
39  &special_hit_counts_out
40  ](const typename ActsTrk::TrackStateBackend::ConstTrackStateProxy &state) -> void
41  {
42 
43  auto flag = state.typeFlags();
44  if (flag.test(Acts::TrackStateFlag::HoleFlag)) {
45  xAOD::UncalibMeasType det_type = xAOD::UncalibMeasType::Other;
46  if (state.hasReferenceSurface()) {
47  if (state.referenceSurface().associatedDetectorElement()) {
48  const ActsDetectorElement *
49  actsDetEl = dynamic_cast<const ActsDetectorElement *>(state.referenceSurface().associatedDetectorElement());
50  if (actsDetEl) {
51  const InDetDD::SiDetectorElement *
52  detEl = dynamic_cast<const InDetDD::SiDetectorElement *>(actsDetEl->upstreamDetectorElement());
53  if (detEl) {
54  if (detEl->isPixel()) {
55  det_type = xAOD::UncalibMeasType::PixelClusterType;
56  }
57  else if (detEl->isSCT()) {
58  det_type = xAOD::UncalibMeasType::StripClusterType;
59  }
60  }
61  }
62  }
63  }
64 
65  Acts::BoundaryTolerance tolerance = Acts::BoundaryTolerance::AbsoluteBound(
66  // local0 tolerance
68  || state.referenceSurface().bounds().type() != Acts::SurfaceBounds::eAnnulus)
69  ? 0.0 : std::numeric_limits<double>::infinity(),
70  // local1 tolerance
72  || state.referenceSurface().bounds().type() == Acts::SurfaceBounds::eAnnulus)
73  ? 0.0 : std::numeric_limits<double>::infinity()
74  );
75  Acts::Vector2 localPos(state.predicted()[Acts::eBoundLoc0],state.predicted()[Acts::eBoundLoc1]);
76  if (state.referenceSurface().insideBounds(localPos,tolerance)) {
77  // @TODO check whether detector element is dead..
78  // if (dead) {
79  // ++specialHitCounts.at(to_underlying(det_type)).at(HitCategory::DeadSensor);
80  // } else {
81  ++special_hit_counts_out.at(to_underlying(det_type)).at(HitCategory::Hole);
82  }
83 
84  }
85  else if (flag.test(Acts::TrackStateFlag::MeasurementFlag)) {
86  // do not consider material states
87  param_state_idx_out.push_back(state.index());
88  }
89  // @TODO dead elements
90 
91  if (state.hasUncalibratedSourceLink()) {
92  auto sl = state.getUncalibratedSourceLink().template get<ActsTrk::ATLASUncalibSourceLink>();
93  assert( sl != nullptr );
94  const xAOD::UncalibratedMeasurement &uncalibMeas = getUncalibratedMeasurement(sl);
95  if (measurement_to_summary_type.at(to_underlying(uncalibMeas.type())) < xAOD::numberOfTrackSummaryTypes ) {
96  if (static_cast<unsigned int>(to_underlying(uncalibMeas.type())) < siDetEleColl.size()) {
97  hit_info_out.addHit(siDetEleColl[to_underlying(uncalibMeas.type())],
98  uncalibMeas.identifierHash(),
99  (flag.test(Acts::TrackStateFlag::OutlierFlag)
100  ? HitSummaryData::Outlier
101  : HitSummaryData::Hit));
102  }
103  }
104  if (state.calibratedSize()>0 && !flag.test(Acts::TrackStateFlag::OutlierFlag)) {
105  // from Tracking/TrkTools/TrkTrackSummaryTool/src/TrackSummaryTool.cxx
106  // processTrackState
107  double chi2add = std::min(state.chi2(),1e5f) / state.calibratedSize();
108  chi2_stat_out.add(chi2add );
109  }
110  }
111 
112  });
113  hit_info_out.computeSummaries();
114  }

◆ getMeasurementSelector()

std::unique_ptr< ActsTrk::IMeasurementSelector > ActsTrk::detail::getMeasurementSelector ( const ActsTrk::IOnBoundStateCalibratorTool onTrackCalibratorTool,
const ActsTrk::detail::MeasurementRangeList measurementRanges,
const std::vector< float > &  etaBinsf,
const std::vector< std::pair< float, float > > &  chi2CutOffOutlier,
const std::vector< size_t > &  numMeasurementsCutOff 
)

Definition at line 377 of file AtlasMeasurementSelector.cxx.

381  {
382 
383  // set calibrators per measurement container type (order does not matter);
384  ActsTrk::MeasurementCalibrator2 atl_measurement_calibrator(onTrackCalibratorTool);
385  using AtlMeasurementSelectorCuts = AtlasMeasurementSelectorCuts;
386 
387  using AtlMeasurementSelector = AtlasActsMeasurmentSelector<RecoTrackContainer>;
388  using AtlMeasurementSelectorConfig = AtlMeasurementSelector::TheAtlasMeasurementSelector::Config;
389 
390  std::unique_ptr<ActsTrk::IMeasurementSelector>
391  selector(new AtlMeasurementSelector(
392  std::move(atl_measurement_calibrator),
393  measurementRanges,
394  AtlMeasurementSelectorConfig{ {Acts::GeometryIdentifier(),
395  AtlMeasurementSelectorCuts{ etaBinsf,
396  chi2CutOffOutlier,
397  numMeasurementsCutOff} }}));
398  return selector;
399 
400 }

◆ restoreDecorations()

std::vector< Decoration > ActsTrk::detail::restoreDecorations ( const SG::IConstAuxStore container,
const std::set< std::string > &  staticVariables 
)
  • container - source container to look for decorations
  • staticVariables - set of names of predefined variables for this container

Definition at line 9 of file Decoration.cxx.

11  {
12  std::vector<Decoration> decorations;
13  for (auto id : container->getAuxIDs()) {
14  const std::string name = SG::AuxTypeRegistry::instance().getName(id);
15  const std::type_info* typeInfo =
17  if (staticVariables.count(name) == 1) {
18  continue;
19  }
20 
21  // try making decoration accessor of matching type
22  // there is a fixed set of supported types (as there is a fixed set
23  // available in MutableMTJ) setters are not needed so replaced by a
24  // "nullptr"
25  if (*typeInfo == typeid(float)) {
26  decorations.emplace_back(
27  decoration<float>(name, ActsTrk::detail::constDecorationGetter<float>,
28  ActsTrk::detail::decorationCopier<float>));
29  } else if (*typeInfo == typeid(double)) {
30  decorations.emplace_back(decoration<double>(
31  name, ActsTrk::detail::constDecorationGetter<double>,
32  ActsTrk::detail::decorationCopier<double>));
33  } else if (*typeInfo == typeid(short)) {
34  decorations.emplace_back(
35  decoration<short>(name, ActsTrk::detail::constDecorationGetter<short>,
36  ActsTrk::detail::decorationCopier<short>));
37  } else if (*typeInfo == typeid(uint32_t)) {
38  decorations.emplace_back(decoration<uint32_t>(
39  name, ActsTrk::detail::constDecorationGetter<uint32_t>,
40  ActsTrk::detail::decorationCopier<uint32_t>));
41  } else {
42  throw std::runtime_error("Can't restore decoration of " + name +
43  " because it is of an unsupported type");
44  }
45  }
46  return decorations;
47 }

◆ to_underlying()

template<typename T_EnumClass >
constexpr std::underlying_type<T_EnumClass>::type ActsTrk::detail::to_underlying ( T_EnumClass  an_enum)
constexpr

Helper to convert class enum into an integer.

Definition at line 24 of file HitSummaryDataUtils.h.

24  {
25  return static_cast<typename std::underlying_type<T_EnumClass>::type>(an_enum);
26  }
data
char data[hepevt_bytes_allocation_ATLAS]
Definition: HepEvt.cxx:11
SG::IConstAuxStore::getData
virtual const void * getData(SG::auxid_t auxid) const =0
Return the data vector for one aux data item.
get_generator_info.result
result
Definition: get_generator_info.py:21
SG::AuxTypeRegistry::instance
static AuxTypeRegistry & instance()
Return the singleton registry instance.
Definition: AuxTypeRegistry.cxx:639
xAOD::uint32_t
setEventNumber uint32_t
Definition: EventInfo_v1.cxx:127
SG::AuxTypeRegistry::getName
std::string getName(SG::auxid_t auxid) const
Return the name of an aux data item.
Definition: AuxTypeRegistry.cxx:881
ActsTrk::detail::computeFreeToPathDerivatives
Acts::FreeToPathMatrix computeFreeToPathDerivatives(const Acts::Vector3 &direction, double qop, const Acts::Vector3 &bfield, const Acts::ParticleHypothesis &particle_hypothesis)
Compute the path length derivatives for the free/bound to curvilinear paramter transform.
Definition: CurvilinearCovarianceHelper.h:27
ActsDetectorElement::upstreamDetectorElement
const GeoVDetectorElement * upstreamDetectorElement() const
Returns the underllying GeoModel detectorelement that this one is based on.
Definition: ActsDetectorElement.cxx:284
SG::IConstAuxStore::size
virtual size_t size() const =0
Return the number of elements in the store.
Trk::u
@ u
Enums for curvilinear frames.
Definition: ParamDefs.h:77
python.CaloAddPedShiftConfig.type
type
Definition: CaloAddPedShiftConfig.py:42
InDetDD::SolidStateDetectorElementBase::getIdHelper
const AtlasDetectorID * getIdHelper() const
Returns the id helper (inline)
python.setupRTTAlg.size
int size
Definition: setupRTTAlg.py:39
SG::AuxTypeRegistry::getType
const std::type_info * getType(SG::auxid_t auxid) const
Return the type of an aux data item.
Definition: AuxTypeRegistry.cxx:908
InDetDD::DetectorType
DetectorType
Definition: DetectorDesign.h:45
AtlasMeasurementSelectorCuts
Definition: MeasurementSelector.h:289
master.flag
bool flag
Definition: master.py:29
InDetDD::DetectorDesign::type
virtual DetectorType type() const
Type of element.
Definition: DetectorDesign.cxx:101
ActsDetectorElement
Definition: ActsDetectorElement.h:42
ActsTrk::MeasurementCalibrator2
Definition: MeasurementCalibrator2.h:101
InDetDD::SiDetectorElement::isPixel
bool isPixel() const
tolerance
Definition: suep_shower.h:17
PixelID::layer_disk
int layer_disk(const Identifier &id) const
Definition: PixelID.h:626
name
std::string name
Definition: Control/AthContainers/Root/debug.cxx:228
InDetDD::PixelBarrel
@ PixelBarrel
Definition: DetectorDesign.h:46
SCT_ID::layer_disk
int layer_disk(const Identifier &id) const
Definition: SCT_ID.h:734
InDetDD::SiDetectorElement
Definition: SiDetectorElement.h:109
InDetDD::SiDetectorElement::isBarrel
bool isBarrel() const
python.Dumpers.typename
def typename(t)
Definition: Dumpers.py:194
ActsTrk::detail::computeDtDs
double computeDtDs(const Acts::ParticleHypothesis &hypothesis, double qop)
Helper function to compute dt/ds Helper function to compute the derivative of the time as function of...
Definition: CurvilinearCovarianceHelper.h:16
python.selector.AtlRunQuerySelectorLhcOlc.selector
selector
Definition: AtlRunQuerySelectorLhcOlc.py:611
SCT_ID
Definition: SCT_ID.h:68
SG::IAuxStore::getData
virtual void * getData(auxid_t auxid, size_t size, size_t capacity)=0
Return the data vector for one aux data item.
if
if(febId1==febId2)
Definition: LArRodBlockPhysicsV0.cxx:567
LArNewCalib_DelayDump_OFC_Cali.idx
idx
Definition: LArNewCalib_DelayDump_OFC_Cali.py:69
LArCellBinning.step
step
Definition: LArCellBinning.py:158
IActsExtrapolationTool::propagationSteps
virtual ActsPropagationOutput propagationSteps(const EventContext &ctx, const Acts::BoundTrackParameters &startParameters, Acts::Direction navDir=Acts::Direction::Forward(), double pathLimit=std::numeric_limits< double >::max()) const =0
InDetDD::SiDetectorElement::isSCT
bool isSCT() const
xAOD::track
@ track
Definition: TrackingPrimitives.h:513
InDetDD::SiDetectorElement::design
virtual const SiDetectorDesign & design() const override final
access to the local description (inline):
PixelID
Definition: PixelID.h:67
InDetDD::SolidStateDetectorElementBase::identify
virtual Identifier identify() const override final
identifier of this detector element (inline)
SG::IConstAuxStore::getAuxIDs
virtual const SG::auxid_set_t & getAuxIDs() const =0
Return a set of identifiers for existing data items in this store.
TSU::T
unsigned long long T
Definition: L1TopoDataTypes.h:35
ActsPropagationOutput
std::pair< std::vector< Acts::detail::Step >, ActsRecordedMaterial > ActsPropagationOutput
Finally the output of the propagation test.
Definition: IActsExtrapolationTool.h:25
xAOD::UncalibMeasType::PixelClusterType
@ PixelClusterType