#include <Calibration/EcalCalibAlgos/src/ZeeCalibration.cc>
Private Member Functions | |
void | bookHistograms () |
float | computeCoefficientDistanceAtIteration (float v1[250], float v2[250], int size) |
float | EvalDPhi (float Phi, float Phi_ref) |
float | EvalDR (float Eta, float Eta_ref, float Phi, float Phi_ref) |
double | fEtaBarrelBad (double scEta) const |
double | fEtaBarrelGood (double scEta) const |
double | fEtaEndcapBad (double scEta) const |
double | fEtaEndcapGood (double scEta) const |
void | fillEleInfo (std::vector< HepMC::GenParticle * > &a, std::map< HepMC::GenParticle *, const reco::GsfElectron * > &b) |
void | fillMCInfo (HepMC::GenParticle *mcele) |
void | fillMCmap (const std::vector< const reco::GsfElectron * > *electronCollection, const std::vector< HepMC::GenParticle * > &mcEle, std::map< HepMC::GenParticle *, const reco::GsfElectron * > &myMCmap) |
double | getEtaCorrection (const reco::GsfElectron *) |
std::pair< DetId, double > | getHottestDetId (const std::vector< std::pair< DetId, float > > &mySCRecHits, const EBRecHitCollection *ebhits, const EERecHitCollection *eehits) |
void | printStatistics () |
void | resetHistograms () |
void | resetVariables () |
int | ringNumberCorrector (int k) |
bool | xtalIsOnModuleBorder (EBDetId myEBDetId) |
Additional Inherited Members | |
Public Types inherited from edm::EDLooperBase | |
enum | Status { kContinue, kStop } |
Public Types inherited from edm::EDConsumerBase | |
typedef ProductLabels | Labels |
Static Public Member Functions inherited from edm::eventsetup::DataProxyProvider | |
static void | prevalidate (ConfigurationDescriptions &) |
Protected Types inherited from edm::ESProxyFactoryProducer | |
using | EventSetupRecordKey = eventsetup::EventSetupRecordKey |
Protected Types inherited from edm::eventsetup::DataProxyProvider | |
using | KeyedProxiesVector = std::vector< std::pair< DataKey, std::shared_ptr< DataProxy >>> |
Protected Member Functions inherited from edm::ESProducerLooper | |
void | registerFactoryWithKey (const eventsetup::EventSetupRecordKey &iRecord, std::unique_ptr< eventsetup::ProxyFactoryBase > iFactory, const std::string &iLabel=std::string()) override |
void | setIntervalFor (const eventsetup::EventSetupRecordKey &iKey, const IOVSyncValue &iTime, ValidityInterval &oInterval) override |
Protected Member Functions inherited from edm::ESProducer | |
template<typename T > | |
auto | setWhatProduced (T *iThis, const es::Label &iLabel={}) |
template<typename T > | |
auto | setWhatProduced (T *iThis, const char *iLabel) |
template<typename T > | |
auto | setWhatProduced (T *iThis, const std::string &iLabel) |
template<typename T , typename TDecorator > | |
auto | setWhatProduced (T *iThis, const TDecorator &iDec, const es::Label &iLabel={}) |
template<typename T , typename TReturn , typename TRecord > | |
auto | setWhatProduced (T *iThis, TReturn(T::*iMethod)(const TRecord &), const es::Label &iLabel={}) |
template<typename T , typename TReturn , typename TRecord , typename TArg > | |
ESConsumesCollectorT< TRecord > | setWhatProduced (T *iThis, TReturn(T::*iMethod)(const TRecord &), const TArg &iDec, const es::Label &iLabel={}) |
void | usesResources (std::vector< std::string > const &) |
Protected Member Functions inherited from edm::ESProxyFactoryProducer | |
template<class TFactory > | |
void | registerFactory (std::unique_ptr< TFactory > iFactory, const std::string &iLabel=std::string()) |
KeyedProxiesVector | registerProxies (const EventSetupRecordKey &, unsigned int iovIndex) override |
Protected Member Functions inherited from edm::eventsetup::DataProxyProvider | |
template<class T > | |
void | usingRecord () |
void | usingRecordWithKey (const EventSetupRecordKey &key) |
Protected Member Functions inherited from edm::EventSetupRecordIntervalFinder | |
template<class T > | |
void | findingRecord () |
void | findingRecordWithKey (const eventsetup::EventSetupRecordKey &) |
Protected Member Functions inherited from edm::EDLooperBase | |
ModuleChanger * | moduleChanger () |
This only returns a non-zero value during the call to endOfLoop. More... | |
ScheduleInfo const * | scheduleInfo () const |
This returns a non-zero value after the constructor has been called. More... | |
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 ProductType , BranchType B = InEvent> | |
void | consumesMany () |
void | consumesMany (const TypeToGet &id) |
template<BranchType B> | |
void | consumesMany (const TypeToGet &id) |
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: Perform single electron calibration (tested on TB data only).
Implementation: <Notes on="" implementation>="">
Definition at line 68 of file ZeeCalibration.h.
ZeeCalibration::ZeeCalibration | ( | const edm::ParameterSet & | iConfig | ) |
Constructor.
Definition at line 40 of file ZeeCalibration.cc.
References barrelfile_, calibMode_, coefficientDistanceAtIteration, gather_cfg::cout, electronSelection_, endcapfile_, etaBins_, etaMax_, etaMin_, etBins_, etMax_, etMin_, EcalIndexingTools::getInstance(), edm::ParameterSet::getParameter(), edm::ParameterSet::getUntrackedParameter(), mps_fire::i, iConfig, loopArray, mass4tree, massDiff4tree, maxInvMassCut_, minInvMassCut_, myTree, outputFile_, outputFileName_, produceEcalIntercalibConstants(), EcalIndexingTools::setBinRange(), edm::ESProducer::setWhatProduced(), sigmaArray, sigmaErrorArray, AlCaHLTBitMon_QueryRunRegistry::string, theAlgorithm_, theMaxLoops, theParameterSet, and wantEtaCorrection_.
|
override |
Destructor.
Definition at line 130 of file ZeeCalibration.cc.
|
overridevirtual |
Called at beginning of job.
Reimplemented from edm::EDLooperBase.
Definition at line 143 of file ZeeCalibration.cc.
References isfirstcall_.
|
private |
Definition at line 1463 of file ZeeCalibration.cc.
References ZeePlots::bookEleHistograms(), ZeePlots::bookEleMCHistograms(), ZeePlots::bookHLTHistograms(), ZeePlots::bookZHistograms(), ZeePlots::bookZMCHistograms(), h1_borderElectronClassification_, h1_eleClasses_, h1_electronCosTheta_SC_, h1_electronCosTheta_SC_TK_, h1_electronCosTheta_TK_, h1_eleEtaResol_, h1_elePhiResol_, h1_eventsAfterBorderSelection_, h1_eventsAfterEWKSelection_, h1_eventsBeforeBorderSelection_, h1_eventsBeforeEWKSelection_, h1_mc_, h1_mcEB_, h1_mcEBParz_, h1_mcEE_, h1_mcEEParz_, h1_mcParz_, h1_nEleReco_, h1_occupancy_, h1_occupancyBarrel_, h1_occupancyEndcap_, h1_occupancyVsEta_, h1_preshowerOverSC_, h1_reco_ZMass_, h1_reco_ZMassCorr_, h1_reco_ZMassCorrBB_, h1_reco_ZMassCorrEE_, h1_seedOverSC_, h1_weightSumMeanBarrel_, h1_weightSumMeanEndcap_, h1_ZCandMult_, h1_zEtaResol_, h1_zMassResol_, h1_zPhiResol_, h2_chi2_, h2_coeffVsEta_, h2_coeffVsEtaGrouped_, h2_coeffVsLoop_, h2_fEtaBarrelBad_, h2_fEtaBarrelGood_, h2_fEtaEndcapBad_, h2_fEtaEndcapGood_, h2_iterations_, h2_miscalRecal_, h2_miscalRecalEB_, h2_miscalRecalEE_, h2_residualSigma_, h2_xtalMiscalibCoeffBarrel_, h2_xtalMiscalibCoeffEndcapMinus_, h2_xtalMiscalibCoeffEndcapPlus_, h2_xtalRecalibCoeffBarrel_, h2_xtalRecalibCoeffEndcapMinus_, h2_xtalRecalibCoeffEndcapPlus_, h2_zMassDiffVsLoop_, h2_zMassVsLoop_, h2_zWidthVsLoop_, h_eleEffEta_, h_eleEffPhi_, h_eleEffPt_, h_ESCcorrEtrue_, h_ESCcorrEtrueVsEta_, h_ESCEtrue_, h_ESCEtrueVsEta_, mps_fire::i, and myZeePlots_.
Referenced by duringLoop().
|
private |
Definition at line 1974 of file ZeeCalibration.cc.
References funct::abs(), calibMode_, mps_fire::i, funct::pow(), ringNumberCorrector(), findQualityFiles::size, and mathSSE::sqrt().
Referenced by endOfLoop().
|
overridevirtual |
Called at each event.
START HERE....
Implements edm::EDLooper.
Definition at line 552 of file ZeeCalibration.cc.
References funct::abs(), ZIterativeAlgorithmWithFit::addEvent(), aHLTResults, BARREL_ELECTRONS_AFTER_BORDER_CUT, BARREL_ELECTRONS_BEFORE_BORDER_CUT, barrelfile_, BBZN, BBZN_gg, BBZN_t0, BBZN_tt, bookHistograms(), ZeeKinematicTools::calculateZMass_withTK(), ZeeKinematicTools::calculateZMassWithCorrectedElectrons_withTK(), calibCoeff, calibCoeffError, calibMode_, EcnaPython_AdcPeg12_S1_10_R170298_1_0_150_Dee0::cerr, RecoTauCleanerPlugins::charge, ZeeKinematicTools::cosThetaElectrons_SC(), ZeeKinematicTools::cosThetaElectrons_TK(), gather_cfg::cout, CRACK_ELECTRONS_IN_BARREL, CRACK_ELECTRONS_IN_ENDCAP, ebRecHitToken_, EBZN, EBZN_gg, EBZN_t0, EBZN_tt, EcalBarrel, EcalEndcap, eeRecHitToken_, EEZN, EEZN_gg, EEZN_t0, EEZN_tt, electronSelection_, endcapfile_, PVValHelper::eta, funct::exp(), ZeePlots::fillEleInfo(), fillEleInfo(), ZeePlots::fillEleMCInfo(), ZeePlots::fillHLTInfo(), fillMCmap(), ZeePlots::fillZInfo(), ZeePlots::fillZMCInfo(), EcalCondObjectContainer< T >::find(), first, GenParticle::GenParticle, relativeConstraints::geometry, geometryToken_, CaloMiscalibMapEcal::get(), edm::Event::getByToken(), edm::EventSetup::getData(), EcalRingCalibrationTools::getDetIdsInECAL(), EcalRingCalibrationTools::getDetIdsInModule(), EcalRingCalibrationTools::getDetIdsInRing(), getEtaCorrection(), getHottestDetId(), EcalCondObjectContainer< T >::getMap(), ZIterativeAlgorithmWithFit::getNumberOfChannels(), GOLDEN_ELECTRONS_IN_BARREL, GOLDEN_ELECTRONS_IN_ENDCAP, gsfElectronToken_, h1_borderElectronClassification_, h1_eleClasses_, h1_electronCosTheta_SC_, h1_electronCosTheta_SC_TK_, h1_electronCosTheta_TK_, h1_eventsAfterBorderSelection_, h1_eventsAfterEWKSelection_, h1_eventsBeforeBorderSelection_, h1_eventsBeforeEWKSelection_, h1_reco_ZMass_, h1_reco_ZMassCorr_, h1_reco_ZMassCorrBB_, h1_reco_ZMassCorrEE_, h1_ZCandMult_, h1_zMassResol_, h2_xtalMiscalibCoeffBarrel_, h2_xtalMiscalibCoeffEndcapMinus_, h2_xtalMiscalibCoeffEndcapPlus_, hepMCToken_, hltCount, mps_fire::i, ical, EBDetId::ieta(), init_, initCalibCoeff, EBDetId::iphi(), isfirstcall_, islandSCToken_, EEDetId::ix(), EEDetId::iy(), isotrackApplyRegressor::k, edm::EDLooperBase::kContinue, loopFlag_, mass, mass4tree, massDiff4tree, maxInvMassCut_, mcProducer_, MCZBB, MCZEB, MCZEE, minInvMassCut_, myTree, myZeePlots_, MZ, NEVT, outputFile_, AlCaHLTBitMon_ParallelJobs::p, MiscalibReaderFromXML::parseXMLMiscalibFile(), phits, CaloMiscalibMapEcal::prefillMap(), read_events, scToken_, edm::second(), EcalRingCalibrationTools::setCaloGeometry(), SHOWER_ELECTRONS_IN_BARREL, SHOWER_ELECTRONS_IN_ENDCAP, SILVER_ELECTRONS_IN_BARREL, SILVER_ELECTRONS_IN_ENDCAP, funct::sin(), mathSSE::sqrt(), theAlgorithm_, TOTAL_ELECTRONS_IN_BARREL, TOTAL_ELECTRONS_IN_ENDCAP, trigResultsToken_, wantEtaCorrection_, xtalIsOnModuleBorder(), and EEDetId::zside().
|
overridevirtual |
Called at end of job.
if not ETA_ET MODE - begin
if not ETA_ET MODE - end
Reimplemented from edm::EDLooperBase.
Definition at line 146 of file ZeeCalibration.cc.
References funct::abs(), calibCoeff, calibCoeffError, calibMode_, coefficientDistanceAtIteration, gather_cfg::cout, EcalBarrel, EcalEndcap, ZIterativeAlgorithmWithFit::getHistos(), ZIterativeAlgorithmWithFit::getNumberOfChannels(), ZIterativeAlgorithmWithFit::getNumberOfIterations(), h1_borderElectronClassification_, h1_eleClasses_, h1_electronCosTheta_SC_, h1_electronCosTheta_SC_TK_, h1_electronCosTheta_TK_, h1_eleEtaResol_, h1_elePhiResol_, h1_eventsAfterBorderSelection_, h1_eventsAfterEWKSelection_, h1_eventsBeforeBorderSelection_, h1_eventsBeforeEWKSelection_, h1_mc_, h1_mcEB_, h1_mcEE_, h1_occupancy_, h1_occupancyBarrel_, h1_occupancyEndcap_, h1_occupancyVsEta_, h1_preshowerOverSC_, h1_reco_ZMass_, h1_reco_ZMassCorr_, h1_reco_ZMassCorrBB_, h1_reco_ZMassCorrEE_, h1_seedOverSC_, h1_weightSumMeanBarrel_, h1_weightSumMeanEndcap_, h1_ZCandMult_, h1_zEtaResol_, h1_zMassResol_, h1_zPhiResol_, h2_chi2_, h2_coeffVsEta_, h2_coeffVsEtaGrouped_, h2_coeffVsLoop_, h2_fEtaBarrelBad_, h2_fEtaBarrelGood_, h2_fEtaEndcapBad_, h2_fEtaEndcapGood_, h2_iterations_, h2_miscalRecal_, h2_miscalRecalEB_, h2_miscalRecalEE_, h2_residualSigma_, h2_xtalMiscalibCoeffBarrel_, h2_xtalMiscalibCoeffEndcapMinus_, h2_xtalMiscalibCoeffEndcapPlus_, h2_zMassDiffVsLoop_, h2_zMassVsLoop_, h2_zWidthVsLoop_, h_eleEffEta_, h_eleEffPhi_, h_eleEffPt_, h_ESCcorrEtrue_, h_ESCcorrEtrueVsEta_, h_ESCEtrue_, h_ESCEtrueVsEta_, mps_fire::i, cuy::ib, ical, gpuClustering::id, initCalibCoeff, EEDetId::IX_MAX, EEDetId::IX_MIN, EEDetId::IY_MAX, EEDetId::IY_MIN, dqmiolumiharvest::j, isotrackApplyRegressor::k, loopArray, EBDetId::MAX_IETA, EBDetId::MAX_IPHI, SiStripPI::mean, EBDetId::MIN_IPHI, myTree, myZeePlots_, pileupDistInMC::num, outputFile_, funct::pow(), printStatistics(), DetId::rawId(), ringNumberCorrector(), SiStripPI::rms, sigmaArray, sigmaErrorArray, mathSSE::sqrt(), theAlgorithm_, theMaxLoops, EBDetId::validDetId(), EEDetId::validDetId(), ZIterativeAlgorithmWithFit::ZIterativeAlgorithmWithFitPlots::weightedRescaleFactor, ZeePlots::writeEleHistograms(), calibXMLwriter::writeLine(), ZeePlots::writeMCEleHistograms(), ZeePlots::writeMCZHistograms(), ZeePlots::writeZHistograms(), and SiPixelPI::zero.
|
overridevirtual |
Called at end of loop.
Implements edm::EDLooperBase.
Definition at line 1295 of file ZeeCalibration.cc.
References funct::abs(), calibCoeff, calibCoeffError, calibMode_, coefficientDistanceAtIteration, computeCoefficientDistanceAtIteration(), gather_cfg::cout, EcalBarrel, EcalEndcap, ZIterativeAlgorithmWithFit::gausfit(), EcalRingCalibrationTools::getDetIdsInECAL(), EcalRingCalibrationTools::getDetIdsInModule(), EcalRingCalibrationTools::getDetIdsInRing(), ZIterativeAlgorithmWithFit::getNumberOfChannels(), ZIterativeAlgorithmWithFit::getOptimizedChiSquare(), ZIterativeAlgorithmWithFit::getOptimizedCoefficients(), ZIterativeAlgorithmWithFit::getOptimizedCoefficientsError(), ZIterativeAlgorithmWithFit::getOptimizedIterations(), h1_mcEBParz_, h1_mcEEParz_, h1_mcParz_, h1_reco_ZMass_, h2_chi2_, h2_iterations_, h2_residualSigma_, h2_xtalRecalibCoeffBarrel_, h2_xtalRecalibCoeffEndcapMinus_, h2_xtalRecalibCoeffEndcapPlus_, h2_zMassDiffVsLoop_, h2_zMassVsLoop_, h2_zWidthVsLoop_, ical, EBDetId::ieta(), initCalibCoeff, EBDetId::iphi(), ZIterativeAlgorithmWithFit::iterate(), EEDetId::ix(), EEDetId::iy(), isotrackApplyRegressor::k, edm::EDLooperBase::kContinue, edm::EDLooperBase::kStop, loopArray, loopFlag_, MZ, NewCalibCoeff, outputFile_, funct::pow(), ringNumberCorrector(), sigmaArray, sigmaErrorArray, mathSSE::sqrt(), theAlgorithm_, theMaxLoops, and EEDetId::zside().
|
private |
|
private |
Definition at line 1804 of file ZeeCalibration.cc.
References colinearityKinematic::Phi, Pi, and mathSSE::sqrt().
Referenced by fillMCmap().
|
private |
Definition at line 1740 of file ZeeCalibration.cc.
References fireworks::p1, fireworks::p2, and x.
Referenced by getEtaCorrection().
|
private |
Definition at line 1772 of file ZeeCalibration.cc.
References fireworks::p1, fireworks::p2, and x.
Referenced by getEtaCorrection().
|
private |
Definition at line 1762 of file ZeeCalibration.cc.
References fireworks::p1, fireworks::p2, and x.
Referenced by getEtaCorrection().
|
private |
Definition at line 1750 of file ZeeCalibration.cc.
References fireworks::p1, fireworks::p2, and x.
Referenced by getEtaCorrection().
|
private |
Definition at line 1827 of file ZeeCalibration.cc.
References alignCSCRings::e, reco::CaloCluster::energy(), reco::LeafCandidate::eta(), getEtaCorrection(), h1_eleEtaResol_, h1_elePhiResol_, h1_preshowerOverSC_, h1_seedOverSC_, h_eleEffEta_, h_eleEffPhi_, h_eleEffPt_, h_ESCcorrEtrue_, h_ESCcorrEtrueVsEta_, h_ESCEtrue_, h_ESCEtrueVsEta_, mps_fire::i, loopFlag_, perp(), phi, reco::LeafCandidate::phi(), reco::CaloCluster::position(), reco::SuperCluster::preshowerEnergy(), reco::SuperCluster::seed(), and reco::GsfElectron::superCluster().
Referenced by duringLoop().
|
private |
|
private |
Definition at line 1784 of file ZeeCalibration.cc.
References runTauDisplay::dr, PVValHelper::eta, EvalDR(), mps_fire::i, dqmiolumiharvest::j, HLT_FULL_cff::minDR, and phi.
Referenced by duringLoop().
|
private |
Definition at line 1895 of file ZeeCalibration.cc.
References c, reco::GsfElectron::classification(), pixelCPEforGPU::correction(), fEtaBarrelBad(), fEtaBarrelGood(), fEtaEndcapBad(), fEtaEndcapGood(), and reco::GsfElectron::superCluster().
Referenced by duringLoop(), and fillEleInfo().
|
private |
Definition at line 1914 of file ZeeCalibration.cc.
References gather_cfg::cout, EcalBarrel, EcalEndcap, edm::SortedCollection< T, SORT >::end(), EcalRecHit::energy(), edm::SortedCollection< T, SORT >::find(), EcalRecHit::id(), and trackerHitRTTI::vector.
Referenced by duringLoop().
|
private |
Definition at line 2078 of file ZeeCalibration.cc.
References BARREL_ELECTRONS_AFTER_BORDER_CUT, BARREL_ELECTRONS_BEFORE_BORDER_CUT, BBZN, BBZN_gg, BBZN_t0, BBZN_tt, gather_cfg::cout, CRACK_ELECTRONS_IN_BARREL, CRACK_ELECTRONS_IN_ENDCAP, EBZN, EBZN_gg, EBZN_t0, EBZN_tt, EEZN, EEZN_gg, EEZN_t0, EEZN_tt, groupFilesInBlocks::fout, GOLDEN_ELECTRONS_IN_BARREL, GOLDEN_ELECTRONS_IN_ENDCAP, MCZBB, MCZEB, MCZEE, NEVT, SHOWER_ELECTRONS_IN_BARREL, SHOWER_ELECTRONS_IN_ENDCAP, SILVER_ELECTRONS_IN_BARREL, SILVER_ELECTRONS_IN_ENDCAP, TOTAL_ELECTRONS_IN_BARREL, and TOTAL_ELECTRONS_IN_ENDCAP.
Referenced by endOfJob().
|
inlinevirtual |
Dummy implementation (job done in duringLoop)
Definition at line 77 of file ZeeCalibration.h.
|
virtual |
Produce Ecal interCalibrations.
Definition at line 137 of file ZeeCalibration.cc.
References gather_cfg::cout, and ical.
Referenced by ZeeCalibration().
|
private |
Definition at line 2034 of file ZeeCalibration.cc.
References h1_eleClasses_, h1_electronCosTheta_SC_, h1_electronCosTheta_SC_TK_, h1_electronCosTheta_TK_, h1_eleEtaResol_, h1_elePhiResol_, h1_eventsAfterBorderSelection_, h1_eventsAfterEWKSelection_, h1_eventsBeforeBorderSelection_, h1_eventsBeforeEWKSelection_, h1_occupancy_, h1_occupancyBarrel_, h1_occupancyEndcap_, h1_occupancyVsEta_, h1_preshowerOverSC_, h1_reco_ZMass_, h1_reco_ZMassCorr_, h1_reco_ZMassCorrBB_, h1_reco_ZMassCorrEE_, h1_seedOverSC_, h1_ZCandMult_, h1_zMassResol_, h2_fEtaBarrelBad_, h2_fEtaBarrelGood_, h2_fEtaEndcapBad_, h2_fEtaEndcapGood_, h_eleEffEta_, h_eleEffPhi_, h_eleEffPt_, and mps_fire::i.
Referenced by startingNewLoop().
|
private |
Definition at line 2000 of file ZeeCalibration.cc.
References BARREL_ELECTRONS_AFTER_BORDER_CUT, BARREL_ELECTRONS_BEFORE_BORDER_CUT, BBZN, BBZN_gg, BBZN_t0, BBZN_tt, CRACK_ELECTRONS_IN_BARREL, CRACK_ELECTRONS_IN_ENDCAP, EBZN, EBZN_gg, EBZN_t0, EBZN_tt, EEZN, EEZN_gg, EEZN_t0, EEZN_tt, GOLDEN_ELECTRONS_IN_BARREL, GOLDEN_ELECTRONS_IN_ENDCAP, SHOWER_ELECTRONS_IN_BARREL, SHOWER_ELECTRONS_IN_ENDCAP, SILVER_ELECTRONS_IN_BARREL, SILVER_ELECTRONS_IN_ENDCAP, TOTAL_ELECTRONS_IN_BARREL, and TOTAL_ELECTRONS_IN_ENDCAP.
Referenced by startingNewLoop().
|
private |
Definition at line 1867 of file ZeeCalibration.cc.
References calibMode_.
Referenced by computeCoefficientDistanceAtIteration(), endOfJob(), and endOfLoop().
|
overridevirtual |
Called at beginning of loop.
Implements edm::EDLooperBase.
Definition at line 1280 of file ZeeCalibration.cc.
References gather_cfg::cout, resetHistograms(), ZIterativeAlgorithmWithFit::resetIteration(), resetVariables(), and theAlgorithm_.
|
private |
Definition at line 1955 of file ZeeCalibration.cc.
References funct::abs(), mps_fire::i, EBDetId::ieta(), and EBDetId::iphi().
Referenced by duringLoop().
|
private |
Definition at line 366 of file ZeeCalibration.h.
|
private |
Definition at line 369 of file ZeeCalibration.h.
Referenced by duringLoop().
|
private |
Definition at line 368 of file ZeeCalibration.h.
|
private |
Definition at line 362 of file ZeeCalibration.h.
|
private |
Definition at line 363 of file ZeeCalibration.h.
|
private |
Definition at line 331 of file ZeeCalibration.h.
Referenced by duringLoop(), printStatistics(), and resetVariables().
|
private |
Definition at line 330 of file ZeeCalibration.h.
Referenced by duringLoop(), printStatistics(), and resetVariables().
|
private |
Definition at line 181 of file ZeeCalibration.h.
Referenced by duringLoop(), and ZeeCalibration().
|
private |
Definition at line 314 of file ZeeCalibration.h.
Referenced by duringLoop(), printStatistics(), and resetVariables().
|
private |
Definition at line 314 of file ZeeCalibration.h.
Referenced by duringLoop(), printStatistics(), and resetVariables().
|
private |
Definition at line 314 of file ZeeCalibration.h.
Referenced by duringLoop(), printStatistics(), and resetVariables().
|
private |
Definition at line 314 of file ZeeCalibration.h.
Referenced by duringLoop(), printStatistics(), and resetVariables().
|
private |
Definition at line 195 of file ZeeCalibration.h.
Referenced by duringLoop(), endOfJob(), and endOfLoop().
|
private |
Definition at line 197 of file ZeeCalibration.h.
Referenced by duringLoop(), endOfJob(), and endOfLoop().
|
private |
Definition at line 161 of file ZeeCalibration.h.
Referenced by computeCoefficientDistanceAtIteration(), duringLoop(), endOfJob(), endOfLoop(), ringNumberCorrector(), and ZeeCalibration().
|
private |
Definition at line 328 of file ZeeCalibration.h.
Referenced by endOfJob(), endOfLoop(), and ZeeCalibration().
|
private |
Definition at line 345 of file ZeeCalibration.h.
Referenced by duringLoop(), printStatistics(), and resetVariables().
|
private |
Definition at line 346 of file ZeeCalibration.h.
Referenced by duringLoop(), printStatistics(), and resetVariables().
|
private |
Definition at line 165 of file ZeeCalibration.h.
Referenced by duringLoop().
|
private |
Definition at line 314 of file ZeeCalibration.h.
Referenced by duringLoop(), printStatistics(), and resetVariables().
|
private |
Definition at line 314 of file ZeeCalibration.h.
Referenced by duringLoop(), printStatistics(), and resetVariables().
|
private |
Definition at line 314 of file ZeeCalibration.h.
Referenced by duringLoop(), printStatistics(), and resetVariables().
|
private |
Definition at line 314 of file ZeeCalibration.h.
Referenced by duringLoop(), printStatistics(), and resetVariables().
|
private |
Definition at line 166 of file ZeeCalibration.h.
Referenced by duringLoop().
|
private |
Definition at line 314 of file ZeeCalibration.h.
Referenced by duringLoop(), printStatistics(), and resetVariables().
|
private |
Definition at line 314 of file ZeeCalibration.h.
Referenced by duringLoop(), printStatistics(), and resetVariables().
|
private |
Definition at line 314 of file ZeeCalibration.h.
Referenced by duringLoop(), printStatistics(), and resetVariables().
|
private |
Definition at line 314 of file ZeeCalibration.h.
Referenced by duringLoop(), printStatistics(), and resetVariables().
|
private |
Definition at line 159 of file ZeeCalibration.h.
|
private |
Definition at line 158 of file ZeeCalibration.h.
|
private |
Definition at line 323 of file ZeeCalibration.h.
Referenced by duringLoop(), and ZeeCalibration().
|
private |
Definition at line 182 of file ZeeCalibration.h.
Referenced by duringLoop(), and ZeeCalibration().
|
private |
Definition at line 151 of file ZeeCalibration.h.
|
private |
Definition at line 150 of file ZeeCalibration.h.
|
private |
Definition at line 173 of file ZeeCalibration.h.
Referenced by ZeeCalibration().
|
private |
Definition at line 178 of file ZeeCalibration.h.
Referenced by ZeeCalibration().
|
private |
Definition at line 176 of file ZeeCalibration.h.
Referenced by ZeeCalibration().
|
private |
Definition at line 174 of file ZeeCalibration.h.
Referenced by ZeeCalibration().
|
private |
Definition at line 179 of file ZeeCalibration.h.
Referenced by ZeeCalibration().
|
private |
Definition at line 177 of file ZeeCalibration.h.
Referenced by ZeeCalibration().
|
private |
Definition at line 171 of file ZeeCalibration.h.
Referenced by duringLoop().
|
private |
Definition at line 336 of file ZeeCalibration.h.
Referenced by duringLoop(), printStatistics(), and resetVariables().
|
private |
Definition at line 337 of file ZeeCalibration.h.
Referenced by duringLoop(), printStatistics(), and resetVariables().
|
private |
Definition at line 169 of file ZeeCalibration.h.
Referenced by duringLoop().
|
private |
Definition at line 312 of file ZeeCalibration.h.
Referenced by bookHistograms(), duringLoop(), and endOfJob().
|
private |
Definition at line 224 of file ZeeCalibration.h.
Referenced by bookHistograms(), duringLoop(), endOfJob(), and resetHistograms().
|
private |
Definition at line 309 of file ZeeCalibration.h.
Referenced by bookHistograms(), duringLoop(), endOfJob(), and resetHistograms().
|
private |
Definition at line 310 of file ZeeCalibration.h.
Referenced by bookHistograms(), duringLoop(), endOfJob(), and resetHistograms().
|
private |
Definition at line 308 of file ZeeCalibration.h.
Referenced by bookHistograms(), duringLoop(), endOfJob(), and resetHistograms().
|
private |
Definition at line 246 of file ZeeCalibration.h.
|
private |
Definition at line 248 of file ZeeCalibration.h.
Referenced by bookHistograms(), endOfJob(), fillEleInfo(), and resetHistograms().
|
private |
Definition at line 249 of file ZeeCalibration.h.
Referenced by bookHistograms(), endOfJob(), fillEleInfo(), and resetHistograms().
|
private |
Definition at line 217 of file ZeeCalibration.h.
Referenced by bookHistograms(), duringLoop(), endOfJob(), and resetHistograms().
|
private |
Definition at line 214 of file ZeeCalibration.h.
Referenced by bookHistograms(), duringLoop(), endOfJob(), and resetHistograms().
|
private |
Definition at line 216 of file ZeeCalibration.h.
Referenced by bookHistograms(), duringLoop(), endOfJob(), and resetHistograms().
|
private |
Definition at line 213 of file ZeeCalibration.h.
Referenced by bookHistograms(), duringLoop(), endOfJob(), and resetHistograms().
|
private |
Definition at line 269 of file ZeeCalibration.h.
Referenced by bookHistograms(), and endOfJob().
|
private |
Definition at line 278 of file ZeeCalibration.h.
Referenced by bookHistograms(), and endOfJob().
|
private |
Definition at line 279 of file ZeeCalibration.h.
Referenced by bookHistograms(), and endOfLoop().
|
private |
Definition at line 282 of file ZeeCalibration.h.
Referenced by bookHistograms(), and endOfJob().
|
private |
Definition at line 283 of file ZeeCalibration.h.
Referenced by bookHistograms(), and endOfLoop().
|
private |
Definition at line 270 of file ZeeCalibration.h.
Referenced by bookHistograms(), and endOfLoop().
|
private |
Definition at line 223 of file ZeeCalibration.h.
Referenced by bookHistograms().
|
private |
Definition at line 304 of file ZeeCalibration.h.
Referenced by bookHistograms(), endOfJob(), and resetHistograms().
|
private |
Definition at line 305 of file ZeeCalibration.h.
Referenced by bookHistograms(), endOfJob(), and resetHistograms().
|
private |
Definition at line 306 of file ZeeCalibration.h.
Referenced by bookHistograms(), endOfJob(), and resetHistograms().
|
private |
Definition at line 299 of file ZeeCalibration.h.
Referenced by bookHistograms(), endOfJob(), and resetHistograms().
|
private |
Definition at line 302 of file ZeeCalibration.h.
|
private |
Definition at line 300 of file ZeeCalibration.h.
|
private |
Definition at line 303 of file ZeeCalibration.h.
|
private |
Definition at line 301 of file ZeeCalibration.h.
|
private |
Definition at line 231 of file ZeeCalibration.h.
Referenced by bookHistograms(), endOfJob(), fillEleInfo(), and resetHistograms().
|
private |
Definition at line 236 of file ZeeCalibration.h.
Referenced by bookHistograms(), duringLoop(), endOfJob(), endOfLoop(), and resetHistograms().
|
private |
Definition at line 242 of file ZeeCalibration.h.
|
private |
Definition at line 238 of file ZeeCalibration.h.
Referenced by bookHistograms(), duringLoop(), endOfJob(), and resetHistograms().
|
private |
Definition at line 239 of file ZeeCalibration.h.
Referenced by bookHistograms(), duringLoop(), endOfJob(), and resetHistograms().
|
private |
Definition at line 240 of file ZeeCalibration.h.
Referenced by bookHistograms(), duringLoop(), endOfJob(), and resetHistograms().
|
private |
Definition at line 241 of file ZeeCalibration.h.
|
private |
Definition at line 244 of file ZeeCalibration.h.
|
private |
Definition at line 245 of file ZeeCalibration.h.
|
private |
Definition at line 230 of file ZeeCalibration.h.
Referenced by bookHistograms(), endOfJob(), fillEleInfo(), and resetHistograms().
|
private |
Definition at line 296 of file ZeeCalibration.h.
Referenced by bookHistograms(), and endOfJob().
|
private |
Definition at line 297 of file ZeeCalibration.h.
Referenced by bookHistograms(), and endOfJob().
|
private |
Definition at line 243 of file ZeeCalibration.h.
Referenced by bookHistograms(), duringLoop(), endOfJob(), and resetHistograms().
|
private |
Definition at line 234 of file ZeeCalibration.h.
Referenced by bookHistograms(), and endOfJob().
|
private |
Definition at line 233 of file ZeeCalibration.h.
Referenced by bookHistograms(), duringLoop(), endOfJob(), and resetHistograms().
|
private |
Definition at line 235 of file ZeeCalibration.h.
Referenced by bookHistograms(), and endOfJob().
|
private |
Definition at line 285 of file ZeeCalibration.h.
Referenced by bookHistograms(), endOfJob(), and endOfLoop().
|
private |
Definition at line 260 of file ZeeCalibration.h.
Referenced by bookHistograms(), and endOfJob().
|
private |
Definition at line 261 of file ZeeCalibration.h.
Referenced by bookHistograms(), and endOfJob().
|
private |
Definition at line 265 of file ZeeCalibration.h.
Referenced by bookHistograms(), and endOfJob().
|
private |
Definition at line 220 of file ZeeCalibration.h.
Referenced by bookHistograms(), endOfJob(), and resetHistograms().
|
private |
Definition at line 219 of file ZeeCalibration.h.
Referenced by bookHistograms(), endOfJob(), and resetHistograms().
|
private |
Definition at line 222 of file ZeeCalibration.h.
Referenced by bookHistograms(), endOfJob(), and resetHistograms().
|
private |
Definition at line 221 of file ZeeCalibration.h.
Referenced by bookHistograms(), endOfJob(), and resetHistograms().
|
private |
Definition at line 286 of file ZeeCalibration.h.
Referenced by bookHistograms(), endOfJob(), and endOfLoop().
|
private |
Definition at line 267 of file ZeeCalibration.h.
Referenced by bookHistograms(), and endOfJob().
|
private |
Definition at line 276 of file ZeeCalibration.h.
Referenced by bookHistograms(), and endOfJob().
|
private |
Definition at line 280 of file ZeeCalibration.h.
Referenced by bookHistograms(), and endOfJob().
|
private |
Definition at line 275 of file ZeeCalibration.h.
Referenced by bookHistograms(), endOfJob(), and endOfLoop().
|
private |
Definition at line 292 of file ZeeCalibration.h.
Referenced by bookHistograms(), duringLoop(), and endOfJob().
|
private |
Definition at line 293 of file ZeeCalibration.h.
Referenced by bookHistograms(), duringLoop(), and endOfJob().
|
private |
Definition at line 294 of file ZeeCalibration.h.
Referenced by bookHistograms(), duringLoop(), and endOfJob().
|
private |
Definition at line 288 of file ZeeCalibration.h.
Referenced by bookHistograms(), and endOfLoop().
|
private |
Definition at line 289 of file ZeeCalibration.h.
Referenced by bookHistograms(), and endOfLoop().
|
private |
Definition at line 290 of file ZeeCalibration.h.
Referenced by bookHistograms(), and endOfLoop().
|
private |
Definition at line 263 of file ZeeCalibration.h.
Referenced by bookHistograms(), endOfJob(), and endOfLoop().
|
private |
Definition at line 262 of file ZeeCalibration.h.
Referenced by bookHistograms(), endOfJob(), and endOfLoop().
|
private |
Definition at line 264 of file ZeeCalibration.h.
Referenced by bookHistograms(), endOfJob(), and endOfLoop().
|
private |
Definition at line 226 of file ZeeCalibration.h.
|
private |
Definition at line 251 of file ZeeCalibration.h.
Referenced by bookHistograms(), endOfJob(), fillEleInfo(), and resetHistograms().
|
private |
Definition at line 227 of file ZeeCalibration.h.
|
private |
Definition at line 252 of file ZeeCalibration.h.
Referenced by bookHistograms(), endOfJob(), fillEleInfo(), and resetHistograms().
|
private |
Definition at line 228 of file ZeeCalibration.h.
|
private |
Definition at line 253 of file ZeeCalibration.h.
Referenced by bookHistograms(), endOfJob(), fillEleInfo(), and resetHistograms().
|
private |
Definition at line 257 of file ZeeCalibration.h.
Referenced by bookHistograms(), endOfJob(), and fillEleInfo().
|
private |
Definition at line 258 of file ZeeCalibration.h.
Referenced by bookHistograms(), endOfJob(), and fillEleInfo().
|
private |
Definition at line 254 of file ZeeCalibration.h.
Referenced by bookHistograms(), endOfJob(), and fillEleInfo().
|
private |
Definition at line 255 of file ZeeCalibration.h.
Referenced by bookHistograms(), endOfJob(), and fillEleInfo().
|
private |
Definition at line 164 of file ZeeCalibration.h.
Referenced by duringLoop().
|
private |
Definition at line 355 of file ZeeCalibration.h.
|
private |
Definition at line 356 of file ZeeCalibration.h.
|
private |
Definition at line 358 of file ZeeCalibration.h.
|
private |
Definition at line 365 of file ZeeCalibration.h.
Referenced by duringLoop().
|
private |
Definition at line 367 of file ZeeCalibration.h.
|
private |
Definition at line 145 of file ZeeCalibration.h.
|
private |
Definition at line 354 of file ZeeCalibration.h.
|
private |
Definition at line 200 of file ZeeCalibration.h.
Referenced by duringLoop(), endOfJob(), endOfLoop(), and produceEcalIntercalibConstants().
|
private |
Definition at line 359 of file ZeeCalibration.h.
Referenced by duringLoop().
|
private |
Definition at line 198 of file ZeeCalibration.h.
Referenced by duringLoop(), endOfJob(), and endOfLoop().
|
private |
Definition at line 371 of file ZeeCalibration.h.
Referenced by beginOfJob(), and duringLoop().
|
private |
Definition at line 168 of file ZeeCalibration.h.
Referenced by duringLoop().
|
private |
Definition at line 325 of file ZeeCalibration.h.
Referenced by endOfJob(), endOfLoop(), and ZeeCalibration().
|
private |
Definition at line 193 of file ZeeCalibration.h.
Referenced by duringLoop(), endOfLoop(), and fillEleInfo().
|
private |
Definition at line 186 of file ZeeCalibration.h.
Referenced by Particle.Particle::__str__(), ZMuMuRochCorAnalyzer.DiMuon::__str__(), DiObject.DiMuon::__str__(), and duringLoop().
|
private |
Definition at line 188 of file ZeeCalibration.h.
Referenced by duringLoop(), and ZeeCalibration().
|
private |
Definition at line 189 of file ZeeCalibration.h.
Referenced by duringLoop(), and ZeeCalibration().
|
private |
Definition at line 185 of file ZeeCalibration.h.
Referenced by duringLoop(), and ZeeCalibration().
|
private |
Definition at line 147 of file ZeeCalibration.h.
Referenced by duringLoop().
|
private |
Definition at line 315 of file ZeeCalibration.h.
Referenced by duringLoop(), and printStatistics().
|
private |
Definition at line 315 of file ZeeCalibration.h.
Referenced by duringLoop(), and printStatistics().
|
private |
Definition at line 315 of file ZeeCalibration.h.
Referenced by duringLoop(), and printStatistics().
|
private |
Definition at line 184 of file ZeeCalibration.h.
Referenced by duringLoop(), and ZeeCalibration().
|
private |
Definition at line 141 of file ZeeCalibration.h.
Referenced by duringLoop(), endOfJob(), and ZeeCalibration().
|
private |
Definition at line 204 of file ZeeCalibration.h.
Referenced by bookHistograms(), duringLoop(), and endOfJob().
|
private |
Definition at line 205 of file ZeeCalibration.h.
|
private |
Definition at line 351 of file ZeeCalibration.h.
|
private |
Definition at line 352 of file ZeeCalibration.h.
|
private |
Definition at line 348 of file ZeeCalibration.h.
|
private |
Definition at line 315 of file ZeeCalibration.h.
Referenced by duringLoop(), and printStatistics().
|
private |
Definition at line 196 of file ZeeCalibration.h.
Referenced by endOfLoop().
|
private |
Definition at line 350 of file ZeeCalibration.h.
|
private |
Definition at line 317 of file ZeeCalibration.h.
Referenced by duringLoop(), endOfJob(), endOfLoop(), and ZeeCalibration().
|
private |
Definition at line 143 of file ZeeCalibration.h.
Referenced by ZeeCalibration().
|
private |
Definition at line 191 of file ZeeCalibration.h.
Referenced by duringLoop().
|
private |
Definition at line 149 of file ZeeCalibration.h.
|
private |
Definition at line 148 of file ZeeCalibration.h.
|
private |
Definition at line 153 of file ZeeCalibration.h.
|
private |
Definition at line 156 of file ZeeCalibration.h.
|
private |
Definition at line 155 of file ZeeCalibration.h.
|
private |
Definition at line 152 of file ZeeCalibration.h.
|
private |
Definition at line 167 of file ZeeCalibration.h.
Referenced by duringLoop().
|
private |
Definition at line 342 of file ZeeCalibration.h.
Referenced by duringLoop(), printStatistics(), and resetVariables().
|
private |
Definition at line 343 of file ZeeCalibration.h.
Referenced by duringLoop(), printStatistics(), and resetVariables().
|
private |
Definition at line 326 of file ZeeCalibration.h.
Referenced by endOfJob(), endOfLoop(), and ZeeCalibration().
|
private |
Definition at line 327 of file ZeeCalibration.h.
Referenced by endOfJob(), endOfLoop(), and ZeeCalibration().
|
private |
Definition at line 339 of file ZeeCalibration.h.
Referenced by duringLoop(), printStatistics(), and resetVariables().
|
private |
Definition at line 340 of file ZeeCalibration.h.
Referenced by duringLoop(), printStatistics(), and resetVariables().
|
private |
Definition at line 202 of file ZeeCalibration.h.
Referenced by duringLoop(), endOfJob(), endOfLoop(), startingNewLoop(), and ZeeCalibration().
|
private |
Definition at line 319 of file ZeeCalibration.h.
Referenced by endOfJob(), endOfLoop(), and ZeeCalibration().
|
private |
Definition at line 209 of file ZeeCalibration.h.
Referenced by ZeeCalibration().
|
private |
Definition at line 333 of file ZeeCalibration.h.
Referenced by duringLoop(), printStatistics(), and resetVariables().
|
private |
Definition at line 334 of file ZeeCalibration.h.
Referenced by duringLoop(), printStatistics(), and resetVariables().
|
private |
Definition at line 361 of file ZeeCalibration.h.
|
private |
Definition at line 163 of file ZeeCalibration.h.
Referenced by duringLoop().
|
private |
Definition at line 321 of file ZeeCalibration.h.
Referenced by duringLoop(), and ZeeCalibration().