CMS 3D CMS Logo

 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Properties Friends Macros Groups Pages
EnergyScaleAnalyzer.cc
Go to the documentation of this file.
1 // -*- C++ -*-
2 //
3 // Package: EnergyScaleAnalyzer
4 // Class: EnergyScaleAnalyzer
5 //
14 // Original Author: Keti Kaadze
15 // Created: Thu Jun 21 08:59:42 CDT 2007
16 //
17 
19 
20 // Framework
31 
32 // Geometry
39 
40 #include "TFile.h"
41 // Reconstruction classes
50 
54 
61 
62 #include "TString.h"
64 #include <fstream>
65 #include <iomanip>
66 #include <ios>
67 #include <iostream>
68 #include <map>
69 
70 //========================================================================
72 //========================================================================
73 {
74  hepMCLabel_ = consumes<edm::HepMCProduct>(ps.getParameter<std::string>("hepMCLabel"));
75  hybridSuperClusters_token = consumes<reco::SuperClusterCollection>(
76  ps.getUntrackedParameter<edm::InputTag>("hybridSuperClusters", edm::InputTag("hybridSuperClusters")));
77  dynamicHybridSuperClusters_token = consumes<reco::SuperClusterCollection>(ps.getUntrackedParameter<edm::InputTag>(
78  "dynamicHybridSuperClusters", edm::InputTag("dynamicHybridSuperClusters")));
79  correctedHybridSuperClusters_token = consumes<reco::SuperClusterCollection>(ps.getUntrackedParameter<edm::InputTag>(
80  "correctedHybridSuperClusters", edm::InputTag("correctedHybridSuperClusters")));
82  consumes<reco::SuperClusterCollection>(ps.getUntrackedParameter<edm::InputTag>(
83  "correctedDynamicHybridSuperClusters", edm::InputTag("correctedDynamicHybridSuperClusters")));
84  correctedFixedMatrixSuperClustersWithPreshower_token = consumes<reco::SuperClusterCollection>(
85  ps.getUntrackedParameter<edm::InputTag>("correctedFixedMatrixSuperClustersWithPreshower",
86  edm::InputTag("correctedFixedMatrixSuperClustersWithPreshower")));
88  consumes<reco::SuperClusterCollection>(ps.getUntrackedParameter<edm::InputTag>(
89  "fixedMatrixSuperClustersWithPreshower", edm::InputTag("fixedMatrixSuperClustersWithPreshower")));
90 
91  outputFile_ = ps.getParameter<std::string>("outputFile");
92  rootFile_ = TFile::Open(outputFile_.c_str(),
93  "RECREATE"); // open output file to store histograms
94 
95  evtN = 0;
96 }
97 
98 //========================================================================
100 //========================================================================
101 {
102  delete rootFile_;
103 }
104 
105 //========================================================================
107  //========================================================================
108 
109  mytree_ = new TTree("energyScale", "");
110  TString treeVariables =
111  "mc_npar/I:parID:mc_sep/"
112  "F:mc_e:mc_et:mc_phi:mc_eta:mc_theta:"; // MC information
113  treeVariables += "em_dR/F:"; // MC <-> EM matching information
114  treeVariables +=
115  "em_isInCrack/I:em_scType:em_e/F:em_et:em_phi:em_eta:em_theta:em_nCell/"
116  "I:em_nBC:"; // EM SC info
117  treeVariables += "em_pet/F:em_pe:em_peta:em_ptheta:"; // EM SC physics (eta corrected
118  // information)
119 
120  treeVariables += "emCorr_e/F:emCorr_et:emCorr_eta:emCorr_phi:emCorr_theta:"; // CMSSW
121  // standard
122  // corrections
123  treeVariables += "emCorr_pet/F:emCorr_peta:emCorr_ptheta:"; // CMSSW standard physics
124 
125  treeVariables += "em_pw/F:em_ew:em_br"; // EM widths pw -- phiWidth, ew --
126  // etaWidth, ratios of pw/ew
127 
128  mytree_->Branch("energyScale", &(tree_.mc_npar), treeVariables);
129 }
130 
131 //========================================================================
133  using namespace edm; // needed for all fwk related classes
134  using namespace std;
135 
136  // std::cout << "Proceccing event # " << ++evtN << std::endl;
137 
138  // Get containers for MC truth, SC etc.
139  // ===================================================
140  // =======================================================================================
141  // =======================================================================================
142  Handle<HepMCProduct> hepMC;
143  evt.getByToken(hepMCLabel_, hepMC);
144 
145  Labels l;
147 
148  const HepMC::GenEvent *genEvent = hepMC->GetEvent();
149  if (!(hepMC.isValid())) {
150  LogInfo("EnergyScaleAnalyzer") << "Could not get MC Product!";
151  return;
152  }
153 
154  //=======================For Vertex correction
155  std::vector<Handle<HepMCProduct>> evtHandles;
156  evt.getManyByType(evtHandles);
157 
158  for (unsigned int i = 0; i < evtHandles.size(); ++i) {
159  if (evtHandles[i].isValid()) {
160  const HepMC::GenEvent *evt = evtHandles[i]->GetEvent();
161 
162  // take only 1st vertex for now - it's been tested only of PGuns...
163  //
164  HepMC::GenEvent::vertex_const_iterator vtx = evt->vertices_begin();
165  if (evtHandles[i].provenance()->moduleLabel() == std::string(l.module)) {
166  // Corrdinates of Vertex w.r.o. the point (0,0,0)
167  xVtx_ = 0.1 * (*vtx)->position().x();
168  yVtx_ = 0.1 * (*vtx)->position().y();
169  zVtx_ = 0.1 * (*vtx)->position().z();
170  }
171  }
172  }
173  //==============================================================================
174  // Get handle to SC collections
175 
177  try {
179  } catch (cms::Exception &ex) {
180  edm::LogError("EnergyScaleAnalyzer") << "Can't get collection with producer hybridSuperClusters.";
181  }
182 
184  try {
186  } catch (cms::Exception &ex) {
187  edm::LogError("EnergyScaleAnalyzer") << "Can't get collection with producer dynamicHybridSuperClusters.";
188  }
189 
190  Handle<reco::SuperClusterCollection> fixedMatrixSuperClustersWithPS;
191  try {
192  evt.getByToken(fixedMatrixSuperClustersWithPreshower_token, fixedMatrixSuperClustersWithPS);
193  } catch (cms::Exception &ex) {
194  edm::LogError("EnergyScaleAnalyzer") << "Can't get collection with producer "
195  "fixedMatrixSuperClustersWithPreshower.";
196  }
197 
198  // Corrected collections
199  Handle<reco::SuperClusterCollection> correctedHybridSC;
200  try {
201  evt.getByToken(correctedHybridSuperClusters_token, correctedHybridSC);
202  } catch (cms::Exception &ex) {
203  edm::LogError("EnergyScaleAnalyzer") << "Can't get collection with producer correctedHybridSuperClusters.";
204  }
205 
206  Handle<reco::SuperClusterCollection> correctedDynamicHybridSC;
207  try {
208  evt.getByToken(correctedDynamicHybridSuperClusters_token, correctedDynamicHybridSC);
209  } catch (cms::Exception &ex) {
210  edm::LogError("EnergyScaleAnalyzer") << "Can't get collection with producer "
211  "correctedDynamicHybridSuperClusters.";
212  }
213 
214  Handle<reco::SuperClusterCollection> correctedFixedMatrixSCWithPS;
215  try {
216  evt.getByToken(correctedFixedMatrixSuperClustersWithPreshower_token, correctedFixedMatrixSCWithPS);
217  } catch (cms::Exception &ex) {
218  edm::LogError("EnergyScaleAnalyzer") << "Can't get collection with producer "
219  "correctedFixedMatrixSuperClustersWithPreshower.";
220  }
221 
223  const reco::SuperClusterCollection *hSC = hybridSuperClusters.product();
224  const reco::SuperClusterCollection *fmSC = fixedMatrixSuperClustersWithPS.product();
225  const reco::SuperClusterCollection *chSC = correctedHybridSC.product();
226  const reco::SuperClusterCollection *cdSC = correctedDynamicHybridSC.product();
227  const reco::SuperClusterCollection *cfmSC = correctedFixedMatrixSCWithPS.product();
228 
229  // ----------------------- Print outs for debugging
230  /*
231  std::cout << "MC truth" << std::endl;
232  int counterI = 0;
233  for( HepMC::GenEvent::particle_const_iterator p =
234  genEvent->particles_begin(); p != genEvent->particles_end(); ++p ) { if (
235  fabs((*p)->momentum().eta()) < 1.5 ) { std::cout << ++counterI << " " <<
236  (*p)->momentum().e() << " "
237  << (*p)->momentum().phi() << " " << (*p)->momentum().eta() <<
238  std::endl;
239  }
240  }
241 
242  std::cout << "Standard clusters" << std::endl;
243  counterI = 0;
244  for(reco::SuperClusterCollection::const_iterator em = hSC->begin();
245  em != hSC->end(); ++em )
246  std::cout << ++counterI << " " << em->energy() << " " <<
247  em->position().phi() << " " << em->position().eta() << std::endl;
248 
249  std::cout << "Dynamic clusters" << std::endl;
250  counterI = 0;
251  for(reco::SuperClusterCollection::const_iterator em = dSC->begin();
252  em != dSC->end(); ++em )
253  std::cout << ++counterI << " " << em->energy() << " " <<
254  em->position().phi() << " " << em->position().eta() << std::endl;
255 
256  std::cout << "FixedMatrix clusters with PS" << std::endl;
257  counterI = 0;
258  for(reco::SuperClusterCollection::const_iterator em = fmSC->begin();
259  em != fmSC->end(); ++em )
260  std::cout << ++counterI << " " << em->energy() << " " <<
261  em->position().phi() << " " << em->position().eta() << std::endl;
262  */
263  // -----------------------------
264  //=====================================================================
265  // All containers are loaded, perform the analysis
266  //====================================================================
267 
268  // --------------------------- Store MC particles
269  HepMC::GenEvent::particle_const_iterator p = genEvent->particles_begin();
270 
271  // Search for MC electrons or photons that satisfy the criteria
272  float min_eT = 5;
273  float max_eta = 2.5;
274 
275  std::vector<HepMC::GenParticle *> mcParticles;
276  // int counter = 0;
277  for (HepMC::GenEvent::particle_const_iterator p = genEvent->particles_begin(); p != genEvent->particles_end(); ++p) {
278  // LogInfo("EnergyScaleAnalyzer") << "Particle " << ++counter
279  //<< " PDG ID = " << (*p)->pdg_id() << " pT = " << (*p)->momentum().perp();
280  // require photon or electron
281  if ((*p)->pdg_id() != 22 && abs((*p)->pdg_id()) != 11)
282  continue;
283 
284  // require selection criteria
285  bool satisfySelectionCriteria = (*p)->momentum().perp() > min_eT && fabs((*p)->momentum().eta()) < max_eta;
286 
287  if (!satisfySelectionCriteria)
288  continue;
289 
290  // EM MC particle is found, save it in the vector
291  mcParticles.push_back(*p);
292  }
293  // separation in dR between 2 first MC particles
294  // should not be used for MC samples with > 2 em objects generated!
295  if (mcParticles.size() == 2) {
296  HepMC::GenParticle *mc1 = mcParticles[0];
297  HepMC::GenParticle *mc2 = mcParticles[1];
298  tree_.mc_sep =
299  kinem::delta_R(mc1->momentum().eta(), mc1->momentum().phi(), mc2->momentum().eta(), mc2->momentum().phi());
300  } else
301  tree_.mc_sep = -100;
302 
303  // now loop over MC particles, find the match with SC and do everything we
304  // need then save info in the tree for every MC particle
305  for (std::vector<HepMC::GenParticle *>::const_iterator p = mcParticles.begin(); p != mcParticles.end(); ++p) {
306  HepMC::GenParticle *mc = *p;
307 
308  // Fill MC information
309  tree_.mc_npar = mcParticles.size();
310  tree_.parID = mc->pdg_id();
311  tree_.mc_e = mc->momentum().e();
312  tree_.mc_et = mc->momentum().e() * sin(mc->momentum().theta());
313  tree_.mc_phi = mc->momentum().phi();
314  tree_.mc_eta = mc->momentum().eta();
315  tree_.mc_theta = mc->momentum().theta();
316 
317  // Call function to fill tree
318  // scType coprreponds:
319  // HybridSuperCluster -- 1
320  // DynamicHybridSuperCluster -- 2
321  // FixedMatrixSuperClustersWithPreshower -- 3
322 
323  fillTree(hSC, chSC, mc, tree_, xVtx_, yVtx_, zVtx_, 1);
324  // std::cout << " TYPE " << 1 << " : " << tree_.em_e << " : " <<
325  // tree_.em_phi << " : " << tree_.em_eta << std::endl;
326 
327  fillTree(dSC, cdSC, mc, tree_, xVtx_, yVtx_, zVtx_, 2);
328  // std::cout << " TYPE " << 2 << " : " << tree_.em_e << " : " <<
329  // tree_.em_phi << " : " << tree_.em_eta << std::endl;
330 
331  fillTree(fmSC, cfmSC, mc, tree_, xVtx_, yVtx_, zVtx_, 3);
332  // std::cout << " TYPE " << 3 << " : " << tree_.em_e << " : " <<
333  // tree_.em_phi << " : " << tree_.em_eta << std::endl;
334 
335  // mytree_->Fill();
336  } // loop over particles
337 }
338 
340  const reco::SuperClusterCollection *corrSCColl,
341  HepMC::GenParticle *mc,
343  float xV,
344  float yV,
345  float zV,
346  int scType) {
347  // ----------------------------- SuperClusters before energy correction
348  reco::SuperClusterCollection::const_iterator em = scColl->end();
349  float energyMax = -100.0; // dummy energy of the matched SC
350  for (reco::SuperClusterCollection::const_iterator aClus = scColl->begin(); aClus != scColl->end(); ++aClus) {
351  // check the matching
352  float dR =
353  kinem::delta_R(mc->momentum().eta(), mc->momentum().phi(), aClus->position().eta(), aClus->position().phi());
354  if (dR < 0.4) { // a rather loose matching cut
355  float energy = aClus->energy();
356  if (energy < energyMax)
357  continue;
358  energyMax = energy;
359  em = aClus;
360  }
361  }
362 
363  if (em == scColl->end()) {
364  // std::cout << "No matching SC with type " << scType << " was found for
365  // MC particle! " << std::endl; std::cout << "Going to next type of SC.
366  // " << std::endl;
367  return;
368  }
369  // ------------
370 
371  tree_.em_scType = scType;
372 
373  tree_.em_isInCrack = 0;
374  double emAbsEta = fabs(em->position().eta());
375  // copied from
376  // RecoEgama/EgammaElectronAlgos/src/EgammaElectronClassification.cc
377  if (emAbsEta < 0.018 || (emAbsEta > 0.423 && emAbsEta < 0.461) || (emAbsEta > 0.770 && emAbsEta < 0.806) ||
378  (emAbsEta > 1.127 && emAbsEta < 1.163) || (emAbsEta > 1.460 && emAbsEta < 1.558))
379  tree_.em_isInCrack = 1;
380 
381  tree_.em_dR = kinem::delta_R(mc->momentum().eta(), mc->momentum().phi(), em->position().eta(), em->position().phi());
382  tree_.em_e = em->energy();
383  tree_.em_et = em->energy() * sin(em->position().theta());
384  tree_.em_phi = em->position().phi();
385  tree_.em_eta = em->position().eta();
386  tree_.em_theta = em->position().theta();
387  tree_.em_nCell = em->size();
388  tree_.em_nBC = em->clustersSize();
389 
390  // Get physics e, et etc:
391  // Coordinates of EM object with respect of the point (0,0,0)
392  xClust_zero_ = em->position().x();
393  yClust_zero_ = em->position().y();
394  zClust_zero_ = em->position().z();
395  // Coordinates of EM object w.r.o. the Vertex position
396  xClust_vtx_ = xClust_zero_ - xV;
397  yClust_vtx_ = yClust_zero_ - yV;
398  zClust_vtx_ = zClust_zero_ - zV;
399 
400  energyMax_ = em->energy();
401  thetaMax_ = em->position().theta();
402  etaMax_ = em->position().eta();
403  phiMax_ = em->position().phi();
405  if (phiMax_ < 0)
406  phiMax_ += 2 * 3.14159;
407 
409  thetaMaxVtx_ = acos(zClust_vtx_ / rClust_vtx_);
410  etaMaxVtx_ = -log(tan(thetaMaxVtx_ / 2));
413  if (phiMaxVtx_ < 0)
414  phiMaxVtx_ += 2 * 3.14159;
415  //=============================
416  // parametres of EM object after vertex correction
417  tree_.em_pet = eTMaxVtx_;
418  tree_.em_pe = tree_.em_pet / sin(thetaMaxVtx_);
419  tree_.em_peta = etaMaxVtx_;
420  tree_.em_ptheta = thetaMaxVtx_;
421 
422  //------------------------------- Get SC after energy correction
423  em = corrSCColl->end();
424  energyMax = -100.0; // dummy energy of the matched SC
425  for (reco::SuperClusterCollection::const_iterator aClus = corrSCColl->begin(); aClus != corrSCColl->end(); ++aClus) {
426  // check the matching
427  float dR =
428  kinem::delta_R(mc->momentum().eta(), mc->momentum().phi(), aClus->position().eta(), aClus->position().phi());
429  if (dR < 0.4) {
430  float energy = aClus->energy();
431  if (energy < energyMax)
432  continue;
433  energyMax = energy;
434  em = aClus;
435  }
436  }
437 
438  if (em == corrSCColl->end()) {
439  // std::cout << "No matching corrected SC with type " << scType << " was
440  // found for MC particle! " << std::endl; std::cout << "Going to next
441  // type of SC. " << std::endl;
442  return;
443  }
444  // ------------
445 
447  tree_.emCorr_e = em->energy();
448  tree_.emCorr_et = em->energy() * sin(em->position().theta());
449  tree_.emCorr_phi = em->position().phi();
450  tree_.emCorr_eta = em->position().eta();
451  tree_.emCorr_theta = em->position().theta();
452 
453  // =========== Eta and Theta wrt Vertex does not change after energy
454  // corrections are applied
455  // =========== So, no need to calculate them again
456 
457  tree_.emCorr_peta = tree_.em_peta;
458  tree_.emCorr_ptheta = tree_.em_ptheta;
459  tree_.emCorr_pet = tree_.emCorr_e / cosh(tree_.emCorr_peta);
460 
461  tree_.em_pw = em->phiWidth();
462  tree_.em_ew = em->etaWidth();
463  tree_.em_br = tree_.em_pw / tree_.em_ew;
464 
465  mytree_->Fill();
466 }
467 
468 //==========================================================================
470  //========================================================================
471  // Fill ROOT tree
472  rootFile_->Write();
473 }
474 
edm::EDGetTokenT< reco::SuperClusterCollection > dynamicHybridSuperClusters_token
T getUntrackedParameter(std::string const &, T const &) const
edm::EDGetTokenT< reco::SuperClusterCollection > fixedMatrixSuperClustersWithPreshower_token
static std::vector< std::string > checklist log
const bool isValid(const Frame &aFrame, const FrameQuality &aQuality, const uint16_t aExpectedPos)
bool getByToken(EDGetToken token, Handle< PROD > &result) const
Definition: Event.h:539
#define DEFINE_FWK_MODULE(type)
Definition: MakerMacros.h:16
void analyze(const edm::Event &, const edm::EventSetup &) override
Sin< T >::type sin(const T &t)
Definition: Sin.h:22
edm::EDGetTokenT< edm::HepMCProduct > hepMCLabel_
void getManyByType(std::vector< Handle< PROD >> &results) const
Definition: Event.h:530
edm::EDGetTokenT< reco::SuperClusterCollection > correctedFixedMatrixSuperClustersWithPreshower_token
Log< level::Error, false > LogError
edm::EDGetTokenT< reco::SuperClusterCollection > hybridSuperClusters_token
void fillTree(const reco::SuperClusterCollection *scColl, const reco::SuperClusterCollection *corrSCColl, HepMC::GenParticle *mc, tree_structure_ &tree_, float xV, float yV, float zV, int scType)
std::vector< SuperCluster > SuperClusterCollection
collection of SuperCluser objectr
T sqrt(T t)
Definition: SSEVec.h:19
Tan< T >::type tan(const T &t)
Definition: Tan.h:22
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
tuple genEvent
Definition: MCTruth.py:34
double delta_R(double eta1, double phi1, double eta2, double phi2)
Definition: AnglesUtil.h:106
edm::EDGetTokenT< reco::SuperClusterCollection > correctedDynamicHybridSuperClusters_token
edm::EDGetTokenT< reco::SuperClusterCollection > correctedHybridSuperClusters_token
Log< level::Info, false > LogInfo
EnergyScaleAnalyzer(const edm::ParameterSet &)
T getParameter(std::string const &) const
Definition: ParameterSet.h:303
void labelsForToken(EDGetToken iToken, Labels &oLabels) const