CMS 3D CMS Logo

List of all members | Classes | Public Member Functions | Private Attributes
PhotonValidatorMiniAOD Class Reference

#include <PhotonValidatorMiniAOD.h>

Inheritance diagram for PhotonValidatorMiniAOD:
DQMEDAnalyzer edm::stream::EDProducer< edm::GlobalCache< DQMEDAnalyzerGlobalCache >, edm::EndRunProducer, edm::EndLuminosityBlockProducer, edm::Accumulator >

Classes

class  sortPhotons
 

Public Member Functions

void analyze (const edm::Event &, const edm::EventSetup &) override
 
void bookHistograms (DQMStore::IBooker &, edm::Run const &, edm::EventSetup const &) override
 
 PhotonValidatorMiniAOD (const edm::ParameterSet &)
 
 ~PhotonValidatorMiniAOD () override
 
- Public Member Functions inherited from DQMEDAnalyzer
void accumulate (edm::Event const &event, edm::EventSetup const &setup) final
 
void beginLuminosityBlock (edm::LuminosityBlock const &lumi, edm::EventSetup const &setup) final
 
void beginRun (edm::Run const &run, edm::EventSetup const &setup) final
 
void beginStream (edm::StreamID id) final
 
virtual void dqmBeginRun (edm::Run const &, edm::EventSetup const &)
 
 DQMEDAnalyzer ()
 
void endLuminosityBlock (edm::LuminosityBlock const &lumi, edm::EventSetup const &setup) final
 
void endRun (edm::Run const &run, edm::EventSetup const &setup) final
 
virtual bool getCanSaveByLumi ()
 
- Public Member Functions inherited from edm::stream::EDProducer< edm::GlobalCache< DQMEDAnalyzerGlobalCache >, edm::EndRunProducer, edm::EndLuminosityBlockProducer, edm::Accumulator >
 EDProducer ()=default
 
 EDProducer (const EDProducer &)=delete
 
bool hasAbilityToProduceInBeginLumis () const final
 
bool hasAbilityToProduceInBeginProcessBlocks () const final
 
bool hasAbilityToProduceInBeginRuns () const final
 
bool hasAbilityToProduceInEndLumis () const final
 
bool hasAbilityToProduceInEndProcessBlocks () const final
 
bool hasAbilityToProduceInEndRuns () const final
 
const EDProduceroperator= (const EDProducer &)=delete
 

Private Attributes

std::string fName_
 
edm::EDGetTokenT< reco::GenParticleCollectiongenpartToken_
 
MonitorElementh_chHadIso_ [3]
 
MonitorElementh_ecalRecHitSumEtConeDR04_ [3][3]
 
MonitorElementh_full5x5_r9_ [3][3]
 
MonitorElementh_full5x5_sigmaIetaIeta_ [3][3]
 
MonitorElementh_hcalTowerBcSumEtConeDR04_ [3][3]
 
MonitorElementh_hcalTowerSumEtConeDR04_ [3][3]
 
MonitorElementh_hOverE_ [3][3]
 
MonitorElementh_isoTrkSolidConeDR04_ [3][3]
 
MonitorElementh_newhOverE_ [3][3]
 
MonitorElementh_nHadIso_ [3]
 
MonitorElementh_nTrkSolidConeDR04_ [3][3]
 
MonitorElementh_phoE_ [2][3]
 
MonitorElementh_phoERes_ [3][3]
 
MonitorElementh_phoEt_ [2][3]
 
MonitorElementh_phoIso_ [3]
 
MonitorElementh_phoSigmaEoE_ [3][3]
 
MonitorElementh_r1_ [3][3]
 
MonitorElementh_r2_ [3][3]
 
MonitorElementh_r9_ [3][3]
 
MonitorElementh_scEta_ [2]
 
MonitorElementh_scPhi_ [2]
 
MonitorElementh_sigmaIetaIeta_ [3][3]
 
std::string outputFileName_
 
edm::ParameterSet parameters_
 
edm::EDGetTokenT< edm::View< pat::Photon > > photonToken_
 
int verbosity_
 

Additional Inherited Members

- Public Types inherited from DQMEDAnalyzer
typedef dqm::reco::DQMStore DQMStore
 
typedef dqm::reco::MonitorElement MonitorElement
 
- Public Types inherited from edm::stream::EDProducer< edm::GlobalCache< DQMEDAnalyzerGlobalCache >, edm::EndRunProducer, edm::EndLuminosityBlockProducer, edm::Accumulator >
using CacheTypes = CacheContexts< T... >
 
using GlobalCache = typename CacheTypes::GlobalCache
 
using HasAbility = AbilityChecker< T... >
 
using InputProcessBlockCache = typename CacheTypes::InputProcessBlockCache
 
using LuminosityBlockCache = typename CacheTypes::LuminosityBlockCache
 
using LuminosityBlockContext = LuminosityBlockContextT< LuminosityBlockCache, RunCache, GlobalCache >
 
using LuminosityBlockSummaryCache = typename CacheTypes::LuminosityBlockSummaryCache
 
using RunCache = typename CacheTypes::RunCache
 
using RunContext = RunContextT< RunCache, GlobalCache >
 
using RunSummaryCache = typename CacheTypes::RunSummaryCache
 
- Static Public Member Functions inherited from DQMEDAnalyzer
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< DQMEDAnalyzerGlobalCacheinitializeGlobalCache (edm::ParameterSet const &)
 
- Protected Member Functions inherited from DQMEDAnalyzer
uint64_t meId () const
 
- Protected Attributes inherited from DQMEDAnalyzer
edm::EDPutTokenT< DQMTokenlumiToken_
 
