|
|
#include <ElectronAnalyzer.h>
|
float | computeInvMass (const reco::GsfElectron &e1, const reco::GsfElectron &e2) |
|
bool | etCut (const reco::GsfElectronCollection::const_iterator &gsfIter) |
|
bool | generalCut (const reco::GsfElectronCollection::const_iterator &gsfIter) |
|
bool | idCut (const reco::GsfElectronCollection::const_iterator &gsfIter) |
|
bool | isolationCut (const reco::GsfElectronCollection::const_iterator &gsfIter, double vertexTIP) |
|
bool | selected (const reco::GsfElectronCollection::const_iterator &gsfIter, double vertexTIP) |
|
|
typedef dqm::reco::DQMStore | DQMStore |
|
typedef dqm::reco::MonitorElement | MonitorElement |
|
typedef CacheContexts< T... > | CacheTypes |
|
typedef CacheTypes::GlobalCache | GlobalCache |
|
typedef AbilityChecker< T... > | HasAbility |
|
typedef CacheTypes::LuminosityBlockCache | LuminosityBlockCache |
|
typedef LuminosityBlockContextT< LuminosityBlockCache, RunCache, GlobalCache > | LuminosityBlockContext |
|
typedef CacheTypes::LuminosityBlockSummaryCache | LuminosityBlockSummaryCache |
|
typedef CacheTypes::RunCache | RunCache |
|
typedef RunContextT< RunCache, GlobalCache > | RunContext |
|
typedef CacheTypes::RunSummaryCache | RunSummaryCache |
|
static void | globalEndJob (DQMEDAnalyzerGlobalCache const *) |
|
static void | globalEndLuminosityBlockProduce (edm::LuminosityBlock &lumi, edm::EventSetup const &setup, LuminosityBlockContext const *context) |
|
static void | globalEndRunProduce (edm::Run &run, edm::EventSetup const &setup, RunContext const *context) |
|
static std::unique_ptr< DQMEDAnalyzerGlobalCache > | initializeGlobalCache (edm::ParameterSet const &) |
|
MonitorElement * | bookH1 (DQMStore::IBooker &, const std::string &name, const std::string &title, int nchX, double lowX, double highX, const std::string &titleX="", const std::string &titleY="Events", Option_t *option="E1 P") |
|
MonitorElement * | bookH1withSumw2 (DQMStore::IBooker &, const std::string &name, const std::string &title, int nchX, double lowX, double highX, const std::string &titleX="", const std::string &titleY="Events", Option_t *option="E1 P") |
|
MonitorElement * | bookH2 (DQMStore::IBooker &, const std::string &name, const std::string &title, int nchX, double lowX, double highX, int nchY, double lowY, double highY, const std::string &titleX="", const std::string &titleY="", Option_t *option="COLZ") |
|
MonitorElement * | bookH2withSumw2 (DQMStore::IBooker &, const std::string &name, const std::string &title, int nchX, double lowX, double highX, int nchY, double lowY, double highY, const std::string &titleX="", const std::string &titleY="", Option_t *option="COLZ") |
|
MonitorElement * | bookP1 (DQMStore::IBooker &, const std::string &name, const std::string &title, int nchX, double lowX, double highX, double lowY, double highY, const std::string &titleX="", const std::string &titleY="", Option_t *option="E1 P") |
|
MonitorElement * | cloneH1 (DQMStore::IBooker &iBooker, const std::string &name, const std::string &original, const std::string &title="") |
|
MonitorElement * | cloneH1 (DQMStore::IBooker &iBooker, const std::string &name, MonitorElement *original, const std::string &title="") |
|
| ElectronDqmAnalyzerBase (const edm::ParameterSet &conf) |
|
void | setBookEfficiencyFlag (const bool &) |
|
void | setBookIndex (short) |
|
void | setBookPrefix (const std::string &) |
|
void | setBookStatOverflowFlag (const bool &) |
|
int | verbosity () |
|
| ~ElectronDqmAnalyzerBase () override |
|
uint64_t | meId () const |
|
edm::EDPutTokenT< DQMToken > | lumiToken_ |
|
edm::EDPutTokenT< DQMToken > | runToken_ |
|
unsigned int | streamId_ |
|
Definition at line 35 of file ElectronAnalyzer.h.
◆ ElectronAnalyzer()
Definition at line 27 of file ElectronAnalyzer.cc.
References cms::cuda::assert(), beamSpotTag_, deltaR_, detamatchmax, detamatchmin, detamax, dEtaMaxBarrel_, dEtaMaxEndcaps_, detamin, dEtaMinBarrel_, dEtaMinEndcaps_, dphimatchmax, dphimatchmin, dphimax, dPhiMaxBarrel_, dPhiMaxEndcaps_, dphimin, dPhiMinBarrel_, dPhiMinEndcaps_, ecalIso03MaxBarrel_, ecalIso03MaxEndcaps_, electronCollection_, eopmax, eopmaxsht, eOverPMaxBarrel_, eOverPMaxEndcaps_, eOverPMinBarrel_, eOverPMinEndcaps_, etamax, etamin, fhitsmax, edm::ParameterSet::getParameter(), gsftrackCollection_, hadronicOverEmMaxBarrel_, hadronicOverEmMaxEndcaps_, hcalIso03Depth1MaxBarrel_, hcalIso03Depth1MaxEndcaps_, hcalIso03Depth2MaxEndcaps_, hoemax, hoemin, isEB_, isEcalDriven_, isEE_, isNotEBEEGap_, isTrackerDriven_, lhitsmax, matchingCondition_, matchingObjectCollection_, maxAbsEta_, maxAbsEtaMatchingObject_, maxPtMatchingObject_, meemax, meemin, minEt_, minPt_, mvaMin_, nbindeta, nbindetamatch, nbindetamatch2D, nbindphi, nbindphimatch, nbindphimatch2D, nbineop, nbineop2D, nbineta, nbineta2D, nbinfhits, nbinhoe, nbinlhits, nbinmee, nbinp, nbinp2D, nbinphi, nbinphi2D, nbinpoptrue, nbinpt, nbinpt2D, nbinpteff, nbinxyz, nbinxyz2D, phimax, phimin, pmax, poptruemax, poptruemin, ptmax, readAOD_, Selection_, sigIetaIetaMaxBarrel_, sigIetaIetaMaxEndcaps_, sigIetaIetaMinBarrel_, sigIetaIetaMinEndcaps_, AlCaHLTBitMon_QueryRunRegistry::string, tipMaxBarrel_, tipMaxEndcaps_, tkIso03Max_, trackCollection_, triggerResults_, and vertexCollection_.
◆ ~ElectronAnalyzer()
ElectronAnalyzer::~ElectronAnalyzer |
( |
| ) |
|
|
override |
◆ analyze()
Reimplemented from ElectronDqmAnalyzerBase.
Definition at line 549 of file ElectronAnalyzer.cc.
571 <<
" from event " << ievt <<
" in run " << irun <<
" and lumiblock " << ils;
575 reco::GsfElectronCollection::const_iterator gsfIter;
578 double vertexTIP = (gsfIter->vertex().x() -
bs.position().x()) * (gsfIter->vertex().x() -
bs.position().x()) +
579 (gsfIter->vertex().y() -
bs.position().y()) * (gsfIter->vertex().y() -
bs.position().y());
580 vertexTIP =
sqrt(vertexTIP);
587 reco::GsfElectronCollection::const_iterator gsfIter2;
588 for (gsfIter2 = gsfIter + 1; gsfIter2 !=
gsfElectrons->end(); gsfIter2++) {
593 if (((gsfIter->charge()) * (gsfIter2->charge())) < 0.) {
595 if (gsfIter->isEB() && gsfIter2->isEB())
597 else if (gsfIter->isEE() && gsfIter2->isEE())
617 double R = TMath::Sqrt(sclRef->x() * sclRef->x() + sclRef->y() * sclRef->y() + sclRef->z() * sclRef->z());
618 double Rt = TMath::Sqrt(sclRef->x() * sclRef->x() + sclRef->y() * sclRef->y());
629 h1_chi2->
Fill(gsfIter->gsfTrack()->normalizedChi2());
635 if (gsfIter->isEB()) {
646 if (gsfIter->isEE()) {
649 if (gsfIter->eta() > 0) {
673 int eleClass = gsfIter->classification();
680 if (gsfIter->ecalDrivenSeed())
682 if (gsfIter->trackerDrivenSeed())
684 if (gsfIter->trackerDrivenSeed() || gsfIter->ecalDrivenSeed())
686 if (gsfIter->trackerDrivenSeed() && !gsfIter->ecalDrivenSeed())
688 if (!gsfIter->trackerDrivenSeed() && gsfIter->ecalDrivenSeed())
704 int matchingObjectNum = 0;
705 reco::SuperClusterCollection::const_iterator moIter;
706 for (moIter = recoClusters->begin(); moIter != recoClusters->end(); moIter++) {
720 bool okGsfFound =
false;
721 double gsfOkRatio = 999999999.;
723 reco::GsfElectronCollection::const_iterator gsfIter;
725 double vertexTIP = (gsfIter->vertex().x() -
bs.position().x()) * (gsfIter->vertex().x() -
bs.position().x()) +
726 (gsfIter->vertex().y() -
bs.position().y()) * (gsfIter->vertex().y() -
bs.position().y());
727 vertexTIP =
sqrt(vertexTIP);
735 double dphi = gsfIter->phi() - moIter->phi();
737 dphi = dphi < 0 ? (CLHEP::twopi) + dphi : dphi - CLHEP::twopi;
739 double deltaR =
sqrt(
pow((moIter->eta() - gsfIter->eta()), 2) +
pow(dphi, 2));
741 double tmpGsfRatio = gsfIter->p() / moIter->energy();
743 gsfOkRatio = tmpGsfRatio;
744 bestGsfElectron = *gsfIter;
References funct::abs(), beamSpotTag_, cms::cuda::bs, computeInvMass(), PbPb_ZMuSkimMuonDPG_cff::deltaR, deltaR_, electronCollection_, dqm::impl::MonitorElement::Fill(), electronIsolatorFromEffectiveArea_cfi::gsfElectrons, gsftrackCollection_, ecalDrivenGsfElectronCoresFromMultiCl_cff::gsfTracks, h1_chi2, h1_classes, h1_dEtaEleCl_propOut_barrel, h1_dEtaEleCl_propOut_endcapsNeg, h1_dEtaEleCl_propOut_endcapsPos, h1_dEtaSc_propVtx_barrel, h1_dEtaSc_propVtx_endcapsNeg, h1_dEtaSc_propVtx_endcapsPos, h1_dPhiEleCl_propOut_barrel, h1_dPhiEleCl_propOut_endcapsNeg, h1_dPhiEleCl_propOut_endcapsPos, h1_dPhiSc_propVtx_barrel, h1_dPhiSc_propVtx_endcapsNeg, h1_dPhiSc_propVtx_endcapsPos, h1_ecalRecHitSumEt_dr03, h1_EeleOPout_barrel, h1_EeleOPout_endcaps, h1_Eop_barrel, h1_Eop_endcaps, h1_fbrem, h1_foundHits, h1_hcalTowerSumEt_dr03, h1_Hoe_barrel, h1_Hoe_endcaps, h1_lostHits, h1_matchedObject_Eta, h1_matchedObject_Phi, h1_matchedObject_Pt, h1_matchingObject_Eta, h1_matchingObject_Phi, h1_matchingObject_Pt, h1_mee, h1_mee_os, h1_mee_os_bb, h1_mee_os_eb, h1_mee_os_ee, h1_mva, h1_PFch_dr03, h1_PFem_dr03, h1_PFnh_dr03, h1_provenance, h1_sclEt, h1_sclSigEtaEta_barrel, h1_sclSigEtaEta_endcaps, h1_sigIEtaIEta5x5_barrel, h1_sigIEtaIEta5x5_endcaps, h1_tkSumPt_dr03, h1_vertexEta, h1_vertexPt_barrel, h1_vertexPt_endcaps, h1_vertexZ, h2_vertexEtaVsPhi, h2_vertexXvsY, iEvent, matchingCondition_, matchingObjectCollection_, maxAbsEtaMatchingObject_, maxPtMatchingObject_, nEvents_, pi, funct::pow(), py_chi2VsEta, py_chi2VsPhi, py_dEtaSc_propVtxVsPhi, py_dPhiSc_propVtxVsPhi, py_EopVsPhi, py_fbremVsEta, py_fbremVsPhi, py_foundHitsVsEta, py_foundHitsVsPhi, py_HoeVsPhi, py_lostHitsVsEta, py_lostHitsVsPhi, dttmaxenums::R, readAOD_, selected(), mathSSE::sqrt(), reco::GsfElectron::PflowIsolationVariables::sumChargedHadronPt, reco::GsfElectron::PflowIsolationVariables::sumNeutralHadronEt, reco::GsfElectron::PflowIsolationVariables::sumPhotonEt, trackCollection_, PDWG_EXOHSCP_cff::tracks, vertexCollection_, and pwdgSkimBPark_cfi::vertices.
◆ bookHistograms()
Reimplemented from ElectronDqmAnalyzerBase.
Definition at line 158 of file ElectronAnalyzer.cc.
165 iBooker,
"vertexPt_barrel",
"ele transverse momentum in barrel",
nbinpt, 0.,
ptmax,
"p_{T vertex} (GeV/c)");
167 iBooker,
"vertexPt_endcaps",
"ele transverse momentum in endcaps",
nbinpt, 0.,
ptmax,
"p_{T vertex} (GeV/c)");
171 "ele momentum #eta vs #phi",
181 iBooker,
"vertexXvsY",
"ele vertex x vs y",
nbinxyz2D, -0.1, 0.1,
nbinxyz2D, -0.1, 0.1,
"x (cm)",
"y (cm)");
188 h1_chi2 =
bookH1(iBooker,
"chi2",
"ele track #chi^{2}", 100, 0., 15.,
"#Chi^{2}");
190 iBooker,
"chi2VsEta",
"ele track #chi^{2} vs #eta",
nbineta2D,
etamin,
etamax, 0., 15.,
"#eta",
"<#chi^{2}>");
193 "ele track #chi^{2} vs #phi",
204 "ele track # found hits vs #eta",
214 "ele track # found hits vs #phi",
222 h1_lostHits =
bookH1(iBooker,
"lostHits",
"ele track # lost hits", 5, 0., 5.,
"N_{lost hits}");
225 "ele track # lost hits vs #eta",
235 "ele track # lost hits vs #eta",
249 "ele E/P_{vertex} vs #phi",
258 bookH1(iBooker,
"EeleOPout_barrel",
"ele E_{ele}/P_{out} in barrel",
nbineop, 0.,
eopmax,
"E_{ele}/P_{out}");
260 bookH1(iBooker,
"EeleOPout_endcaps",
"ele E_{ele}/P_{out} in endcaps",
nbineop, 0.,
eopmax,
"E_{ele}/P_{out}");
262 "dEtaSc_propVtx_barrel",
263 "ele #eta_{sc} - #eta_{tr}, prop from vertex, in barrel",
267 "#eta_{sc} - #eta_{tr}");
269 "dEtaSc_propVtx_endcapsPos",
270 "ele #eta_{sc} - #eta_{tr}, prop from vertex, in positive endcap",
274 "#eta_{sc} - #eta_{tr}");
276 "dEtaSc_propVtx_endcapsNeg",
277 "ele #eta_{sc} - #eta_{tr}, prop from vertex, in negative endcap",
281 "#eta_{sc} - #eta_{tr}");
283 "dEtaSc_propVtxVsPhi",
284 "ele #eta_{sc} - #eta_{tr}, prop from vertex vs #phi",
291 "<#eta_{sc} - #eta_{tr}>");
293 "dEtaEleCl_propOut_barrel",
294 "ele #eta_{EleCl} - #eta_{tr}, prop from outermost, in barrel",
298 "#eta_{elecl} - #eta_{tr}");
300 "dEtaEleCl_propOut_endcapsPos",
301 "ele #eta_{EleCl} - #eta_{tr}, prop from outermost, in positive endcap",
305 "#eta_{elecl} - #eta_{tr}");
307 "dEtaEleCl_propOut_endcapsNeg",
308 "ele #eta_{EleCl} - #eta_{tr}, prop from outermost, in negative endcap",
312 "#eta_{elecl} - #eta_{tr}");
314 "dPhiSc_propVtx_barrel",
315 "ele #phi_{sc} - #phi_{tr}, prop from vertex, in barrel",
319 "#phi_{sc} - #phi_{tr} (rad)");
321 "dPhiSc_propVtx_endcapsPos",
322 "ele #phi_{sc} - #phi_{tr}, prop from vertex, in positive endcap",
326 "#phi_{sc} - #phi_{tr} (rad)");
328 "dPhiSc_propVtx_endcapsNeg",
329 "ele #phi_{sc} - #phi_{tr}, prop from vertex, in negative endcap",
333 "#phi_{sc} - #phi_{tr} (rad)");
335 "dPhiSc_propVtxVsPhi",
336 "ele #phi_{sc} - #phi_{tr}, prop from vertex vs #phi",
343 "<#phi_{sc} - #phi_{tr}> (rad)");
345 "dPhiEleCl_propOut_barrel",
346 "ele #phi_{EleCl} - #phi_{tr}, prop from outermost, in barrel",
350 "#phi_{elecl} - #phi_{tr} (rad)");
352 "dPhiEleCl_propOut_endcapsPos",
353 "ele #phi_{EleCl} - #phi_{tr}, prop from outermost, in positive endcap",
357 "#phi_{elecl} - #phi_{tr} (rad)");
359 "dPhiEleCl_propOut_endcapsNeg",
360 "ele #phi_{EleCl} - #phi_{tr}, prop from outermost, in negative endcap",
364 "#phi_{elecl} - #phi_{tr} (rad)");
367 "ele hadronic energy / em energy, in barrel",
376 "ele hadronic energy / em energy, in endcaps",
385 "ele hadronic energy / em energy vs #phi",
395 bookH1(iBooker,
"sclSigEtaEta_barrel",
"ele sigma eta eta in barrel", 100, 0., 0.05,
"sietaieta");
397 bookH1(iBooker,
"sclSigEtaEta_endcaps",
"ele sigma eta eta in endcaps", 100, 0., 0.05,
"sietaieta");
399 bookH1(iBooker,
"sigIEtaIEta5x5_barrel",
"ele sigma ieta ieta 5x5 in barrel", 100, 0., 0.05,
"sietaieta5x5");
401 bookH1(iBooker,
"sigIEtaIEta5x5_endcaps",
"ele sigma ieta ieta 5x5 in endcaps", 100, 0., 0.05,
"sietaieta5x5");
404 h1_fbrem =
bookH1(iBooker,
"fbrem",
"ele brem fraction", 100, 0., 1.,
"P_{in} - P_{out} / P_{in}");
407 "ele brem fraction vs #eta",
414 "<P_{in} - P_{out} / P_{in}>");
417 "ele brem fraction vs #phi",
424 "<P_{in} - P_{out} / P_{in}>");
425 h1_classes =
bookH1(iBooker,
"classes",
"ele electron classes", 10, 0.0, 10.);
428 h1_mva =
bookH1(iBooker,
"mva",
"ele identification mva", 100, -1., 1.,
"mva");
433 iBooker,
"tkSumPt_dr03",
"tk isolation sum, dR=0.3", 100, 0.0, 20.,
"TkIsoSum (GeV/c)",
"Events",
"ELE_LOGY E1 P");
435 "ecalRecHitSumEt_dr03",
436 "ecal isolation sum, dR=0.3",
444 "hcalTowerSumEt_dr03",
445 "hcal isolation sum, dR=0.3",
456 "Charged PF candidate sum, dR=0.3",
460 "PF charged (GeV/c)",
465 "Neutral EM PF candidate sum, dR=0.3",
469 "PF neutral EM (GeV)",
474 "Neutral Had PF candidate sum, dR=0.3",
478 "PF neutral Had (GeV)",
487 "ele pairs invariant mass, opposite sign",
491 "m_{e^{+}e^{-}} (GeV/c^{2})");
494 "ele pairs invariant mass, opposite sign, barrel-barrel",
498 "m_{e^{+}e^{-}} (GeV/c^{2})");
501 "ele pairs invariant mass, opposite sign, endcap-endcap",
505 "m_{e^{+}e^{-}} (GeV/c^{2})");
508 "ele pairs invariant mass, opposite sign, barrel-endcap",
512 "m_{e^{+}e^{-}} (GeV/c^{2})");
522 if (std::string::npos !=
std::string(
l.module).find(
"SuperCluster", 0)) {
523 matchingObjectType =
"SC";
525 if (matchingObjectType.empty()) {
526 edm::LogError(
"ElectronMcFakeValidator::beginJob") <<
"Unknown matching object type !";
528 edm::LogInfo(
"ElectronMcFakeValidator::beginJob") <<
"Matching object type: " << matchingObjectType;
533 iBooker,
"matchingObject_Eta", matchingObjectType +
" #eta",
nbineta,
etamin,
etamax,
"#eta_{SC}");
536 iBooker,
"matchingObject_Pt", matchingObjectType +
" pt",
nbinpteff, 5.,
ptmax,
"pt_{SC} (GeV/c)");
538 iBooker,
"matchingObject_Phi", matchingObjectType +
" #phi",
nbinphi,
phimin,
phimax,
"#phi (rad)");
541 iBooker,
"matchedObject_Eta",
"Efficiency vs matching SC #eta",
nbineta,
etamin,
etamax,
"#eta_{SC}");
543 iBooker,
"matchedObject_Pt",
"Efficiency vs matching SC E_{T}",
nbinpteff, 5.,
ptmax,
"pt_{SC} (GeV/c)");
545 iBooker,
"matchedObject_Phi",
"Efficiency vs matching SC #phi",
nbinphi,
phimin,
phimax,
"#phi (rad)");
References ElectronDqmAnalyzerBase::bookH1(), ElectronDqmAnalyzerBase::bookH1withSumw2(), ElectronDqmAnalyzerBase::bookH2(), ElectronDqmAnalyzerBase::bookP1(), detamatchmax, detamatchmin, dphimatchmax, dphimatchmin, eopmax, etamax, etamin, fhitsmax, h1_chi2, h1_classes, h1_dEtaEleCl_propOut_barrel, h1_dEtaEleCl_propOut_endcapsNeg, h1_dEtaEleCl_propOut_endcapsPos, h1_dEtaSc_propVtx_barrel, h1_dEtaSc_propVtx_endcapsNeg, h1_dEtaSc_propVtx_endcapsPos, h1_dPhiEleCl_propOut_barrel, h1_dPhiEleCl_propOut_endcapsNeg, h1_dPhiEleCl_propOut_endcapsPos, h1_dPhiSc_propVtx_barrel, h1_dPhiSc_propVtx_endcapsNeg, h1_dPhiSc_propVtx_endcapsPos, h1_ecalRecHitSumEt_dr03, h1_EeleOPout_barrel, h1_EeleOPout_endcaps, h1_Eop_barrel, h1_Eop_endcaps, h1_fbrem, h1_foundHits, h1_hcalTowerSumEt_dr03, h1_Hoe_barrel, h1_Hoe_endcaps, h1_lostHits, h1_matchedObject_Eta, h1_matchedObject_Phi, h1_matchedObject_Pt, h1_matchingObject_Eta, h1_matchingObject_Phi, h1_matchingObject_Pt, h1_mee, h1_mee_os, h1_mee_os_bb, h1_mee_os_eb, h1_mee_os_ee, h1_mva, h1_PFch_dr03, h1_PFem_dr03, h1_PFnh_dr03, h1_provenance, h1_sclEt, h1_sclSigEtaEta_barrel, h1_sclSigEtaEta_endcaps, h1_sigIEtaIEta5x5_barrel, h1_sigIEtaIEta5x5_endcaps, h1_tkSumPt_dr03, h1_vertexEta, h1_vertexPt_barrel, h1_vertexPt_endcaps, h1_vertexZ, h2_vertexEtaVsPhi, h2_vertexXvsY, hoemax, hoemin, cmsLHEtoEOSManager::l, lhitsmax, matchingObjectCollection_, meemax, meemin, nbindetamatch, nbindphimatch, nbineop, nbineta, nbineta2D, nbinfhits, nbinhoe, nbinmee, nbinphi, nbinphi2D, nbinpt, nbinpteff, nbinxyz, nbinxyz2D, nEvents_, outputInternalPath_, phimax, phimin, ptmax, py_chi2VsEta, py_chi2VsPhi, py_dEtaSc_propVtxVsPhi, py_dPhiSc_propVtxVsPhi, py_EopVsPhi, py_fbremVsEta, py_fbremVsPhi, py_foundHitsVsEta, py_foundHitsVsPhi, py_HoeVsPhi, py_lostHitsVsEta, py_lostHitsVsPhi, ElectronDqmAnalyzerBase::setBookIndex(), dqm::implementation::NavigatorBase::setCurrentFolder(), and AlCaHLTBitMon_QueryRunRegistry::string.
◆ computeInvMass()
◆ etCut()
bool ElectronAnalyzer::etCut |
( |
const reco::GsfElectronCollection::const_iterator & |
gsfIter | ) |
|
|
private |
◆ generalCut()
bool ElectronAnalyzer::generalCut |
( |
const reco::GsfElectronCollection::const_iterator & |
gsfIter | ) |
|
|
private |
◆ idCut()
bool ElectronAnalyzer::idCut |
( |
const reco::GsfElectronCollection::const_iterator & |
gsfIter | ) |
|
|
private |
Definition at line 831 of file ElectronAnalyzer.cc.
References funct::abs(), dEtaMaxBarrel_, dEtaMaxEndcaps_, dEtaMinBarrel_, dEtaMinEndcaps_, dPhiMaxBarrel_, dPhiMaxEndcaps_, dPhiMinBarrel_, dPhiMinEndcaps_, eOverPMaxBarrel_, eOverPMaxEndcaps_, eOverPMinBarrel_, eOverPMinEndcaps_, hadronicOverEmMaxBarrel_, hadronicOverEmMaxEndcaps_, sigIetaIetaMaxBarrel_, sigIetaIetaMaxEndcaps_, sigIetaIetaMinBarrel_, and sigIetaIetaMinEndcaps_.
Referenced by selected().
◆ isolationCut()
bool ElectronAnalyzer::isolationCut |
( |
const reco::GsfElectronCollection::const_iterator & |
gsfIter, |
|
|
double |
vertexTIP |
|
) |
| |
|
private |
◆ selected()
bool ElectronAnalyzer::selected |
( |
const reco::GsfElectronCollection::const_iterator & |
gsfIter, |
|
|
double |
vertexTIP |
|
) |
| |
|
private |
◆ beamSpotTag_
◆ deltaR_
double ElectronAnalyzer::deltaR_ |
|
private |
◆ detamatchmax
double ElectronAnalyzer::detamatchmax |
|
private |
◆ detamatchmin
double ElectronAnalyzer::detamatchmin |
|
private |
◆ detamax
double ElectronAnalyzer::detamax |
|
private |
◆ dEtaMaxBarrel_
double ElectronAnalyzer::dEtaMaxBarrel_ |
|
private |
◆ dEtaMaxEndcaps_
double ElectronAnalyzer::dEtaMaxEndcaps_ |
|
private |
◆ detamin
double ElectronAnalyzer::detamin |
|
private |
◆ dEtaMinBarrel_
double ElectronAnalyzer::dEtaMinBarrel_ |
|
private |
◆ dEtaMinEndcaps_
double ElectronAnalyzer::dEtaMinEndcaps_ |
|
private |
◆ dphimatchmax
double ElectronAnalyzer::dphimatchmax |
|
private |
◆ dphimatchmin
double ElectronAnalyzer::dphimatchmin |
|
private |
◆ dphimax
double ElectronAnalyzer::dphimax |
|
private |
◆ dPhiMaxBarrel_
double ElectronAnalyzer::dPhiMaxBarrel_ |
|
private |
◆ dPhiMaxEndcaps_
double ElectronAnalyzer::dPhiMaxEndcaps_ |
|
private |
◆ dphimin
double ElectronAnalyzer::dphimin |
|
private |
◆ dPhiMinBarrel_
double ElectronAnalyzer::dPhiMinBarrel_ |
|
private |
◆ dPhiMinEndcaps_
double ElectronAnalyzer::dPhiMinEndcaps_ |
|
private |
◆ ecalIso03MaxBarrel_
double ElectronAnalyzer::ecalIso03MaxBarrel_ |
|
private |
◆ ecalIso03MaxEndcaps_
double ElectronAnalyzer::ecalIso03MaxEndcaps_ |
|
private |
◆ electronCollection_
◆ eopmax
double ElectronAnalyzer::eopmax |
|
private |
◆ eopmaxsht
double ElectronAnalyzer::eopmaxsht |
|
private |
◆ eOverPMaxBarrel_
double ElectronAnalyzer::eOverPMaxBarrel_ |
|
private |
◆ eOverPMaxEndcaps_
double ElectronAnalyzer::eOverPMaxEndcaps_ |
|
private |
◆ eOverPMinBarrel_
double ElectronAnalyzer::eOverPMinBarrel_ |
|
private |
◆ eOverPMinEndcaps_
double ElectronAnalyzer::eOverPMinEndcaps_ |
|
private |
◆ etamax
double ElectronAnalyzer::etamax |
|
private |
◆ etamin
double ElectronAnalyzer::etamin |
|
private |
◆ fhitsmax
double ElectronAnalyzer::fhitsmax |
|
private |
◆ gsftrackCollection_
◆ h1_chi2
◆ h1_classes
◆ h1_dEtaEleCl_propOut_barrel
◆ h1_dEtaEleCl_propOut_endcapsNeg
◆ h1_dEtaEleCl_propOut_endcapsPos
◆ h1_dEtaSc_propVtx_barrel
◆ h1_dEtaSc_propVtx_endcapsNeg
◆ h1_dEtaSc_propVtx_endcapsPos
◆ h1_dPhiEleCl_propOut_barrel
◆ h1_dPhiEleCl_propOut_endcapsNeg
◆ h1_dPhiEleCl_propOut_endcapsPos
◆ h1_dPhiSc_propVtx_barrel
◆ h1_dPhiSc_propVtx_endcapsNeg
◆ h1_dPhiSc_propVtx_endcapsPos
◆ h1_ecalRecHitSumEt_dr03
◆ h1_EeleOPout_barrel
◆ h1_EeleOPout_endcaps
◆ h1_Eop_barrel
◆ h1_Eop_endcaps
◆ h1_fbrem
◆ h1_foundHits
◆ h1_hcalTowerSumEt_dr03
◆ h1_Hoe_barrel
◆ h1_Hoe_endcaps
◆ h1_lostHits
◆ h1_matchedObject_Eta
◆ h1_matchedObject_Phi
◆ h1_matchedObject_Pt
◆ h1_matchingObject_Eta
◆ h1_matchingObject_Phi
◆ h1_matchingObject_Pt
◆ h1_mee
◆ h1_mee_os
◆ h1_mee_os_bb
◆ h1_mee_os_eb
◆ h1_mee_os_ee
◆ h1_mva
◆ h1_PFch_dr03
◆ h1_PFem_dr03
◆ h1_PFnh_dr03
◆ h1_provenance
◆ h1_sclEt
◆ h1_sclSigEtaEta_barrel
◆ h1_sclSigEtaEta_endcaps
◆ h1_sigIEtaIEta5x5_barrel
◆ h1_sigIEtaIEta5x5_endcaps
◆ h1_tkSumPt_dr03
◆ h1_triggers
◆ h1_vertexEta
◆ h1_vertexPt_barrel
◆ h1_vertexPt_endcaps
◆ h1_vertexZ
◆ h2_beamSpotXvsY
◆ h2_vertexEtaVsPhi
◆ h2_vertexXvsY
◆ hadronicOverEmMaxBarrel_
double ElectronAnalyzer::hadronicOverEmMaxBarrel_ |
|
private |
◆ hadronicOverEmMaxEndcaps_
double ElectronAnalyzer::hadronicOverEmMaxEndcaps_ |
|
private |
◆ hcalIso03Depth1MaxBarrel_
double ElectronAnalyzer::hcalIso03Depth1MaxBarrel_ |
|
private |
◆ hcalIso03Depth1MaxEndcaps_
double ElectronAnalyzer::hcalIso03Depth1MaxEndcaps_ |
|
private |
◆ hcalIso03Depth2MaxEndcaps_
double ElectronAnalyzer::hcalIso03Depth2MaxEndcaps_ |
|
private |
◆ hoemax
double ElectronAnalyzer::hoemax |
|
private |
◆ hoemin
double ElectronAnalyzer::hoemin |
|
private |
◆ inputFile_
std::string ElectronAnalyzer::inputFile_ |
|
private |
◆ inputInternalPath_
std::string ElectronAnalyzer::inputInternalPath_ |
|
private |
◆ isEB_
bool ElectronAnalyzer::isEB_ |
|
private |
◆ isEcalDriven_
bool ElectronAnalyzer::isEcalDriven_ |
|
private |
◆ isEE_
bool ElectronAnalyzer::isEE_ |
|
private |
◆ isNotEBEEGap_
bool ElectronAnalyzer::isNotEBEEGap_ |
|
private |
◆ isTrackerDriven_
bool ElectronAnalyzer::isTrackerDriven_ |
|
private |
◆ lhitsmax
double ElectronAnalyzer::lhitsmax |
|
private |
◆ matchingCondition_
std::string ElectronAnalyzer::matchingCondition_ |
|
private |
◆ matchingObjectCollection_
◆ maxAbsEta_
double ElectronAnalyzer::maxAbsEta_ |
|
private |
◆ maxAbsEtaMatchingObject_
double ElectronAnalyzer::maxAbsEtaMatchingObject_ |
|
private |
◆ maxPtMatchingObject_
double ElectronAnalyzer::maxPtMatchingObject_ |
|
private |
◆ mcEnergy
float ElectronAnalyzer::mcEnergy[10] |
|
private |
◆ mcEta
float ElectronAnalyzer::mcEta[10] |
|
private |
◆ mcPhi
float ElectronAnalyzer::mcPhi[10] |
|
private |
◆ mcPt
float ElectronAnalyzer::mcPt[10] |
|
private |
◆ mcQ
float ElectronAnalyzer::mcQ[10] |
|
private |
◆ meemax
double ElectronAnalyzer::meemax |
|
private |
◆ meemin
double ElectronAnalyzer::meemin |
|
private |
◆ minEt_
double ElectronAnalyzer::minEt_ |
|
private |
◆ minPt_
double ElectronAnalyzer::minPt_ |
|
private |
◆ mvaMin_
double ElectronAnalyzer::mvaMin_ |
|
private |
◆ nbindeta
int ElectronAnalyzer::nbindeta |
|
private |
◆ nbindetamatch
int ElectronAnalyzer::nbindetamatch |
|
private |
◆ nbindetamatch2D
int ElectronAnalyzer::nbindetamatch2D |
|
private |
◆ nbindphi
int ElectronAnalyzer::nbindphi |
|
private |
◆ nbindphimatch
int ElectronAnalyzer::nbindphimatch |
|
private |
◆ nbindphimatch2D
int ElectronAnalyzer::nbindphimatch2D |
|
private |
◆ nbineop
int ElectronAnalyzer::nbineop |
|
private |
◆ nbineop2D
int ElectronAnalyzer::nbineop2D |
|
private |
◆ nbineta
int ElectronAnalyzer::nbineta |
|
private |
◆ nbineta2D
int ElectronAnalyzer::nbineta2D |
|
private |
◆ nbinfhits
int ElectronAnalyzer::nbinfhits |
|
private |
◆ nbinhoe
int ElectronAnalyzer::nbinhoe |
|
private |
◆ nbinlhits
int ElectronAnalyzer::nbinlhits |
|
private |
◆ nbinmee
int ElectronAnalyzer::nbinmee |
|
private |
◆ nbinp
int ElectronAnalyzer::nbinp |
|
private |
◆ nbinp2D
int ElectronAnalyzer::nbinp2D |
|
private |
◆ nbinphi
int ElectronAnalyzer::nbinphi |
|
private |
◆ nbinphi2D
int ElectronAnalyzer::nbinphi2D |
|
private |
◆ nbinpoptrue
int ElectronAnalyzer::nbinpoptrue |
|
private |
◆ nbinpt
int ElectronAnalyzer::nbinpt |
|
private |
◆ nbinpt2D
int ElectronAnalyzer::nbinpt2D |
|
private |
◆ nbinpteff
int ElectronAnalyzer::nbinpteff |
|
private |
◆ nbinxyz
int ElectronAnalyzer::nbinxyz |
|
private |
◆ nbinxyz2D
int ElectronAnalyzer::nbinxyz2D |
|
private |
◆ nEvents_
unsigned int ElectronAnalyzer::nEvents_ |
|
private |
◆ outputFile_
std::string ElectronAnalyzer::outputFile_ |
|
private |
◆ outputInternalPath_
std::string ElectronAnalyzer::outputInternalPath_ |
|
private |
◆ pDD
◆ phimax
double ElectronAnalyzer::phimax |
|
private |
◆ phimin
double ElectronAnalyzer::phimin |
|
private |
◆ pmax
double ElectronAnalyzer::pmax |
|
private |
◆ poptruemax
double ElectronAnalyzer::poptruemax |
|
private |
◆ poptruemin
double ElectronAnalyzer::poptruemin |
|
private |
◆ ptmax
double ElectronAnalyzer::ptmax |
|
private |
◆ py_chi2VsEta
◆ py_chi2VsPhi
◆ py_dEtaSc_propVtxVsPhi
◆ py_dPhiSc_propVtxVsPhi
◆ py_EopVsPhi
◆ py_fbremVsEta
◆ py_fbremVsPhi
◆ py_foundHitsVsEta
◆ py_foundHitsVsPhi
◆ py_HoeVsPhi
◆ py_lostHitsVsEta
◆ py_lostHitsVsPhi
◆ py_nClustersVsLs
◆ py_nElectronsVsLs
◆ py_nGsfTracksVsLs
◆ py_nTracksVsLs
◆ py_nVerticesVsLs
◆ readAOD_
bool ElectronAnalyzer::readAOD_ |
|
private |
◆ seedEta
float ElectronAnalyzer::seedEta[10] |
|
private |
◆ seedMomentum
float ElectronAnalyzer::seedMomentum[10] |
|
private |
◆ seedPhi
float ElectronAnalyzer::seedPhi[10] |
|
private |
◆ seedPt
float ElectronAnalyzer::seedPt[10] |
|
private |
◆ seedQ
float ElectronAnalyzer::seedQ[10] |
|
private |
◆ Selection_
int ElectronAnalyzer::Selection_ |
|
private |
◆ sigIetaIetaMaxBarrel_
double ElectronAnalyzer::sigIetaIetaMaxBarrel_ |
|
private |
◆ sigIetaIetaMaxEndcaps_
double ElectronAnalyzer::sigIetaIetaMaxEndcaps_ |
|
private |
◆ sigIetaIetaMinBarrel_
double ElectronAnalyzer::sigIetaIetaMinBarrel_ |
|
private |
◆ sigIetaIetaMinEndcaps_
double ElectronAnalyzer::sigIetaIetaMinEndcaps_ |
|
private |
◆ superclusterEnergy
float ElectronAnalyzer::superclusterEnergy[10] |
|
private |
◆ superclusterEt
float ElectronAnalyzer::superclusterEt[10] |
|
private |
◆ superclusterEta
float ElectronAnalyzer::superclusterEta[10] |
|
private |
◆ superclusterPhi
float ElectronAnalyzer::superclusterPhi[10] |
|
private |
◆ theMagField
◆ tipMaxBarrel_
double ElectronAnalyzer::tipMaxBarrel_ |
|
private |
◆ tipMaxEndcaps_
double ElectronAnalyzer::tipMaxEndcaps_ |
|
private |
◆ tkIso03Max_
double ElectronAnalyzer::tkIso03Max_ |
|
private |
◆ trackCollection_
◆ triggerResults_
◆ vertexCollection_
MonitorElement * h1_mee_os_bb
MonitorElement * h1_mee_os
bool selected(const reco::GsfElectronCollection::const_iterator &gsfIter, double vertexTIP)
MonitorElement * py_chi2VsEta
MonitorElement * h1_foundHits
edm::EDGetTokenT< reco::SuperClusterCollection > matchingObjectCollection_
MonitorElement * h1_PFch_dr03
double hadronicOverEmMaxBarrel_
ElectronDqmAnalyzerBase(const edm::ParameterSet &conf)
MonitorElement * py_chi2VsPhi
MonitorElement * h1_dPhiEleCl_propOut_endcapsNeg
MonitorElement * h1_Hoe_barrel
MonitorElement * h1_hcalTowerSumEt_dr03
MonitorElement * h1_sclSigEtaEta_barrel
MonitorElement * py_HoeVsPhi
MonitorElement * h1_matchedObject_Pt
bool isolationCut(const reco::GsfElectronCollection::const_iterator &gsfIter, double vertexTIP)
MonitorElement * h1_tkSumPt_dr03
MonitorElement * h1_dPhiSc_propVtx_barrel
MonitorElement * py_lostHitsVsEta
MonitorElement * h1_dEtaEleCl_propOut_endcapsPos
MonitorElement * h1_dEtaEleCl_propOut_barrel
MonitorElement * h1_dEtaSc_propVtx_endcapsPos
MonitorElement * bookH1withSumw2(DQMStore::IBooker &, const std::string &name, const std::string &title, int nchX, double lowX, double highX, const std::string &titleX="", const std::string &titleY="Events", Option_t *option="E1 P")
double hadronicOverEmMaxEndcaps_
MonitorElement * h1_matchedObject_Phi
MonitorElement * h1_ecalRecHitSumEt_dr03
MonitorElement * h1_vertexEta
unsigned int LuminosityBlockNumber_t
edm::InputTag triggerResults_
double sigIetaIetaMinBarrel_
MonitorElement * h1_matchingObject_Eta
float sumPhotonEt
sum pt of PF photons // old float photonIso ;
MonitorElement * h1_Eop_barrel
MonitorElement * h1_PFnh_dr03
MonitorElement * h1_Eop_endcaps
double maxPtMatchingObject_
MonitorElement * bookH2(DQMStore::IBooker &, const std::string &name, const std::string &title, int nchX, double lowX, double highX, int nchY, double lowY, double highY, const std::string &titleX="", const std::string &titleY="", Option_t *option="COLZ")
MonitorElement * h2_vertexXvsY
unsigned long long EventNumber_t
double ecalIso03MaxBarrel_
std::string matchingCondition_
MonitorElement * py_lostHitsVsPhi
MonitorElement * h1_provenance
double sigIetaIetaMaxBarrel_
double sigIetaIetaMinEndcaps_
MonitorElement * h1_mee_os_ee
MonitorElement * h1_dPhiSc_propVtx_endcapsNeg
MonitorElement * py_fbremVsEta
double sigIetaIetaMaxEndcaps_
MonitorElement * h1_PFem_dr03
MonitorElement * h1_dPhiSc_propVtx_endcapsPos
MonitorElement * h1_classes
MonitorElement * h1_sigIEtaIEta5x5_barrel
MonitorElement * h1_dEtaSc_propVtx_endcapsNeg
MonitorElement * bookH1(DQMStore::IBooker &, const std::string &name, const std::string &title, int nchX, double lowX, double highX, const std::string &titleX="", const std::string &titleY="Events", Option_t *option="E1 P")
MonitorElement * py_dPhiSc_propVtxVsPhi
MonitorElement * py_EopVsPhi
MonitorElement * h1_vertexPt_endcaps
std::string outputInternalPath_
MonitorElement * h1_Hoe_endcaps
MonitorElement * py_dEtaSc_propVtxVsPhi
MonitorElement * h1_dPhiEleCl_propOut_endcapsPos
MonitorElement * h1_dEtaSc_propVtx_barrel
MonitorElement * h1_mee_os_eb
const LorentzVector & p4(P4Kind kind) const
double hcalIso03Depth1MaxEndcaps_
float sumNeutralHadronEt
sum pt of neutral hadrons // old float neutralHadronIso ;
MonitorElement * h2_vertexEtaVsPhi
bool generalCut(const reco::GsfElectronCollection::const_iterator &gsfIter)
MonitorElement * h1_vertexZ
bool etCut(const reco::GsfElectronCollection::const_iterator &gsfIter)
double hcalIso03Depth1MaxBarrel_
MonitorElement * h1_fbrem
MonitorElement * h1_dEtaEleCl_propOut_endcapsNeg
MonitorElement * bookP1(DQMStore::IBooker &, const std::string &name, const std::string &title, int nchX, double lowX, double highX, double lowY, double highY, const std::string &titleX="", const std::string &titleY="", Option_t *option="E1 P")
T getParameter(std::string const &) const
MonitorElement * h1_matchedObject_Eta
MonitorElement * h1_EeleOPout_endcaps
double maxAbsEtaMatchingObject_
MonitorElement * h1_sigIEtaIEta5x5_endcaps
double ecalIso03MaxEndcaps_
edm::EDGetTokenT< reco::GsfTrackCollection > gsftrackCollection_
MonitorElement * py_foundHitsVsEta
XYZTLorentzVectorD XYZTLorentzVector
Lorentz vector with cylindrical internal representation using pseudorapidity.
MonitorElement * py_fbremVsPhi
edm::EDGetTokenT< reco::GsfElectronCollection > electronCollection_
MonitorElement * h1_dPhiEleCl_propOut_barrel
MonitorElement * h1_sclSigEtaEta_endcaps
MonitorElement * h1_sclEt
edm::EDGetTokenT< reco::TrackCollection > trackCollection_
double hcalIso03Depth2MaxEndcaps_
MonitorElement * py_foundHitsVsPhi
float computeInvMass(const reco::GsfElectron &e1, const reco::GsfElectron &e2)
Power< A, B >::type pow(const A &a, const B &b)
edm::EDGetTokenT< reco::VertexCollection > vertexCollection_
Abs< T >::type abs(const T &t)
edm::EDGetTokenT< reco::BeamSpot > beamSpotTag_
MonitorElement * h1_lostHits
MonitorElement * h1_EeleOPout_barrel
MonitorElement * h1_vertexPt_barrel
MonitorElement * h1_matchingObject_Phi
float sumChargedHadronPt
sum-pt of charged Hadron // old float chargedHadronIso ;
bool idCut(const reco::GsfElectronCollection::const_iterator &gsfIter)
MonitorElement * h1_matchingObject_Pt