#include <Alignment/GlobalTrackerMuonAlignment/src/GlobalTrackerMuonAlignment.cc>
Static Public Member Functions | |
static void | fillDescriptions (edm::ConfigurationDescriptions &descriptions) |
Static Public Member Functions inherited from edm::one::EDAnalyzerBase | |
static const std::string & | baseType () |
static void | fillDescriptions (ConfigurationDescriptions &descriptions) |
static void | prevalidate (ConfigurationDescriptions &descriptions) |
Private Member Functions | |
void | analyze (const edm::Event &, const edm::EventSetup &) override |
void | beginJob () override |
void | endJob () override |
Additional Inherited Members | |
Public Types inherited from edm::one::EDAnalyzerBase | |
typedef EDAnalyzerBase | ModuleType |
Public Types inherited from edm::EDConsumerBase | |
typedef ProductLabels | Labels |
Protected Member Functions inherited from edm::EDConsumerBase | |
template<typename ProductType , BranchType B = InEvent> | |
EDGetTokenT< ProductType > | consumes (edm::InputTag const &tag) |
template<BranchType B = InEvent> | |
EDConsumerBaseAdaptor< B > | consumes (edm::InputTag tag) noexcept |
EDGetToken | consumes (const TypeToGet &id, edm::InputTag const &tag) |
template<BranchType B> | |
EDGetToken | consumes (TypeToGet const &id, edm::InputTag const &tag) |
ConsumesCollector | consumesCollector () |
Use a ConsumesCollector to gather consumes information from helper functions. More... | |
template<typename ESProduct , typename ESRecord , Transition Tr = Transition::Event> | |
auto | esConsumes () |
template<typename ESProduct , typename ESRecord , Transition Tr = Transition::Event> | |
auto | esConsumes (ESInputTag const &tag) |
template<Transition Tr = Transition::Event> | |
constexpr auto | esConsumes () |
template<Transition Tr = Transition::Event> | |
auto | esConsumes (ESInputTag tag) |
template<Transition Tr = Transition::Event> | |
ESGetTokenGeneric | esConsumes (eventsetup::EventSetupRecordKey const &iRecord, eventsetup::DataKey const &iKey) |
Used with EventSetupRecord::doGet. More... | |
template<typename ProductType , BranchType B = InEvent> | |
EDGetTokenT< ProductType > | mayConsume (edm::InputTag const &tag) |
EDGetToken | mayConsume (const TypeToGet &id, edm::InputTag const &tag) |
template<BranchType B> | |
EDGetToken | mayConsume (const TypeToGet &id, edm::InputTag const &tag) |
void | resetItemsToGetFrom (BranchType iType) |
Description: Producer of relative tracker and muon system alignment
Implementation: A sample of global muons is used for the aligning tracker and muon system relatively as "rigid bodies", i.e. determining offset and rotation (6 numbers)
Definition at line 108 of file GlobalTrackerMuonAlignment.cc.
|
explicit |
Definition at line 290 of file GlobalTrackerMuonAlignment.cc.
References cosmicMuonMode_, Exception, and isolatedMuonMode_.
|
overridedefault |
|
overrideprivatevirtual |
Implements edm::one::EDAnalyzerBase.
Definition at line 359 of file GlobalTrackerMuonAlignment.cc.
References analyzeTrackTrajectory(), and iEvent.
void GlobalTrackerMuonAlignment::analyzeTrackTrack | ( | const edm::Event & | iEvent, |
const edm::EventSetup & | iSetup | ||
) |
Definition at line 625 of file GlobalTrackerMuonAlignment.cc.
References alongMomentum, Matriplex::atan2(), TrajectoryStateOnSurface::cartesianError(), edm::ESWatcher< T >::check(), collectionCosmic, collectionIsolated, cosmicMuonMode_, debug_, Vector3DBase< T, FrameTag >::dot(), MillePedeFileConverter_cfg::e, DetId::Ecal, geometryDiff::epsilon, TrajectoryStateOnSurface::freeState(), edm::EventSetup::getHandle(), TrajectoryStateOnSurface::globalMomentum(), TrajectoryStateOnSurface::globalPosition(), globalPositionRcd_, gmuonCosmicToken_, gmuonIsolateToken_, gmuonToken_, gradientGlobal(), gradientGlobalAlg(), gradientLocal(), DetId::Hcal, histo, histo101, histo102, histo11, histo12, histo13, histo14, histo15, histo16, histo17, histo18, histo19, histo2, histo20, histo21, histo22, histo23, histo24, histo25, histo26, histo27, histo28, histo29, histo3, histo30, histo31, histo32, histo33, histo34, histo35, histo4, histo5, histo6, histo7, histo8, mps_fire::i, iEvent, info(), createfilelist::int, isolatedMuonMode_, TrajectoryStateOnSurface::isValid(), iteratorEcalRcd, iteratorHcalRcd, iteratorMuonRcd, iteratorTrackerRcd, dqmiolumiharvest::j, TrajectoryStateOnSurface::localError(), TrajectoryStateOnSurface::localParameters(), visualization-live-secondInstance_cfg::m, Alignments::m_align, m_globalPosToken, m_MagFieldToken, m_propToken, m_TkGeometryToken, PV3DBase< T, PVType, FrameType >::mag(), mag(), HLT_2024v14_cff::magneticField, magneticField_, CartesianTrajectoryError::matrix(), LocalTrajectoryError::matrix(), misalignMuonL(), DetId::Muon, muonCosmicToken_, muonIsolateToken_, DiMuonV_cfg::muons, muonToken_, MuSelect, N_event, N_track, Plane::normalVector(), oppositeToMomentum, PV3DBase< T, PVType, FrameType >::perp(), GloballyPositioned< T >::position(), SmartPropagator::propagate(), TrackCandidateProducer_cfi::propagator, defaultRKPropagator::Product::propagator, DetId::rawId(), GloballyPositioned< T >::rotation(), SmartPropagator_cfi::SmartPropagator, smuonCosmicToken_, smuonIsolateToken_, smuonToken_, mathSSE::sqrt(), SteppingHelixPropagator_cfi::SteppingHelixPropagator, TrajectoryStateOnSurface::surface(), Surface::tangentPlane(), trackCosmicToken_, DetId::Tracker, trackingGeometry_, trackIsolateToken_, DiMuonV_cfg::tracks, trackToken_, LocalTrajectoryParameters::vector(), watchGlobalPositionRcd_, watchMagneticFieldRecord_, watchTrackingGeometry_, x, PV3DBase< T, PVType, FrameType >::x(), TkRotation< T >::xx(), TkRotation< T >::xy(), TkRotation< T >::xz(), y, PV3DBase< T, PVType, FrameType >::y(), TkRotation< T >::yx(), TkRotation< T >::yy(), TkRotation< T >::yz(), z, PV3DBase< T, PVType, FrameType >::z(), TkRotation< T >::zx(), TkRotation< T >::zy(), and TkRotation< T >::zz().
void GlobalTrackerMuonAlignment::analyzeTrackTrajectory | ( | const edm::Event & | iEvent, |
const edm::EventSetup & | iSetup | ||
) |
Definition at line 1309 of file GlobalTrackerMuonAlignment.cc.
References alongMomentum, Matriplex::atan2(), TrajectoryStateOnSurface::cartesianError(), edm::ESWatcher< T >::check(), Chi2MeasurementEstimator_cfi::Chi2MeasurementEstimator, collectionCosmic, collectionIsolated, cosmicMuonMode_, debug_, debugTrajectorySOS(), defineFitter, Vector3DBase< T, FrameTag >::dot(), MillePedeFileConverter_cfg::e, DetId::Ecal, geometryDiff::epsilon, TrajectoryStateOnSurface::freeState(), edm::EventSetup::getHandle(), TrajectoryStateOnSurface::globalMomentum(), TrajectoryStateOnSurface::globalPosition(), globalPositionRcd_, gmuonCosmicToken_, gmuonIsolateToken_, gmuonToken_, gradientGlobal(), gradientGlobalAlg(), gradientLocal(), DetId::Hcal, histo, histo101, histo102, histo11, histo12, histo13, histo14, histo15, histo16, histo17, histo18, histo19, histo2, histo20, histo21, histo22, histo23, histo24, histo25, histo26, histo27, histo28, histo29, histo3, histo30, histo31, histo32, histo33, histo34, histo35, histo4, histo5, histo6, histo7, histo8, mps_fire::i, iEvent, info(), createfilelist::int, isolatedMuonMode_, edm::ESHandleBase::isValid(), TrajectoryStateOnSurface::isValid(), iteratorEcalRcd, iteratorHcalRcd, iteratorMuonRcd, iteratorTrackerRcd, dqmiolumiharvest::j, TrajectoryStateOnSurface::localError(), TrajectoryStateOnSurface::localParameters(), visualization-live-secondInstance_cfg::m, Alignments::m_align, m_globalPosToken, m_MagFieldToken, m_propToken, m_TkGeometryToken, m_ttrhBuilderToken, PV3DBase< T, PVType, FrameType >::mag(), mag(), HLT_2024v14_cff::magneticField, magneticField_, CartesianTrajectoryError::matrix(), LocalTrajectoryError::matrix(), misalignMuonL(), DetId::Muon, muonCosmicToken_, muonFitter(), muonIsolateToken_, DiMuonV_cfg::muons, muonToken_, MuRHBuilder, MuSelect, N_event, N_track, Plane::normalVector(), oppositeToMomentum, PV3DBase< T, PVType, FrameType >::perp(), GloballyPositioned< T >::position(), SmartPropagator::propagate(), TrackCandidateProducer_cfi::propagator, defaultRKPropagator::Product::propagator, DetId::rawId(), refitMuon_, refitTrack_, GloballyPositioned< T >::rotation(), SmartPropagator_cfi::SmartPropagator, smuonCosmicToken_, smuonIsolateToken_, smuonToken_, mathSSE::sqrt(), SteppingHelixPropagator_cfi::SteppingHelixPropagator, TrajectoryStateOnSurface::surface(), Surface::tangentPlane(), theFitter, theFitterOp, theSmoother, theSmootherOp, theTrackingGeometry, trackCosmicToken_, DetId::Tracker, trackFitter(), trackingGeometry_, trackIsolateToken_, DiMuonV_cfg::tracks, trackToken_, TTRHBuilder, LocalTrajectoryParameters::vector(), watchGlobalPositionRcd_, watchMagneticFieldRecord_, watchTrackingGeometry_, x, PV3DBase< T, PVType, FrameType >::x(), TkRotation< T >::xx(), TkRotation< T >::xy(), TkRotation< T >::xz(), y, PV3DBase< T, PVType, FrameType >::y(), TkRotation< T >::yx(), TkRotation< T >::yy(), TkRotation< T >::yz(), z, PV3DBase< T, PVType, FrameType >::z(), TkRotation< T >::zx(), TkRotation< T >::zy(), and TkRotation< T >::zz().
Referenced by analyze().
|
overrideprivatevirtual |
Reimplemented from edm::one::EDAnalyzerBase.
Definition at line 365 of file GlobalTrackerMuonAlignment.cc.
References bookHist(), collectionCosmic, collectionIsolated, cosmicMuonMode_, file, Gfr, Grad, GradL, Hess, HessL, mps_fire::i, Inf, isolatedMuonMode_, dqmiolumiharvest::j, N_event, N_track, and rootOutFile_.
void GlobalTrackerMuonAlignment::bookHist | ( | ) |
Definition at line 523 of file GlobalTrackerMuonAlignment.cc.
References histo, histo101, histo102, histo11, histo12, histo13, histo14, histo15, histo16, histo17, histo18, histo19, histo2, histo20, histo21, histo22, histo23, histo24, histo25, histo26, histo27, histo28, histo29, histo3, histo30, histo31, histo32, histo33, histo34, histo35, histo4, histo5, histo6, histo7, and histo8.
Referenced by beginJob().
|
inline |
Definition at line 148 of file GlobalTrackerMuonAlignment.cc.
Referenced by gradientGlobal(), gradientLocal(), misalignMuon(), and misalignMuonL().
void GlobalTrackerMuonAlignment::debugTrackHit | ( | const std::string | title, |
reco::TrackRef | alongTr | ||
) |
Definition at line 3312 of file GlobalTrackerMuonAlignment.cc.
References DetId::Muon, runGCPTkAlMap::title, and DetId::Tracker.
Referenced by muonFitter(), and trackFitter().
void GlobalTrackerMuonAlignment::debugTrackHit | ( | const std::string | title, |
reco::TransientTrack & | alongTr | ||
) |
Definition at line 3293 of file GlobalTrackerMuonAlignment.cc.
References mps_fire::i, DetId::Muon, reco::TransientTrack::recHitsBegin(), reco::TransientTrack::recHitsEnd(), runGCPTkAlMap::title, and DetId::Tracker.
void GlobalTrackerMuonAlignment::debugTrajectory | ( | const std::string | title, |
Trajectory & | traj | ||
) |
Definition at line 3389 of file GlobalTrackerMuonAlignment.cc.
References alongMomentum, Trajectory::chiSquared(), debugTrajectorySOSv(), Trajectory::direction(), Trajectory::firstMeasurement(), Trajectory::foundHits(), Trajectory::isValid(), Trajectory::lastMeasurement(), runGCPTkAlMap::title, and TrajectoryMeasurement::updatedState().
Referenced by muonFitter(), and trackFitter().
void GlobalTrackerMuonAlignment::debugTrajectorySOS | ( | const std::string | title, |
TrajectoryStateOnSurface & | trajSOS | ||
) |
Definition at line 3331 of file GlobalTrackerMuonAlignment.cc.
References TrajectoryStateOnSurface::cartesianError(), TrajectoryStateOnSurface::charge(), TrajectoryStateOnSurface::globalMomentum(), TrajectoryStateOnSurface::globalParameters(), TrajectoryStateOnSurface::globalPosition(), TrajectoryStateOnSurface::isValid(), TrajectoryStateOnSurface::localError(), TrajectoryStateOnSurface::localParameters(), PV3DBase< T, PVType, FrameType >::mag(), CartesianTrajectoryError::matrix(), LocalTrajectoryError::matrix(), PV3DBase< T, PVType, FrameType >::perp(), mathSSE::sqrt(), runGCPTkAlMap::title, GlobalTrajectoryParameters::vector(), and LocalTrajectoryParameters::vector().
Referenced by analyzeTrackTrajectory(), muonFitter(), and trackFitter().
void GlobalTrackerMuonAlignment::debugTrajectorySOSv | ( | const std::string | title, |
TrajectoryStateOnSurface | trajSOS | ||
) |
Definition at line 3360 of file GlobalTrackerMuonAlignment.cc.
References TrajectoryStateOnSurface::cartesianError(), TrajectoryStateOnSurface::charge(), TrajectoryStateOnSurface::globalMomentum(), TrajectoryStateOnSurface::globalParameters(), TrajectoryStateOnSurface::globalPosition(), TrajectoryStateOnSurface::isValid(), TrajectoryStateOnSurface::localError(), TrajectoryStateOnSurface::localParameters(), PV3DBase< T, PVType, FrameType >::mag(), CartesianTrajectoryError::matrix(), LocalTrajectoryError::matrix(), PV3DBase< T, PVType, FrameType >::perp(), mathSSE::sqrt(), runGCPTkAlMap::title, GlobalTrajectoryParameters::vector(), and LocalTrajectoryParameters::vector().
Referenced by debugTrajectory(), muonFitter(), and trackFitter().
|
overrideprivatevirtual |
Reimplemented from edm::one::EDAnalyzerBase.
Definition at line 408 of file GlobalTrackerMuonAlignment.cc.
References collectionCosmic, collectionIsolated, ztail::d, debug_, file, fitHist(), Gfr, Grad, GradL, Hess, HessL, mps_fire::i, Inf, dqmiolumiharvest::j, isotrackApplyRegressor::k, MuGlAngle, MuGlShift, MuSelect, N_event, N_track, MillePedeFileConverter_cfg::out, OutGlobalTxt, smuonTags_, mathSSE::sqrt(), txtOutFile_, writeDB_, and writeGlPosRcd().
Referenced by o2olib.O2ORunMgr::executeJob().
|
static |
Definition at line 337 of file GlobalTrackerMuonAlignment.cc.
References edm::ConfigurationDescriptions::add(), submitPVResolutionJobs::desc, ProducerED_cfi::InputTag, and AlCaHLTBitMon_QueryRunRegistry::string.
void GlobalTrackerMuonAlignment::fitHist | ( | ) |
void GlobalTrackerMuonAlignment::gradientGlobal | ( | GlobalVector & | GRt, |
GlobalVector & | GPt, | ||
GlobalVector & | GRm, | ||
GlobalVector & | GPm, | ||
GlobalVector & | GNorm, | ||
AlgebraicSymMatrix66 & | GCov | ||
) |
Definition at line 2187 of file GlobalTrackerMuonAlignment.cc.
References A, a, B, CLHEP_dot(), ztail::d, debug_, dumpMFGeometry_cfg::delta, MillePedeFileConverter_cfg::e, Grad, Hess, mps_fire::i, cuy::ii, info(), dqmiolumiharvest::j, AlCaHLTBitMon_ParallelJobs::p, alignCSCRings::r, alignCSCRings::s, mathSSE::sqrt(), cms::cuda::V, w(), PV3DBase< T, PVType, FrameType >::x(), PV3DBase< T, PVType, FrameType >::y(), and PV3DBase< T, PVType, FrameType >::z().
Referenced by analyzeTrackTrack(), and analyzeTrackTrajectory().
void GlobalTrackerMuonAlignment::gradientGlobalAlg | ( | GlobalVector & | Rt, |
GlobalVector & | Pt, | ||
GlobalVector & | Rm, | ||
GlobalVector & | Nl, | ||
AlgebraicSymMatrix66 & | Cm | ||
) |
Definition at line 2095 of file GlobalTrackerMuonAlignment.cc.
References debug_, HGC3DClusterGenMatchSelector_cfi::dR, MillePedeFileConverter_cfg::e, Gfr, mps_fire::i, Inf, dqmiolumiharvest::j, isotrackApplyRegressor::k, mathSSE::sqrt(), PV3DBase< T, PVType, FrameType >::x(), PV3DBase< T, PVType, FrameType >::y(), and PV3DBase< T, PVType, FrameType >::z().
Referenced by analyzeTrackTrack(), and analyzeTrackTrajectory().
void GlobalTrackerMuonAlignment::gradientLocal | ( | GlobalVector & | GRt, |
GlobalVector & | GPt, | ||
GlobalVector & | GRm, | ||
GlobalVector & | GPm, | ||
GlobalVector & | GNorm, | ||
CLHEP::HepSymMatrix & | covLoc, | ||
CLHEP::HepMatrix & | rotLoc, | ||
CLHEP::HepVector & | R0, | ||
AlgebraicVector4 & | LPRm | ||
) |
Definition at line 2379 of file GlobalTrackerMuonAlignment.cc.
References CLHEP_dot(), debug_, dumpMFGeometry_cfg::delta, GradL, HessL, mps_fire::i, cuy::ii, info(), dqmiolumiharvest::j, HLT_2024v14_cff::R0, mathSSE::sqrt(), cms::cuda::V, PV3DBase< T, PVType, FrameType >::x(), PV3DBase< T, PVType, FrameType >::y(), and PV3DBase< T, PVType, FrameType >::z().
Referenced by analyzeTrackTrack(), and analyzeTrackTrajectory().
void GlobalTrackerMuonAlignment::misalignMuon | ( | GlobalVector & | GRm, |
GlobalVector & | GPm, | ||
GlobalVector & | Nl, | ||
GlobalVector & | Rt, | ||
GlobalVector & | Rm, | ||
GlobalVector & | Pm | ||
) |
Definition at line 2642 of file GlobalTrackerMuonAlignment.cc.
References A, a, B, alignmentValidation::c1, CLHEP_dot(), funct::cos(), ztail::d, debug_, MuGlAngle, MuGlShift, alignCSCRings::s, funct::sin(), PV3DBase< T, PVType, FrameType >::x(), PV3DBase< T, PVType, FrameType >::y(), and PV3DBase< T, PVType, FrameType >::z().
void GlobalTrackerMuonAlignment::misalignMuonL | ( | GlobalVector & | GRm, |
GlobalVector & | GPm, | ||
GlobalVector & | Nl, | ||
GlobalVector & | Rt, | ||
GlobalVector & | Rm, | ||
GlobalVector & | Pm, | ||
AlgebraicVector4 & | Vm, | ||
TrajectoryStateOnSurface & | tsosTrack, | ||
TrajectoryStateOnSurface & | tsosMuon | ||
) |
Definition at line 2791 of file GlobalTrackerMuonAlignment.cc.
References A, a, Matriplex::atan2(), B, alignmentValidation::c1, CLHEP_dot(), funct::cos(), ztail::d, debug_, cuy::ii, TrajectoryStateOnSurface::localParameters(), MuGlAngle, MuGlShift, GloballyPositioned< T >::position(), LocalTrajectoryParameters::pzSign(), HLT_2024v14_cff::R0, GloballyPositioned< T >::rotation(), alignCSCRings::s, funct::sin(), mathSSE::sqrt(), TrajectoryStateOnSurface::surface(), LocalTrajectoryParameters::vector(), PV3DBase< T, PVType, FrameType >::x(), TkRotation< T >::xx(), TkRotation< T >::xy(), TkRotation< T >::xz(), PV3DBase< T, PVType, FrameType >::y(), TkRotation< T >::yx(), TkRotation< T >::yy(), TkRotation< T >::yz(), PV3DBase< T, PVType, FrameType >::z(), TkRotation< T >::zx(), TkRotation< T >::zy(), and TkRotation< T >::zz().
Referenced by analyzeTrackTrack(), and analyzeTrackTrajectory().
void GlobalTrackerMuonAlignment::muonFitter | ( | reco::TrackRef | alongTr, |
reco::TransientTrack & | alongTTr, | ||
PropagationDirection | direction, | ||
TrajectoryStateOnSurface & | trackFittedTSOS | ||
) |
Definition at line 3192 of file GlobalTrackerMuonAlignment.cc.
References alongMomentum, MuonTransientTrackingRecHitBuilder::build(), edm::OwnVector< T, P >::clear(), debugTrackHit(), debugTrajectory(), debugTrajectorySOS(), debugTrajectorySOSv(), info(), reco::TransientTrack::innermostMeasurementState(), TrajectoryStateOnSurface::localError(), TrajectoryStateOnSurface::localParameters(), magneticField_, LocalTrajectoryError::matrix(), MuRHBuilder, reco::TransientTrack::outermostMeasurementState(), trajectoryStateTransform::persistentState(), DetId::rawId(), rpcPointValidation_cfi::recHit, reco::TransientTrack::recHitsBegin(), reco::TransientTrack::recHitsEnd(), edm::OwnVector< T, P >::size(), TrajectoryStateOnSurface::surface(), theFitter, theFitterOp, theSmoother, theSmootherOp, and TrajectorySmoother::trajectories().
Referenced by analyzeTrackTrajectory().
void GlobalTrackerMuonAlignment::trackFitter | ( | reco::TrackRef | alongTr, |
reco::TransientTrack & | alongTTr, | ||
PropagationDirection | direction, | ||
TrajectoryStateOnSurface & | trackFittedTSOS | ||
) |
Definition at line 3076 of file GlobalTrackerMuonAlignment.cc.
References alongMomentum, TransientTrackingRecHitBuilder::build(), edm::OwnVector< T, P >::clear(), debugTrackHit(), debugTrajectory(), debugTrajectorySOS(), debugTrajectorySOSv(), info(), reco::TransientTrack::innermostMeasurementState(), TrajectoryStateOnSurface::localError(), TrajectoryStateOnSurface::localParameters(), magneticField_, LocalTrajectoryError::matrix(), reco::TransientTrack::outermostMeasurementState(), trajectoryStateTransform::persistentState(), DetId::rawId(), rpcPointValidation_cfi::recHit, edm::OwnVector< T, P >::size(), TrajectoryStateOnSurface::surface(), theFitter, theFitterOp, theSmoother, theSmootherOp, TrajectorySmoother::trajectories(), and TTRHBuilder.
Referenced by analyzeTrackTrajectory().
void GlobalTrackerMuonAlignment::writeGlPosRcd | ( | CLHEP::HepVector & | d3 | ) |
Definition at line 3409 of file GlobalTrackerMuonAlignment.cc.
References alignmentValidation::c1, l1tPhase2CaloJetEmulator_cfi::calo, DetId::Calo, funct::cos(), cond::service::PoolDBOutputService::currentTime(), debug_, bsc_activity_cfg::ecal, DetId::Ecal, DetId::Hcal, hltEgammaHLTExtra_cfi::hcal, edm::Service< T >::isAvailable(), iteratorEcalRcd, iteratorHcalRcd, iteratorMuonRcd, iteratorTrackerRcd, DetId::Muon, HLT_2024v14_cff::muon, DetId::rawId(), nano_mu_digi_cff::rawId, funct::sin(), DetId::Tracker, PbPb_ZMuSkimMuonDPG_cff::tracker, and cond::service::PoolDBOutputService::writeOneIOV().
Referenced by endJob().
|
private |
Definition at line 171 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), beginJob(), and endJob().
|
private |
Definition at line 172 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), beginJob(), and endJob().
|
private |
Definition at line 169 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), beginJob(), and GlobalTrackerMuonAlignment().
|
private |
Definition at line 178 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), endJob(), gradientGlobal(), gradientGlobalAlg(), gradientLocal(), misalignMuon(), misalignMuonL(), and writeGlPosRcd().
|
private |
Definition at line 209 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrajectory().
|
private |
Definition at line 239 of file GlobalTrackerMuonAlignment.cc.
Referenced by beginJob(), python.rootplot.utilities.RootFile::cd(), endJob(), ztee.GZipLog::finish(), ztee.GZipLog::flush_block(), python.rootplot.utilities.RootFile::get(), tfile.TFileService::stop(), core.VertexHistograms.VertexHistograms::write(), core.TreeAnalyzerNumpy.TreeAnalyzerNumpy::write(), and ztee.GZipLog::write_block().
|
private |
Definition at line 214 of file GlobalTrackerMuonAlignment.cc.
Referenced by beginJob(), endJob(), and gradientGlobalAlg().
|
private |
Definition at line 203 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), and analyzeTrackTrajectory().
|
private |
Definition at line 186 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), and analyzeTrackTrajectory().
|
private |
Definition at line 182 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), and analyzeTrackTrajectory().
|
private |
Definition at line 166 of file GlobalTrackerMuonAlignment.cc.
|
private |
Definition at line 190 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), and analyzeTrackTrajectory().
|
private |
Definition at line 217 of file GlobalTrackerMuonAlignment.cc.
Referenced by beginJob(), endJob(), and gradientGlobal().
|
private |
Definition at line 220 of file GlobalTrackerMuonAlignment.cc.
Referenced by beginJob(), endJob(), and gradientLocal().
|
private |
Definition at line 218 of file GlobalTrackerMuonAlignment.cc.
Referenced by beginJob(), endJob(), and gradientGlobal().
|
private |
Definition at line 221 of file GlobalTrackerMuonAlignment.cc.
Referenced by beginJob(), endJob(), and gradientLocal().
|
private |
Definition at line 240 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), and bookHist().
|
private |
Definition at line 275 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), and bookHist().
|
private |
Definition at line 276 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), and bookHist().
|
private |
Definition at line 249 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), and bookHist().
|
private |
Definition at line 250 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), bookHist(), and fitHist().
|
private |
Definition at line 251 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), bookHist(), and fitHist().
|
private |
Definition at line 252 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), bookHist(), and fitHist().
|
private |
Definition at line 253 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), bookHist(), and fitHist().
|
private |
Definition at line 254 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), bookHist(), and fitHist().
|
private |
Definition at line 255 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), bookHist(), and fitHist().
|
private |
Definition at line 256 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), and bookHist().
|
private |
Definition at line 257 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), and bookHist().
|
private |
Definition at line 241 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), and bookHist().
|
private |
Definition at line 258 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), and bookHist().
|
private |
Definition at line 259 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), bookHist(), and fitHist().
|
private |
Definition at line 260 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), bookHist(), and fitHist().
|
private |
Definition at line 261 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), bookHist(), and fitHist().
|
private |
Definition at line 262 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), bookHist(), and fitHist().
|
private |
Definition at line 263 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), bookHist(), and fitHist().
|
private |
Definition at line 264 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), bookHist(), and fitHist().
|
private |
Definition at line 265 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), and bookHist().
|
private |
Definition at line 266 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), and bookHist().
|
private |
Definition at line 267 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), and bookHist().
|
private |
Definition at line 242 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), and bookHist().
|
private |
Definition at line 268 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), and bookHist().
|
private |
Definition at line 269 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), and bookHist().
|
private |
Definition at line 270 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), bookHist(), and fitHist().
|
private |
Definition at line 271 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), bookHist(), and fitHist().
|
private |
Definition at line 272 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), bookHist(), and fitHist().
|
private |
Definition at line 273 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), bookHist(), and fitHist().
|
private |
Definition at line 243 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), and bookHist().
|
private |
Definition at line 244 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), and bookHist().
|
private |
Definition at line 245 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), and bookHist().
|
private |
Definition at line 246 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), bookHist(), and fitHist().
|
private |
Definition at line 247 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), and bookHist().
|
private |
Definition at line 215 of file GlobalTrackerMuonAlignment.cc.
Referenced by beginJob(), endJob(), and gradientGlobalAlg().
|
private |
Definition at line 170 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), beginJob(), and GlobalTrackerMuonAlignment().
|
private |
Definition at line 229 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), and writeGlPosRcd().
|
private |
Definition at line 230 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), and writeGlPosRcd().
|
private |
Definition at line 228 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), and writeGlPosRcd().
|
private |
Definition at line 227 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), and writeGlPosRcd().
|
private |
Definition at line 160 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), and analyzeTrackTrajectory().
|
private |
Definition at line 159 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), and analyzeTrackTrajectory().
|
private |
Definition at line 161 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), and analyzeTrackTrajectory().
|
private |
Definition at line 158 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), and analyzeTrackTrajectory().
|
private |
Definition at line 162 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrajectory().
|
private |
Definition at line 198 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), muonFitter(), and trackFitter().
|
private |
Definition at line 233 of file GlobalTrackerMuonAlignment.cc.
Referenced by endJob(), misalignMuon(), and misalignMuonL().
|
private |
Definition at line 232 of file GlobalTrackerMuonAlignment.cc.
Referenced by endJob(), misalignMuon(), and misalignMuonL().
|
private |
Definition at line 185 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), and analyzeTrackTrajectory().
|
private |
Definition at line 181 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), and analyzeTrackTrajectory().
|
private |
Definition at line 165 of file GlobalTrackerMuonAlignment.cc.
|
private |
Definition at line 189 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), and analyzeTrackTrajectory().
|
private |
Definition at line 210 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrajectory(), and muonFitter().
|
private |
Definition at line 235 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), and endJob().
|
private |
Definition at line 223 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), beginJob(), and endJob().
|
private |
Definition at line 224 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), analyzeTrackTrajectory(), beginJob(), and endJob().
|
private |
Definition at line 237 of file GlobalTrackerMuonAlignment.cc.
Referenced by endJob().
|
private |
Definition at line 168 of file GlobalTrackerMuonAlignment.cc.
|
private |
Definition at line 173 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrajectory().
|
private |
Definition at line 174 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrajectory().
|
private |
Definition at line 175 of file GlobalTrackerMuonAlignment.cc.
Referenced by beginJob().
|
private |
Definition at line 187 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), and analyzeTrackTrajectory().
|
private |
Definition at line 183 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), and analyzeTrackTrajectory().
|
private |
Definition at line 167 of file GlobalTrackerMuonAlignment.cc.
Referenced by endJob().
|
private |
Definition at line 191 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), and analyzeTrackTrajectory().
|
private |
Definition at line 205 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrajectory(), muonFitter(), and trackFitter().
|
private |
Definition at line 207 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrajectory(), muonFitter(), and trackFitter().
|
private |
Definition at line 206 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrajectory(), muonFitter(), and trackFitter().
|
private |
Definition at line 208 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrajectory(), muonFitter(), and trackFitter().
|
private |
Definition at line 194 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrajectory().
|
private |
Definition at line 184 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), and analyzeTrackTrajectory().
|
private |
Definition at line 195 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), and analyzeTrackTrajectory().
|
private |
Definition at line 180 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), and analyzeTrackTrajectory().
|
private |
Definition at line 164 of file GlobalTrackerMuonAlignment.cc.
|
private |
Definition at line 188 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), and analyzeTrackTrajectory().
|
private |
Definition at line 211 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrajectory(), and trackFitter().
|
private |
Definition at line 176 of file GlobalTrackerMuonAlignment.cc.
Referenced by endJob().
|
private |
Definition at line 202 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), and analyzeTrackTrajectory().
|
private |
Definition at line 197 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), and analyzeTrackTrajectory().
|
private |
Definition at line 200 of file GlobalTrackerMuonAlignment.cc.
|
private |
Definition at line 193 of file GlobalTrackerMuonAlignment.cc.
Referenced by analyzeTrackTrack(), and analyzeTrackTrajectory().
|
private |
Definition at line 177 of file GlobalTrackerMuonAlignment.cc.
Referenced by endJob().