edm::EDPutTokenT< DQMTokenrunToken_
 
unsigned int streamId_
 

Detailed Description

$Id: PhotonValidatorMiniAOD

Author
Nancy Marinelli, U. of Notre Dame, US

Definition at line 45 of file PhotonValidatorMiniAOD.h.

Constructor & Destructor Documentation

◆ PhotonValidatorMiniAOD()

PhotonValidatorMiniAOD::PhotonValidatorMiniAOD ( const edm::ParameterSet iConfig)
explicit

Definition at line 32 of file PhotonValidatorMiniAOD.cc.

References parameters_.

33  : outputFileName_(iConfig.getParameter<std::string>("outputFileName")),
35  iConfig.getUntrackedParameter<edm::InputTag>("PhotonTag", edm::InputTag("slimmedPhotons")))),
36  genpartToken_(consumes<reco::GenParticleCollection>(
37  iConfig.getUntrackedParameter<edm::InputTag>("genpartTag", edm::InputTag("prunedGenParticles"))))
38 
39 {
40  parameters_ = iConfig;
41 }
edm::EDGetTokenT< reco::GenParticleCollection > genpartToken_
T getParameter(std::string const &) const
Definition: ParameterSet.h:307
T getUntrackedParameter(std::string const &, T const &) const
edm::EDGetTokenT< edm::View< pat::Photon > > photonToken_

◆ ~PhotonValidatorMiniAOD()

PhotonValidatorMiniAOD::~PhotonValidatorMiniAOD ( )
override

Definition at line 43 of file PhotonValidatorMiniAOD.cc.

43 {}

Member Function Documentation

◆ analyze()

void PhotonValidatorMiniAOD::analyze ( const edm::Event iEvent,
const edm::EventSetup  
)
overridevirtual

Reimplemented from DQMEDAnalyzer.

Definition at line 193 of file PhotonValidatorMiniAOD.cc.

References pat::Photon::chargedHadronIso(), HGC3DClusterGenMatchSelector_cfi::dR, run3scouting_cff::ecalIso, reco::Photon::ecalRecHitSumEtConeDR04(), reco::LeafCandidate::energy(), reco::LeafCandidate::eta(), dqm::impl::MonitorElement::Fill(), reco::Photon::full5x5_r9(), reco::Photon::full5x5_sigmaIetaIeta(), AJJGenJetFilter_cfi::genParticles, genpartToken_, reco::Photon::getCandidateP4type(), reco::Photon::getCorrectedEnergyError(), h_chHadIso_, h_ecalRecHitSumEtConeDR04_, h_full5x5_r9_, h_full5x5_sigmaIetaIeta_, h_hcalTowerBcSumEtConeDR04_, h_hcalTowerSumEtConeDR04_, h_hOverE_, h_isoTrkSolidConeDR04_, h_newhOverE_, h_nHadIso_, h_nTrkSolidConeDR04_, h_phoE_, h_phoERes_, h_phoEt_, h_phoIso_, h_phoSigmaEoE_, h_r1_, h_r2_, h_r9_, h_scEta_, h_scPhi_, h_sigmaIetaIeta_, reco::Photon::hadronicOverEm(), reco::Photon::hadTowOverEm(), run3scouting_cff::hcalIso, reco::Photon::hcalTowerSumEtBcConeDR04(), reco::Photon::hcalTowerSumEtConeDR04(), EgHLTOffHistBins_cfi::hOverE, iEvent, muonTagProbeFilters_cff::matched, pat::Photon::neutralHadronIso(), reco::Photon::nTrkSolidConeDR04(), reco::LeafCandidate::phi(), gedPhotonSequence_cff::photonIso, pat::Photon::photonIso(), BPHMonitor_cfi::photons, photonToken_, pi, conifer::pow(), diffTwoXMLs::r1, reco::Photon::r1x5(), diffTwoXMLs::r2, reco::Photon::r2x5(), reco::Photon::r9(), electrons_cff::r9, electrons_cff::sieie, reco::Photon::sigmaIetaIeta(), mathSSE::sqrt(), pat::Photon::superCluster(), and reco::Photon::trkSumPtSolidConeDR04().

