31 #include "CLHEP/Units/GlobalPhysicalConstants.h"
65 xyz_nbin=histosSet.getParameter<
int>(
"Nbinxyz");
67 p_nbin=histosSet.getParameter<
int>(
"Nbinp");
68 p2D_nbin=histosSet.getParameter<
int>(
"Nbinp2D");
69 p_max=histosSet.getParameter<
double>(
"Pmax");
71 pt_nbin=histosSet.getParameter<
int>(
"Nbinpt");
72 pt2D_nbin=histosSet.getParameter<
int>(
"Nbinpt2D");
73 pteff_nbin=histosSet.getParameter<
int>(
"Nbinpteff");
74 pt_max=histosSet.getParameter<
double>(
"Ptmax");
76 fhits_nbin=histosSet.getParameter<
int>(
"Nbinfhits");
77 fhits_max=histosSet.getParameter<
double>(
"Fhitsmax");
79 lhits_nbin=histosSet.getParameter<
int>(
"Nbinlhits");
80 lhits_max=histosSet.getParameter<
double>(
"Lhitsmax");
82 eop_nbin=histosSet.getParameter<
int>(
"Nbineop");
83 eop2D_nbin=histosSet.getParameter<
int>(
"Nbineop2D");
84 eop_max=histosSet.getParameter<
double>(
"Eopmax");
85 eopmaxsht=histosSet.getParameter<
double>(
"Eopmaxsht");
87 eta_nbin=histosSet.getParameter<
int>(
"Nbineta");
88 eta2D_nbin=histosSet.getParameter<
int>(
"Nbineta2D");
89 eta_min=histosSet.getParameter<
double>(
"Etamin");
90 eta_max=histosSet.getParameter<
double>(
"Etamax");
92 deta_nbin=histosSet.getParameter<
int>(
"Nbindeta");
93 deta_min=histosSet.getParameter<
double>(
"Detamin");
94 deta_max=histosSet.getParameter<
double>(
"Detamax");
96 phi_nbin=histosSet.getParameter<
int>(
"Nbinphi");
97 phi2D_nbin=histosSet.getParameter<
int>(
"Nbinphi2D");
98 phi_min=histosSet.getParameter<
double>(
"Phimin");
99 phi_max=histosSet.getParameter<
double>(
"Phimax");
103 detamatch_min=histosSet.getParameter<
double>(
"Detamatchmin");
104 detamatch_max=histosSet.getParameter<
double>(
"Detamatchmax");
106 dphi_nbin=histosSet.getParameter<
int>(
"Nbindphi");
107 dphi_min=histosSet.getParameter<
double>(
"Dphimin");
108 dphi_max=histosSet.getParameter<
double>(
"Dphimax");
112 dphimatch_min=histosSet.getParameter<
double>(
"Dphimatchmin");
113 dphimatch_max=histosSet.getParameter<
double>(
"Dphimatchmax");
115 poptrue_nbin= histosSet.getParameter<
int>(
"Nbinpoptrue");
116 poptrue_min=histosSet.getParameter<
double>(
"Poptruemin");
117 poptrue_max=histosSet.getParameter<
double>(
"Poptruemax");
119 mee_nbin= histosSet.getParameter<
int>(
"Nbinmee");
120 mee_min=histosSet.getParameter<
double>(
"Meemin");
121 mee_max=histosSet.getParameter<
double>(
"Meemax");
123 hoe_nbin= histosSet.getParameter<
int>(
"Nbinhoe");
124 hoe_min=histosSet.getParameter<
double>(
"Hoemin");
125 hoe_max=histosSet.getParameter<
double>(
"Hoemax");
197 h2_ele_E2mnE1vsMee_all =
bookH2(
"h_ele_E2mnE1vsMee_all",
"E2 - E1 vs ele pairs invariant mass, all electrons",
mee_nbin,
mee_min,
mee_max, 100, -50., 50.,
"m_{e^{+}e^{-}} (GeV/c^{2})",
"E2 - E1 (GeV)");
198 h2_ele_E2mnE1vsMee_egeg_all =
bookH2(
"h_ele_E2mnE1vsMee_egeg_all",
"E2 - E1 vs ele pairs invariant mass, ecal driven pairs, all electrons",
mee_nbin,
mee_min,
mee_max, 100, -50., 50.,
"m_{e^{+}e^{-}} (GeV/c^{2})",
"E2 - E1 (GeV)");
317 h2_scl_EoEtruePfVsEg =
bookH2(
"h_scl_EoEtruePfVsEg",
"ele supercluster energy / gen energy pflow vs eg",75,-0.1,1.4, 75, -0.1, 1.4,
"E/E_{gen} (e/g)",
"E/E_{gen} (pflow)") ;
569 <<
"Treating event "<<iEvent.
id()
570 <<
" with "<<gsfElectrons.
product()->size()<<
" electrons" ;
580 reco::GsfElectronCollection::const_iterator gsfIter ;
581 for ( gsfIter=gsfElectrons->begin() ; gsfIter!=gsfElectrons->end() ; gsfIter++ )
599 h1_ele_Et_all->
Fill( gsfIter->superCluster()->energy()/cosh(gsfIter->superCluster()->eta()));
600 float enrj1=gsfIter->superCluster()->energy();
603 reco::GsfElectronCollection::const_iterator gsfIter2 ;
604 for ( gsfIter2=gsfIter+1 ; gsfIter2!=gsfElectrons->end() ; gsfIter2++ )
607 float mee2 = p12.Dot(p12);
608 float enrj2=gsfIter2->superCluster()->energy();
611 if (gsfIter->ecalDrivenSeed() && gsfIter2->ecalDrivenSeed())
613 if (gsfIter->charge()*gsfIter2->charge()<0.)
620 ( (gsfIter->classification()==GsfElectron::GOLDEN && gsfIter2->classification()==GsfElectron::GOLDEN) ||
621 (gsfIter->classification()==GsfElectron::GOLDEN && gsfIter2->classification()==GsfElectron::BIGBREM) ||
623 (gsfIter->classification()==GsfElectron::BIGBREM && gsfIter2->classification()==GsfElectron::GOLDEN) ||
624 (gsfIter->classification()==GsfElectron::BIGBREM && gsfIter2->classification()==GsfElectron::BIGBREM)
631 ( (gsfIter->classification()==GsfElectron::SHOWERING && gsfIter2->classification()==GsfElectron::SHOWERING) ||
632 (gsfIter->classification()==GsfElectron::SHOWERING && gsfIter2->isGap()) ||
633 (gsfIter->isGap() && gsfIter2->classification()==GsfElectron::SHOWERING) ||
634 (gsfIter->isGap() && gsfIter2->isGap()) )
642 int flags = gsfIter->convFlags() ;
643 if (flags==-9999) { flags=-1 ; }
657 int mcNum=0, gamNum=0, eleNum=0 ;
658 bool matchingID, matchingMotherID ;
660 reco::GenParticleCollection::const_iterator mcIter ;
662 ( mcIter=genParticles->begin() ; mcIter!=genParticles->end() ; mcIter++ )
669 { matchingID=
true ; }
676 matchingMotherID =
false ;
680 { matchingMotherID =
true ; }
682 if (matchingMotherID)
692 bool okGsfFound =
false ;
693 double gsfOkRatio = 999999. ;
697 reco::GsfElectronCollection::const_iterator gsfIter ;
699 ( gsfIter=gsfElectrons->begin() ; gsfIter!=gsfElectrons->end() ; gsfIter++ )
701 double dphi = gsfIter->
phi()-mcIter->phi() ;
703 { dphi = dphi < 0? (CLHEP::twopi) + dphi : dphi - CLHEP::twopi ; }
707 double mc_charge = mcIter->pdgId() == 11 ? -1. : 1. ;
711 ( ( (mcIter->pdgId() == 11) && (gsfIter->charge() > 0.) ) ||
712 ( (mcIter->pdgId() == -11) && (gsfIter->charge() < 0.) ) )
714 double tmpGsfRatio = gsfIter->p()/mcIter->p();
717 gsfOkRatio = tmpGsfRatio;
718 bestGsfElectron=*gsfIter;
743 for ( mcIter=genParticles->begin() ; mcIter!=genParticles->end() ; mcIter++ )
749 if (mcIter->pdgId() == 22 )
757 { matchingID=
true ; }
759 if (!matchingID) continue ;
764 matchingMotherID =
false ;
768 { matchingMotherID =
true ; }
770 if (!matchingMotherID) continue ;
791 bool okGsfFound =
false ;
792 double gsfOkRatio = 999999. ;
794 reco::GsfElectronCollection::const_iterator gsfIter ;
795 for ( gsfIter=gsfElectrons->begin() ; gsfIter!=gsfElectrons->end() ; gsfIter++ )
797 double dphi = gsfIter->
phi()-mcIter->phi() ;
799 { dphi = dphi < 0? (CLHEP::twopi) + dphi : dphi - CLHEP::twopi ; }
803 if ( ( (mcIter->pdgId() == 11) && (gsfIter->charge() < 0.) ) ||
804 ( (mcIter->pdgId() == -11) && (gsfIter->charge() > 0.) ) )
806 double tmpGsfRatio = gsfIter->p()/mcIter->p() ;
809 gsfOkRatio = tmpGsfRatio;
810 bestGsfElectron=*gsfIter;
816 if (! okGsfFound) continue ;
846 (bestGsfElectron.
vertex().x()-mcIter->vx())*(bestGsfElectron.
vertex().x()-mcIter->vx()) +
847 (bestGsfElectron.
vertex().y()-mcIter->vy())*(bestGsfElectron.
vertex().y()-mcIter->vy()) ;
885 double R=TMath::Sqrt(sclRef->x()*sclRef->x() + sclRef->y()*sclRef->y() +sclRef->z()*sclRef->z());
886 double Rt=TMath::Sqrt(sclRef->x()*sclRef->x() + sclRef->y()*sclRef->y());
940 float pfEnergy=0., egEnergy=0.;
987 ( bestGsfElectron.
gsfTrack()->normalizedChi2(),
1003 if (elseed->subDet2()==1)
1005 else if (elseed->subDet2()==2)
1007 else if (elseed->subDet2()==6)
1128 if (bestGsfElectron.
isEE()) eleClass+=10;
1144 double fbrem_mean=0.;
1146 { fbrem_mean = 1. - bestGsfElectron.
gsfTrack()->outerMomentum().R()/bestGsfElectron.
gsfTrack()->innerMomentum().R() ; }
1147 double fbrem_mode = bestGsfElectron.
fbrem();
1202 if (flags==-9999) { flags=-1 ; }
1224 std::cout <<
"[ElectronMcSignalValidator] efficiency calculation " << std::endl ;
1232 std::cout <<
"[ElectronMcSignalValidator] q-misid calculation " << std::endl;
1238 std::cout <<
"[ElectronMcSignalValidator] all reco electrons " << std::endl ;
1242 std::cout <<
"[ElectronMcSignalValidator] classes " << std::endl ;
1251 double xOverX0 = 0.;
1260 profileX(
"h_scl_EoEtruePfVsEg_pfx",
h2_scl_EoEtruePfVsEg,
"mean pflow sc energy / true energy vs e/g sc energy",
"E/E_{gen} (e/g)",
"<E/E_{gen}> (pflow)") ;
1261 profileY(
"h_scl_EoEtruePfVsEg_pfy",
h2_scl_EoEtruePfVsEg,
"mean e/g sc energy / true energy vs pflow sc energy",
"E/E_{gen} (pflow)",
"<E/E_{gen}> (eg)") ;
1286 profileX(
"h_ele_seedDphi2_VsEta_pfx",
h2_ele_seed_dphi2VsEta_,
"mean ele seed dphi 2nd layer vs eta",
"#eta",
"<#phi_{pred} - #phi_{hit}, 2nd layer> (rad)",-0.004,0.004);
1287 profileX(
"h_ele_seedDphi2_VsPt_pfx",
h2_ele_seed_dphi2VsPt_,
"mean ele seed dphi 2nd layer vs pt",
"p_{T} (GeV/c)",
"<#phi_{pred} - #phi_{hit}, 2nd layer> (rad)",-0.004,0.004);
1288 profileX(
"h_ele_seedDrz2_VsEta_pfx",
h2_ele_seed_drz2VsEta_,
"mean ele seed dr(dz) 2nd layer vs eta",
"#eta",
"<r(z)_{pred} - r(z)_{hit}, 2nd layer> (cm)",-0.15,0.15);
1289 profileX(
"h_ele_seedDrz2_VsPt_pfx",
h2_ele_seed_drz2VsPt_,
"mean ele seed dr(dz) 2nd layer vs pt",
"p_{T} (GeV/c)",
"<r(z)_{pred} - r(z)_{hit}, 2nd layer> (cm)",-0.15,0.15);
1290 profileX(
"h_ele_seedDphi2Pos_VsEta_pfx",
h2_ele_seed_dphi2posVsEta_,
"mean ele seed dphi 2nd layer positron vs eta",
"#eta",
"<#phi_{pred} - #phi_{hit}, 2nd layer> (rad)",-0.004,0.004);
1291 profileX(
"h_ele_seedDphi2Pos_VsPt_pfx",
h2_ele_seed_dphi2posVsPt_,
"mean ele seed dphi 2nd layer positron vs pt",
"p_{T} (GeV/c)",
"<#phi_{pred} - #phi_{hit}, 2nd layer> (rad)",-0.004,0.004);
1292 profileX(
"h_ele_seedDrz2Pos_VsEta_pfx",
h2_ele_seed_drz2posVsEta_,
"mean ele seed dr(dz) 2nd layer positron vs eta",
"#eta",
"<r(z)_{pred} - r(z)_{hit}, 2nd layer> (cm)",-0.15,0.15);
1293 profileX(
"h_ele_seedDrz2Pos_VsPt_pfx",
h2_ele_seed_drz2posVsPt_,
"mean ele seed dr(dz) 2nd layer positron vs pt",
"p_{T} (GeV/c)",
"<r(z)_{pred} - r(z)_{hit}, 2nd layer> (cm)",-0.15,0.15);
MonitorElement * h2_ele_PinVsPoutGolden_mode
MonitorElement * h1_ele_ambiguousTracks
MonitorElement * h1_scl_EoEtrue_endcaps_ringgap
MonitorElement * h1_ele_EoPout
MonitorElement * h1_ele_dPhiCl_propOut_eg_barrel
MonitorElement * h1_ele_simEta_matched
MonitorElement * h1_ele_seed_dphi2_
MonitorElement * h1_ele_EseedOP_eg
MonitorElement * h1_ele_eta
MonitorElement * h1_ele_EoPout_all_barrel
MonitorElement * h1_ele_vertexX
MonitorElement * h1_recTrackNum_
MonitorElement * h1_ele_PhiMnPhiTrue
MonitorElement * h1_ele_convDist_all
T getParameter(std::string const &) const
MonitorElement * h1_ele_hcalTowerSumEt_dr03_depth1_endcaps
MonitorElement * h1_ele_vertexEta
MonitorElement * h1_ele_outerP
edm::InputTag electronSeedCollection_
MonitorElement * h2_ele_PinMnPoutVsChi2_mode
virtual double p() const
magnitude of momentum vector
MonitorElement * h1_scl_SigEtaEta_
MonitorElement * h1_ele_hcalTowerSumEt_dr04_depth1_barrel
MonitorElement * h1_ele_EeleOPout
MonitorElement * h2_ele_HoEVsE
void setBinContent(int binx, double content)
set content of bin (1-D)
MonitorElement * h1_ele_ecalRecHitSumEt_dr04_barrel
MonitorElement * h1_ele_hcalTowerSumEt_dr03_depth1_barrel
MonitorElement * h1_ele_TIP_all_barrel
MonitorElement * h1_ele_ecalRecHitSumEt_dr03_endcaps
MonitorElement * h2_ele_lostHitsVsPhi
MonitorElement * h1_ele_convDcot_all
float scSigmaEtaEta() const
MonitorElement * h1_ele_simZ_matched
MonitorElement * h1_ele_eta_golden
MonitorElement * h1_scl_SigIEtaIEta_barrel_
MonitorElement * h1_ele_mee_os_gg
MonitorElement * h1_scl_E1x5_eg_barrel_
MonitorElement * h1_scl_SigEtaEta_eg_
MonitorElement * h1_scl_E2x5max_eg_barrel_
MonitorElement * h1_ele_hcalTowerSumEt_dr03_depth2
MonitorElement * h1_scl_E1x5_eg_
float eSuperClusterOverP() const
virtual const Candidate * mother(size_type i=0) const =0
return pointer to mother
MonitorElement * bookH1withSumw2(const std::string &name, const std::string &title, int nchX, double lowX, double highX, const std::string &titleX="", const std::string &titleY="Events")
MonitorElement * h1_ele_EseedOP_all_endcaps
MonitorElement * h1_ele_HoE_barrel
MonitorElement * h1_ele_convFlags
MonitorElement * h1_ele_outerPt_mode
MonitorElement * h1_scl_EoEtrue_endcaps_new_eg
MonitorElement * bookH2(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="")
MonitorElement * h1_ele_lostHits_barrel
MonitorElement * h1_ele_outerPt
MonitorElement * h1_ele_EeleOPout_eg_endcaps
float dr04HcalDepth1TowerSumEt() const
MonitorElement * h1_ele_EoP_barrel
MonitorElement * h1_ele_simAbsEta_matched
MonitorElement * h1_scl_SigIEtaIEta_eg_endcaps_
virtual void analyze(const edm::Event &e, const edm::EventSetup &c)
MonitorElement * h2_ele_dPhiScVsEta_propVtx
MonitorElement * h1_recSeedNum_
MonitorElement * h2_ele_chi2VsEta
MonitorElement * h1_ele_PoPtrue_endcaps
virtual const Point & vertex() const
vertex position
MonitorElement * h1_ele_mee_all
MonitorElement * h1_scl_SigEtaEta_barrel_
MonitorElement * h1_ele_dPhiCl_propOut
MonitorElement * h1_ele_mee_os_gb
edm::InputTag beamSpotTag_
MonitorElement * h1_ele_vertexP
MonitorElement * h2_ele_dPhiClVsPhi_propOut
MonitorElement * h2_ele_EtaMnEtaTrueVsPt
MonitorElement * h1_ele_EoPout_eg
MonitorElement * h1_ele_dPhiEleCl_propOut_endcaps
MonitorElement * h1_scl_E1x5_endcaps_
math::XYZVectorF trackMomentumAtVtx() const
MonitorElement * h2_ele_seed_drz2VsEta_
MonitorElement * h2_ele_dEtaEleClVsEta_propOut
MonitorElement * h2_ele_outerPtVsEta_mode
MonitorElement * h1_simEta
MonitorElement * h2_ele_foundHitsVsEta
MonitorElement * h1_ele_EoPout_eg_endcaps
MonitorElement * h1_ele_seed_drz2pos_
MonitorElement * h1_ele_TIP_all_endcaps
MonitorElement * h2_ele_E2mnE1vsMee_all
MonitorElement * h2_ele_seed_dphi2VsEta_
MonitorElement * h1_ele_foundHits_endcaps
MonitorElement * h1_ele_EoverP_all_barrel
MonitorElement * h1_ele_simEta_matched_qmisid
MonitorElement * h1_ele_EoPout_all
MonitorElement * h1_scl_EoEtrue_endcaps_new
MonitorElement * h2_ele_PoPtrueVsPt
MonitorElement * h1_ele_dEtaSc_propVtx_endcaps
MonitorElement * h1_ele_dEtaSc_propVtx_all_endcaps
MonitorElement * profileX(const std::string &name, MonitorElement *me2d, const std::string &title="", const std::string &titleX="", const std::string &titleY="", Double_t minimum=-1111, Double_t maximum=-1111)
MonitorElement * h1_ele_ecalRecHitSumEt_dr04
MonitorElement * h1_ele_PoPtrue_golden_barrel
MonitorElement * h1_ele_dPhiCl_propOut_all_endcaps
MonitorElement * h1_scl_EoEtrue_ebeegap
MonitorElement * h2_ele_EseedOPVsPhi
MonitorElement * h2_ele_EoPVsPhi
float dr04TkSumPt() const
std::vector< Variable::Flags > flags
MonitorElement * h1_ele_PhiMnPhiTrue_barrel
MonitorElement * h2_ele_dPhiClVsPt_propOut
MonitorElement * h1_ele_EeleOPout_all_endcaps
MonitorElement * h1_ele_vertexEta_all
MonitorElement * h1_scl_SigEtaEta_endcaps_
MonitorElement * h1_ele_mee_os_ebee
MonitorElement * h1_ele_lostHits
MonitorElement * h1_ele_HoE_eg
MonitorElement * h1_ele_dEtaCl_propOut_eg_barrel
MonitorElement * h1_ele_HoE_all_barrel
MonitorElement * h1_ele_chi2_barrel
MonitorElement * h1_ele_ChargeMnChargeTrue
MonitorElement * h1_recCoreNum_
MonitorElement * h2_ele_PoPtrueVsPhi
MonitorElement * h1_ele_HoE_all_endcaps
MonitorElement * h2_ele_ambiguousTracksVsEta
MonitorElement * h1_ele_HoE_all
MonitorElement * h2_ele_PtinVsPtoutShowering_mode
MonitorElement * h1_ele_PoPtrue_showering_barrel
MonitorElement * h1_ele_simPt_matched_qmisid
float dr03HcalDepth2TowerSumEt() const
MonitorElement * h1_scl_EoEtrue_barrel
MonitorElement * h2_ele_seed_dphi2posVsEta_
MonitorElement * h1_scl_EoEtrueGolden_endcaps
MonitorElement * h1_ele_mee_os_eeee
MonitorElement * h2_ele_simPtEta_matched
MonitorElement * h1_ele_provenance
SuperClusterRef superCluster() const
reference to a SuperCluster
MonitorElement * h2_ele_EeleOPoutVsEta
MonitorElement * h1_ele_vertexPt_all
MonitorElement * h1_ele_EtaMnEtaTrue_barrel
MonitorElement * h1_scl_E2x5max_eg_
MonitorElement * h1_ele_vertexTIP
MonitorElement * h1_ele_mva_eg
MonitorElement * h1_ele_seed_drz2_
MonitorElement * h1_ele_hcalTowerSumEt_dr04_depth1_endcaps
edm::InputTag electronCoreCollection_
MonitorElement * h2_ele_EseedOPVsEta
MonitorElement * h1_ele_dEtaCl_propOut_eg
MonitorElement * h1_scl_E5x5_endcaps_
MonitorElement * h1_ele_EoverP_all
MonitorElement * h2_ele_seed_drz2posVsEta_
MonitorElement * h1_ele_dEtaSc_propVtx_all
MonitorElement * h1_ele_fbrem_eg
MonitorElement * h1_ele_dPhiCl_propOut_all
edm::InputTag mcTruthCollection_
MonitorElement * h2_ele_HoEVsEta
MonitorElement * h1_ele_seed_subdet2_
virtual double eta() const
momentum pseudorapidity
MonitorElement * h1_scl_EoEtrue_ebeegap_new
MonitorElement * h1_ele_chi2
MonitorElement * h1_ele_tkSumPt_dr04_barrel
MonitorElement * h1_ele_EoP_eg_endcaps
MonitorElement * h2_ele_dPhiEleClVsPhi_propOut
MonitorElement * h1_ele_EseedOP_eg_barrel
MonitorElement * h1_scl_Eta_
MonitorElement * h2_ele_PtinVsPtoutGolden_mean
MonitorElement * h2_ele_dEtaEleClVsPhi_propOut
MonitorElement * h1_ele_dPhiSc_propVtx_all_endcaps
MonitorElement * h1_ele_mee_os
MonitorElement * h1_ele_charge
MonitorElement * h2_ele_PinVsPoutGolden_mean
MonitorElement * h2_simPtEta
MonitorElement * h1_ele_convFlags_all
MonitorElement * h2_ele_dEtaClVsPt_propOut
MonitorElement * h2_ele_vertexEtaVsPhi
MonitorElement * h1_ele_hcalTowerSumEt_dr03_depth1
MonitorElement * h1_ele_chi2_endcaps
MonitorElement * h2_ele_EoPoutVsEta
edm::InputTag electronTrackCollection_
MonitorElement * h1_ele_hcalTowerSumEt_dr04_depth2
MonitorElement * h1_ele_eta_shower
MonitorElement * h1_ele_simZ_matched_qmisid
XYZTLorentzVectorD XYZTLorentzVector
Lorentz vector with cylindrical internal representation using pseudorapidity.
MonitorElement * h1_ele_EseedOP_all_barrel
MonitorElement * h1_ele_EseedOP_barrel
MonitorElement * h1_scl_E1x5_eg_endcaps_
MonitorElement * h2_ele_outerPVsEta_mode
virtual ~ElectronMcSignalValidator()
float dr04HcalDepth2TowerSumEt() const
MonitorElement * h1_scl_EoEtrue_barrel_new_eg
MonitorElement * h1_ele_seed_mask_
MonitorElement * h1_ele_PoPtrue_showering_endcaps
MonitorElement * h2_ele_lostHitsVsEta
MonitorElement * h2_ele_PtinVsPtoutGolden_mode
MonitorElement * h1_ele_HoE_fiducial
float deltaEtaSuperClusterTrackAtVtx() const
MonitorElement * h1_scl_E5x5_
MonitorElement * h2_ele_vertexTIPVsPt
MonitorElement * h1_ele_dEtaEleCl_propOut_endcaps
MonitorElement * h1_ele_eta_bbrem
MonitorElement * h1_ele_EoP_endcaps
bool isNull() const
Checks for null.
void saveStore(const std::string &filename)
float hadronicOverEm() const
MonitorElement * h2_ele_EoPVsEta
float eSeedClusterOverP() const
MonitorElement * h1_ele_dPhiCl_propOut_eg
MonitorElement * h1_ele_dEtaSc_propVtx_barrel
MonitorElement * h1_mcNum
MonitorElement * h1_ele_dPhiSc_propVtx_endcaps
MonitorElement * h2_ele_EoPVsE
float dr04EcalRecHitSumEt() const
MonitorElement * h1_ele_dEtaSc_propVtx_eg_endcaps
MonitorElement * h2_ele_chargeVsPhi
MonitorElement * h2_ele_chargeVsEta
float deltaPhiSeedClusterTrackAtCalo() const
MonitorElement * h1_scl_EoEtrue_endcaps_eg
MonitorElement * h1_ele_outerP_mode
MonitorElement * h2_ele_outerPtVsPhi_mode
void Fill(HcalDetId &id, double val, std::vector< TH2F > &depth)
MonitorElement * h2_ele_PoPtrueVsEta
MonitorElement * h2_ele_chi2VsPhi
MonitorElement * h2_ele_vertexPtVsPhi
MonitorElement * h2_ele_EtaMnEtaTrueVsPhi
MonitorElement * h1_simAbsEta
MonitorElement * h1_ele_dEtaCl_propOut_barrel
math::XYZVectorF trackMomentumOut() const
MonitorElement * h1_ele_ecalRecHitSumEt_dr03
MonitorElement * h2_ele_dEtaScVsPt_propVtx
MonitorElement * h1_ele_seed_mask_tec_
float deltaPhiSuperClusterTrackAtVtx() const
MonitorElement * h1_scl_SigEtaEta_eg_barrel_
MonitorElement * h2_ele_vertexTIPVsPhi
MonitorElement * h1_ele_dPhiEleCl_propOut
MonitorElement * h1_ele_dEtaCl_propOut
MonitorElement * h1_ele_dPhiSc_propVtx_eg_barrel
MonitorElement * h1_ele_simPt_matched
MonitorElement * h1_ele_PhiMnPhiTrue_endcaps
MonitorElement * h2_ele_dPhiEleClVsEta_propOut
MonitorElement * h1_ele_seed_dphi2pos_
MonitorElement * h1_scl_En_
MonitorElement * h1_ele_EtaMnEtaTrue_endcaps
virtual int charge() const
electric charge
MonitorElement * h1_ele_dEtaEleCl_propOut
float dr03TkSumPt() const
MonitorElement * h1_ele_convDcot
MonitorElement * h1_ele_EeleOPout_all
MonitorElement * h2_ele_EoPoutVsPhi
MonitorElement * p1_ele_fbremVsEta_mean
MonitorElement * h1_simPt
MonitorElement * h1_scl_EoEtrueShowering_endcaps
MonitorElement * h1_ele_EseedOP
float dr03HcalDepth1TowerSumEt() const
MonitorElement * h1_ele_HoE_eg_barrel
MonitorElement * h2_ele_PhiMnPhiTrueVsEta
MonitorElement * h1_scl_E5x5_eg_endcaps_
float eEleClusterOverPout() const
MonitorElement * h2_ele_EoPoutVsE
MonitorElement * h1_ele_dEtaSc_propVtx_all_barrel
MonitorElement * h1_ele_vertexPt
MonitorElement * h1_ele_simPhi_matched
MonitorElement * h2_ele_EtaMnEtaTrueVsEta
float eSeedClusterOverPout() const
MonitorElement * h2_ele_foundHitsVsPhi
MonitorElement * h1_ele_convDist
MonitorElement * h2_ele_PinMnPoutVsE_mode
MonitorElement * h2_ele_HoEVsPhi
MonitorElement * h1_scl_SigIEtaIEta_
MonitorElement * p1_ele_fbremVsEta_mode
MonitorElement * h2_ele_dPhiScVsPhi_propVtx
MonitorElement * h1_ele_dPhiSc_propVtx_eg_endcaps
MonitorElement * h1_scl_E5x5_eg_barrel_
MonitorElement * h1_scl_EoEtrue_endcaps
MonitorElement * h2_ele_EeleOPoutVsPhi
MonitorElement * h1_ele_dPhiEleCl_propOut_eg
MonitorElement * h1_scl_E5x5_barrel_
MonitorElement * h1_scl_EoEtrue_barrel_eg
MonitorElement * h1_ele_tkSumPt_dr04
MonitorElement * h2_ele_PinMnPoutVsPt_mode
float scSigmaIEtaIEta() const
MonitorElement * h1_ele_PoPtrue
bool getByLabel(InputTag const &tag, Handle< PROD > &result) const
MonitorElement * h2_ele_dEtaScVsEta_propVtx
MonitorElement * h1_ele_hcalTowerSumEt_dr04_depth1
MonitorElement * h1_scl_E1x5_barrel_
MonitorElement * h1_scl_Phi_
MonitorElement * h1_ele_fbrem
float deltaPhiEleClusterTrackAtCalo() const
MonitorElement * h1_ele_dPhiSc_propVtx_all_barrel
MonitorElement * h1_scl_SigEtaEta_eg_endcaps_
MonitorElement * h1_ele_dEtaCl_propOut_eg_endcaps
MonitorElement * h1_scl_EoEtrueShowering_barrel
MonitorElement * h1_ele_dPhiSc_propVtx_eg
MonitorElement * profileY(const std::string &name, MonitorElement *me2d, const std::string &title="", const std::string &titleX="", const std::string &titleY="", Double_t minimum=-1111, Double_t maximum=-1111)
MonitorElement * h1_scl_SigIEtaIEta_eg_
MonitorElement * h1_ele_TIP_all
MonitorElement * h1_ele_PtoPttrue_endcaps
MonitorElement * h1_scl_E5x5_eg_
double deltaR(double eta1, double eta2, double phi1, double phi2)
MonitorElement * h1_ele_convRadius_all
virtual int pdgId() const =0
PDG identifier.
MonitorElement * h2_ele_foundHitsVsPt
MonitorElement * h1_ele_simAbsEta_matched_qmisid
MonitorElement * h1_scl_EoEtrue_barrel_etagap
GsfTrackRef gsfTrack() const
reference to a GsfTrack
MonitorElement * h1_ele_vertexY
MonitorElement * h1_ele_eta_narrow
MonitorElement * h1_ele_dPhiEleCl_propOut_barrel
MonitorElement * h1_ele_seed_mask_fpix_
MonitorElement * h1_ele_lostHits_endcaps
MonitorElement * h2_ele_seed_drz2posVsPt_
MonitorElement * h2_scl_EtVsEta_
MonitorElement * h1_scl_EoEtrue_barrel_new_etagap
MonitorElement * h1_scl_E1x5_
MonitorElement * h1_recEleNum_
MonitorElement * h1_ele_dPhiEleCl_propOut_eg_barrel
Log< T >::type log(const T &t)
MonitorElement * h2_ele_outerPtVsPt_mode
MonitorElement * h1_ele_classes
MonitorElement * bookH2withSumw2(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="")
MonitorElement * h2_ele_EseedOPVsE
MonitorElement * h1_ele_EoPout_all_endcaps
MonitorElement * h1_ele_foundHits_barrel
float deltaEtaEleClusterTrackAtCalo() const
MonitorElement * h2_scl_EtVsPhi_
MonitorElement * h1_scl_Et_
MonitorElement * h1_ele_EseedOP_all
virtual double pt() const
transverse momentum
MonitorElement * h2_ele_dEtaScVsPhi_propVtx
MonitorElement * h2_ele_ambiguousTracksVsPhi
MonitorElement * h1_ele_EeleOPout_eg
Classification classification() const
MonitorElement * h1_ele_vertexPhi
REF castTo() const
cast to a concrete type
MonitorElement * h1_scl_E2x5max_endcaps_
MonitorElement * h2_ele_lostHitsVsPt
MonitorElement * h1_ele_EoPout_eg_barrel
MonitorElement * h1_ele_PhiMnPhiTrue2
GsfTrackRefVector::size_type ambiguousGsfTracksSize() const
MonitorElement * h1_ele_dEtaCl_propOut_endcaps
MonitorElement * h1_ele_dPhiSc_propVtx
MonitorElement * h1_gamNum
ElectronMcSignalValidator(const edm::ParameterSet &conf)
MonitorElement * h2_ele_PinVsPoutShowering_mean
MonitorElement * h1_ele_EoP_eg_barrel
MonitorElement * h1_ele_EeleOPout_barrel
MonitorElement * h1_ele_PinMnPout_mode
MonitorElement * h1_ele_tkSumPt_dr03_endcaps
MonitorElement * h2_scl_EtaVsPhi_
MonitorElement * h2_ele_EeleOPoutVsE
MonitorElement * h1_ele_EeleOPout_eg_barrel
T const * product() const
MonitorElement * h1_ele_mee_os_ebeb
float dr03EcalRecHitSumEt() const
MonitorElement * h1_ele_dPhiCl_propOut_barrel
MonitorElement * h1_ele_dPhiCl_propOut_all_barrel
MonitorElement * h2_ele_PinMnPoutVsPhi_mode
MonitorElement * h1_ele_dEtaCl_propOut_all_barrel
MonitorElement * h2_ele_dPhiClVsEta_propOut
MonitorElement * h1_ele_PoPtrue_barrel
MonitorElement * h2_ele_chargeVsPt
MonitorElement * h1_ele_dEtaEleCl_propOut_eg_barrel
MonitorElement * h2_ele_vertexTIPVsEta
MonitorElement * h2_ele_seed_dphi2VsPt_
double getBinContent(int binx) const
get content of bin (1-D)
float deltaEtaSeedClusterTrackAtCalo() const
MonitorElement * h2_ele_PhiMnPhiTrueVsPhi
MonitorElement * h1_ele_EeleOPout_endcaps
MonitorElement * h1_scl_E2x5max_eg_endcaps_
MonitorElement * h1_ele_dPhiSc_propVtx_barrel
MonitorElement * h1_ele_dEtaEleCl_propOut_eg_endcaps
T perp() const
Magnitude of transverse component.
MonitorElement * bookH1(const std::string &name, const std::string &title, int nchX, double lowX, double highX, const std::string &titleX="", const std::string &titleY="Events")
MonitorElement * h2_ele_vertexPtVsEta
MonitorElement * h2_ele_seed_dphi2posVsPt_
MonitorElement * h2_ele_ambiguousTracksVsPt
void setStoreFolder(const std::string &path)
MonitorElement * h1_ele_dEtaCl_propOut_all
MonitorElement * h2_ele_E2mnE1vsMee_egeg_all
MonitorElement * h2_ele_PinMnPoutVsEta_mode
MonitorElement * h1_ele_ecalRecHitSumEt_dr03_barrel
MonitorElement * h2_ele_seed_drz2VsPt_
MonitorElement * h1_scl_SigIEtaIEta_endcaps_
MonitorElement * h1_scl_EoEtrue_endcaps_new_deegap
MonitorElement * bookH1andDivide(const std::string &name, MonitorElement *num, MonitorElement *denom, const std::string &titleX, const std::string &titleY, const std::string &title="", bool print=false)
int getNbinsX(void) const
get # of bins in X-axis
MonitorElement * h2_ele_chi2VsPt
MonitorElement * h1_ele_dPhiSc_propVtx_all
bool trackerDrivenSeed() const
MonitorElement * h1_ele_EoPout_endcaps
MonitorElement * h1_scl_E2x5max_
MonitorElement * h2_ele_PinVsPoutShowering_mode
MonitorElement * h1_ele_vertexZ
std::vector< int > matchingIDs_
MonitorElement * h1_ele_EoP
MonitorElement * bookH2andDivide(const std::string &name, MonitorElement *num, MonitorElement *denom, const std::string &titleX, const std::string &titleY, const std::string &title="", bool print=false)
MonitorElement * h1_ele_EoP_eg
MonitorElement * h1_ele_HoE
MonitorElement * h1_ele_EtaMnEtaTrue
MonitorElement * h1_ele_ecalRecHitSumEt_dr04_endcaps
MonitorElement * h1_ele_dEtaCl_propOut_all_endcaps
MonitorElement * h1_ele_PinMnPout
MonitorElement * h1_ele_EoPout_barrel
MonitorElement * h1_scl_SigIEtaIEta_eg_barrel_
MonitorElement * h1_scl_EoEtrue_barrel_new
MonitorElement * h2_ele_PhiMnPhiTrueVsPt
MonitorElement * h1_ele_Et
MonitorElement * h1_scl_EoEtrue_barrel_phigap
MonitorElement * h1_ele_dEtaSc_propVtx_eg
MonitorElement * h1_ele_Et_all
MonitorElement * h1_ele_EeleOPout_all_barrel
MonitorElement * h1_ele_HoE_eg_endcaps
MonitorElement * h1_ele_EoverP_all_endcaps
MonitorElement * h1_scl_E2x5max_barrel_
MonitorElement * h1_ele_dPhiEleCl_propOut_eg_endcaps
MonitorElement * h1_ele_PtoPttrue
MonitorElement * h1_ele_tkSumPt_dr03_barrel
MonitorElement * h2_scl_EoEtruePfVsEg
MonitorElement * h2_ele_dEtaClVsEta_propOut
MonitorElement * h1_simPhi
virtual double phi() const
momentum azimuthal angle
MonitorElement * h1_scl_EoEtrue_barrel_new_phigap
MonitorElement * h2_ele_PtinVsPtoutShowering_mean
MonitorElement * h1_scl_EoEtrue_endcaps_new_ringgap
MonitorElement * h1_scl_EoEtrue_endcaps_deegap
MonitorElement * h1_ele_seed_mask_bpix_
MonitorElement * h1_ele_dEtaEleCl_propOut_barrel
SuperClusterRef pflowSuperCluster() const
MonitorElement * h1_ele_PtoPttrue_barrel
MonitorElement * h1_ele_convRadius
std::vector< int > matchingMotherIDs_
MonitorElement * h1_ele_dEtaSc_propVtx_eg_barrel
MonitorElement * h1_eleNum
MonitorElement * h1_ele_tkSumPt_dr03
MonitorElement * h1_ele_dPhiCl_propOut_endcaps
virtual double py() const
y coordinate of momentum vector
Power< A, B >::type pow(const A &a, const B &b)
MonitorElement * h1_ele_EseedOP_eg_endcaps
MonitorElement * h1_ele_PoPtrue_golden_endcaps
MonitorElement * h2_ele_dEtaClVsPhi_propOut
MonitorElement * h2_ele_dPhiScVsPt_propVtx
edm::InputTag electronCollection_
MonitorElement * h2_ele_dEtaEleClVsPt_propOut
MonitorElement * h1_ele_mee_os_bb
MonitorElement * h1_scl_EoEtrueGolden_barrel
MonitorElement * h1_ele_simPhi_matched_qmisid
MonitorElement * h1_ele_mva
MonitorElement * h1_ele_dPhiCl_propOut_eg_endcaps
MonitorElement * h1_ele_HoE_endcaps
MonitorElement * h1_ele_tkSumPt_dr04_endcaps
MonitorElement * h2_ele_dPhiEleClVsPt_propOut
MonitorElement * h1_ele_dEtaSc_propVtx
bool ecalDrivenSeed() const
MonitorElement * h1_ele_dEtaEleCl_propOut_eg
MonitorElement * h1_ele_foundHits
MonitorElement * bookP1(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="")
MonitorElement * h1_ele_EseedOP_endcaps