#include <Alignment/OfflineValidation/plugins/PrimaryVertexValidation.cc>
Private Member Functions | |
void | add (std::map< std::string, TH1 * > &h, TH1 *hist) |
virtual void | analyze (const edm::Event &, const edm::EventSetup &) override |
virtual void | beginJob () 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) |
virtual void | endJob () 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_) |
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::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 |
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_ = 1000 |
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 |
Static Public Member Functions inherited from edm::one::EDAnalyzerBase | |
static const std::string & | baseType () |
static void | fillDescriptions (ConfigurationDescriptions &descriptions) |
static void | prevalidate (ConfigurationDescriptions &descriptions) |
Protected Member Functions inherited from edm::EDConsumerBase | |
template<typename ProductType , BranchType B = InEvent> | |
EDGetTokenT< ProductType > | consumes (edm::InputTag const &tag) |
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 ProductType , BranchType B = InEvent> | |
void | consumesMany () |
void | consumesMany (const TypeToGet &id) |
template<BranchType B> | |
void | consumesMany (const TypeToGet &id) |
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) |
Description: Validate alignment constants using unbiased vertex residuals
Implementation: <Notes on="" implementation>="">
Definition at line 67 of file PrimaryVertexValidation.h.
|
explicit |
Definition at line 69 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, TFileService::kSharedResource, PVValHelper::ladder, PVValHelper::modZ, 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, and PVValHelper::histodetails::trendbins.
|
override |
Definition at line 168 of file PrimaryVertexValidation.cc.
|
private |
Referenced by counter.Counter::register(), SequenceTypes.Task::remove(), and SequenceTypes.Task::replace().
|
overrideprivatevirtual |
Definition at line 181 of file PrimaryVertexValidation.cc.
References a_d3DEtaResiduals, a_d3DPhiResiduals, a_d3DResidualsMap, a_dxEtaResiduals, a_dxPhiResiduals, a_dxyBiasResidualsMap, a_dxyEtaBiasResiduals, a_dxyEtaResiduals, a_dxyPhiBiasResiduals, a_dxyPhiResiduals, a_dxyResidualsMap, a_dxyVsEta, a_dxyVsPhi, a_dyEtaResiduals, a_dyPhiResiduals, a_dzBiasResidualsMap, a_dzEtaBiasResiduals, a_dzEtaResiduals, 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_, ecalDrivenElectronSeedsParameters_cff::beamSpot, reco::BeamSpot::BeamWidthX(), BeamWidthX_, reco::BeamSpot::BeamWidthY(), BeamWidthY_, BSx0_, BSy0_, BSz0_, TransientTrackBuilder::build(), reco::TrackBase::charge(), charge_, reco::Vertex::chi2(), reco::TrackBase::chi2(), chi2_, chi2ndof_, chi2normUnbiasedVertex_, chi2ProbUnbiasedVertex_, chi2UnbiasedVertex_, TrackClusterizerInZ::clusterize(), fastPrimaryVertexProducer_cfi::clusters, cmToum, allConversions_cfi::d0, reco::TrackBase::d0Error(), d3DErrorFromMyVertex_, d3DFromMyVertex_, debug_, TrackerGeometry::dets(), doBPix_, doFPix_, DOFUnbiasedVertex_, reco::BeamSpot::dxdz(), reco::TrackBase::dxy(), dxy_, dxyBs_, dxyErrorFromMyVertex_, dxyFromMyVertex_, reco::TrackBase::dz(), dz_, dzBs_, reco::TrackBase::dzError(), dzErrorFromMyVertex_, dzFromMyVertex_, PVValHelper::eta, reco::TrackBase::eta(), eta_, etaOfProbe_, edm::EventID::event(), edm::Event::eventAuxiliary(), EventNumber_, PVValHelper::fillByIndex(), fillTrackHistos(), TrackingRecHit::geographicalId(), edm::EventSetup::get(), edm::Event::getByToken(), h2_probeEtaPhi_, h2_probeEtaPt_, 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_nbins, h_nClus, h_nLadders, 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_probeL1Ladder_, h_probeL1Module_, h_probeNormChi2_, h_probeP_, h_probePhi_, h_probePt_, 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_runFromEvent, h_runNumber, h_xErrOfflineVertex, h_xOfflineVertex, h_yErrOfflineVertex, h_yOfflineVertex, h_zErrOfflineVertex, h_zOfflineVertex, hasFirstLayerPixelHits(), hasRecVertex_, hDA, reco::TrackBase::hitPattern(), hfClusterShapes_cfi::hits, mps_fire::i, edm::EventAuxiliary::id(), createfilelist::int, IP3DsigFromMyVertex_, IPLsigFromMyVertex_, IPTsigFromMyVertex_, isBFieldConsistentWithMode(), isGoodTrack_, isHighPurity_, isHit2D(), isPhase1_, TrackerGeometry::isThere(), reco::Vertex::isValid(), edm::HandleBase::isValid(), TrackingRecHit::isValid(), LogDebug, LogTrace, PerigeeTrajectoryParameters::longitudinalImpactParameter(), PerigeeTrajectoryError::longitudinalImpactParameterError(), edm::EventAuxiliary::luminosityBlock(), LuminosityBlockNumber_, M_PI, min(), mypT_bins_, n_d3DEtaResiduals, n_d3DPhiResiduals, n_d3DResidualsMap, n_dxyBiasResidualsMap, n_dxyEtaBiasResiduals, n_dxyEtaResiduals, n_dxyPhiBiasResiduals, n_dxyPhiResiduals, n_dxyResidualsMap, n_dxyVsEta, n_dxyVsPhi, n_dzBiasResidualsMap, n_dzEtaBiasResiduals, n_dzEtaResiduals, n_dzPhiBiasResiduals, n_dzPhiResiduals, n_dzResidualsMap, n_dzVsEta, n_dzVsPhi, n_IP2DEtaResiduals, n_IP2DPhiResiduals, n_IP3DEtaResiduals, n_IP3DPhiResiduals, n_reszEtaResiduals, n_reszPhiResiduals, nBins_, nClus_, reco::Vertex::ndof(), Nevt_, nhits1D_, nhits2D_, nhits_, nhitsBPIX_, nhitsFPIX_, nHitsOfProbe_, nhitsTEC_, nhitsTIB_, nhitsTID_, nhitsTOB_, nLadders_, nMaxtracks_, nOfflineVertices_, reco::Vertex::normalizedChi2(), reco::TrackBase::normalizedChi2(), nPtBins_, nTracks_, nTracksPerClus_, reco::TrackBase::numberOfValidHits(), reco::HitPattern::numberOfValidPixelBarrelHits(), reco::HitPattern::numberOfValidPixelEndcapHits(), reco::HitPattern::numberOfValidStripTECHits(), reco::HitPattern::numberOfValidStripTIBHits(), reco::HitPattern::numberOfValidStripTIDHits(), reco::HitPattern::numberOfValidStripTOBHits(), reco::TrackBase::p(), GeomDetEnumerators::P1PXB, GeomDetEnumerators::P1PXEC, p_, TrajectoryStateClosestToPoint::perigeeError(), TrajectoryStateClosestToPoint::perigeeParameters(), PVValHelper::phi, reco::TrackBase::phi(), phi_, PixelSubdetector::PixelBarrel, pixelHitsCheck(), pOfProbe_, point, FreeTrajectoryState::position(), TrajectoryStateClosestToPoint::position(), reco::Vertex::position(), position, funct::pow(), edm::ESHandle< T >::product(), EnergyCorrector::pt, reco::TrackBase::pt(), pt_, ptOfProbe_, MetAnalyzer::pv(), reco::TrackBase::px(), TrackerTopology::pxbLadder(), TrackerTopology::pxbLayer(), TrackerTopology::pxbModule(), reco::TrackBase::py(), reco::TrackBase::pz(), reco::TrackBase::qoverp(), qoverp_, reco::TrackBase::quality(), reco::Track::recHitsBegin(), reco::Track::recHitsEnd(), rootTree_, edm::EventAuxiliary::run(), runControl_, runControlNumbers_, RunNumber_, TrackFilterForPVFindingBase::select(), reco::TransientTrack::setBeamSpot(), SetVarToZero(), PVValHelper::shrinkHistVectorToFit(), reco::BeamSpot::sigmaZ(), IPTools::signedImpactParameter3D(), IPTools::signedTransverseImpactParameter(), mathSSE::sqrt(), storeNtuple_, DetId::subdetId(), sumOfWeightsUnbiasedVertex_, funct::tan(), theBeamspotToken, theDetails_, TrajectoryStateClosestToPoint::theState(), reco::TrackBase::theta(), theta_, theTrackClusterizer_, theTrackCollectionToken, theTrackFilter_, theVertexCollectionToken, HiIsolationCommonParameters_cff::track, l1t::tracks, reco::Vertex::tracks_begin(), reco::Vertex::tracks_end(), reco::Vertex::tracksSize(), tracksUsedForVertexing_, PerigeeConversions::trajectoryStateClosestToPoint(), PerigeeTrajectoryParameters::transverseImpactParameter(), PVValHelper::histodetails::trendbins, groupFilesInBlocks::tt, useTracksFromRecoVtx_, reco::TrackBase::vertex(), vertexZMax_, ecalDrivenElectronSeedsParameters_cff::vertices, vtxSort(), cms::Exception::what(), wxy2_, x, PV3DBase< T, PVType, FrameType >::x(), reco::BeamSpot::x0(), xErrOfflineVertex_, xOfflineVertex_, xPCA_, xUnbiasedVertex_, y, PV3DBase< T, PVType, FrameType >::y(), reco::BeamSpot::y0(), yErrOfflineVertex_, yOfflineVertex_, yPCA_, yUnbiasedVertex_, z, reco::BeamSpot::z0(), zErrOfflineVertex_, zOfflineVertex_, zPCA_, zUnbiasedVertex_, and CombinatorialSeedGeneratorForCosmicsRegionalReconstruction_cfi::zVertex.
|
overrideprivatevirtual |
Reimplemented from edm::one::EDAnalyzerBase.
Definition at line 1128 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_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_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_, 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_, fs, PVValHelper::histodetails::getHigh(), h2_probeEtaPhi_, h2_probeEtaPt_, 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_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_probeL1Ladder_, h_probeL1Module_, h_probeNormChi2_, h_probeP_, h_probePhi_, h_probePt_, 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_runFromConfig, h_runFromEvent, h_runNumber, h_xErrOfflineVertex, h_xOfflineVertex, h_yErrOfflineVertex, h_yOfflineVertex, h_zErrOfflineVertex, h_zOfflineVertex, hasRecVertex_, hDA, PVValHelper::histodetails::histobins, mps_fire::i, intLumi_, PVValHelper::IP2D, PVValHelper::IP3D, IP3DsigFromMyVertex_, IPLsigFromMyVertex_, IPTsigFromMyVertex_, isGoodTrack_, isHighPurity_, PVValHelper::ladder, lightNtupleSwitch_, 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_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_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_, 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_, alignCSCRings::r, PVValHelper::resz, rootTree_, runControlNumbers_, RunNumber_, sumOfWeightsUnbiasedVertex_, theDetails_, theta_, tracksUsedForVertexing_, PVValHelper::histodetails::trendbins, useTracksFromRecoVtx_, Width2DMapsDir, WidthTrendsDir, xOfflineVertex_, xPCA_, xUnbiasedVertex_, yOfflineVertex_, yPCA_, yUnbiasedVertex_, zOfflineVertex_, zPCA_, and zUnbiasedVertex_.
|
private |
Definition at line 2650 of file PrimaryVertexValidation.cc.
References down, PVValHelper::eta, PVValHelper::getTypeString(), PVValHelper::getVarString(), h, cond::hash, PVValHelper::histodetails::histobins, mps_fire::i, TFileDirectory::make(), PVValHelper::phi, PVValHelper::histodetails::range, AlCaHLTBitMon_QueryRunRegistry::string, theDetails_, fftjetcommon_cfi::title, PVValHelper::histodetails::trendbins, units(), and up.
Referenced by beginJob().
|
private |
Definition at line 2596 of file PrimaryVertexValidation.cc.
References h, M_PI, TFileDirectory::make(), AlCaHLTBitMon_QueryRunRegistry::string, and cutBasedMuonId_MuonPOG_V0_cff::types.
Referenced by beginJob().
|
overrideprivatevirtual |
Reimplemented from edm::one::EDAnalyzerBase.
Definition at line 2041 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_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_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, PVValHelper::eta, fillMap(), fillTrendPlotByIndex(), 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_, PVValHelper::MAD, TFileDirectory::make(), PVValHelper::MEAN, MeanTrendsDir, PVValHelper::MEDIAN, n_dxyBiasResidualsMap, n_dxyEtaBiasResiduals, n_dxyEtaMADBiasTrend, n_dxyEtaMADTrend, n_dxyEtaMeanBiasTrend, n_dxyEtaMeanTrend, n_dxyEtaMedianBiasTrend, n_dxyEtaMedianTrend, n_dxyEtaResiduals, n_dxyEtaWidthBiasTrend, n_dxyEtaWidthTrend, 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_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, Nevt_, nLadders_, nModZ_, PVValHelper::phi, useTracksFromRecoVtx_, PVValHelper::WIDTH, and WidthTrendsDir.
Referenced by o2olib.O2ORunMgr::executeJob().
|
private |
|
private |
|
private |
|
private |
Definition at line 2497 of file PrimaryVertexValidation.cc.
References Measurement1D::error(), PVValHelper::eta, PVValHelper::fitResiduals(), PVValHelper::getMAD(), PVValHelper::getMedian(), mps_fire::i, PVValHelper::MAD, PVValHelper::MEAN, PVValHelper::MEDIAN, nBins_, PVValHelper::phi, theDetails_, PVValHelper::histodetails::trendbins, Measurement1D::value(), and PVValHelper::WIDTH.
Referenced by endJob().
|
private |
Definition at line 2700 of file PrimaryVertexValidation.cc.
References funct::abs(), reco::TrackBase::algo(), Reference_intrackfit_cff::barrel, reco::BeamSpot::BeamWidthX(), reco::BeamSpot::BeamWidthY(), funct::cos(), allConversions_cfi::d0, reco::TrackBase::d0Error(), DEFINE_FWK_MODULE, reco::TrackBase::dxy(), PVValHelper::dz, reco::TrackBase::dz(), reco::TrackBase::dzError(), reco::TrackBase::eta(), PVValHelper::fill(), objects.autophobj::float, reco::Track::found(), reco::TrackBase::hitPattern(), reco::Track::innerPosition(), edm::Ref< C, T, F >::isNonnull(), reco::Vertex::isValid(), kappa, reco::TrackBase::lambda(), cmsBatch::log, reco::Track::lost(), reco::TrackBase::normalizedChi2(), reco::HitPattern::numberOfHits(), reco::TrackBase::p(), reco::TrackBase::phi(), PixelSubdetector::PixelBarrel, reco::HitPattern::pixelBarrelLayersWithMeasurement(), reco::HitPattern::pixelLayersWithMeasurement(), reco::BeamSpot::position(), reco::Vertex::position(), position, funct::pow(), reco::TrackBase::pt(), lumiQueryAPI::q, reco::TrackBase::qoverp(), reco::TrackBase::qualityMask(), reco::Track::recHitsBegin(), reco::Track::recHitsEnd(), funct::sin(), mathSSE::sqrt(), reco::TransientTrack::stateAtBeamLine(), funct::tan(), reco::TrackBase::theta(), reco::TransientTrack::track(), DetId::Tracker, reco::HitPattern::trackerLayersWithMeasurement(), TrajectoryStateClosestToBeamLine::trackStateAtPCA(), reco::TrackBase::vx(), reco::TrackBase::vy(), reco::TrackBase::vz(), wxy2_, reco::BeamSpot::x0(), reco::BeamSpot::y0(), and z.
Referenced by analyze().
|
private |
Definition at line 2367 of file PrimaryVertexValidation.cc.
References Measurement1D::error(), PVValHelper::eta, PVValHelper::fitResiduals(), PVValHelper::getMAD(), PVValHelper::getMedian(), mps_fire::i, PVValHelper::MAD, PVValHelper::MEAN, PVValHelper::MEDIAN, nBins_, PVValHelper::phi, theDetails_, PVValHelper::histodetails::trendbins, Measurement1D::value(), and PVValHelper::WIDTH.
|
private |
FIXME DO SOMETHING HERE
Definition at line 2431 of file PrimaryVertexValidation.cc.
References stringResolutionProvider_cfi::bin, SoftLeptonByDistance_cfi::distance, Measurement1D::error(), PVValHelper::eta, PVValHelper::fitResiduals(), PVValHelper::getMAD(), PVValHelper::getMedian(), PVValHelper::MAD, PVValHelper::MEAN, PVValHelper::MEDIAN, PVValHelper::phi, theDetails_, PVValHelper::histodetails::trendbins, Measurement1D::value(), and PVValHelper::WIDTH.
Referenced by endJob().
|
private |
|
private |
|
private |
|
private |
|
private |
|
private |
Definition at line 1110 of file PrimaryVertexValidation.cc.
References reco::HitPattern::getHitPattern(), reco::HitPattern::getLayer(), reco::TransientTrack::hitPattern(), mps_fire::i, reco::HitPattern::numberOfHits(), AlCaHLTBitMon_ParallelJobs::p, listBenchmarks::pattern, reco::HitPattern::pixelBarrelHitFilter(), reco::HitPattern::pixelEndcapHitFilter(), and reco::HitPattern::validHitFilter().
Referenced by analyze().
|
private |
Definition at line 2278 of file PrimaryVertexValidation.cc.
References RunInfo::m_avg_current, edm::ESHandle< T >::product(), and ptOfProbe_.
Referenced by analyze().
|
private |
Definition at line 1061 of file PrimaryVertexValidation.cc.
References TrackingRecHit::dimension(), TrackingRecHit::geographicalId(), PixelSubdetector::PixelBarrel, PixelSubdetector::PixelEndcap, and DetId::Tracker.
Referenced by analyze().
|
private |
Definition at line 2569 of file PrimaryVertexValidation.cc.
References funct::abs(), reco::TrackBase::d0Error(), PVValHelper::dxy, reco::TrackBase::dxy(), PVValHelper::dz, reco::TrackBase::dz(), reco::TrackBase::dzError(), reco::Vertex::position(), reco::TrackBase::pt(), reco::TrackBase::ptError(), reco::TrackBase::quality(), reco::TrackBase::qualityByName(), mathSSE::sqrt(), reco::Vertex::xError(), reco::Vertex::yError(), and reco::Vertex::zError().
|
private |
Definition at line 1092 of file PrimaryVertexValidation.cc.
References reco::TransientTrack::hitPattern(), reco::HitPattern::numberOfValidPixelBarrelHits(), reco::HitPattern::numberOfValidPixelEndcapHits(), and AlCaHLTBitMon_ParallelJobs::p.
Referenced by analyze().
|
private |
Definition at line 2292 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 2559 of file PrimaryVertexValidation.cc.
References reco::Vertex::chi2(), funct::false, and reco::Vertex::tracksSize().
Referenced by analyze().
|
private |
Definition at line 290 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 289 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
Definition at line 316 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 272 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 271 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
Definition at line 460 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 445 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 496 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 473 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 329 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 495 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 395 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 269 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 474 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 330 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 373 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 374 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 512 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 426 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 368 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 369 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 444 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 491 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 468 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 324 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 490 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 390 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 268 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 469 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 325 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 351 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 352 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 346 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 347 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
Definition at line 314 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 418 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 412 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 518 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 432 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 275 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 274 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
Definition at line 461 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 448 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 498 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 475 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 331 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 397 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 278 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 476 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 332 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 375 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 376 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 513 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 427 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 370 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 371 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 447 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 493 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 470 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 326 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 492 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 277 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 471 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 327 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 353 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 354 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 348 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 349 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
Definition at line 315 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 419 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 413 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 519 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 433 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 281 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 280 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 284 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 283 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 287 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 286 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 136 of file PrimaryVertexValidation.h.
Referenced by analyze().
|
private |
Definition at line 192 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 191 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 193 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 194 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 188 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 189 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 190 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 215 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 213 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 214 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 227 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 229 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 228 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
staticprivate |
Definition at line 161 of file PrimaryVertexValidation.h.
Referenced by analyze().
|
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 147 of file PrimaryVertexValidation.h.
Referenced by analyze(), and PrimaryVertexValidation().
|
private |
Definition at line 137 of file PrimaryVertexValidation.h.
Referenced by analyze().
|
private |
Definition at line 138 of file PrimaryVertexValidation.h.
Referenced by analyze().
|
private |
Definition at line 230 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 218 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 219 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 238 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 234 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 217 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 220 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 239 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 235 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 210 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 141 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and PrimaryVertexValidation().
|
private |
Definition at line 178 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 249 of file PrimaryVertexValidation.h.
Referenced by beginJob().
|
private |
Definition at line 547 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 548 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 541 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 542 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 543 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 538 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 539 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 540 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 618 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 633 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 631 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 630 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 625 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 613 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 619 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 634 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 626 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 614 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 260 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 597 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 599 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 600 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 596 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 598 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 602 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 601 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 529 of file PrimaryVertexValidation.h.
Referenced by beginJob().
|
private |
Definition at line 261 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 526 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 262 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 527 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 620 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 635 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 627 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 615 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 621 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 636 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 628 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 616 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 525 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 556 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 554 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 565 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 569 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 560 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 563 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 559 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 562 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 552 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 592 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 581 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 582 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 580 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 587 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 588 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 586 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 583 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 585 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 584 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 590 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 591 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 555 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 550 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 553 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 551 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 557 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 573 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 572 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 577 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 576 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 578 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 575 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 574 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 570 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 568 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 566 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 605 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 606 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 604 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 607 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 530 of file PrimaryVertexValidation.h.
Referenced by beginJob().
|
private |
Definition at line 531 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 528 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 535 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 532 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 536 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 533 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 537 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 534 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 246 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 609 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 133 of file PrimaryVertexValidation.h.
Referenced by beginJob().
|
private |
Definition at line 244 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 242 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 209 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 143 of file PrimaryVertexValidation.h.
Referenced by analyze().
|
private |
Definition at line 123 of file PrimaryVertexValidation.h.
Referenced by beginJob().
|
private |
Definition at line 179 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 254 of file PrimaryVertexValidation.h.
Referenced by beginJob().
|
private |
Definition at line 256 of file PrimaryVertexValidation.h.
Referenced by beginJob().
|
private |
Definition at line 251 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 253 of file PrimaryVertexValidation.h.
Referenced by beginJob().
|
private |
Definition at line 170 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 310 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 309 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
Definition at line 320 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
Definition at line 463 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 453 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 506 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 483 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 339 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 505 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 405 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 295 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 484 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 340 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 383 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 384 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 515 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 378 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 379 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 452 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 501 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 478 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 334 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 400 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 294 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 479 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 335 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 361 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 362 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 356 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 357 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
Definition at line 318 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 421 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 415 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 521 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 435 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
Definition at line 464 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 456 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 508 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 485 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 341 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 507 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 298 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 486 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 342 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 385 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 386 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 516 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 380 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 381 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 455 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 503 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 480 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 336 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 502 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 297 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 481 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 337 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 363 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 364 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 358 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 359 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
Definition at line 319 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 422 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 416 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 522 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 436 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 301 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 300 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 304 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 303 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 307 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 306 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 144 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), fillMap(), fillTrendPlot(), and PrimaryVertexValidation().
|
private |
Definition at line 175 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 113 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 201 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 202 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 200 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 203 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 204 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 142 of file PrimaryVertexValidation.h.
Referenced by analyze().
|
private |
Definition at line 208 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 205 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 206 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 207 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 164 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
staticprivate |
Definition at line 119 of file PrimaryVertexValidation.h.
|
staticprivate |
Definition at line 160 of file PrimaryVertexValidation.h.
Referenced by analyze(), and SetVarToZero().
|
private |
Definition at line 165 of file PrimaryVertexValidation.h.
Referenced by endJob().
|
private |
Definition at line 176 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
staticprivate |
Definition at line 162 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 173 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 174 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 199 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 212 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 140 of file PrimaryVertexValidation.h.
Referenced by analyze().
|
private |
Definition at line 198 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 139 of file PrimaryVertexValidation.h.
Referenced by analyze(), and isBFieldConsistentWithMode().
|
private |
Definition at line 216 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 154 of file PrimaryVertexValidation.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 148 of file PrimaryVertexValidation.h.
Referenced by analyze().
|
private |
Definition at line 145 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and PrimaryVertexValidation().
|
private |
Definition at line 177 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 122 of file PrimaryVertexValidation.h.
Referenced by analyze().
|
private |
Definition at line 231 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 152 of file PrimaryVertexValidation.h.
Referenced by analyze(), and PrimaryVertexValidation().
|
private |
Definition at line 112 of file PrimaryVertexValidation.h.
|
private |
Definition at line 127 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), bookResidualsHistogram(), fillMap(), fillTrendPlot(), fillTrendPlotByIndex(), and PrimaryVertexValidation().
|
private |
Definition at line 211 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 116 of file PrimaryVertexValidation.h.
Referenced by analyze(), and PrimaryVertexValidation().
|
private |
Definition at line 150 of file PrimaryVertexValidation.h.
Referenced by analyze(), and PrimaryVertexValidation().
|
private |
Definition at line 115 of file PrimaryVertexValidation.h.
Referenced by analyze(), and PrimaryVertexValidation().
|
private |
Definition at line 151 of file PrimaryVertexValidation.h.
Referenced by analyze(), and PrimaryVertexValidation().
|
private |
Definition at line 232 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 124 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and endJob().
|
private |
Definition at line 130 of file PrimaryVertexValidation.h.
Referenced by analyze().
|
private |
Definition at line 257 of file PrimaryVertexValidation.h.
Referenced by beginJob().
|
private |
Definition at line 252 of file PrimaryVertexValidation.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 195 of file PrimaryVertexValidation.h.
Referenced by analyze(), fillTrackHistos(), and SetVarToZero().
|
private |
Definition at line 184 of file PrimaryVertexValidation.h.
Referenced by analyze(), and SetVarToZero().
|
private |
Definition at line 180 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 221 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 224 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 185 of file PrimaryVertexValidation.h.
Referenced by analyze(), and SetVarToZero().
|
private |
Definition at line 181 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 222 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 225 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 186 of file PrimaryVertexValidation.h.
Referenced by analyze(), and SetVarToZero().
|
private |
Definition at line 182 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 223 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().
|
private |
Definition at line 226 of file PrimaryVertexValidation.h.
Referenced by analyze(), beginJob(), and SetVarToZero().