193  {
194  // ********************************************************************************
195  using namespace edm;
196 
197  // access edm objects
198  Handle<View<pat::Photon> > photonsHandle;
199  iEvent.getByToken(photonToken_, photonsHandle);
200  const auto &photons = *photonsHandle;
201  //
203  iEvent.getByToken(genpartToken_, genParticles);
204 
205  for (reco::GenParticleCollection::const_iterator mcIter = genParticles->begin(); mcIter != genParticles->end();
206  mcIter++) {
207  if (!(mcIter->pdgId() == 22))
208  continue;
209  if (mcIter->mother() != nullptr && !(mcIter->mother()->pdgId() == 25))
210  continue;
211  if (fabs(mcIter->eta()) > 2.5)
212  continue;
213  // if ( mcIter->pt() < 5) continue;
214  // if ( fabs(mcIter->eta()) > 1.4442 && fabs(mcIter->eta()) < 1.566) continue;
215 
216  float mcPhi = mcIter->phi();
217  float mcEta = mcIter->eta();
218  //mcEta = etaTransformation(mcEta, (*mcPho).primaryVertex().z() );
219  float mcEnergy = mcIter->energy();
220 
221  double dR = 9999999.;
222  float minDr = 10000.;
223  int iMatch = -1;
224  bool matched = false;
225  for (size_t ipho = 0; ipho < photons.size(); ipho++) {
226  Ptr<pat::Photon> pho = photons.ptrAt(ipho);
227 
228  double dphi = pho->phi() - mcPhi;
229  if (std::fabs(dphi) > CLHEP::pi) {
230  dphi = dphi < 0 ? (CLHEP::twopi) + dphi : dphi - CLHEP::twopi;
231  }
232  double deta = pho->superCluster()->position().eta() - mcEta;
233 
234  dR = sqrt(pow((deta), 2) + pow(dphi, 2));
235  if (dR < 0.1 && dR < minDr) {
236  minDr = dR;
237  iMatch = ipho;
238  }
239  }
240 
241  if (iMatch > -1)
242  matched = true;
243  if (!matched)
244  continue;
245 
246  Ptr<pat::Photon> matchingPho = photons.ptrAt(iMatch);
247 
248  bool phoIsInBarrel = false;
249  bool phoIsInEndcap = false;
250 
251  float phoEta = matchingPho->superCluster()->position().eta();
252  if (fabs(phoEta) < 1.479) {
253  phoIsInBarrel = true;
254  } else {
255  phoIsInEndcap = true;
256  }
257 
258  float photonE = matchingPho->energy();
259  float sigmaEoE = matchingPho->getCorrectedEnergyError(matchingPho->getCandidateP4type()) / matchingPho->energy();
260  float photonEt = matchingPho->energy() / cosh(matchingPho->eta());
261  // float photonERegr1 = matchingPho->getCorrectedEnergy(reco::Photon::regression1);
262  //float photonERegr2 = matchingPho->getCorrectedEnergy(reco::Photon::regression2);
263  float r9 = matchingPho->r9();
264  float full5x5_r9 = matchingPho->full5x5_r9();
265  float r1 = matchingPho->r1x5();
266  float r2 = matchingPho->r2x5();
267  float sieie = matchingPho->sigmaIetaIeta();
268  float full5x5_sieie = matchingPho->full5x5_sigmaIetaIeta();
269  float hOverE = matchingPho->hadronicOverEm();
270  float newhOverE = matchingPho->hadTowOverEm();
271  float ecalIso = matchingPho->ecalRecHitSumEtConeDR04();
272  float hcalIso = matchingPho->hcalTowerSumEtConeDR04();
273  float newhcalIso = matchingPho->hcalTowerSumEtBcConeDR04();
274  float trkIso = matchingPho->trkSumPtSolidConeDR04();
275  float nIsoTrk = matchingPho->nTrkSolidConeDR04();
276  // PF related quantities
277  float chargedHadIso = matchingPho->chargedHadronIso();
278  float neutralHadIso = matchingPho->neutralHadronIso();
279  float photonIso = matchingPho->photonIso();
280  // float etOutsideMustache = matchingPho->etOutsideMustache();
281  // int nClusterOutsideMustache = matchingPho->nClusterOutsideMustache();
282  //float pfMVA = matchingPho->pfMVA();
283 
284  h_scEta_[0]->Fill(matchingPho->superCluster()->eta());
285  h_scPhi_[0]->Fill(matchingPho->superCluster()->phi());
286 
287  h_phoE_[0][0]->Fill(photonE);
288  h_phoEt_[0][0]->Fill(photonEt);
289 
290  h_phoERes_[0][0]->Fill(photonE / mcEnergy);
291  h_phoSigmaEoE_[0][0]->Fill(sigmaEoE);
292 
293  h_r9_[0][0]->Fill(r9);
294  h_full5x5_r9_[0][0]->Fill(full5x5_r9);
295  h_r1_[0][0]->Fill(r1);
296  h_r2_[0][0]->Fill(r2);
297 
298  h_sigmaIetaIeta_[0][0]->Fill(sieie);
299  h_full5x5_sigmaIetaIeta_[0][0]->Fill(full5x5_sieie);
300  h_hOverE_[0][0]->Fill(hOverE);
301  h_newhOverE_[0][0]->Fill(newhOverE);
302 
305  h_hcalTowerBcSumEtConeDR04_[0][0]->Fill(newhcalIso);
306  h_isoTrkSolidConeDR04_[0][0]->Fill(trkIso);
307  h_nTrkSolidConeDR04_[0][0]->Fill(nIsoTrk);
308 
309  //
310  h_chHadIso_[0]->Fill(chargedHadIso);
311  h_nHadIso_[0]->Fill(neutralHadIso);
312  h_phoIso_[0]->Fill(photonIso);
313 
314  //
315  if (phoIsInBarrel) {
316  h_phoE_[0][1]->Fill(photonE);
317  h_phoEt_[0][1]->Fill(photonEt);
318  h_phoERes_[0][1]->Fill(photonE / mcEnergy);
319  h_phoSigmaEoE_[0][1]->Fill(sigmaEoE);
320 
321  h_r9_[0][1]->Fill(r9);
322  h_full5x5_r9_[0][1]->Fill(full5x5_r9);
323  h_r1_[0][1]->Fill(r1);
324  h_r2_[0][1]->Fill(r2);
325  h_sigmaIetaIeta_[0][1]->Fill(sieie);
326  h_full5x5_sigmaIetaIeta_[0][1]->Fill(full5x5_sieie);
327  h_hOverE_[0][1]->Fill(hOverE);
328  h_newhOverE_[0][1]->Fill(newhOverE);
331  h_hcalTowerBcSumEtConeDR04_[0][1]->Fill(newhcalIso);
332  h_isoTrkSolidConeDR04_[0][1]->Fill(trkIso);
333  h_nTrkSolidConeDR04_[0][1]->Fill(nIsoTrk);
334  h_chHadIso_[1]->Fill(chargedHadIso);
335  h_nHadIso_[1]->Fill(neutralHadIso);
336  h_phoIso_[1]->Fill(photonIso);
337  }
338  if (phoIsInEndcap) {
339  h_phoE_[0][2]->Fill(photonE);
340  h_phoEt_[0][2]->Fill(photonEt);
341 
342  h_phoERes_[0][2]->Fill(photonE / mcEnergy);
343  h_phoSigmaEoE_[0][2]->Fill(sigmaEoE);
344  h_r9_[0][2]->Fill(r9);
345  h_full5x5_r9_[0][2]->Fill(full5x5_r9);
346  h_r1_[0][2]->Fill(r1);
347  h_r2_[0][2]->Fill(r2);
348  h_sigmaIetaIeta_[0][2]->Fill(sieie);
349  h_full5x5_sigmaIetaIeta_[0][2]->Fill(full5x5_sieie);
350  h_hOverE_[0][2]->Fill(hOverE);
351  h_newhOverE_[0][2]->Fill(newhOverE);
354  h_hcalTowerBcSumEtConeDR04_[0][2]->Fill(newhcalIso);
355  h_isoTrkSolidConeDR04_[0][2]->Fill(trkIso);
356  h_nTrkSolidConeDR04_[0][2]->Fill(nIsoTrk);
357  h_chHadIso_[2]->Fill(chargedHadIso);
358  h_nHadIso_[2]->Fill(neutralHadIso);
359  h_phoIso_[2]->Fill(photonIso);
360  }
361 
362  } // end loop over gen photons
363 }
edm::EDGetTokenT< reco::GenParticleCollection > genpartToken_
float neutralHadronIso() const
Definition: Photon.h:130
float photonIso() const
Definition: Photon.h:133
float ecalRecHitSumEtConeDR04() const
Definition: Photon.h:457
MonitorElement * h_full5x5_sigmaIetaIeta_[3][3]
MonitorElement * h_r1_[3][3]
MonitorElement * h_full5x5_r9_[3][3]
constexpr int pow(int x)
Definition: conifer.h:24
float r1x5() const
Definition: Photon.h:274
MonitorElement * h_phoSigmaEoE_[3][3]
float chargedHadronIso() const
Definition: Photon.h:127
MonitorElement * h_nHadIso_[3]
MonitorElement * h_ecalRecHitSumEtConeDR04_[3][3]
const Double_t pi
void Fill(long long x)
P4type getCandidateP4type() const
Definition: Photon.h:360
MonitorElement * h_sigmaIetaIeta_[3][3]
float trkSumPtSolidConeDR04() const
Definition: Photon.h:495
int iEvent
Definition: GenABIO.cc:224
MonitorElement * h_chHadIso_[3]
MonitorElement * h_hcalTowerBcSumEtConeDR04_[3][3]
float hcalTowerSumEtConeDR04(int depth=0) const
Definition: Photon.h:475
MonitorElement * h_newhOverE_[3][3]
float sigmaIetaIeta() const
Definition: Photon.h:273
MonitorElement * h_isoTrkSolidConeDR04_[3][3]
T sqrt(T t)
Definition: SSEVec.h:19
MonitorElement * h_phoIso_[3]
float full5x5_sigmaIetaIeta() const
Definition: Photon.h:285
float getCorrectedEnergyError(P4type type) const
MonitorElement * h_nTrkSolidConeDR04_[3][3]
float hcalTowerSumEtBcConeDR04(int depth=0) const
Definition: Photon.h:493
float hadTowOverEm(int depth=0) const
Definition: Photon.h:256
MonitorElement * h_hOverE_[3][3]
MonitorElement * h_scPhi_[2]
MonitorElement * h_phoERes_[3][3]
MonitorElement * h_phoE_[2][3]
MonitorElement * h_r9_[3][3]
int nTrkSolidConeDR04() const
Definition: Photon.h:499
float r2x5() const
Definition: Photon.h:275
float hadronicOverEm(int depth=0) const
Definition: Photon.h:236
reco::SuperClusterRef superCluster() const override
override the superCluster method from CaloJet, to access the internal storage of the supercluster ...
float r9() const
Definition: Photon.h:276
edm::EDGetTokenT< edm::View< pat::Photon > > photonToken_
MonitorElement * h_phoEt_[2][3]
HLT enums.
MonitorElement * h_hcalTowerSumEtConeDR04_[3][3]
MonitorElement * h_r2_[3][3]
double phi() const final
momentum azimuthal angle
MonitorElement * h_scEta_[2]
float full5x5_r9() const
Definition: Photon.h:288
double energy() const final
energy
double eta() const final
momentum pseudorapidity

