28#include "Acts/Utilities/MathHelpers.hpp"
29#include "Acts/Utilities/Enumerate.hpp"
33 constexpr double c_inv = 1./ Gaudi::Units::c_light;
38 using namespace Acts::UnitLiterals;
50 return StatusCode::SUCCESS;
56 std::vector<int> signs = SeedingAux::strawSigns(trackPos, trackDir,
58 for (
const auto [spIdx,
sp]: Acts::enumerate(hitsToCalib)) {
59 sp->setDriftRadius(
sp->driftRadius() * signs[spIdx]);
66 const double timeDelay)
const {
71 calibSP = std::make_unique<CalibratedSpacePoint>(spacePoint);
73 if (spacePoint.
fitState() == State::Outlier) {
74 calibSP->setFitState(State::Outlier);
75 }
else if (spacePoint.
fitState() == State::Duplicate) {
76 calibSP->setFitState(State::Duplicate);
84 const double timeDelay,
87 const EventContext* ctx = cctx.get<
const EventContext*>();
88 newCalib.reserve(spacePoints.size());
90 newCalib.emplace_back(
calibrate(*ctx, *
sp, segPos, segDir, timeDelay));
99 const double timeOffset)
const {
112 : spPos +
Amg::intersect<3>(posInChamb, dirInChamb, spPos, chDir).value_or(0) * chDir;
117 switch (spacePoint->
type()) {
121 posInChamb, dirInChamb).value_or(0) * dirInChamb;
123 Amg::Vector3D closestApproach{locToGlob* locClosestApproach};
124 const double timeOfArrival = closestApproach.mag() * c_inv + timeOffset;
130 Acts::abs(dirInChamb.phi() - 90._degree) > 1.e-7 );
136 State fitState{State::Valid};
138 if (calibOutput.
status() != Muon::MdtDriftCircleStatus::MdtStatusDriftTime) {
140 <<std::endl<<calibInput<<std::endl<<calibOutput);
141 fitState = State::FailedCalib;
142 cov[Acts::toUnderlying(AxisDefs::etaCov)] = dc->readoutElement()->innerTubeRadius();
144 cov[Acts::toUnderlying(AxisDefs::etaCov)] = Acts::square(calibOutput.
driftRadiusUncert());
146 calibSP = std::make_unique<CalibratedSpacePoint>(spacePoint, std::move(calibSpPos), fitState);
147 calibSP->setCovariance(cov);
148 calibSP->setDriftRadius(calibOutput.
driftRadius());
155 MdtCalibInput twinInput{dc->twinIdentify(), dc->twinAdc(), dc->twinTdc(), dc->readoutElement(), *gctx};
160 std::move(calibInput),
161 std::move(twinInput));
163 State fitState{State::Valid};
164 if (calibOutput.
primaryStatus() != Muon::MdtDriftCircleStatus::MdtStatusDriftTime) {
166 <<std::endl<<calibOutput);
167 cov[Acts::toUnderlying(AxisDefs::etaCov)] = Acts::square(dc->readoutElement()->innerTubeRadius());
168 cov[Acts::toUnderlying(AxisDefs::phiCov)] = Acts::square(0.5* dc->readoutElement()->activeTubeLength(dc->measurementHash()));
169 fitState = State::FailedCalib;
171 cov[Acts::toUnderlying(AxisDefs::etaCov)] = Acts::square(calibOutput.
uncertPrimaryR());
172 cov[Acts::toUnderlying(AxisDefs::phiCov)] = Acts::square(calibOutput.
sigmaZ());
174 calibSP = std::make_unique<CalibratedSpacePoint>(spacePoint, std::move(calibSpPos), fitState);
175 calibSP->setCovariance(cov);
187 calibSP = std::make_unique<CalibratedSpacePoint>(spacePoint, std::move(calibSpPos));
191 const double time1 =
strip->time()
192 -
strip->readoutElement()->distanceToEdge(
strip->layerHash(), lPos,
198 const double time2 = strip2->time() -
199 strip2->readoutElement()->distanceToEdge(strip2->layerHash(),lPos, EdgeSide::readOut)/
m_rpcSignalVelocity;
201 calibSP->setTimeMeasurement(0.5*(time1 + time2));
203 cov[Acts::toUnderlying(AxisDefs::timeCov)] += Acts::square(0.5*(time1 - time2));
205 calibSP->setCovariance(cov);
207 <<
", at "<<
Amg::toString(calibSP->localPosition())<<
", uncalib time: "
208 <<
strip->time()<<
", calib time: "<<calibSP->time()<<
" cov " <<calibSP->covariance());
212 calibSP = std::make_unique<CalibratedSpacePoint>(spacePoint, std::move(calibSpPos));
213 calibSP->setCovariance(cov);
221 std::pair<double, double> calibPosCov {
calibrateMM(ctx, *gctx, *cluster, globalPos, globalDir)};
223 ATH_MSG_DEBUG(
"Calibrated pos and cov" << calibPosCov.first <<
" " << calibPosCov.second);
224 cov[Acts::toUnderlying(AxisDefs::etaCov)] = calibPosCov.second;
228 Amg::Vector3D calibSpPosInLayer = toChamberTrans.inverse() * calibSpPos;
230 calibSpPosInLayer.x() = calibPosCov.first;
232 calibSpPos = toChamberTrans * calibSpPosInLayer;
234 calibSP = std::make_unique<CalibratedSpacePoint>(spacePoint, std::move(calibSpPos));
235 calibSP->setCovariance(cov);
246 calibSP = std::make_unique<CalibratedSpacePoint>(spacePoint, std::move(calibSpPos));
247 calibSP->setCovariance(cov);
251 std::optional<double> posAlongTheStrip{std::nullopt};
258 if (secMeas->numDimensions() == 2) {
259 posAlongTheStrip =
static_cast<double>(secMeas->localPosition<2>()[0]);
261 posAlongTheStrip =
static_cast<double>(secMeas->localPosition<1>()[0]);
271 const auto [calibPos, calibCov] =
calibratesTGC(ctx, *gctx, *stripClus, posAlongTheStrip, globalPos, globalDir);
273 ATH_MSG_DEBUG(
"Calibrated pos and cov" << calibPos <<
" " << calibCov);
274 cov[Acts::toUnderlying(AxisDefs::etaCov)] = calibCov;
275 Amg::Transform3D toChamberTrans{ locToGlob.inverse() * cluster->readoutElement()->localToGlobalTransform(*gctx, cluster->layerHash())};
278 Amg::Vector3D calibSpPosInLayer = toChamberTrans.inverse() * calibSpPos;
280 calibSpPosInLayer.x() = calibPos;
282 calibSpPos = toChamberTrans * calibSpPosInLayer;
284 calibSP = std::make_unique<CalibratedSpacePoint>(spacePoint, std::move(calibSpPos));
285 calibSP->setCovariance(cov);
286 ATH_MSG_DEBUG(
"calibrated sTGC cluster "<<
m_idHelperSvc->toString(cluster->identify()) <<
" loc x old " << cluster->localPosition<1>()[0] <<
" new loc x " << calibSP->localPosition()[1] <<
"cov " << calibSP->covariance());
297 const std::vector<const SpacePoint*>& spacePoints,
300 const double timeOffset)
const {
302 calibSpacePoints.reserve(spacePoints.size());
303 for(
const SpacePoint* spacePoint : spacePoints) {
306 calibSpacePoints.push_back(std::move(hit));
309 return calibSpacePoints;
316 const std::optional<double> driftTime = calibConsts->
rtRelation->tr()->driftTime(spacePoint.
driftRadius());
317 return calibConsts->
rtRelation->rt()->driftVelocity(driftTime.value_or(0.));
325 const std::optional<double> driftTime = calibConsts->
rtRelation->tr()->driftTime(spacePoint.
driftRadius());
326 return calibConsts->
rtRelation->rt()->driftAcceleration(driftTime.value_or(0.));
336 std::vector<NSWCalib::CalibratedStrip> calibClus;
337 StatusCode
sc =
m_nswCalibTool->calibrateClus(ctx, gctx, cluster, globalPos, calibClus);
340 return std::make_pair(0., 0.);
347 calibCov.resize(1,1);
349 ATH_MSG_DEBUG(
"old loc pos " << locPos[0] <<
" old cov" << calibCov(0,0) );
352 if(rotAuthor == Muon::IMMClusterBuilderTool::RIO_Author::unKnownAuthor){
355 ATH_MSG_DEBUG(
"new loc pos " << locPos[0] <<
" new cov" << calibCov(0,0) );
356 return std::make_pair(locPos[0], calibCov(0,0));
362 std::optional<double> posAlongTheStrip,
367 if(!posAlongTheStrip) {
369 posAlongTheStrip = extPosLocal[1];
379 ActsTrk::MutableTrackContainer::TrackStateProxy state)
const {
400 const auto& radialDesign = stripMeas->readoutElement()->stripLayout(stripMeas->layerHash());
401 const auto& wireDesign = wireMeas->readoutElement()->wireGangLayout(wireMeas->layerHash());
403 const double dirDots = radialDesign.stripDir(stripMeas->channelNumber()).dot(wireDesign.stripNormal());
406 const double invDist = 1. / (1. - Acts::square(dirDots));
407 stereoTrf(0, 0) = stereoTrf(1, 1) = invDist;
408 stereoTrf(0, 1) = stereoTrf(1, 0) = -dirDots * invDist;
411 stripMeas->localPosition<1>()[0]};
413 cmbCov (0, 0) = wireMeas->localCovariance<1>()(0,0);
414 cmbCov (1, 1) = stripMeas->localCovariance<1>()(0,0);
417 stereoTrf*cmbCov*stereoTrf.transpose(), sl, state);
432 const Acts::BoundTrackParameters trackPars{state.referenceSurface().getSharedPtr(),
433 state.parameters(), state.covariance(),
434 Acts::ParticleHypothesis::muon()};
435 std::pair<double, double> calibPosCov{
calibratesTGC(ctx, gctx, *primStripMeas, cmbPos[1] , trackPars.position(gctx.
context()), trackPars.direction())};
436 cmbPos[0] = calibPosCov.first;
437 cmbCov(0,0) = calibPosCov.second;
440 cmbPos[1] = secMeas->localPosition<1>()[0];
441 cmbCov(1,1) = secMeas->localCovariance<1>()(0,0);
443 cmbPos[1] = secMeas->localPosition<2>()[1];
444 cmbCov(1,1) = secMeas->localCovariance<2>()(1,1);
446 THROW_EXCEPTION(
"Unexpected secondary measurement type for combined sTGC space point "
451 cmbPos[0] = primMeas->localPosition<2>()[0];
452 cmbCov(0,0) = primMeas->localCovariance<2>()(0,0);
455 cmbPos[1] = secMeas->localPosition<1>()[0];
456 cmbCov(1,1) = secMeas->localCovariance<1>()(0,0);
458 THROW_EXCEPTION(
"Unexpected secondary measurement type for combined sTGC space point "
463 THROW_EXCEPTION(
"Unexpected primary measurement type for combined sTGC space point "
475 const Acts::CalibrationContext& cctx,
476 const Acts::SourceLink& link,
477 ActsTrk::MutableTrackContainer::TrackStateProxy trackState)
const {
480 const Acts::BoundTrackParameters trackPars{trackState.referenceSurface().getSharedPtr(),
481 trackState.parameters(), trackState.covariance(),
482 Acts::ParticleHypothesis::muon()};
487 const EventContext* ctx = cctx.get<
const EventContext*>();
489 <<
" @ surface "<<trackState.referenceSurface().geometryId());
491 if (muonMeas->numDimensions() == 0u) {
500 switch (muonMeas->type()){
502 case MdtDriftCircleType: {
509 static_cast<double>(dec_trackSign(*dc)) :
510 Acts::copySign(1.,trackPars.parameters()[Acts::eBoundLoc0]);
513 if (
ATH_LIKELY(muonMeas->numDimensions() == 1)) {
519 if (calibOutput.
status() != Muon::MdtDriftCircleStatus::MdtStatusDriftTime) {
521 <<std::endl<<calibInput<<std::endl<<calibOutput);
522 cov(Acts::eBoundLoc0,Acts::eBoundLoc0) = std::pow(dc->readoutElement()->innerTubeRadius(), 2);
524 pos[Acts::eBoundLoc0] = driftSign*calibOutput.
driftRadius();
525 cov(Acts::eBoundLoc0, Acts::eBoundLoc0) = std::pow(calibOutput.
driftRadiusUncert(), 2);
532 MdtCalibInput twinInput{twinDC->twinIdentify(), twinDC->twinAdc(), twinDC->twinTdc(), twinDC->readoutElement(), *gctx};
537 std::move(calibInput),
538 std::move(twinInput));
541 if (calibOutput.
primaryStatus() != Muon::MdtDriftCircleStatus::MdtStatusDriftTime) {
543 <<std::endl<<calibOutput);
544 locCov(Acts::eBoundLoc0, Acts::eBoundLoc0) = std::pow(dc->readoutElement()->innerTubeRadius(), 2);
545 locCov(Acts::eBoundLoc1, Acts::eBoundLoc1) = std::pow(0.5* dc->readoutElement()->activeTubeLength(dc->measurementHash()), 2);
547 locCov(Acts::eBoundLoc0, Acts::eBoundLoc0) = std::pow(calibOutput.
uncertPrimaryR(), 2);
548 locCov(Acts::eBoundLoc1, Acts::eBoundLoc1) = std::pow(calibOutput.
sigmaZ(), 2);
549 locPos[Acts::eBoundLoc0] = driftSign*calibOutput.
primaryDriftR();
550 locPos[Acts::eBoundLoc1] = calibOutput.
locZ();
555 }
case RpcStripType: {
558 if (
ATH_LIKELY(rpcClust->numDimensions() == 1)) {
564 rpcClust->localPosition<1>(),
565 rpcClust->localCovariance<1>(), link, trackState);
569 measPars[0] = rpcClust->localPosition<1>()[0];
570 measCov(0,0) = rpcClust->localCovariance<1>()(0, 0);
571 ATH_MSG_WARNING(__FILE__<<
":"<<__LINE__<<
"Please fix me using the ActsInterops package");
576 measPars, measCov, link, trackState);
583 rpcClust->localPosition<2>(),
584 rpcClust->localCovariance<2>(), link, trackState);
588 measPars.block<2,1>(0,0) = xAOD::toEigen(rpcClust->localPosition<2>());
589 measCov.block<2,2>(0,0) = xAOD::toEigen(rpcClust->localCovariance<2>());
590 ATH_MSG_WARNING(__FILE__<<
":"<<__LINE__<<
"Please fix me using the ActsInterops package");
593 measPars, measCov, link, trackState);
597 }
case TgcStripType: {
598 const auto* tgcClust =
static_cast<const xAOD::TgcStrip*
>(muonMeas);
603 tgcClust->localPosition<1>(),
604 tgcClust->localCovariance<1>(), link, trackState);
610 case MMClusterType: {
612 std::pair<double, double> calibPosCov{
calibrateMM(*ctx,* gctx, *mmClust, trackPos, trackDir)};
617 pos, cov, link, trackState);
619 }
case sTgcStripType: {
624 muonMeas->localPosition<1>(),
625 muonMeas->localCovariance<1>(), link, trackState);
628 stgcClust->localPosition<2>(),
629 stgcClust->localCovariance<2>(), link, trackState);
632 std::pair<double, double> calibPosCov{
calibratesTGC(*ctx, *gctx, *stgCluster, std::nullopt, trackPos, trackDir)};
637 pos, cov, link, trackState);
642 pos[0] = calibPosCov.first;
643 pos[1] = stgCluster->time();
644 cov(0,0) = calibPosCov.second;
645 ATH_MSG_WARNING(__FILE__<<
":"<<__LINE__<<
"Please fix me using the ActsInterops package");
646 cov(1,1) = std::pow(25 , 2);
649 pos, cov, link, trackState);
654 THROW_EXCEPTION(
"The parsed measurement is not a muon measurement. Please check.");
663 dec_trackSign(*meas->spacePoint()->primaryMeasurement()) =
664 SeedingAux::strawSign(segPos, segLine, *meas);
#define ATH_CHECK
Evaluate an expression and check for errors.
#define ATH_MSG_VERBOSE(x)
#define ATH_MSG_WARNING(x)
#define AmgSymMatrix(dim)
Acts::GeometryContext context() const
@ e2DimWithTime
Project out the locY & time coordinate - (Applies to Rpc, Tgc, sTgc)
@ e2DimNoTime
Project out solely the locY - Complementary projector if the strip plane is rotated (Applies to Itk e...
@ e1DimWithTime
Project out the two spatial coordinates - (Applies to ITk pixel, BI-Rpc, sTgc pad)
@ e1DimRotNoTime
Project out solely the locX (Applies to Itk strips, Rpc, Tgc, sTgc, Mm)
@ e1DimRotWithTime
Project out the locX & time coordinate - (Applies to Rpc, Tgc, Mm, sTgc)
void setState(const ProjectorType projector, const pos_t &locpos, const cov_t &cov, Acts::SourceLink link, TrackState_t< trajectory_t > &trackState) const
Copy the local position & covariance into the Acts track state proxy.
static const xAOD::UncalibratedMeasurement * unpack(const Acts::SourceLink &sl)
Helper method to unpack an Acts source link to an uncalibrated measurement.
static Acts::SourceLink pack(const xAOD::UncalibratedMeasurement *meas)
Helper method to pack an uncalibrated measurement to an Acts source link.
double driftRadiusUncert() const
Returns the uncertainty on the drift radius.
double driftRadius() const
Returns the drift radius of the calibrated object.
MdtDriftCircleStatus status() const
Status of the calibration.
MdtDriftCircleStatus primaryStatus() const
double primaryDriftR() const
double uncertPrimaryR() const
const Amg::Transform3D & localToGlobalTransform(const ActsTrk::GeometryContext &ctx) const
Returns the transformation from the local coordinate system of the readout element into the global AT...
Amg::Transform3D globalToLocalTransform(const ActsTrk::GeometryContext &ctx) const
Returns the transformation from the global ATLAS coordinate system into the local coordinate system o...
const Amg::Transform3D & localToGlobalTransform(const ActsTrk::GeometryContext &gctx) const
Returns the local -> global tarnsformation from the sector.
The calibrated Space point is created during the calibration process.
double driftRadius() const
: Returns the size of the drift radius
const SpacePoint * spacePoint() const
The pointer to the space point out of which this space point has been built.
xAOD::UncalibMeasType type() const
Returns the space point type.
State
State flag to distinguish different space point states.
State fitState() const
Returns the state of the calibrated space point.
std::unique_ptr< CalibratedSpacePoint > CalibSpacePointPtr
std::vector< CalibSpacePointPtr > CalibSpacePointVec
Placeholder for what will later be the muon segment EDM representation.
const MeasVec & measurements() const
Returns the associated measurements.
Gaudi::Property< bool > m_useRpcTime
Load the Rpc time on the track states for the track fit.
void calibrateCombinedPrd(const EventContext &ctx, const ActsTrk::GeometryContext &gctx, const xAOD::CombinedMuonStrip *combinedPrd, ActsTrk::MutableTrackContainer::TrackStateProxy state) const
Calibrates the track states from a combined muon strip.
ToolHandle< Muon::IMMClusterBuilderTool > m_clusterBuilderToolMM
void calibrateSourceLink(const Acts::GeometryContext &geoctx, const Acts::CalibrationContext &cctx, const Acts::SourceLink &link, ActsTrk::MutableTrackContainer::TrackStateProxy state) const override final
ToolHandle< Muon::INSWCalibTool > m_nswCalibTool
std::pair< double, double > calibratesTGC(const EventContext &ctx, const ActsTrk::GeometryContext &gctx, const xAOD::sTgcStripCluster &cluster, std::optional< double > posAlongTheStrip, const Amg::Vector3D &globalPos, const Amg::Vector3D &globalDir) const
Calibrates the position and covariance of an sTGC (small-strip Thin Gap Chamber) cluster.
double driftVelocity(const Acts::CalibrationContext &ctx, const CalibratedSpacePoint &spacePoint) const override final
ToolHandle< IMdtCalibrationTool > m_mdtCalibrationTool
CalibSpacePointPtr calibrate(const EventContext &ctx, const SpacePoint *spacePoint, const Amg::Vector3D &seedPosInChamb, const Amg::Vector3D &seedDirInChamb, const double timeDelay) const override final
Gaudi::Property< double > m_rpcSignalVelocity
How fast does an electron signal travel along an rpc strip.
void updateSigns(const Amg::Vector3D &trackPos, const Amg::Vector3D &trackDir, CalibSpacePointVec &hitsToCalib) const override final
StatusCode initialize() override final
ServiceHandle< Muon::IMuonIdHelperSvc > m_idHelperSvc
const MuonGMR4::MuonDetectorManager * m_detMgr
Gaudi::Property< bool > m_MdtSignFromSegment
Gaudi::Property< bool > m_useTgcTime
Load the Tgc bunch crossing ID on the track states.
SG::ReadHandleKey< ActsTrk::GeometryContext > m_geoCtxKey
access to the ACTS geometry context
Gaudi::Property< bool > m_usesTgcTime
double driftAcceleration(const Acts::CalibrationContext &ctx, const CalibratedSpacePoint &spacePoint) const override final
Gaudi::Property< double > m_rpcTimeResolution
std::pair< double, double > calibrateMM(const EventContext &ctx, const ActsTrk::GeometryContext &gctx, const xAOD::MMCluster &cluster, const Amg::Vector3D &globalPos, const Amg::Vector3D &globalDir) const
Calibrates the position and covariance of a MicroMegas (MM) cluster.
void stampSignsOnMeasurements(const xAOD::MuonSegment &segment) const override final
The muon space point is the combination of two uncalibrated measurements one of them measures the eta...
unsigned dimension() const
Is the space point a 1D or combined 2D measurement.
const Amg::Vector3D & sensorDirection() const
const xAOD::UncalibratedMeasurement * secondaryMeasurement() const
const Amg::Vector3D & localPosition() const
std::array< double, 3 > Cov_t
Abrivation of the covariance type.
const Identifier & identify() const
: Identifier of the primary measurement
xAOD::UncalibMeasType type() const
const Cov_t & covariance() const
Returns the covariance array.
const xAOD::UncalibratedMeasurement * primaryMeasurement() const
const MuonGMR4::SpectrometerSector * msSector() const
Helper class to provide type-safe access to aux data.
const xAOD::UncalibratedMeasurement * secondaryStrip() const
Returns the secondary associated measurement.
const xAOD::UncalibratedMeasurement * primaryStrip() const
Returns the primary associated measurement.
virtual xAOD::UncalibMeasType type() const override final
Returns the type of the measurement type as a simple enumeration.
const Identifier & identify() const
: Returns the Athena identifier of the micro mega cluster It's constructed from the measurementHash &...
IdentifierHash layerHash() const
Returns the hash of the associated layer (Needed for surface retrieval)
const MuonGMR4::MmReadoutElement * readoutElement() const
Retrieve the associated MmReadoutElement.
ConstMatrixMap< N > localCovariance() const
Returns the local covariance of the measurement.
ConstVectorMap< N > localPosition() const
Returns the local position of the measurement.
IdentifierHash layerHash() const
Returns the hash of the associated gasGap layer.
const MuonGMR4::sTgcReadoutElement * readoutElement() const
Retrieve the associated sTgcReadoutElement.
std::optional< double > intersect(const AmgVector(N)&posA, const AmgVector(N)&dirA, const AmgVector(N)&posB, const AmgVector(N)&dirB)
Calculates the point B' along the line B that's closest to a second line A.
std::string toString(const Translation3D &translation, int precision=4)
GeoPrimitvesToStringConverter.
Eigen::Matrix< double, Eigen::Dynamic, Eigen::Dynamic > MatrixX
Dynamic Matrix - dynamic allocation.
Eigen::Affine3d Transform3D
Eigen::Matrix< double, 2, 1 > Vector2D
Eigen::Matrix< double, 3, 1 > Vector3D
Parameters localSegmentPars(const xAOD::MuonSegment &seg)
Returns the localSegPars decoration from a xAODMuon::Segment.
std::pair< Amg::Vector3D, Amg::Vector3D > makeLine(const Parameters &pars)
Returns the parsed parameters into an Eigen line parametrization.
This header ties the generic definitions in this package.
ISpacePointCalibrator::CalibSpacePointVec CalibSpacePointVec
CalibratedSpacePoint::State State
ISpacePointCalibrator::CalibSpacePointPtr CalibSpacePointPtr
const Segment * detailedSegment(const xAOD::MuonSegment &seg)
Helper function to navigate from the xAOD::MuonSegment to the MuonR4::Segment.
Amg::Vector3D toLocal(const Amg::Transform3D &toLocalTrans, const Amg::Vector3D &dir)
Rotates a direction vector into a local frame: x-axis : Parallell to the radial direction of the dete...
const T * get(const ReadCondHandleKey< T > &key, const EventContext &ctx)
Convenience function to retrieve an object given a ReadCondHandleKey.
MdtDriftCircle_v1 MdtDriftCircle
MdtTwinDriftCircle_v1 MdtTwinDriftCircle
sTgcStripCluster_v1 sTgcStripCluster
UncalibMeasType
Define the type of the uncalibrated measurement.
const Identifier & identify(const UncalibratedMeasurement *meas)
Returns the associated identifier from the muon measurement.
RpcMeasurement_v1 RpcMeasurement
sTgcMeasurement_v1 sTgcMeasurement
MuonSegment_v1 MuonSegment
Reference the current persistent version:
CombinedMuonStrip_v1 CombinedMuonStrip
class which holds the full set of calibration constants for a given tube
#define THROW_EXCEPTION(MESSAGE)