#include <Alignment/OfflineValidation/plugins/PrimaryVertexValidation.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 | add (std::map< std::string, TH1 *> &h, TH1 *hist) |
void | analyze (const edm::Event &, const edm::EventSetup &) override |
void | beginJob () override |
void | beginRun (edm::Run const &iRun, edm::EventSetup const &iSetup) override |
std::vector< TH1F * > | bookResidualsHistogram (const TFileDirectory &dir, unsigned int theNOfBins, PVValHelper::residualType resType, PVValHelper::plotVariable varType, bool isNormalized=false) |
std::map< std::string, TH1 * > | bookVertexHistograms (const TFileDirectory &dir) |
void | endJob () override |
void | endRun (edm::Run const &, edm::EventSetup const &) override |
void | fill (std::map< std::string, TH1 *> &h, const std::string &s, double x) |
void | fill (std::map< std::string, TH1 *> &h, const std::string &s, double x, double y) |
void | fillByIndex (std::vector< TH1F *> &h, unsigned int index, double x, std::string tag="") |
void | fillMap (TH2F *trendMap, TH1F *residualsMapPlot[100][100], PVValHelper::estimator fitPar_, const int nXBins_, const int nYBins_) |
void | fillTrackHistos (std::map< std::string, TH1 *> &h, const std::string &ttype, const reco::TransientTrack *tt, const reco::Vertex &v, const reco::BeamSpot &beamSpot, double fBfield) |
void | fillTrendPlot (TH1F *trendPlot, TH1F *residualsPlot[100], PVValHelper::estimator fitPar_, const std::string &var_) |
void | fillTrendPlotByIndex (TH1F *trendPlot, std::vector< TH1F *> &h, PVValHelper::estimator fitPar_, PVValHelper::plotVariable plotVar=PVValHelper::END_OF_PLOTS) |
std::pair< Measurement1D, Measurement1D > | fitResiduals (TH1 *hist) |
Measurement1D | getMAD (TH1F *histo) |
Measurement1D | getMedian (TH1F *histo) |
std::pair< long long, long long > | getRunTime (const edm::EventSetup &iSetup) const |
std::tuple< std::string, std::string, std::string > | getTypeString (PVValHelper::residualType type) |
std::tuple< std::string, std::string, std::string > | getVarString (PVValHelper::plotVariable var) |
bool | hasFirstLayerPixelHits (const reco::TransientTrack &track) |
bool | isBFieldConsistentWithMode (const edm::EventSetup &iSetup) const |
bool | isHit2D (const TrackingRecHit &hit, const PVValHelper::detectorPhase &thePhase) const |
bool | passesTrackCuts (const reco::Track &track, const reco::Vertex &vertex, const std::string &qualityString_, double dxyErrMax_, double dzErrMax_, double ptErrMax_) |
std::pair< bool, bool > | pixelHitsCheck (const reco::TransientTrack &track) |
void | SetVarToZero () |
void | shrinkHistVectorToFit (std::vector< TH1F *> &h, unsigned int desired_size) |
double | square (double x) |
Static Private Member Functions | |
static bool | vtxSort (const reco::Vertex &a, const reco::Vertex &b) |
Static Private Attributes | |
static const int | cmToum = 10000 |
static const int | nMaxBins_ = 100 |
static const int | nMaxtracks_ = 10000 |
static const int | nPtBins_ = 48 |
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: Validate alignment constants using unbiased vertex residuals
Implementation: <Notes on="" implementation>="">
Definition at line 73 of file PrimaryVertexValidation.h.
|
explicit |
Definition at line 68 of file PrimaryVertexValidation.cc.
References PVValHelper::d3D, debug_, PVValHelper::dx, PVValHelper::dxy, PVValHelper::END_OF_PLOTS, PVValHelper::END_OF_TYPES, PVValHelper::eta, etaOfProbe_, PVValHelper::generateBins(), PVValHelper::histodetails::getHigh(), PVValHelper::histodetails::getLow(), edm::ParameterSet::getParameter(), PVValHelper::getTypeString(), edm::ParameterSet::getUntrackedParameter(), PVValHelper::getVarString(), PVValHelper::histodetails::histobins, mps_fire::i, hcalRecHitTable_cff::ieta, hcalRecHitTable_cff::iphi, dqmiolumiharvest::j, TFileService::kSharedResource, PVValHelper::ladder, maxPt_, minPt_, PVValHelper::modZ, mypT_bins_, nBins_, PVValHelper::norm_d3D, PVValHelper::phi, PVValHelper::pT, PVValHelper::pTCentral, PVValHelper::histodetails::range, runControlNumbers_, PVValHelper::histodetails::setMap(), AlCaHLTBitMon_QueryRunRegistry::string, theBeamspotToken_, theDetails_, theTrackClusterizer_, theTrackCollectionToken_, theTrackFilter_, theVertexCollectionToken_, to_string(), and PVValHelper::histodetails::trendbins.
|
overridedefault |
|
private |
|
overrideprivatevirtual |
Implements edm::one::EDAnalyzerBase.
Definition at line 211 of file PrimaryVertexValidation.cc.
References a_d3DEtaResiduals, a_d3DPhiResiduals, a_d3DResidualsMap, a_dxEtaResiduals, a_dxPhiResiduals, a_dxyBiasResidualsMap, a_dxyEtaBiasResiduals, a_dxyEtaResiduals, a_dxyL1ResidualsMap, a_dxyPhiBiasResiduals, a_dxyPhiResiduals, a_dxyResidualsMap, a_dxyVsEta, a_dxyVsPhi, a_dyEtaResiduals, a_dyPhiResiduals, a_dzBiasResidualsMap, a_dzEtaBiasResiduals, a_dzEtaResiduals, a_dzL1ResidualsMap, a_dzPhiBiasResiduals, a_dzPhiResiduals, a_dzResidualsMap, a_dzVsEta, a_dzVsPhi, a_IP2DEtaResiduals, a_IP2DPhiResiduals, a_IP3DEtaResiduals, a_IP3DPhiResiduals, a_reszEtaResiduals, a_reszPhiResiduals, funct::abs(), IPTools::absoluteImpactParameter3D(), askFirstLayerHit_, Beamdxdz_, Beamsigmaz_, pwdgSkimBPark_cfi::beamSpot, BeamWidthX_, BeamWidthY_, BSx0_, BSy0_, BSz0_, TransientTrackBuilder::build(), reco::TrackBase::charge(), charge_, reco::TrackBase::chi2(), chi2_, chi2ndof_, chi2normUnbiasedVertex_, chi2ProbUnbiasedVertex_, chi2UnbiasedVertex_, SiPixelRecHit::clusterProbability(), bsc_activity_cfg::clusters, cmToum, d0, reco::TrackBase::d0Error(), d3DErrorFromMyVertex_, d3DFromMyVertex_, debug_, hcalRecHitTable_cff::detId, doBPix_, doFPix_, DOFUnbiasedVertex_, reco::TrackBase::dxy(), dxy_, dxyBs_, dxyErrorFromMyVertex_, dxyFromMyVertex_, reco::TrackBase::dz(), dz_, dzBs_, reco::TrackBase::dzError(), dzErrorFromMyVertex_, dzFromMyVertex_, PVValHelper::eta, reco::TrackBase::eta(), eta_, etaOfProbe_, EventNumber_, PVValHelper::fillByIndex(), fillTrackHistos(), forceBeamSpotContraint_, edm::EventSetup::getData(), edm::EventSetup::getHandle(), h2_probeEtaPhi_, h2_probeEtaPt_, h2_probeLayer1Map_, h2_probePassingLayer1Map_, h_Beamsigmaz, h_BeamWidthX, h_BeamWidthY, h_BSx0, h_BSy0, h_BSz0, h_dxy_Central_pT_, h_dxy_ladder_, h_dxy_ladderNoOverlap_, h_dxy_ladderOverlap_, h_dxy_modZ_, h_dxy_pT_, h_dz_Central_pT_, h_dz_ladder_, h_dz_modZ_, h_dz_pT_, h_fitVtxChi2_, h_fitVtxChi2ndf_, h_fitVtxChi2Prob_, h_fitVtxNdof_, h_fitVtxNtracks_, h_fitVtxTrackAverageWeight_, h_fitVtxTrackWeights_, h_nClus, h_nOfflineVertices, h_norm_dxy_Central_pT_, h_norm_dxy_ladder_, h_norm_dxy_modZ_, h_norm_dxy_pT_, h_norm_dz_Central_pT_, h_norm_dz_ladder_, h_norm_dz_modZ_, h_norm_dz_pT_, h_nTracks, h_probeCharge_, h_probeChi2_, h_probed0RefitV_, h_probed3DRefitV_, h_probedxyRecoV_, h_probedxyRefitV_, h_probedzRecoV_, h_probedzRefitV_, h_probeEta_, h_probeHasBPixL1Overlap_, h_probeHits1D_, h_probeHits2D_, h_probeHits_, h_probeHitsInBPIX_, h_probeHitsInFPIX_, h_probeHitsInTEC_, h_probeHitsInTIB_, h_probeHitsInTID_, h_probeHitsInTOB_, h_probeL1ClusterProb_, h_probeL1Ladder_, h_probeL1Module_, h_probeNormChi2_, h_probeP_, h_probePhi_, h_probePt_, h_probePtRebin_, h_probeQoverP_, h_probeRecoVSigXY_, h_probeRecoVSigZ_, h_probeRefitVLogSig3D_, h_probeRefitVSig3D_, h_probeRefitVSigResZ_, h_probeRefitVSigXY_, h_probeRefitVSigZ_, h_probereszRefitV_, h_probesignIP2DRefitV_, h_probez0RefitV_, h_recoVtxChi2ndf_, h_recoVtxChi2Prob_, h_recoVtxNtracks_, h_recoVtxSumPt_, h_xErrOfflineVertex, h_xOfflineVertex, h_yErrOfflineVertex, h_yOfflineVertex, h_zErrOfflineVertex, h_zOfflineVertex, hasFirstLayerPixelHits(), hasRecVertex_, hDA, reco::TrackBase::hitPattern(), hfClusterShapes_cfi::hits, mps_fire::i, iEvent, createfilelist::int, IP3DsigFromMyVertex_, IPLsigFromMyVertex_, IPTsigFromMyVertex_, isGoodTrack_, isHighPurity_, isHit2D(), sistrip::SpyUtilities::isValid(), edm::HandleBase::isValid(), dqmiolumiharvest::j, nano_mu_digi_cff::layer, LogDebug, LogTrace, PerigeeTrajectoryParameters::longitudinalImpactParameter(), PerigeeTrajectoryError::longitudinalImpactParameterError(), LuminosityBlockNumber_, M_PI, magFieldToken_, mypT_bins_, n_d3DEtaResiduals, n_d3DPhiResiduals, n_d3DResidualsMap, n_dxyBiasResidualsMap, n_dxyEtaBiasResiduals, n_dxyEtaResiduals, n_dxyL1ResidualsMap, n_dxyPhiBiasResiduals, n_dxyPhiResiduals, n_dxyResidualsMap, n_dxyVsEta, n_dxyVsPhi, n_dzBiasResidualsMap, n_dzEtaBiasResiduals, n_dzEtaResiduals, n_dzL1ResidualsMap, n_dzPhiBiasResiduals, n_dzPhiResiduals, n_dzResidualsMap, n_dzVsEta, n_dzVsPhi, n_IP2DEtaResiduals, n_IP2DPhiResiduals, n_IP3DEtaResiduals, n_IP3DPhiResiduals, n_reszEtaResiduals, n_reszPhiResiduals, nBins_, nClus_, Nevt_, nhits1D_, nhits2D_, nhits_, nhitsBPIX_, nhitsFPIX_, nHitsOfProbe_, nhitsTEC_, nhitsTIB_, nhitsTID_, nhitsTOB_, nMaxtracks_, nOfflineVertices_, reco::TrackBase::normalizedChi2(), nPtBins_, vertices_cff::ntracks, nTracks_, nTracksPerClus_, reco::TrackBase::numberOfValidHits(), reco::TrackBase::p(), p_, TrajectoryStateClosestToPoint::perigeeError(), TrajectoryStateClosestToPoint::perigeeParameters(), phase_, PVValHelper::phi, reco::TrackBase::phi(), phi_, PixelSubdetector::PixelBarrel, pixelHitsCheck(), pOfProbe_, point, FreeTrajectoryState::position(), TrajectoryStateClosestToPoint::position(), position, conifer::pow(), DiDispStaMuonMonitor_cfi::pt, reco::TrackBase::pt(), pt_, ptOfProbe_, reco::TrackBase::px(), TrackerTopology::pxbLadder(), TrackerTopology::pxbLayer(), TrackerTopology::pxbModule(), reco::TrackBase::py(), reco::TrackBase::pz(), reco::TrackBase::qoverp(), qoverp_, reco::TrackBase::quality(), pixelTrack::qualityByName(), reco::Track::recHits(), rootTree_, runControl_, PV_cfg::runControlNumber, runControlNumbers_, RunNumber_, SetVarToZero(), IPTools::signedImpactParameter3D(), IPTools::signedTransverseImpactParameter(), jetUpdater_cfi::sort, mathSSE::sqrt(), storeNtuple_, sumOfWeightsUnbiasedVertex_, funct::tan(), theBeamspotToken_, theDetails_, TrajectoryStateClosestToPoint::theState(), reco::TrackBase::theta(), theta_, theTrackClusterizer_, theTrackCollectionToken_, theTrackFilter_, theVertexCollectionToken_, topoToken_, HLT_2023v12_cff::track, trackingGeomToken_, pwdgSkimBPark_cfi::tracks, tracksUsedForVertexing_, PerigeeConversions::trajectoryStateClosestToPoint(), PerigeeTrajectoryParameters::transverseImpactParameter(), PVValHelper::histodetails::trendbins, ttkToken_, useTracksFromRecoVtx_, bphysicsOniaDQM_cfi::vertex, reco::TrackBase::vertex(), vertexZMax_, AlignmentTracksFromVertexSelector_cfi::vertices, vtxSort(), cms::Exception::what(), wxy2_, x, PV3DBase< T, PVType, FrameType >::x(), xErrOfflineVertex_, xOfflineVertex_, xPCA_, xUnbiasedVertex_, y, PV3DBase< T, PVType, FrameType >::y(), yErrOfflineVertex_, yOfflineVertex_, yPCA_, yUnbiasedVertex_, z, HLTMuonOfflineAnalyzer_cfi::z0, zErrOfflineVertex_, globals_cff::zError, zOfflineVertex_, zPCA_, zUnbiasedVertex_, and HLT_FULL_cff::zVertex.
|
overrideprivatevirtual |
Reimplemented from edm::one::EDAnalyzerBase.
Definition at line 1080 of file PrimaryVertexValidation.cc.
References a_d3DEtaResiduals, a_d3DPhiResiduals, a_d3DResidualsMap, a_dxEtaResiduals, a_dxPhiResiduals, a_dxyBiasResidualsMap, a_dxyEtaBiasResiduals, a_dxyEtaMADBiasTrend, a_dxyEtaMADTrend, a_dxyEtaMeanBiasTrend, a_dxyEtaMeanTrend, a_dxyEtaMedianBiasTrend, a_dxyEtaMedianTrend, a_dxyEtaResiduals, a_dxyEtaWidthBiasTrend, a_dxyEtaWidthTrend, a_dxyL1ResidualsMap, a_dxyMeanBiasMap, a_dxyMeanMap, a_dxyPhiBiasResiduals, a_dxyPhiMADBiasTrend, a_dxyPhiMADTrend, a_dxyPhiMeanBiasTrend, a_dxyPhiMeanTrend, a_dxyPhiMedianBiasTrend, a_dxyPhiMedianTrend, a_dxyPhiResiduals, a_dxyPhiWidthBiasTrend, a_dxyPhiWidthTrend, a_dxypTCentralMeanTrend, a_dxypTCentralWidthTrend, a_dxypTMeanTrend, a_dxypTWidthTrend, a_dxyResidualsMap, a_dxyVsEta, a_dxyVsPhi, a_dxyWidthBiasMap, a_dxyWidthMap, a_dyEtaResiduals, a_dyPhiResiduals, a_dzBiasResidualsMap, a_dzEtaBiasResiduals, a_dzEtaMADBiasTrend, a_dzEtaMADTrend, a_dzEtaMeanBiasTrend, a_dzEtaMeanTrend, a_dzEtaMedianBiasTrend, a_dzEtaMedianTrend, a_dzEtaResiduals, a_dzEtaWidthBiasTrend, a_dzEtaWidthTrend, a_dzL1ResidualsMap, a_dzMeanBiasMap, a_dzMeanMap, a_dzPhiBiasResiduals, a_dzPhiMADBiasTrend, a_dzPhiMADTrend, a_dzPhiMeanBiasTrend, a_dzPhiMeanTrend, a_dzPhiMedianBiasTrend, a_dzPhiMedianTrend, a_dzPhiResiduals, a_dzPhiWidthBiasTrend, a_dzPhiWidthTrend, a_dzpTCentralMeanTrend, a_dzpTCentralWidthTrend, a_dzpTMeanTrend, a_dzpTWidthTrend, a_dzResidualsMap, a_dzVsEta, a_dzVsPhi, a_dzWidthBiasMap, a_dzWidthMap, a_IP2DEtaResiduals, a_IP2DPhiResiduals, a_IP3DEtaResiduals, a_IP3DPhiResiduals, a_reszEtaResiduals, a_reszPhiResiduals, Beamdxdz_, Beamsigmaz_, BeamWidthX_, BeamWidthY_, bookResidualsHistogram(), bookVertexHistograms(), BSx0_, BSy0_, BSz0_, charge_, chi2_, chi2ndof_, chi2normUnbiasedVertex_, chi2ProbUnbiasedVertex_, chi2UnbiasedVertex_, compressionSettings_, PVValHelper::d3D, d3DFromMyVertex_, DOFUnbiasedVertex_, PVValHelper::dx, PVValHelper::dxy, dxy_, dxyBs_, dxyErrorFromMyVertex_, dxyFromMyVertex_, PVValHelper::dy, PVValHelper::dz, dz_, dzBs_, dzErrorFromMyVertex_, dzFromMyVertex_, PVValHelper::eta, eta_, etaOfProbe_, EventNumber_, TFileService::file(), fs, PVValHelper::histodetails::getHigh(), h2_probeEtaPhi_, h2_probeEtaPt_, h2_probeLayer1Map_, h2_probePassingLayer1Map_, h_Beamsigmaz, h_BeamWidthX, h_BeamWidthY, h_BSx0, h_BSy0, h_BSz0, h_dxy_Central_pT_, h_dxy_ladder_, h_dxy_ladderNoOverlap_, h_dxy_ladderOverlap_, h_dxy_modZ_, h_dxy_pT_, h_dz_Central_pT_, h_dz_ladder_, h_dz_modZ_, h_dz_pT_, h_etaMax, h_fitVtxChi2_, h_fitVtxChi2ndf_, h_fitVtxChi2Prob_, h_fitVtxNdof_, h_fitVtxNtracks_, h_fitVtxTrackAverageWeight_, h_fitVtxTrackWeights_, h_lumiFromConfig, h_nbins, h_nClus, h_nLadders, h_nModZ, h_nOfflineVertices, h_norm_dxy_Central_pT_, h_norm_dxy_ladder_, h_norm_dxy_modZ_, h_norm_dxy_pT_, h_norm_dz_Central_pT_, h_norm_dz_ladder_, h_norm_dz_modZ_, h_norm_dz_pT_, h_nTracks, h_probeCharge_, h_probeChi2_, h_probed0RefitV_, h_probed3DRefitV_, h_probedxyRecoV_, h_probedxyRefitV_, h_probedzRecoV_, h_probedzRefitV_, h_probeEta_, h_probeHasBPixL1Overlap_, h_probeHits1D_, h_probeHits2D_, h_probeHits_, h_probeHitsInBPIX_, h_probeHitsInFPIX_, h_probeHitsInTEC_, h_probeHitsInTIB_, h_probeHitsInTID_, h_probeHitsInTOB_, h_probeL1ClusterProb_, h_probeL1Ladder_, h_probeL1Module_, h_probeNormChi2_, h_probeP_, h_probePhi_, h_probePt_, h_probePtRebin_, h_probeQoverP_, h_probeRecoVSigXY_, h_probeRecoVSigZ_, h_probeRefitVLogSig3D_, h_probeRefitVSig3D_, h_probeRefitVSigResZ_, h_probeRefitVSigXY_, h_probeRefitVSigZ_, h_probereszRefitV_, h_probesignIP2DRefitV_, h_probez0RefitV_, h_pTinfo, h_recoVtxChi2ndf_, h_recoVtxChi2Prob_, h_recoVtxNtracks_, h_recoVtxSumPt_, h_runFromConfig, h_runFromEvent, h_runNumber, h_xErrOfflineVertex, h_xOfflineVertex, h_yErrOfflineVertex, h_yOfflineVertex, h_zErrOfflineVertex, h_zOfflineVertex, hasRecVertex_, hDA, MonitorHOAlCaRecoStream_cfi::highedge, PVValHelper::histodetails::histobins, mps_fire::i, intLumi_, PVValHelper::IP2D, PVValHelper::IP3D, IP3DsigFromMyVertex_, IPLsigFromMyVertex_, IPTsigFromMyVertex_, isGoodTrack_, isHighPurity_, dqmiolumiharvest::j, PVValHelper::ladder, lightNtupleSwitch_, MonitorHOAlCaRecoStream_cfi::lowedge, LuminosityBlockNumber_, M_PI, MADTrendsDir, TFileDirectory::make(), TFileService::make(), Mean2DMapsDir, MeanTrendsDir, MedianTrendsDir, TFileService::mkdir(), PVValHelper::modZ, mypT_bins_, n_d3DEtaResiduals, n_d3DPhiResiduals, n_d3DResidualsMap, n_dxyBiasResidualsMap, n_dxyEtaBiasResiduals, n_dxyEtaMADBiasTrend, n_dxyEtaMADTrend, n_dxyEtaMeanBiasTrend, n_dxyEtaMeanTrend, n_dxyEtaMedianBiasTrend, n_dxyEtaMedianTrend, n_dxyEtaResiduals, n_dxyEtaWidthBiasTrend, n_dxyEtaWidthTrend, n_dxyL1ResidualsMap, n_dxyMeanBiasMap, n_dxyMeanMap, n_dxyPhiBiasResiduals, n_dxyPhiMADBiasTrend, n_dxyPhiMADTrend, n_dxyPhiMeanBiasTrend, n_dxyPhiMeanTrend, n_dxyPhiMedianBiasTrend, n_dxyPhiMedianTrend, n_dxyPhiResiduals, n_dxyPhiWidthBiasTrend, n_dxyPhiWidthTrend, n_dxypTCentralMeanTrend, n_dxypTCentralWidthTrend, n_dxypTMeanTrend, n_dxypTWidthTrend, n_dxyResidualsMap, n_dxyVsEta, n_dxyVsPhi, n_dxyWidthBiasMap, n_dxyWidthMap, n_dzBiasResidualsMap, n_dzEtaBiasResiduals, n_dzEtaMADBiasTrend, n_dzEtaMADTrend, n_dzEtaMeanBiasTrend, n_dzEtaMeanTrend, n_dzEtaMedianBiasTrend, n_dzEtaMedianTrend, n_dzEtaResiduals, n_dzEtaWidthBiasTrend, n_dzEtaWidthTrend, n_dzL1ResidualsMap, n_dzMeanBiasMap, n_dzMeanMap, n_dzPhiBiasResiduals, n_dzPhiMADBiasTrend, n_dzPhiMADTrend, n_dzPhiMeanBiasTrend, n_dzPhiMeanTrend, n_dzPhiMedianBiasTrend, n_dzPhiMedianTrend, n_dzPhiResiduals, n_dzPhiWidthBiasTrend, n_dzPhiWidthTrend, n_dzpTCentralMeanTrend, n_dzpTCentralWidthTrend, n_dzpTMeanTrend, n_dzpTWidthTrend, n_dzResidualsMap, n_dzVsEta, n_dzVsPhi, n_dzWidthBiasMap, n_dzWidthMap, n_IP2DEtaResiduals, n_IP2DPhiResiduals, n_IP3DEtaResiduals, n_IP3DPhiResiduals, n_reszEtaResiduals, n_reszPhiResiduals, nBins_, nClus_, Nevt_, nhits1D_, nhits2D_, nhits_, nhitsBPIX_, nhitsFPIX_, nhitsTEC_, nhitsTIB_, nhitsTID_, nhitsTOB_, nLadders_, nModZ_, nOfflineVertices_, PVValHelper::norm_d3D, PVValHelper::norm_dxy, PVValHelper::norm_dz, PVValHelper::norm_IP2D, PVValHelper::norm_IP3D, PVValHelper::norm_resz, nPtBins_, nTracks_, nTracksPerClus_, p_, PVValHelper::phi, phi_, PVValHelper::pT, pt_, PVValHelper::pTCentral, qoverp_, PVValHelper::resz, rootTree_, writedatasetfile::run, runControlNumbers_, RunNumber_, sumOfWeightsUnbiasedVertex_, theDetails_, theta_, tracksUsedForVertexing_, PVValHelper::histodetails::trendbins, useTracksFromRecoVtx_, Width2DMapsDir, WidthTrendsDir, xOfflineVertex_, xPCA_, xUnbiasedVertex_, yOfflineVertex_, yPCA_, yUnbiasedVertex_, zOfflineVertex_, zPCA_, and zUnbiasedVertex_.
|
overrideprivate |
Definition at line 2520 of file PrimaryVertexValidation.cc.
References debug_, TrackerGeometry::dets(), etaOfProbe_, Exception, geomTokenBR_, edm::EventSetup::getData(), edm::EventSetup::getHandle(), PixelTopologyMap::getPXBLadders(), PixelTopologyMap::getPXBModules(), getRunTime(), h_dxy_ladder_, h_dxy_ladderNoOverlap_, h_dxy_ladderOverlap_, h_dxy_modZ_, h_dz_ladder_, h_dz_modZ_, h_etaMax, h_nbins, h_nLadders, h_nModZ, h_norm_dxy_ladder_, h_norm_dxy_modZ_, h_norm_dz_ladder_, h_pTinfo, h_runFromEvent, h_runNumber, isBFieldConsistentWithMode(), TrackerGeometry::isThere(), PVValHelper::max_eta_phase0, PVValHelper::max_eta_phase1, PVValHelper::max_eta_phase2, maxPt_, SiStripPI::min, minPt_, mypT_bins_, nBins_, nLadders_, nModZ_, GeomDetEnumerators::P1PXB, GeomDetEnumerators::P1PXEC, GeomDetEnumerators::P2PXB, GeomDetEnumerators::P2PXEC, PVValHelper::phase0, PVValHelper::phase1, PVValHelper::phase2, phase_, edm::ESHandle< T >::product(), ptOfProbe_, edm::RunBase::run(), sistrip::runNumber_, RunNumber_, runNumbersTimesLog_, PVValHelper::shrinkHistVectorToFit(), and topoTokenBR_.
|
private |
Definition at line 3481 of file PrimaryVertexValidation.cc.
References cms::cuda::assert(), DeadROC_duringRun::dir, down, PVValHelper::eta, PVValHelper::getTypeString(), PVValHelper::getVarString(), h, cond::hash, PVValHelper::histodetails::histobins, mps_fire::i, PVValHelper::phi, PVValHelper::histodetails::range, AlCaHLTBitMon_QueryRunRegistry::string, theDetails_, runGCPTkAlMap::title, PVValHelper::histodetails::trendbins, units(), up, and dumpRecoGeometry_cfg::varType.
Referenced by beginJob().
|
private |
Definition at line 3359 of file PrimaryVertexValidation.cc.
References DeadROC_duringRun::dir, h, M_PI, and AlCaHLTBitMon_QueryRunRegistry::string.
Referenced by beginJob().
|
overrideprivatevirtual |
Reimplemented from edm::one::EDAnalyzerBase.
Definition at line 2656 of file PrimaryVertexValidation.cc.
References a_dxyBiasResidualsMap, a_dxyEtaBiasResiduals, a_dxyEtaMADBiasTrend, a_dxyEtaMADTrend, a_dxyEtaMeanBiasTrend, a_dxyEtaMeanTrend, a_dxyEtaMedianBiasTrend, a_dxyEtaMedianTrend, a_dxyEtaResiduals, a_dxyEtaWidthBiasTrend, a_dxyEtaWidthTrend, a_dxyL1MeanMap, a_dxyL1ResidualsMap, a_dxyL1WidthMap, a_dxyladderMeanTrend, a_dxyladderWidthTrend, a_dxyMeanBiasMap, a_dxyMeanMap, a_dxymodZMeanTrend, a_dxymodZWidthTrend, a_dxyPhiBiasResiduals, a_dxyPhiMADBiasTrend, a_dxyPhiMADTrend, a_dxyPhiMeanBiasTrend, a_dxyPhiMeanTrend, a_dxyPhiMedianBiasTrend, a_dxyPhiMedianTrend, a_dxyPhiResiduals, a_dxyPhiWidthBiasTrend, a_dxyPhiWidthTrend, a_dxypTCentralMeanTrend, a_dxypTCentralWidthTrend, a_dxypTMeanTrend, a_dxypTWidthTrend, a_dxyResidualsMap, a_dxyWidthBiasMap, a_dxyWidthMap, a_dzBiasResidualsMap, a_dzEtaBiasResiduals, a_dzEtaMADBiasTrend, a_dzEtaMADTrend, a_dzEtaMeanBiasTrend, a_dzEtaMeanTrend, a_dzEtaMedianBiasTrend, a_dzEtaMedianTrend, a_dzEtaResiduals, a_dzEtaWidthBiasTrend, a_dzEtaWidthTrend, a_dzL1MeanMap, a_dzL1ResidualsMap, a_dzL1WidthMap, a_dzladderMeanTrend, a_dzladderWidthTrend, a_dzMeanBiasMap, a_dzMeanMap, a_dzmodZMeanTrend, a_dzmodZWidthTrend, a_dzPhiBiasResiduals, a_dzPhiMADBiasTrend, a_dzPhiMADTrend, a_dzPhiMeanBiasTrend, a_dzPhiMeanTrend, a_dzPhiMedianBiasTrend, a_dzPhiMedianTrend, a_dzPhiResiduals, a_dzPhiWidthBiasTrend, a_dzPhiWidthTrend, a_dzpTCentralMeanTrend, a_dzpTCentralWidthTrend, a_dzpTMeanTrend, a_dzpTWidthTrend, a_dzResidualsMap, a_dzWidthBiasMap, a_dzWidthMap, submitPVResolutionJobs::count, PVValHelper::eta, fillMap(), fillTrendPlotByIndex(), fs, h2_probeLayer1Map_, h2_probePassingLayer1Map_, h_dxy_Central_pT_, h_dxy_ladder_, h_dxy_modZ_, h_dxy_pT_, h_dz_Central_pT_, h_dz_ladder_, h_dz_modZ_, h_dz_pT_, h_norm_dxy_Central_pT_, h_norm_dxy_ladder_, h_norm_dxy_modZ_, h_norm_dxy_pT_, h_norm_dz_Central_pT_, h_norm_dz_ladder_, h_norm_dz_modZ_, h_norm_dz_pT_, h_probeL1Ladder_, h_probeL1Module_, h_runEndTimes, h_runStartTimes, PVValHelper::MAD, TFileDirectory::make(), PVValHelper::MEAN, Mean2DMapsDir, MeanTrendsDir, PVValHelper::MEDIAN, TFileService::mkdir(), n_dxyBiasResidualsMap, n_dxyEtaBiasResiduals, n_dxyEtaMADBiasTrend, n_dxyEtaMADTrend, n_dxyEtaMeanBiasTrend, n_dxyEtaMeanTrend, n_dxyEtaMedianBiasTrend, n_dxyEtaMedianTrend, n_dxyEtaResiduals, n_dxyEtaWidthBiasTrend, n_dxyEtaWidthTrend, n_dxyL1MeanMap, n_dxyL1ResidualsMap, n_dxyL1WidthMap, n_dxyladderMeanTrend, n_dxyladderWidthTrend, n_dxyMeanBiasMap, n_dxyMeanMap, n_dxymodZMeanTrend, n_dxymodZWidthTrend, n_dxyPhiBiasResiduals, n_dxyPhiMADBiasTrend, n_dxyPhiMADTrend, n_dxyPhiMeanBiasTrend, n_dxyPhiMeanTrend, n_dxyPhiMedianBiasTrend, n_dxyPhiMedianTrend, n_dxyPhiResiduals, n_dxyPhiWidthBiasTrend, n_dxyPhiWidthTrend, n_dxypTCentralMeanTrend, n_dxypTCentralWidthTrend, n_dxypTMeanTrend, n_dxypTWidthTrend, n_dxyResidualsMap, n_dxyWidthBiasMap, n_dxyWidthMap, n_dzBiasResidualsMap, n_dzEtaBiasResiduals, n_dzEtaMADBiasTrend, n_dzEtaMADTrend, n_dzEtaMeanBiasTrend, n_dzEtaMeanTrend, n_dzEtaMedianBiasTrend, n_dzEtaMedianTrend, n_dzEtaResiduals, n_dzEtaWidthBiasTrend, n_dzEtaWidthTrend, n_dzL1MeanMap, n_dzL1ResidualsMap, n_dzL1WidthMap, n_dzladderMeanTrend, n_dzladderWidthTrend, n_dzMeanBiasMap, n_dzMeanMap, n_dzmodZMeanTrend, n_dzmodZWidthTrend, n_dzPhiBiasResiduals, n_dzPhiMADBiasTrend, n_dzPhiMADTrend, n_dzPhiMeanBiasTrend, n_dzPhiMeanTrend, n_dzPhiMedianBiasTrend, n_dzPhiMedianTrend, n_dzPhiResiduals, n_dzPhiWidthBiasTrend, n_dzPhiWidthTrend, n_dzpTCentralMeanTrend, n_dzpTCentralWidthTrend, n_dzpTMeanTrend, n_dzpTWidthTrend, n_dzResidualsMap, n_dzWidthBiasMap, n_dzWidthMap, nBins_, Nevt_, nLadders_, nModZ_, PVValHelper::phi, writedatasetfile::run, runNumbersTimesLog_, to_string(), useTracksFromRecoVtx_, PVValHelper::WIDTH, Width2DMapsDir, and WidthTrendsDir.
Referenced by o2olib.O2ORunMgr::executeJob().
|
inlineoverrideprivate |
Definition at line 84 of file PrimaryVertexValidation.h.
|
private |
|
private |
|
private |
|
static |
Definition at line 3666 of file PrimaryVertexValidation.cc.
References edm::ConfigurationDescriptions::add(), edm::ParameterSetDescription::add(), submitPVResolutionJobs::desc, GapClusterizerInZ::fillPSetDescription(), TrackFilterForPVFinding::fillPSetDescription(), DAClusterizerInZ_vect::fillPSetDescription(), ProducerED_cfi::InputTag, and AlCaHLTBitMon_QueryRunRegistry::string.
|
private |
Definition at line 3251 of file PrimaryVertexValidation.cc.
References Measurement1D::error(), PVValHelper::eta, HLT_2023v12_cff::etaBins, PVValHelper::fitResiduals(), PVValHelper::getMAD(), PVValHelper::getMedian(), mps_fire::i, dqmiolumiharvest::j, PVValHelper::MAD, PVValHelper::MEAN, PVValHelper::MEDIAN, PVValHelper::phi, l1tTrackJets_cfi::phiBins, theDetails_, PVValHelper::histodetails::trendbins, Measurement1D::value(), and PVValHelper::WIDTH.
Referenced by endJob().
|
private |
Definition at line 3546 of file PrimaryVertexValidation.cc.
References funct::abs(), Reference_intrackfit_cff::barrel, pwdgSkimBPark_cfi::beamSpot, funct::cos(), d0, PVValHelper::dz, PVValHelper::fill(), nano_mu_digi_cff::float, h, edm::Ref< C, T, F >::isNonnull(), hgcalLayerClustersEE_cfi::kappa, dqm-mbProfile::log, PixelSubdetector::PixelBarrel, position, conifer::pow(), submitPVResolutionJobs::q, nanoDQM_cfi::Rho, funct::sin(), mathSSE::sqrt(), funct::tan(), DetId::Tracker, findQualityFiles::v, wxy2_, testProducerWithPsetDescEmpty_cfi::x1, testProducerWithPsetDescEmpty_cfi::y1, and z.
Referenced by analyze().
|
private |
Definition at line 3127 of file PrimaryVertexValidation.cc.
References Measurement1D::error(), PVValHelper::eta, HLT_2023v12_cff::etaBins, PVValHelper::fitResiduals(), PVValHelper::getMAD(), PVValHelper::getMedian(), mps_fire::i, PVValHelper::MAD, PVValHelper::MEAN, PVValHelper::MEDIAN, nBins_, PVValHelper::phi, l1tTrackJets_cfi::phiBins, theDetails_, PVValHelper::histodetails::trendbins, Measurement1D::value(), and PVValHelper::WIDTH.
|
private |
FIXME DO SOMETHING HERE
Definition at line 3189 of file PrimaryVertexValidation.cc.
References newFWLiteAna::bin, HLT_2023v12_cff::distance, Measurement1D::error(), PVValHelper::eta, HLT_2023v12_cff::etaBins, PVValHelper::fitResiduals(), PVValHelper::getMAD(), PVValHelper::getMedian(), h, PVValHelper::MAD, PVValHelper::MEAN, PVValHelper::MEDIAN, PVValHelper::phi, l1tTrackJets_cfi::phiBins, theDetails_, PVValHelper::histodetails::trendbins, Measurement1D::value(), and PVValHelper::WIDTH.
Referenced by endJob().
|
private |
|
private |
|
private |
|
private |
Definition at line 3029 of file PrimaryVertexValidation.cc.
References debug_, submitPVValidationJobs::runInfo, and runInfoTokenBR_.
Referenced by beginRun().
|
private |
|
private |
|
private |
Definition at line 1063 of file PrimaryVertexValidation.cc.
References mps_fire::i, AlCaHLTBitMon_ParallelJobs::p, topSingleLeptonDQM_PU_cfi::pattern, and HLT_2023v12_cff::track.
Referenced by analyze().
|
private |
Definition at line 3041 of file PrimaryVertexValidation.cc.
References ptOfProbe_, submitPVValidationJobs::runInfo, and runInfoTokenBR_.
Referenced by beginRun().
|
private |
Definition at line 1013 of file PrimaryVertexValidation.cc.
References hcalRecHitTable_cff::detId, PVValHelper::phase2, PixelSubdetector::PixelBarrel, PixelSubdetector::PixelEndcap, and DetId::Tracker.
Referenced by analyze().
|
private |
Definition at line 3325 of file PrimaryVertexValidation.cc.
References funct::abs(), PVValHelper::dxy, PVValHelper::dz, reco::TrackBase::qualityByName(), mathSSE::sqrt(), HLT_2023v12_cff::track, and bphysicsOniaDQM_cfi::vertex.
|
private |
Definition at line 1047 of file PrimaryVertexValidation.cc.
References AlCaHLTBitMon_ParallelJobs::p, and HLT_2023v12_cff::track.
Referenced by analyze().
|
private |
Definition at line 3053 of file PrimaryVertexValidation.cc.
References Beamdxdz_, Beamsigmaz_, BeamWidthX_, BeamWidthY_, BSx0_, BSy0_, BSz0_, charge_, chi2_, chi2ndof_, chi2normUnbiasedVertex_, chi2ProbUnbiasedVertex_, chi2UnbiasedVertex_, d3DErrorFromMyVertex_, d3DFromMyVertex_, DOFUnbiasedVertex_, dxy_, dxyBs_, dxyErrorFromMyVertex_, dxyFromMyVertex_, dz_, dzBs_, dzErrorFromMyVertex_, dzFromMyVertex_, eta_, hasRecVertex_, mps_fire::i, IP3DsigFromMyVertex_, IPLsigFromMyVertex_, IPTsigFromMyVertex_, isGoodTrack_, isHighPurity_, LuminosityBlockNumber_, nClus_, nhits1D_, nhits2D_, nhits_, nhitsBPIX_, nhitsFPIX_, nhitsTEC_, nhitsTIB_, nhitsTID_, nhitsTOB_, nMaxtracks_, nOfflineVertices_, nTracks_, p_, phi_, pt_, qoverp_, RunNumber_, sumOfWeightsUnbiasedVertex_, theta_, tracksUsedForVertexing_, wxy2_, xErrOfflineVertex_, xOfflineVertex_, xPCA_, xUnbiasedVertex_, yErrOfflineVertex_, yOfflineVertex_, yPCA_, yUnbiasedVertex_, zErrOfflineVertex_, zOfflineVertex_, zPCA_, and zUnbiasedVertex_.
Referenced by analyze().
|
private |
|
inlineprivate |
|
staticprivate |
Definition at line 3315 of file PrimaryVertexValidation.cc.
References a, b, and funct::true.
Referenced by analyze().
|
private |
Definition at line 350 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 349 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
Definition at line 376 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 332 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 331 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
Definition at line 541 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 526 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 577 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 463 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 554 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 396 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 576 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 462 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 329 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 555 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 397 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 507 of file PrimaryVertexValidation.h.
Referenced by endJob().
Definition at line 384 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 513 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 440 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 441 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 593 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 493 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 435 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 436 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 525 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 572 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 458 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 549 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 391 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 571 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 457 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 328 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 550 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 392 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 418 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 419 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 413 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 414 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
Definition at line 374 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 485 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 479 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 599 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 499 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 335 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 334 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
Definition at line 542 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 529 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 579 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 465 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 556 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 398 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 578 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 464 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 338 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 557 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 399 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 508 of file PrimaryVertexValidation.h.
Referenced by endJob().
Definition at line 385 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 514 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 442 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 443 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 594 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 494 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 437 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 438 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 528 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 574 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 460 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 551 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 393 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 573 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 459 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 337 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 552 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 394 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 420 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 421 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 415 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 416 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
Definition at line 375 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 486 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 480 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 600 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 500 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 341 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 340 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 344 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 343 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 347 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 346 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 177 of file PrimaryVertexValidation.h.
Referenced by analyze().
|
private |
Definition at line 246 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 245 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 247 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 248 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 242 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 243 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 244 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 269 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 267 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 268 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 281 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 283 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 282 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
staticprivate |
Definition at line 212 of file PrimaryVertexValidation.h.
Referenced by analyze().
|
private |
Definition at line 162 of file PrimaryVertexValidation.h.
Referenced by beginJob().
|
private |
Definition at line 294 of file PrimaryVertexValidation.h.
Referenced by analyze(), and SetVarToZero().
|
private |
Definition at line 290 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 195 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginRun(), getRunTime(), and PrimaryVertexValidation().
|
private |
Definition at line 178 of file PrimaryVertexValidation.h.
Referenced by analyze().
|
private |
Definition at line 179 of file PrimaryVertexValidation.h.
Referenced by analyze().
|
private |
Definition at line 284 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 272 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 273 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 292 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 288 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 271 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 274 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 293 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 289 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 264 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 182 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), beginRun(), and PrimaryVertexValidation().
|
private |
Definition at line 232 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 199 of file PrimaryVertexValidation.h.
Referenced by analyze().
|
private |
Definition at line 303 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 159 of file PrimaryVertexValidation.h.
Referenced by beginRun().
|
private |
Definition at line 628 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 629 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 677 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 678 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 622 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 623 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 624 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 619 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 620 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 621 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 704 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 719 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), beginRun(), and endJob().
|
private |
Definition at line 717 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and beginRun().
|
private |
Definition at line 716 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and beginRun().
|
private |
Definition at line 711 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), beginRun(), and endJob().
|
private |
Definition at line 699 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 705 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 720 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), beginRun(), and endJob().
|
private |
Definition at line 712 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), beginRun(), and endJob().
|
private |
Definition at line 700 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 314 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and beginRun().
|
private |
Definition at line 683 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 685 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 686 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 682 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 684 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 688 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 687 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 610 of file PrimaryVertexValidation.h.
Referenced by beginJob().
|
private |
Definition at line 315 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and beginRun().
|
private |
Definition at line 607 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 316 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and beginRun().
|
private |
Definition at line 317 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and beginRun().
|
private |
Definition at line 608 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 706 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 721 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), beginRun(), and endJob().
|
private |
Definition at line 713 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), beginRun(), and endJob().
|
private |
Definition at line 701 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 707 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 722 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), beginRun(), and endJob().
|
private |
Definition at line 714 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 702 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 606 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 638 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 636 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 647 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 651 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 642 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 645 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 641 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 644 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 634 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 674 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 663 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 664 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 662 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 669 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 670 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 668 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 665 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 667 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 666 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 676 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 672 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 673 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 637 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 631 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 635 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 632 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 633 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 639 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 655 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 654 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 659 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 658 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 660 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 657 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 656 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 652 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 650 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 648 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 318 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and beginRun().
|
private |
Definition at line 691 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 692 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 690 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 693 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 322 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 611 of file PrimaryVertexValidation.h.
Referenced by beginJob().
|
private |
Definition at line 612 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and beginRun().
|
private |
Definition at line 609 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and beginRun().
|
private |
Definition at line 321 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 616 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 613 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 617 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 614 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 618 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 615 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 300 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 695 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 174 of file PrimaryVertexValidation.h.
Referenced by beginJob().
|
private |
Definition at line 298 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 297 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 296 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 301 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 263 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 164 of file PrimaryVertexValidation.h.
Referenced by beginJob().
|
private |
Definition at line 233 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 308 of file PrimaryVertexValidation.h.
Referenced by beginJob().
|
private |
Definition at line 154 of file PrimaryVertexValidation.h.
Referenced by analyze().
|
private |
Definition at line 191 of file PrimaryVertexValidation.h.
Referenced by beginRun(), and PrimaryVertexValidation().
|
private |
Definition at line 310 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 305 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 307 of file PrimaryVertexValidation.h.
Referenced by beginJob().
|
private |
Definition at line 190 of file PrimaryVertexValidation.h.
Referenced by beginRun(), and PrimaryVertexValidation().
|
private |
Definition at line 224 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), beginRun(), and PrimaryVertexValidation().
|
private |
Definition at line 370 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 369 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
Definition at line 380 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
Definition at line 544 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 534 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 587 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 473 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 564 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 406 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 586 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 472 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 355 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 565 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 407 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 510 of file PrimaryVertexValidation.h.
Referenced by endJob().
Definition at line 386 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 516 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 450 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 451 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 596 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 496 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 445 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 446 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 533 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 582 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 468 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 559 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 401 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 581 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 467 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 354 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 560 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 402 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 428 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 429 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 423 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 424 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
Definition at line 378 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 488 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 482 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 602 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 502 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
Definition at line 545 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 537 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 589 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 475 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 566 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 408 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 588 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 474 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 358 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 567 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 409 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 511 of file PrimaryVertexValidation.h.
Referenced by endJob().
Definition at line 387 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 517 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 452 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 453 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 597 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 497 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 447 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 448 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 536 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 584 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 470 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 561 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 403 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 583 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 469 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 357 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 562 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 404 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 430 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 431 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 425 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 426 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
Definition at line 379 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 489 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 483 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 603 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 503 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 361 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 360 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 364 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 363 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 367 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 366 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 187 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), beginRun(), endJob(), fillTrendPlot(), and PrimaryVertexValidation().
|
private |
Definition at line 229 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 143 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 255 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 256 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 254 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 257 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 258 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 183 of file PrimaryVertexValidation.h.
Referenced by analyze().
|
private |
Definition at line 262 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 259 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 260 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 261 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 216 of file PrimaryVertexValidation.h.
Referenced by beginJob(), beginRun(), and endJob().
|
staticprivate |
Definition at line 149 of file PrimaryVertexValidation.h.
|
staticprivate |
Definition at line 211 of file PrimaryVertexValidation.h.
Referenced by analyze(), and SetVarToZero().
|
private |
Definition at line 217 of file PrimaryVertexValidation.h.
Referenced by beginJob(), beginRun(), and endJob().
|
private |
Definition at line 230 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
staticprivate |
Definition at line 213 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 227 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 228 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 253 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 184 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginRun().
|
private |
Definition at line 266 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 181 of file PrimaryVertexValidation.h.
Referenced by analyze().
|
private |
Definition at line 252 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 180 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginRun(), and isBFieldConsistentWithMode().
|
private |
Definition at line 270 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 205 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 196 of file PrimaryVertexValidation.h.
Referenced by analyze().
|
private |
Definition at line 193 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and PrimaryVertexValidation().
|
private |
Definition at line 160 of file PrimaryVertexValidation.h.
Referenced by getRunTime(), and isBFieldConsistentWithMode().
|
private |
Definition at line 231 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), beginRun(), and SetVarToZero().
|
private |
Definition at line 320 of file PrimaryVertexValidation.h.
Referenced by beginRun(), and endJob().
|
private |
Definition at line 163 of file PrimaryVertexValidation.h.
Referenced by analyze().
|
private |
Definition at line 285 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 203 of file PrimaryVertexValidation.h.
Referenced by analyze(), and PrimaryVertexValidation().
|
private |
Definition at line 168 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), bookResidualsHistogram(), fillMap(), fillTrendPlot(), fillTrendPlotByIndex(), and PrimaryVertexValidation().
|
private |
Definition at line 265 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 146 of file PrimaryVertexValidation.h.
Referenced by analyze(), and PrimaryVertexValidation().
|
private |
Definition at line 201 of file PrimaryVertexValidation.h.
Referenced by analyze(), and PrimaryVertexValidation().
|
private |
Definition at line 145 of file PrimaryVertexValidation.h.
Referenced by analyze(), and PrimaryVertexValidation().
|
private |
Definition at line 202 of file PrimaryVertexValidation.h.
Referenced by analyze(), and PrimaryVertexValidation().
|
private |
Definition at line 157 of file PrimaryVertexValidation.h.
Referenced by analyze().
|
private |
Definition at line 158 of file PrimaryVertexValidation.h.
Referenced by beginRun().
|
private |
Definition at line 155 of file PrimaryVertexValidation.h.
Referenced by analyze().
|
private |
Definition at line 286 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 156 of file PrimaryVertexValidation.h.
Referenced by analyze().
|
private |
Definition at line 165 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 171 of file PrimaryVertexValidation.h.
Referenced by analyze().
|
private |
Definition at line 311 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 306 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 249 of file PrimaryVertexValidation.h.
Referenced by analyze(), fillTrackHistos(), and SetVarToZero().
|
private |
Definition at line 238 of file PrimaryVertexValidation.h.
Referenced by analyze(), and SetVarToZero().
|
private |
Definition at line 234 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 275 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 278 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 239 of file PrimaryVertexValidation.h.
Referenced by analyze(), and SetVarToZero().
|
private |
Definition at line 235 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 276 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 279 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 240 of file PrimaryVertexValidation.h.
Referenced by analyze(), and SetVarToZero().
|
private |
Definition at line 236 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 277 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 280 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().