◆ bookHistograms()

void PhotonValidatorMiniAOD::bookHistograms ( DQMStore::IBooker iBooker,
edm::Run const &  run,
edm::EventSetup const &   
)
overridevirtual

Implements DQMEDAnalyzer.

Definition at line 45 of file PhotonValidatorMiniAOD.cc.

References dqm::implementation::IBooker::book1D(), photonAnalyzer_cfi::eBin, cosmicPhotonAnalyzer_cfi::eMax, photonAnalyzer_cfi::eMin, muonRecoAnalyzer_cfi::etaBin, ALCARECOTkAlBeamHalo_cff::etaMax, ALCARECOTkAlBeamHalo_cff::etaMin, photonAnalyzer_cfi::etBin, cosmicPhotonAnalyzer_cfi::etMax, photonAnalyzer_cfi::etMin, edm::ParameterSet::getParameter(), h_chHadIso_, h_ecalRecHitSumEtConeDR04_, h_full5x5_r9_, h_full5x5_sigmaIetaIeta_, h_hcalTowerBcSumEtConeDR04_, h_hcalTowerSumEtConeDR04_, h_hOverE_, h_isoTrkSolidConeDR04_, h_newhOverE_, h_nHadIso_, h_nTrkSolidConeDR04_, h_phoE_, h_phoERes_, h_phoEt_, h_phoIso_, h_phoSigmaEoE_, h_r1_, h_r2_, h_r9_, h_scEta_, h_scPhi_, h_sigmaIetaIeta_, parameters_, BeamMonitor_cff::phiBin, AlignmentTrackSelector_cfi::phiMax, AlignmentTrackSelector_cfi::phiMin, photonAnalyzer_cfi::r9Bin, cosmicPhotonAnalyzer_cfi::r9Max, photonAnalyzer_cfi::r9Min, photonValidator_cfi::resBin, photonValidator_cfi::resMax, photonValidator_cfi::resMin, dqm::implementation::NavigatorBase::setCurrentFolder(), and AlCaHLTBitMon_QueryRunRegistry::string.

45  {
46  double eMin = parameters_.getParameter<double>("eMin");
47  double eMax = parameters_.getParameter<double>("eMax");
48  int eBin = parameters_.getParameter<int>("eBin");
49 
50  double etMin = parameters_.getParameter<double>("etMin");
51  double etMax = parameters_.getParameter<double>("etMax");
52  int etBin = parameters_.getParameter<int>("etBin");
53 
54  double resMin = parameters_.getParameter<double>("resMin");
55  double resMax = parameters_.getParameter<double>("resMax");
56  int resBin = parameters_.getParameter<int>("resBin");
57 
58  double etaMin = parameters_.getParameter<double>("etaMin");
59  double etaMax = parameters_.getParameter<double>("etaMax");
60  int etaBin = parameters_.getParameter<int>("etaBin");
61 
62  double phiMin = parameters_.getParameter<double>("phiMin");
63  double phiMax = parameters_.getParameter<double>("phiMax");
64  int phiBin = parameters_.getParameter<int>("phiBin");
65 
66  double r9Min = parameters_.getParameter<double>("r9Min");
67  double r9Max = parameters_.getParameter<double>("r9Max");
68  int r9Bin = parameters_.getParameter<int>("r9Bin");
69 
70  iBooker.setCurrentFolder("EgammaV/PhotonValidatorMiniAOD/Photons");
71 
72  h_scEta_[0] = iBooker.book1D("scEta_miniAOD", " SC Eta ", etaBin, etaMin, etaMax);
73  h_scPhi_[0] = iBooker.book1D("scPhi_miniAOD", " SC Phi ", phiBin, phiMin, phiMax);
74 
75  std::string histname = " ";
76 
77  histname = "phoE";
78  h_phoE_[0][0] = iBooker.book1D(histname + "All_miniAOD", " Photon Energy: All ecal ", eBin, eMin, eMax);
79  h_phoE_[0][1] = iBooker.book1D(histname + "Barrel_miniAOD", " Photon Energy: barrel ", eBin, eMin, eMax);
80  h_phoE_[0][2] = iBooker.book1D(histname + "Endcap_miniAOD", " Photon Energy: Endcap ", eBin, eMin, eMax);
81 
82  histname = "phoEt";
83  h_phoEt_[0][0] =
84  iBooker.book1D(histname + "All_miniAOD", " Photon Transverse Energy: All ecal ", etBin, etMin, etMax);
85  h_phoEt_[0][1] =
86  iBooker.book1D(histname + "Barrel_miniAOD", " Photon Transverse Energy: Barrel ", etBin, etMin, etMax);
87  h_phoEt_[0][2] =
88  iBooker.book1D(histname + "Endcap_miniAOD", " Photon Transverse Energy: Endcap ", etBin, etMin, etMax);
89 
90  histname = "eRes";
91  h_phoERes_[0][0] = iBooker.book1D(
92  histname + "All_miniAOD", " Photon E/E_{true}: All ecal; E/E_{true} (GeV)", resBin, resMin, resMax);
93  h_phoERes_[0][1] = iBooker.book1D(
94  histname + "Barrel_miniAOD", "Photon E/E_{true}: Barrel; E/E_{true} (GeV)", resBin, resMin, resMax);
95  h_phoERes_[0][2] = iBooker.book1D(
96  histname + "Endcap_miniAOD", " Photon E/E_{true}: Endcap; E/E_{true} (GeV)", resBin, resMin, resMax);
97 
98  histname = "sigmaEoE";
99  h_phoSigmaEoE_[0][0] =
100  iBooker.book1D(histname + "All_miniAOD", "#sigma_{E}/E: All ecal; #sigma_{E}/E", 100, 0., 0.08);
101  h_phoSigmaEoE_[0][1] =
102  iBooker.book1D(histname + "Barrel_miniAOD", "#sigma_{E}/E: Barrel; #sigma_{E}/E", 100, 0., 0.08);
103  h_phoSigmaEoE_[0][2] =
104  iBooker.book1D(histname + "Endcap_miniAOD", "#sigma_{E}/E: Endcap, #sigma_{E}/E", 100, 0., 0.08);
105 
106  histname = "r9";
107  h_r9_[0][0] = iBooker.book1D(histname + "All_miniAOD", " r9: All Ecal", r9Bin, r9Min, r9Max);
108  h_r9_[0][1] = iBooker.book1D(histname + "Barrel_miniAOD", " r9: Barrel ", r9Bin, r9Min, r9Max);
109  h_r9_[0][2] = iBooker.book1D(histname + "Endcap_miniAOD", " r9: Endcap ", r9Bin, r9Min, r9Max);
110  histname = "full5x5_r9";
111  h_full5x5_r9_[0][0] = iBooker.book1D(histname + "All_miniAOD", " r9: All Ecal", r9Bin, r9Min, r9Max);
112  h_full5x5_r9_[0][1] = iBooker.book1D(histname + "Barrel_miniAOD", " r9: Barrel ", r9Bin, r9Min, r9Max);
113  h_full5x5_r9_[0][2] = iBooker.book1D(histname + "Endcap_miniAOD", " r9: Endcap ", r9Bin, r9Min, r9Max);
114  histname = "r1";
115  h_r1_[0][0] = iBooker.book1D(histname + "All_miniAOD", " e1x5/e5x5: All Ecal", r9Bin, r9Min, r9Max);
116  h_r1_[0][1] = iBooker.book1D(histname + "Barrel_miniAOD", " e1x5/e5x5: Barrel ", r9Bin, r9Min, r9Max);
117  h_r1_[0][2] = iBooker.book1D(histname + "Endcap_miniAOD", " e1x5/e5x5: Endcap ", r9Bin, r9Min, r9Max);
118  histname = "r2";
119  h_r2_[0][0] = iBooker.book1D(histname + "All_miniAOD", " e2x5/e5x5: All Ecal", r9Bin, r9Min, r9Max);
120  h_r2_[0][1] = iBooker.book1D(histname + "Barrel_miniAOD", " e2x5/e5x5: Barrel ", r9Bin, r9Min, r9Max);
121  h_r2_[0][2] = iBooker.book1D(histname + "Endcap_miniAOD", " e2x5/e5x5: Endcap ", r9Bin, r9Min, r9Max);
122  histname = "hOverE";
123  h_hOverE_[0][0] = iBooker.book1D(histname + "All_miniAOD", "H/E: All Ecal", 100, 0., 0.2);
124  h_hOverE_[0][1] = iBooker.book1D(histname + "Barrel_miniAOD", "H/E: Barrel ", 100, 0., 0.2);
125  h_hOverE_[0][2] = iBooker.book1D(histname + "Endcap_miniAOD", "H/E: Endcap ", 100, 0., 0.2);
126  //
127  histname = "newhOverE";
128  h_newhOverE_[0][0] = iBooker.book1D(histname + "All_miniAOD", "new H/E: All Ecal", 100, 0., 0.2);
129  h_newhOverE_[0][1] = iBooker.book1D(histname + "Barrel_miniAOD", "new H/E: Barrel ", 100, 0., 0.2);
130  h_newhOverE_[0][2] = iBooker.book1D(histname + "Endcap_miniAOD", "new H/E: Endcap ", 100, 0., 0.2);
131  //
132  histname = "sigmaIetaIeta";
133  h_sigmaIetaIeta_[0][0] = iBooker.book1D(histname + "All_miniAOD", "sigmaIetaIeta: All Ecal", 100, 0., 0.1);
134  h_sigmaIetaIeta_[0][1] = iBooker.book1D(histname + "Barrel_miniAOD", "sigmaIetaIeta: Barrel ", 100, 0., 0.05);
135  h_sigmaIetaIeta_[0][2] = iBooker.book1D(histname + "Endcap_miniAOD", "sigmaIetaIeta: Endcap ", 100, 0., 0.1);
136  histname = "full5x5_sigmaIetaIeta";
138  iBooker.book1D(histname + "All_miniAOD", "Full5x5 sigmaIetaIeta: All Ecal", 100, 0., 0.1);
140  iBooker.book1D(histname + "Barrel_miniAOD", "Full5x5 sigmaIetaIeta: Barrel ", 100, 0., 0.05);
142  iBooker.book1D(histname + "Endcap_miniAOD", "Full5x5 sigmaIetaIeta: Endcap ", 100, 0., 0.1);
143  //
144  histname = "ecalRecHitSumEtConeDR04";
146  iBooker.book1D(histname + "All_miniAOD", "ecalRecHitSumEtDR04: All Ecal", etBin, etMin, 20.);
148  iBooker.book1D(histname + "Barrel_miniAOD", "ecalRecHitSumEtDR04: Barrel ", etBin, etMin, 20.);
150  iBooker.book1D(histname + "Endcap_miniAOD", "ecalRecHitSumEtDR04: Endcap ", etBin, etMin, 20.);
151  histname = "hcalTowerSumEtConeDR04";
153  iBooker.book1D(histname + "All_miniAOD", "hcalTowerSumEtConeDR04: All Ecal", etBin, etMin, 20.);
155  iBooker.book1D(histname + "Barrel_miniAOD", "hcalTowerSumEtConeDR04: Barrel ", etBin, etMin, 20.);
157  iBooker.book1D(histname + "Endcap_miniAOD", "hcalTowerSumEtConeDR04: Endcap ", etBin, etMin, 20.);
158  //
159  histname = "hcalTowerBcSumEtConeDR04";
161  iBooker.book1D(histname + "All_miniAOD", "hcalTowerBcSumEtConeDR04: All Ecal", etBin, etMin, 20.);
163  iBooker.book1D(histname + "Barrel_miniAOD", "hcalTowerBcSumEtConeDR04: Barrel ", etBin, etMin, 20.);
165  iBooker.book1D(histname + "Endcap_miniAOD", "hcalTowerBcSumEtConeDR04: Endcap ", etBin, etMin, 20.);
166  histname = "isoTrkSolidConeDR04";
167  h_isoTrkSolidConeDR04_[0][0] =
168  iBooker.book1D(histname + "All_miniAOD", "isoTrkSolidConeDR04: All Ecal", etBin, etMin, etMax * 0.1);
169  h_isoTrkSolidConeDR04_[0][1] =
170  iBooker.book1D(histname + "Barrel_miniAOD", "isoTrkSolidConeDR04: Barrel ", etBin, etMin, etMax * 0.1);
171  h_isoTrkSolidConeDR04_[0][2] =
172  iBooker.book1D(histname + "Endcap_miniAOD", "isoTrkSolidConeDR04: Endcap ", etBin, etMin, etMax * 0.1);
173  histname = "nTrkSolidConeDR04";
174  h_nTrkSolidConeDR04_[0][0] = iBooker.book1D(histname + "All_miniAOD", "nTrkSolidConeDR04: All Ecal", 20, 0., 20);
175  h_nTrkSolidConeDR04_[0][1] = iBooker.book1D(histname + "Barrel_miniAOD", "nTrkSolidConeDR04: Barrel ", 20, 0., 20);
176  h_nTrkSolidConeDR04_[0][2] = iBooker.book1D(histname + "Endcap_miniAOD", "nTrkSolidConeDR04: Endcap ", 20, 0., 20);
177 
178  // Infos from Particle Flow - isolation and ID
179  histname = "chargedHadIso";
180  h_chHadIso_[0] = iBooker.book1D(histname + "All_miniAOD", "PF chargedHadIso: All Ecal", etBin, etMin, 20.);
181  h_chHadIso_[1] = iBooker.book1D(histname + "Barrel_miniAOD", "PF chargedHadIso: Barrel", etBin, etMin, 20.);
182  h_chHadIso_[2] = iBooker.book1D(histname + "Endcap_miniAOD", "PF chargedHadIso: Endcap", etBin, etMin, 20.);
183  histname = "neutralHadIso";
184  h_nHadIso_[0] = iBooker.book1D(histname + "All_miniAOD", "PF neutralHadIso: All Ecal", etBin, etMin, 20.);
185  h_nHadIso_[1] = iBooker.book1D(histname + "Barrel_miniAOD", "PF neutralHadIso: Barrel", etBin, etMin, 20.);
186  h_nHadIso_[2] = iBooker.book1D(histname + "Endcap_miniAOD", "PF neutralHadIso: Endcap", etBin, etMin, 20.);
187  histname = "photonIso";
188  h_phoIso_[0] = iBooker.book1D(histname + "All_miniAOD", "PF photonIso: All Ecal", etBin, etMin, 20.);
189  h_phoIso_[1] = iBooker.book1D(histname + "Barrel_miniAOD", "PF photonIso: Barrel", etBin, etMin, 20.);
190  h_phoIso_[2] = iBooker.book1D(histname + "Endcap_miniAOD", "PF photonIso: Endcap", etBin, etMin, 20.);
191 }
T getParameter(std::string const &) const
Definition: ParameterSet.h:307
virtual void setCurrentFolder(std::string const &fullpath)
Definition: DQMStore.cc:36
MonitorElement * h_full5x5_sigmaIetaIeta_[3][3]
MonitorElement * h_r1_[3][3]
MonitorElement * h_full5x5_r9_[3][3]
MonitorElement * h_phoSigmaEoE_[3][3]
MonitorElement * h_nHadIso_[3]
MonitorElement * h_ecalRecHitSumEtConeDR04_[3][3]
eBin
CAREFULL for the time being only Loos exists 1 => Tight Photon = GoodCandidate.
MonitorElement * h_sigmaIetaIeta_[3][3]
MonitorElement * h_chHadIso_[3]
MonitorElement * h_hcalTowerBcSumEtConeDR04_[3][3]
MonitorElement * h_newhOverE_[3][3]
MonitorElement * h_isoTrkSolidConeDR04_[3][3]
MonitorElement * h_phoIso_[3]
MonitorElement * h_nTrkSolidConeDR04_[3][3]
MonitorElement * h_hOverE_[3][3]
MonitorElement * h_scPhi_[2]
MonitorElement * h_phoERes_[3][3]
MonitorElement * h_phoE_[2][3]
MonitorElement * h_r9_[3][3]
MonitorElement * h_phoEt_[2][3]
MonitorElement * h_hcalTowerSumEtConeDR04_[3][3]
MonitorElement * h_r2_[3][3]
MonitorElement * book1D(TString const &name, TString const &title, int const nchX, double const lowX, double const highX, FUNC onbooking=NOOP())
Definition: DQMStore.h:98
MonitorElement * h_scEta_[2]

Member Data Documentation

◆ fName_

std::string PhotonValidatorMiniAOD::fName_
private

Definition at line 60 of file PhotonValidatorMiniAOD.h.

◆ genpartToken_

edm::EDGetTokenT<reco::GenParticleCollection> PhotonValidatorMiniAOD::genpartToken_
private

Definition at line 58 of file PhotonValidatorMiniAOD.h.

Referenced by analyze().

◆ h_chHadIso_

MonitorElement* PhotonValidatorMiniAOD::h_chHadIso_[3]
private

Definition at line 90 of file PhotonValidatorMiniAOD.h.

Referenced by analyze(), and bookHistograms().

◆ h_ecalRecHitSumEtConeDR04_

MonitorElement* PhotonValidatorMiniAOD::h_ecalRecHitSumEtConeDR04_[3][3]
private

Definition at line 77 of file PhotonValidatorMiniAOD.h.

Referenced by analyze(), and bookHistograms().

◆ h_full5x5_r9_

MonitorElement* PhotonValidatorMiniAOD::h_full5x5_r9_[3][3]
private

Definition at line 70 of file PhotonValidatorMiniAOD.h.

Referenced by analyze(), and bookHistograms().

◆ h_full5x5_sigmaIetaIeta_

MonitorElement* PhotonValidatorMiniAOD::h_full5x5_sigmaIetaIeta_[3][3]
private

Definition at line 72 of file PhotonValidatorMiniAOD.h.

Referenced by analyze(), and bookHistograms().

◆ h_hcalTowerBcSumEtConeDR04_

MonitorElement* PhotonValidatorMiniAOD::h_hcalTowerBcSumEtConeDR04_[3][3]
private

Definition at line 79 of file PhotonValidatorMiniAOD.h.

Referenced by analyze(), and bookHistograms().

◆ h_hcalTowerSumEtConeDR04_

MonitorElement* PhotonValidatorMiniAOD::h_hcalTowerSumEtConeDR04_[3][3]
private

Definition at line 78 of file PhotonValidatorMiniAOD.h.

Referenced by analyze(), and bookHistograms().

◆ h_hOverE_

MonitorElement* PhotonValidatorMiniAOD::h_hOverE_[3][3]
private

Definition at line 75 of file PhotonValidatorMiniAOD.h.

Referenced by analyze(), and bookHistograms().

◆ h_isoTrkSolidConeDR04_

MonitorElement* PhotonValidatorMiniAOD::h_isoTrkSolidConeDR04_[3][3]
private

Definition at line 80 of file PhotonValidatorMiniAOD.h.

Referenced by analyze(), and bookHistograms().

◆ h_newhOverE_

MonitorElement* PhotonValidatorMiniAOD::h_newhOverE_[3][3]
private

Definition at line 76 of file PhotonValidatorMiniAOD.h.

Referenced by analyze(), and bookHistograms().

◆ h_nHadIso_

MonitorElement* PhotonValidatorMiniAOD::h_nHadIso_[3]
private

Definition at line 91 of file PhotonValidatorMiniAOD.h.

Referenced by analyze(), and bookHistograms().

◆ h_nTrkSolidConeDR04_

MonitorElement* PhotonValidatorMiniAOD::h_nTrkSolidConeDR04_[3][3]
private

Definition at line 81 of file PhotonValidatorMiniAOD.h.

Referenced by analyze(), and bookHistograms().

◆ h_phoE_

MonitorElement* PhotonValidatorMiniAOD::h_phoE_[2][3]
private

Definition at line 83 of file PhotonValidatorMiniAOD.h.

Referenced by analyze(), and bookHistograms().

◆ h_phoERes_

MonitorElement* PhotonValidatorMiniAOD::h_phoERes_[3][3]
private

Definition at line 85 of file PhotonValidatorMiniAOD.h.

Referenced by analyze(), and bookHistograms().

◆ h_phoEt_

MonitorElement* PhotonValidatorMiniAOD::h_phoEt_[2][3]
private

Definition at line 84 of file PhotonValidatorMiniAOD.h.

Referenced by analyze(), and bookHistograms().

◆ h_phoIso_

MonitorElement* PhotonValidatorMiniAOD::h_phoIso_[3]
private

Definition at line 92 of file PhotonValidatorMiniAOD.h.

Referenced by analyze(), and bookHistograms().

◆ h_phoSigmaEoE_

MonitorElement* PhotonValidatorMiniAOD::h_phoSigmaEoE_[3][3]
private

Definition at line 86 of file PhotonValidatorMiniAOD.h.

Referenced by analyze(), and bookHistograms().

◆ h_r1_

MonitorElement* PhotonValidatorMiniAOD::h_r1_[3][3]
private

Definition at line 73 of file PhotonValidatorMiniAOD.h.

Referenced by analyze(), and bookHistograms().

◆ h_r2_

MonitorElement* PhotonValidatorMiniAOD::h_r2_[3][3]
private

Definition at line 74 of file PhotonValidatorMiniAOD.h.

Referenced by analyze(), and bookHistograms().

◆ h_r9_

MonitorElement* PhotonValidatorMiniAOD::h_r9_[3][3]
private

Definition at line 69 of file PhotonValidatorMiniAOD.h.

Referenced by analyze(), and bookHistograms().

◆ h_scEta_

MonitorElement* PhotonValidatorMiniAOD::h_scEta_[2]
private

Definition at line 66 of file PhotonValidatorMiniAOD.h.

Referenced by analyze(), and bookHistograms().

◆ h_scPhi_

MonitorElement* PhotonValidatorMiniAOD::h_scPhi_[2]
private

Definition at line 67 of file PhotonValidatorMiniAOD.h.

Referenced by analyze(), and bookHistograms().

◆ h_sigmaIetaIeta_

MonitorElement* PhotonValidatorMiniAOD::h_sigmaIetaIeta_[3][3]
private

Definition at line 71 of file PhotonValidatorMiniAOD.h.

Referenced by analyze(), and bookHistograms().

◆ outputFileName_

std::string PhotonValidatorMiniAOD::outputFileName_
private

Definition at line 56 of file PhotonValidatorMiniAOD.h.

◆ parameters_

edm::ParameterSet PhotonValidatorMiniAOD::parameters_
private

◆ photonToken_

edm::EDGetTokenT<edm::View<pat::Photon> > PhotonValidatorMiniAOD::photonToken_
private

Definition at line 57 of file PhotonValidatorMiniAOD.h.

Referenced by analyze().

◆ verbosity_

int PhotonValidatorMiniAOD::verbosity_
private

Definition at line 64 of file PhotonValidatorMiniAOD.h.