CMS 3D CMS Logo

 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Properties Friends Macros Pages
List of all members | Public Member Functions | Private Member Functions | Private Attributes | Static Private Attributes
MBUEandQCDValidation Class Reference

#include <MBUEandQCDValidation.h>

Inheritance diagram for MBUEandQCDValidation:
edm::EDAnalyzer

Public Member Functions

virtual void analyze (const edm::Event &, const edm::EventSetup &)
 
virtual void beginJob ()
 
virtual void beginRun (const edm::Run &, const edm::EventSetup &)
 
virtual void endJob ()
 
virtual void endRun (const edm::Run &, const edm::EventSetup &)
 
 MBUEandQCDValidation (const edm::ParameterSet &)
 
virtual ~MBUEandQCDValidation ()
 
- Public Member Functions inherited from edm::EDAnalyzer
 EDAnalyzer ()
 
std::string workerType () const
 
virtual ~EDAnalyzer ()
 

Private Member Functions

unsigned int getHFbin (double eta)
 
bool isCharged (unsigned int i)
 
bool isNeutral (unsigned int i)
 
bool isNeutrino (unsigned int i)
 

Private Attributes

MonitorElement_JM25ht
 
MonitorElement_JM25njets
 
MonitorElement_JM25pt1
 
MonitorElement_JM25pt2
 
MonitorElement_JM25pt3
 
MonitorElement_JM25pt4
 
MonitorElement_JM80ht
 
MonitorElement_JM80njets
 
MonitorElement_JM80pt1
 
MonitorElement_JM80pt2
 
MonitorElement_JM80pt3
 
MonitorElement_JM80pt4
 
MonitorElement_sumEt
 
MonitorElement_sumEt1
 
MonitorElement_sumEt2
 
MonitorElement_sumEt3
 
MonitorElement_sumEt4
 
MonitorElement_sumEt5
 
DQMStoredbe
 ME's "container". More...
 
MonitorElementdEdetaHFdj
 
MonitorElementdEdetaHFmb
 
MonitorElementdjr10
 
MonitorElementdjr21
 
MonitorElementdjr32
 
MonitorElementdjr43
 
MonitorElementdNchdeta1
 
MonitorElementdNchdeta2
 
MonitorElementdNchdphi
 
MonitorElementdNchdpt1
 
MonitorElementdNchdpt2
 
MonitorElementdNchdSpt
 
MonitorElementdNchjdeta
 
MonitorElementdNchjdpt
 
MonitorElementdNjdeta
 
MonitorElementdNjdpt
 
MonitorElementdSptdphi
 
MonitorElementelePt
 
MonitorElementEmpzHFm
 
MonitorElementeneHFmSel
 
std::vector< double > eneInCell
 
edm::ESHandle
< HepPDT::ParticleDataTable
fPDGTable
 PDT table. More...
 
edm::InputTag genchjetCollection_
 
edm::InputTag genjetCollection_
 
std::vector< double > hepmcCharge
 
edm::InputTag hepmcCollection_
 
std::vector< const
HepMC::GenParticle * > 
hepmcGPCollection
 status 1 GenParticle collection More...
 
MonitorElementleadChjeta
 
MonitorElementleadChjpt
 
MonitorElementleadTracketa
 
MonitorElementleadTrackpt
 
MonitorElementmissEtosumJEt
 
MonitorElementmuoPt
 
MonitorElementnbquark
 
MonitorElementncandbquark
 
MonitorElementnCha
 
MonitorElementnChaDenLpt
 
MonitorElementnChj
 
MonitorElementncnobquark
 
MonitorElementnDijet
 
MonitorElementnEvt
 
MonitorElementnEvt1
 QCD-09-010 analysis. More...
 
MonitorElementnEvt2
 
MonitorElementnGamma
 
MonitorElementnHFflow
 
MonitorElementnHFSD
 
MonitorElementnj
 
MonitorElementnK0s
 
MonitorElementnKpm
 
MonitorElementnL0
 
MonitorElementnNNbar
 
MonitorElementnNoFwdTrig
 
MonitorElementnOmega
 
MonitorElementnPPbar
 
MonitorElementnSaFwdTrig
 
MonitorElementntHFm
 
MonitorElementnXim
 
MonitorElementpGamma
 
MonitorElementpK0s
 
MonitorElementpKpm
 
MonitorElementpL0
 
MonitorElementpNNbar
 
MonitorElementpOmega
 
MonitorElementpPPbar
 
MonitorElementpt1pt2balance
 
MonitorElementpt1pt2Dphi
 
MonitorElementpt1pt2InvM
 
MonitorElementpt1pt2optot
 
MonitorElementpt1pt2optotch
 
MonitorElementpt3Frac
 
MonitorElementpXim
 
MonitorElementsptDenLpt
 
MonitorElementsumChPt
 
MonitorElementsumJEt
 
MonitorElementsumPt
 
CaloCellManagertheCalo
 manager of calorimetric cell structure More...
 
unsigned int verbosity_
 

Static Private Attributes

static const unsigned int initSize = 1000
 
static const unsigned int nphiBin = 36
 

Additional Inherited Members

- Public Types inherited from edm::EDAnalyzer
typedef EDAnalyzer ModuleType
 
typedef WorkerT< EDAnalyzerWorkerType
 
- Static Public Member Functions inherited from edm::EDAnalyzer
static const std::string & baseType ()
 
static void fillDescriptions (ConfigurationDescriptions &descriptions)
 
- Protected Member Functions inherited from edm::EDAnalyzer
CurrentProcessingContext const * currentContext () const
 

Detailed Description

Definition at line 39 of file MBUEandQCDValidation.h.

Constructor & Destructor Documentation

MBUEandQCDValidation::MBUEandQCDValidation ( const edm::ParameterSet iPSet)
explicit

Definition at line 21 of file MBUEandQCDValidation.cc.

References dbe, eneInCell, hepmcCharge, hepmcGPCollection, initSize, CaloCellManager::nCaloCell, cmsCodeRules.cppFunctionSkipper::operator, theCalo, and verbosity_.

21  :
22  hepmcCollection_(iPSet.getParameter<edm::InputTag>("hepmcCollection")),
23  genchjetCollection_(iPSet.getParameter<edm::InputTag>("genChjetsCollection")),
24  genjetCollection_(iPSet.getParameter<edm::InputTag>("genjetsCollection")),
25  verbosity_(iPSet.getUntrackedParameter<unsigned int>("verbosity",0))
26 {
27  dbe = 0;
29 
30  hepmcGPCollection.reserve(initSize);
31  hepmcCharge.reserve(initSize);
32 
34 
36 
37 }
T getParameter(std::string const &) const
T getUntrackedParameter(std::string const &, T const &) const
std::vector< const HepMC::GenParticle * > hepmcGPCollection
status 1 GenParticle collection
DQMStore * dbe
ME&#39;s &quot;container&quot;.
CaloCellManager * theCalo
manager of calorimetric cell structure
edm::InputTag genjetCollection_
std::vector< double > hepmcCharge
static const unsigned int nCaloCell
std::vector< double > eneInCell
edm::InputTag hepmcCollection_
edm::InputTag genchjetCollection_
static const unsigned int initSize
MBUEandQCDValidation::~MBUEandQCDValidation ( )
virtual

Definition at line 39 of file MBUEandQCDValidation.cc.

References theCalo.

39  {
40 
41  delete theCalo;
42 
43 }
CaloCellManager * theCalo
manager of calorimetric cell structure

Member Function Documentation

void MBUEandQCDValidation::analyze ( const edm::Event iEvent,
const edm::EventSetup iSetup 
)
virtual

Gathering the HepMCProduct information

Implements edm::EDAnalyzer.

Definition at line 229 of file MBUEandQCDValidation.cc.

References _JM25ht, _JM25njets, _JM25pt1, _JM25pt2, _JM25pt3, _JM25pt4, _JM80ht, _JM80njets, _JM80pt1, _JM80pt2, _JM80pt3, _JM80pt4, _sumEt, _sumEt1, _sumEt2, _sumEt3, _sumEt4, _sumEt5, abs, HepMCValidationHelper::allStatus1(), DeDxDiscriminatorTools::charge(), funct::cos(), gather_cfg::cout, dEdetaHFdj, dEdetaHFmb, Geom::deltaPhi(), djr10, djr21, djr32, djr43, dNchdeta1, dNchdeta2, dNchdphi, dNchdpt1, dNchdpt2, dNchdSpt, dNchjdeta, dNchjdpt, dNjdeta, dNjdpt, dSptdphi, elePt, EmpzHFm, eneHFmSel, eneInCell, eta(), MonitorElement::Fill(), CaloCellId::Forward, fPDGTable, genchjetCollection_, genjetCollection_, edm::Event::getByLabel(), CaloCellManager::getCellFromIndex(), CaloCellManager::getCellIndexFromAngle(), CaloCellId::getEtaMin(), CaloCellManager::getEtaRanges(), getHFbin(), CaloCellId::getSubSys(), MonitorElement::getTH1(), CaloCellId::getThetaCell(), hepmcCharge, hepmcCollection_, hepmcGPCollection, i, isCharged(), isNeutral(), isNeutrino(), k0s, leadChjeta, leadChjpt, leadTracketa, leadTrackpt, missEtosumJEt, muoPt, CaloCellManager::nBarrelCell, CaloCellManager::nBarrelEta, nbquark, CaloCellManager::nCaloCell, ncandbquark, nCha, nChaDenLpt, nChj, ncnobquark, nDijet, CaloCellManager::nEndcapCell, CaloCellManager::nEndcapEta, nEvt, nEvt1, nEvt2, CaloCellManager::nForwardEta, nGamma, nHFflow, nHFSD, nj, nK0s, nKpm, nL0, nNNbar, nNoFwdTrig, nOmega, nphiBin, nPPbar, nSaFwdTrig, ntHFm, nXim, RecoTau_DiTaus_pt_20-420_cfg::ParticleID, benchmark_cfg::pdgId, perp(), pGamma, phi, jptDQMConfig_cff::phiMax, pK0s, pKpm, pL0, pNNbar, pOmega, pPPbar, pt1pt2balance, pt1pt2Dphi, pt1pt2InvM, pt1pt2optot, pt1pt2optotch, pt3Frac, jptDQMConfig_cff::ptMax, pXim, HepMCValidationHelper::removeIsolatedLeptons(), sptDenLpt, mathSSE::sqrt(), sumChPt, sumJEt, sumPt, theCalo, dtT0WireCalibration_cfg::threshold, and verbosity_.

230 {
231 
234  iEvent.getByLabel(hepmcCollection_, evt);
235 
236  //Get HepMC EVENT
237  HepMC::GenEvent *myGenEvent = new HepMC::GenEvent(*(evt->GetEvent()));
238 
239  if ( verbosity_ > 0 ) { myGenEvent->print(); }
240 
241  double binW = 1.;
242 
243  hepmcGPCollection.clear();
244  hepmcCharge.clear();
245  for (unsigned int i = 0; i < eneInCell.size(); i++) { eneInCell[i] = 0.; }
246 
247  nEvt->Fill(0.5);
248 
249  //Looping through HepMC::GenParticle collection to search for status 1 particles
250  double charge = 0.;
251  unsigned int nb = 0;
252  unsigned int nc = 0;
253  for (HepMC::GenEvent::particle_const_iterator iter = myGenEvent->particles_begin(); iter != myGenEvent->particles_end(); ++iter){
254  if ( std::fabs((*iter)->pdg_id()) == 4 ) { nc++; }
255  if ( std::fabs((*iter)->pdg_id()) == 5 ) { nb++; }
256  if ( (*iter)->status() == 1) {
257  hepmcGPCollection.push_back(*iter);
258  const HepPDT::ParticleData* PData = fPDGTable->particle(HepPDT::ParticleID((*iter)->pdg_id()));
259  if(PData==0) { charge = -999.; }
260  else
261  charge = PData->charge();
262 
263  hepmcCharge.push_back(charge);
264 
265  if ( verbosity_ > 0 ) {
266  std::cout << "HepMC " << std::setw(14) << std::fixed << (*iter)->barcode()
267  << std::setw(14) << std::fixed << (*iter)->pdg_id()
268  << std::setw(14) << std::fixed << (*iter)->momentum().perp()
269  << std::setw(14) << std::fixed << (*iter)->momentum().eta()
270  << std::setw(14) << std::fixed << (*iter)->momentum().phi() << std::endl;
271  }
272 
273  }
274  }
275 
276  int nBSCp = 0; int nBSCm = 0; double eneHFp = 0.; double eneHFm = 0.; int nChapt05 = 0; int nChaVtx = 0;
277  for (unsigned int i = 0; i < hepmcGPCollection.size(); i++ ){
278  if ( !isNeutrino(i) ) {
279 
280  // BSC trigger
281 
282  if ( hepmcGPCollection[i]->momentum().eta() > 3.23 && hepmcGPCollection[i]->momentum().eta() < 4.65 ) { nBSCp++; }
283  if ( hepmcGPCollection[i]->momentum().eta() < -3.23 && hepmcGPCollection[i]->momentum().eta() > -4.65 ) { nBSCm++; }
284 
285  // number of charged particles in different selections
286 
287  if ( std::fabs(hepmcGPCollection[i]->momentum().eta()) < 2.5 && hepmcGPCollection[i]->momentum().perp() > 0.5 && isCharged(i) ) { nChapt05++; }
288  if ( std::fabs(hepmcGPCollection[i]->momentum().eta()) < 2.5 && hepmcGPCollection[i]->momentum().perp() > 0.1 && isCharged(i) ) { nChaVtx++; }
289  unsigned int theIndex = theCalo->getCellIndexFromAngle(hepmcGPCollection[i]->momentum().eta(),hepmcGPCollection[i]->momentum().phi());
290  if ( theIndex < CaloCellManager::nCaloCell ) eneInCell[theIndex] += hepmcGPCollection[i]->momentum().rho();
291  }
292  }
293 
294  // Forward calorimeters energy
295 
296  for (unsigned int icell = CaloCellManager::nBarrelCell+CaloCellManager::nEndcapCell; icell < CaloCellManager::nCaloCell; icell++ ) {
297  if ( theCalo->getCellFromIndex(icell)->getEtaMin() < 0. ) { eneHFm += eneInCell[icell]; }
298  else { eneHFp += eneInCell[icell]; }
299  }
300 
301  // QCD-09-010 selection
302  bool sel1 = false;
303  if ( (nBSCp > 0 || nBSCm > 0) && eneHFp >= 3. && eneHFm >= 3. ) { sel1 = true; }
304 
305  // QCD-10-001 selection
306  bool sel2 = false;
307  if ( (nBSCp >0 || nBSCm > 0) && nChaVtx >= 3 && nChapt05 > 1 ) { sel2 = true; }
308 
309  // no forward trigger selection
310  bool sel3 = false;
311  if ( nBSCp == 0 && nBSCm == 0 ) { sel3 = true; }
312 
313  // single arm forward trigger selection
314  bool sel4 = false;
315  if ( ( nBSCp>0 && nBSCm == 0 ) || ( nBSCm>0 && nBSCp == 0 ) ) { sel4 = true; }
316 
317  // BSC selection
318  bool sel5 = false;
319  if ( nBSCp > 0 && nBSCm > 0 ) { sel5 = true; }
320 
321  // basic JME-10-001, FWD-10-002 and Jet-Multiplicity selection
322  bool sel6 = false;
323  if ( sel5 && nChaVtx > 3 ) { sel6 = true; }
324 
325  // FWD-10-001 selection
326  bool sel7 = false;
327  if ( nChaVtx >= 3 && nBSCm > 0 && eneHFp < 8. ) { sel7 = true; }
328 
329  // Fill selection histograms
330  if ( sel1 ) nEvt1->Fill(0.5);
331  if ( sel2 ) nEvt2->Fill(0.5);
332  if ( sel3 ) nNoFwdTrig->Fill(0.5);
333  if ( sel4 ) nSaFwdTrig->Fill(0.5);
334  if ( sel6 ) nHFflow->Fill(0.5);
335  if ( sel7 ) nHFSD->Fill(0.5);
336 
337  if ( nb > 0 ) nbquark->Fill(0.5);
338  if ( nb > 0 && nc > 0 ) ncandbquark->Fill(0.5);
339  if ( nb == 0 && nc > 0 ) ncnobquark->Fill(0.5);
340 
341  // track analyses
342  double ptMax = 0.;
343  unsigned int iMax = 0;
344  double ptot = 0.;
345  unsigned int ppbar = 0; unsigned int nnbar = 0; unsigned int kpm = 0; unsigned int k0s = 0; unsigned int l0 = 0; unsigned int gamma = 0;
346  unsigned int xim = 0; unsigned int omega = 0;
347  unsigned int ele = 0; unsigned int muo = 0;
348  unsigned int eleMax = 0;
349  unsigned int muoMax = 0;
350 
351  std::vector<double> hfMB (CaloCellManager::nForwardEta,0);
352  std::vector<double> hfDJ (CaloCellManager::nForwardEta,0);
353 
354  for (unsigned int i = 0; i < hepmcGPCollection.size(); i++ ){
355  double eta = hepmcGPCollection[i]->momentum().eta();
356  double pt = hepmcGPCollection[i]->momentum().perp();
357  int pdgId = hepmcGPCollection[i]->pdg_id();
358  if ( isCharged(i) && std::fabs(eta) < 2.5 ) {
359  if ( sel1 ) {
360  // QCD-09-010
361  binW = dNchdpt1->getTH1()->GetBinWidth(1);
362  dNchdpt1->Fill(pt,1./binW); // weight to account for the pt bin width
363  binW = dNchdeta1->getTH1()->GetBinWidth(1);
364  dNchdeta1->Fill(eta,1./binW); // weight to account for the eta bin width
365  }
366  // search for the leading track QCD-10-001
367  if ( sel2 ) {
368  if ( pt > ptMax ) { ptMax = pt; iMax = i; }
369  ptot += pt;
370 
371  // identified charged particle
372  if (std::abs(pdgId) == 2212) {
373  ppbar++;
374  pPPbar->Fill(std::log10(pt));
375  }
376  else if (std::abs(pdgId) == 321) {
377  kpm++;
378  pKpm->Fill(std::log10(pt));
379  }
380  else if (std::abs(pdgId) == 3312) {
381  xim++;
382  pXim->Fill(std::log10(pt));
383  }
384  else if (std::abs(pdgId) == 3334) {
385  omega++;
386  pOmega->Fill(std::log10(pt));
387  }
388  else if (std::abs(pdgId) == 11) {
389  ele++;
390  eleMax = i;
391  }
392  else if (std::abs(pdgId) == 13) {
393  muo++;
394  muoMax = i;
395  }
396  }
397  }
398  else if ( sel2 && isNeutral(i) && std::fabs(eta) < 2.5 ) {
399  if (std::abs(pdgId) == 310) {
400  k0s++;
401  pK0s->Fill(std::log10(pt));
402  }
403  else if (std::abs(pdgId) == 3122) {
404  l0++;
405  pL0->Fill(std::log10(pt));
406  }
407  }
408  else if ( sel2 && isNeutral(i) && std::fabs(eta) < 5.19 ) {
409  if (std::abs(pdgId) == 2112) {
410  nnbar++;
411  pNNbar->Fill(std::log10(pt));
412  }
413  else if (std::abs(pdgId) == 22) {
414  gamma++;
415  pGamma->Fill(std::log10(pt));
416  }
417  }
418  unsigned int iBin = getHFbin(eta);
419  if ( sel6 && !isNeutrino(i) && iBin < CaloCellManager::nForwardEta ) {
420  hfMB[iBin] += hepmcGPCollection[i]->momentum().rho();
421  }
422  }
423  nPPbar->Fill(ppbar);
424  nNNbar->Fill(nnbar);
425  nKpm->Fill(kpm);
426  nK0s->Fill(k0s);
427  nL0->Fill(l0);
428  nXim->Fill(xim);
429  nOmega->Fill(omega);
430  nGamma->Fill(gamma);
431 
432  if ( ele > 0 ) elePt->Fill(std::log10(hepmcGPCollection[eleMax]->momentum().perp()));
433  if ( muo > 0 ) muoPt->Fill(std::log10(hepmcGPCollection[muoMax]->momentum().perp()));
434 
435  leadTrackpt->Fill(hepmcGPCollection[iMax]->momentum().perp());
436  leadTracketa->Fill(hepmcGPCollection[iMax]->momentum().eta());
437 
438  std::vector<double> theEtaRanges(theCalo->getEtaRanges());
439 
440  for (unsigned int i = 0; i < CaloCellManager::nForwardEta; i++ ) {
442  dEdetaHFmb->Fill(i+0.5,hfMB[i]/binW);
443  }
444 
445  // FWD-10-001
446 
447  if ( sel7 ) {
448 
449  double empz = 0.;
450  unsigned int nCellOvTh = 0;
451  double threshold = 0.;
452 
453  for (unsigned int icell = 0; icell < eneInCell.size(); icell++ ) {
454 
455  if ( theCalo->getCellFromIndex(icell)->getSubSys() != CaloCellId::Forward ) { threshold = 3.; }
456  else { threshold = 4.; }
457 
458  if ( eneInCell[icell] > threshold ) {
459  if ( theCalo->getCellFromIndex(icell)->getSubSys() == CaloCellId::Forward ) { nCellOvTh++; }
460  empz += eneInCell[icell]*(1.-std::cos(theCalo->getCellFromIndex(icell)->getThetaCell()));
461  }
462 
463  }
464 
465  EmpzHFm->Fill(empz);
466  ntHFm->Fill(nCellOvTh);
467  eneHFmSel->Fill(eneHFm);
468 
469  }
470 
471  // QCD-10-001
472  double phiMax = hepmcGPCollection[iMax]->momentum().phi();
473  std::vector<unsigned int> nchvsphi (nphiBin,0);
474  std::vector<double> sptvsphi (nphiBin,0.);
475  unsigned int nChaTra = 0;
476  double sptTra = 0.;
477 
478  double binPhiW = 360./nphiBin;
479  if ( sel2 ) {
480  for (unsigned int i = 0; i < hepmcGPCollection.size(); i++ ){
481  if ( isCharged(i) && std::fabs(hepmcGPCollection[i]->momentum().eta()) < 2. ) {
482  double thePhi = (hepmcGPCollection[i]->momentum().phi()-phiMax)/CLHEP::degree;
483  if ( thePhi < -180. ) { thePhi += 360.; }
484  else if ( thePhi > 180. ) { thePhi -= 360.; }
485  unsigned int thePhiBin = (int)((thePhi+180.)/binPhiW);
486  if ( thePhiBin == nphiBin ) { thePhiBin -= 1; }
487  nchvsphi[thePhiBin]++;
488  sptvsphi[thePhiBin] += hepmcGPCollection[i]->momentum().perp();
489  // analysis in the transverse region
490  if ( std::fabs(thePhi) > 60. && std::fabs(thePhi) < 120. ) {
491  nChaTra++;
492  sptTra += hepmcGPCollection[i]->momentum().perp();
493  binW = dNchdpt2->getTH1()->GetBinWidth(1);
494  dNchdpt2->Fill(hepmcGPCollection[i]->momentum().perp(),1./binW); // weight to account for the pt bin width
495  binW = dNchdeta2->getTH1()->GetBinWidth(1);
496  dNchdeta2->Fill(hepmcGPCollection[i]->momentum().eta(),1./binW); // weight to account for the eta bin width
497  }
498  }
499  }
500  nCha->Fill(nChaTra);
501  binW = dNchdSpt->getTH1()->GetBinWidth(1);
502  dNchdSpt->Fill(sptTra,1.);
503  nChaDenLpt->Fill(hepmcGPCollection[iMax]->momentum().perp(),nChaTra/4./CLHEP::twopi);
504  sptDenLpt->Fill(hepmcGPCollection[iMax]->momentum().perp(),sptTra/4./CLHEP::twopi);
505  for ( unsigned int i = 0; i < nphiBin; i++ ) {
506  double thisPhi = -180.+(i+0.5)*binPhiW;
507  dNchdphi->Fill(thisPhi,nchvsphi[i]/binPhiW/4.); // density in phi and eta
508  dSptdphi->Fill(thisPhi,sptvsphi[i]/binPhiW/4.); // density in phi and eta
509  }
510  }
511 
512  // Gather information in the charged GenJet collection
514  iEvent.getByLabel(genchjetCollection_, genChJets );
515 
516  unsigned int nJets = 0;
517  double pt1 = 0.;
518  double pt2 = 0.;
519  reco::GenJetCollection::const_iterator ij1 = genChJets->begin();
520  reco::GenJetCollection::const_iterator ij2 = genChJets->begin();
521  if ( sel2 ) {
522  for (reco::GenJetCollection::const_iterator iter=genChJets->begin();iter!=genChJets->end();++iter){
523  double eta = (*iter).eta();
524  double pt = (*iter).pt();
525  if ( verbosity_ > 0 ) {
526  std::cout << "GenJet " << std::setw(14) << std::fixed << (*iter).pt()
527  << std::setw(14) << std::fixed << (*iter).eta()
528  << std::setw(14) << std::fixed << (*iter).phi() << std::endl;
529  }
530  if ( std::fabs(eta) < 2. ) {
531  nJets++;
532  binW = dNchjdeta->getTH1()->GetBinWidth(1);
533  dNchjdeta->Fill(eta,1./binW);
534  binW = dNchjdpt->getTH1()->GetBinWidth(1);
535  dNchjdpt->Fill(pt,1./binW);
536  if ( pt >= pt1 ) { pt1 = pt; ij1 = iter; }
537  if ( pt < pt1 && pt >= pt2 ) { pt2 = pt; ij2 = iter; }
538  }
539  }
540 
541  nChj->Fill(nJets);
542  if ( nJets > 0 && ij1 != genChJets->end() ) {
543  leadChjpt->Fill(pt1);
544  leadChjeta->Fill((*ij1).eta());
545  if ( nJets > 1 && ij2 != genChJets->end() ) {
546  pt1pt2optotch->Fill(pt1+pt2,(pt1+pt2)/ptot);
547  }
548  }
549  }
550 
551 
552  // Gather information in the GenJet collection
554  iEvent.getByLabel(genjetCollection_, genJets );
555 
556  nJets = 0;
557  pt1 = 0.;
558  pt2 = 0.;
559  double pt3 = 0.;
560 
561 
562  // needed for Jet-Multiplicity Analysis
563  int jm25njets = 0;
564  double jm25HT = 0.;
565  double jm25pt1 = 0.;
566  double jm25pt2 = 0.;
567  double jm25pt3 = 0.;
568  double jm25pt4 = 0.;
569 
570  int jm80njets = 0;
571  double jm80HT = 0.;
572  double jm80pt1 = 0.;
573  double jm80pt2 = 0.;
574  double jm80pt3 = 0.;
575  double jm80pt4 = 0.;
576 
577 
578 
579  reco::GenJetCollection::const_iterator ij3 = genJets->begin();
580  if ( sel6 ) {
581  for (reco::GenJetCollection::const_iterator iter=genJets->begin();iter!=genJets->end();++iter){
582  double eta = (*iter).eta();
583  double pt = (*iter).pt();
584  if ( verbosity_ > 0 ) {
585  std::cout << "GenJet " << std::setw(14) << std::fixed << (*iter).pt()
586  << std::setw(14) << std::fixed << (*iter).eta()
587  << std::setw(14) << std::fixed << (*iter).phi() << std::endl;
588  }
589  if ( std::fabs(eta) < 5. ) {
590  nJets++;
591  if ( pt >= pt1 ) { pt1 = pt; ij1 = iter; }
592  if ( pt < pt1 && pt >= pt2 ) { pt2 = pt; ij2 = iter; }
593  if ( pt < pt2 && pt >= pt3 ) { pt3 = pt; ij3 = iter; }
594  }
595 
596  // find variables for Jet-Multiplicity Analysis
597  if(fabs(iter->eta()) < 3. && iter->pt()>25.) {
598  jm25njets++;
599  jm25HT += iter->pt();
600  if(iter->pt()>jm25pt1) {
601  jm25pt4 = jm25pt3;
602  jm25pt3 = jm25pt2;
603  jm25pt2 = jm25pt1;
604  jm25pt1 = iter->pt();
605  } else if(iter->pt()>jm25pt2) {
606  jm25pt4 = jm25pt3;
607  jm25pt3 = jm25pt2;
608  jm25pt2 = iter->pt();
609  } else if(iter->pt()>jm25pt3) {
610  jm25pt4 = jm25pt3;
611  jm25pt3 = iter->pt();
612  } else if(iter->pt()>jm25pt4) {
613  jm25pt4 = iter->pt();
614  }
615  // even harder jets...
616  if(iter->pt()>80.) {
617  jm80njets++;
618  jm80HT += iter->pt();
619  if(iter->pt()>jm80pt1) {
620  jm80pt4 = jm80pt3;
621  jm80pt3 = jm80pt2;
622  jm80pt2 = jm80pt1;
623  jm80pt1 = iter->pt();
624  } else if(iter->pt()>jm80pt2) {
625  jm80pt4 = jm80pt3;
626  jm80pt3 = jm80pt2;
627  jm80pt2 = iter->pt();
628  } else if(iter->pt()>jm80pt3) {
629  jm80pt4 = jm80pt3;
630  jm80pt3 = iter->pt();
631  } else if(iter->pt()>jm80pt4) {
632  jm80pt4 = iter->pt();
633  }
634  }
635 
636  }
637 
638  if(jm25njets>3) {
639  _JM25njets ->Fill(jm25njets);
640  _JM25ht ->Fill(jm25HT);
641  _JM25pt1 ->Fill(jm25pt1);
642  _JM25pt2 ->Fill(jm25pt2);
643  _JM25pt3 ->Fill(jm25pt3);
644  _JM25pt4 ->Fill(jm25pt4);
645  }
646  if(jm80njets>3) {
647  _JM80njets ->Fill(jm80njets);
648  _JM80ht ->Fill(jm80HT);
649  _JM80pt1 ->Fill(jm80pt1);
650  _JM80pt2 ->Fill(jm80pt2);
651  _JM80pt3 ->Fill(jm80pt3);
652  _JM80pt4 ->Fill(jm80pt4);
653  }
654  }
655 
656  // select a di-jet event JME-10-001 variant
657  double sumJetEt = 0; double sumPartPt = 0.; double sumChPartPt = 0.;
658  double jpx = 0; double jpy = 0;
659  if ( nJets >= 2 && ij1 != genJets->end() && ij2 != genJets->end() ) {
660  if ( (*ij1).pt() > 25. && (*ij1).pt() > 25. ) {
661  double deltaPhi = std::fabs((*ij1).phi()-(*ij2).phi())/CLHEP::degree;
662  if ( deltaPhi > 180. ) deltaPhi = 360.-deltaPhi;
663  pt1pt2Dphi->Fill(deltaPhi);
664  if ( std::fabs(deltaPhi) > 2.5*CLHEP::degree ) {
665 
666  nDijet->Fill(0.5);
667 
668  for (unsigned int i = 0; i < hepmcGPCollection.size(); i++ ){
669  double eta = hepmcGPCollection[i]->momentum().eta();
670  unsigned int iBin = getHFbin(eta);
671  if ( !isNeutrino(i) && iBin < CaloCellManager::nForwardEta ) {
672  hfDJ[iBin] += hepmcGPCollection[i]->momentum().rho();
673  }
674  if ( !isNeutrino(i) && std::fabs(eta) < 5. ) {
675  sumPartPt += hepmcGPCollection[i]->momentum().perp();
676  if ( isCharged(i) ) {
677  sumChPartPt += hepmcGPCollection[i]->momentum().perp();
678  }
679  }
680  }
681  for (unsigned int i = 0; i < CaloCellManager::nForwardEta; i++ ) {
683  dEdetaHFdj->Fill(i+0.5,hfDJ[i]/binW);
684  }
685 
686  double invMass = (*ij1).energy()*(*ij2).energy()-(*ij1).px()*(*ij2).px()-(*ij1).py()*(*ij2).py()-(*ij1).pz()*(*ij2).pz();
687  invMass = std::sqrt(invMass);
688  pt1pt2InvM->Fill(invMass);
689 
690  sumPt->Fill(sumPartPt);
691  sumChPt->Fill(sumChPartPt);
692 
693  unsigned int nSelJets = 0;
694  for (reco::GenJetCollection::const_iterator iter=genJets->begin();iter!=genJets->end();++iter){
695  double pt = (*iter).pt();
696  double eta = (*iter).eta();
697  if ( std::fabs(eta) < 5. ) {
698  nSelJets++;
699  binW = dNjdeta->getTH1()->GetBinWidth(1);
700  dNjdeta->Fill(eta,1./binW);
701  binW = dNjdpt->getTH1()->GetBinWidth(1);
702  dNjdpt->Fill(pt,1./binW);
703  sumJetEt += (*iter).pt();
704  jpx += (*iter).px();
705  jpy += (*iter).py();
706  }
707  }
708 
709  nj->Fill(nSelJets);
710  double mEt = std::sqrt(jpx*jpx+jpy*jpy);
711  sumJEt->Fill(sumJetEt);
712  missEtosumJEt->Fill(mEt/sumJetEt);
713 
714  if ( nSelJets >= 3 ) { pt3Frac->Fill((*ij3).pt()/(pt1+pt2)); }
715 
716  pt1pt2optot->Fill(pt1+pt2,(pt1+pt2)/sumJetEt);
717  pt1pt2balance->Fill((pt1-pt2)/(pt1+pt2));
718  }
719  }
720  }
721  }
722 
723 
724  //compute differential jet rates
725  std::vector<const HepMC::GenParticle*> qcdActivity;
726  HepMCValidationHelper::removeIsolatedLeptons(myGenEvent, 0.2, 3., qcdActivity);
727  //HepMCValidationHelper::allStatus1(myGenEvent, qcdActivity);
728  //fill PseudoJets to use fastjet
729  std::vector<fastjet::PseudoJet> vecs;
730  int counterUser = 1;
731  std::vector<const HepMC::GenParticle*>::const_iterator iqcdact;
732  for (iqcdact = qcdActivity.begin(); iqcdact != qcdActivity.end(); ++iqcdact){
733  const HepMC::FourVector& fmom = (*iqcdact)->momentum();
734  fastjet::PseudoJet pseudoJet(fmom.px(), fmom.py(), fmom.pz(), fmom.e());
735  pseudoJet.set_user_index(counterUser);
736  vecs.push_back(pseudoJet);
737  ++counterUser;
738  }
739  //compute jets
740  fastjet::ClusterSequence cseq(vecs, fastjet::JetDefinition(fastjet::kt_algorithm, 1., fastjet::E_scheme));
741  //access the cluster sequence and get the relevant info
742  djr10->Fill(std::log10(sqrt(cseq.exclusive_dmerge(0))));
743  djr21->Fill(std::log10(sqrt(cseq.exclusive_dmerge(1))));
744  djr32->Fill(std::log10(sqrt(cseq.exclusive_dmerge(2))));
745  djr43->Fill(std::log10(sqrt(cseq.exclusive_dmerge(3))));
746 
747 
748  // compute sumEt for all stable particles
749  std::vector<const HepMC::GenParticle*> allStable;
750  HepMCValidationHelper::allStatus1(myGenEvent, allStable);
751 
752  double sumEt = 0.;
753  double sumEt1 = 0.;
754  double sumEt2 = 0.;
755  double sumEt3 = 0.;
756  double sumEt4 = 0.;
757  double sumEt5 = 0.;
758 
759  for(std::vector<const HepMC::GenParticle*>::const_iterator iter=allStable.begin();
760  iter != allStable.end(); ++iter) {
761 
762  double thisEta=fabs((*iter)->momentum().eta());
763 
764  if(thisEta < 5.) {
765  const HepMC::FourVector mom=(*iter)->momentum();
766  double px=mom.px();
767  double py=mom.py();
768  double pz=mom.pz();
769  double E=mom.e();
770  double thisSumEt = (
771  sqrt(px*px + py*py)*E /
772  sqrt(px*px + py*py + pz*pz)
773  );
774  sumEt += thisSumEt;
775  if(thisEta<1.0) sumEt1 += thisSumEt;
776  else if(thisEta<2.0) sumEt2 += thisSumEt;
777  else if(thisEta<3.0) sumEt3 += thisSumEt;
778  else if(thisEta<4.0) sumEt4 += thisSumEt;
779  else sumEt5 += thisSumEt;
780 
781  }
782  }
783 
784  if(sumEt>0.)
785  _sumEt->Fill(sumEt);
786  if(sumEt1>0.)
787  _sumEt1->Fill(sumEt1);
788  if(sumEt2>0.)
789  _sumEt2->Fill(sumEt2);
790  if(sumEt3>0.)
791  _sumEt3->Fill(sumEt3);
792  if(sumEt4>0.)
793  _sumEt4->Fill(sumEt4);
794  if(sumEt5>0.)
795  _sumEt5->Fill(sumEt5);
796 
797  delete myGenEvent;
798 }//analyze
bool isCharged(unsigned int i)
MonitorElement * ncnobquark
int i
Definition: DBlmapReader.cc:9
double getThetaCell()
Definition: CaloCellId.cc:49
MonitorElement * nbquark
static const unsigned int nphiBin
std::vector< const HepMC::GenParticle * > hepmcGPCollection
status 1 GenParticle collection
MonitorElement * sptDenLpt
MonitorElement * leadTracketa
static const unsigned int nForwardEta
MonitorElement * leadTrackpt
double deltaPhi(float phi1, float phi2)
Definition: VectorUtil.h:30
static const unsigned int nBarrelCell
MonitorElement * dNchdpt1
#define abs(x)
Definition: mlp_lapack.h:159
MonitorElement * _JM80njets
void allStatus1(const HepMC::GenEvent *all, std::vector< const HepMC::GenParticle * > &status1)
MonitorElement * dNchjdeta
T eta() const
CaloCellManager * theCalo
manager of calorimetric cell structure
MonitorElement * dNchdeta1
static const unsigned int nEndcapEta
edm::InputTag genjetCollection_
double charge(const std::vector< uint8_t > &Ampls)
double getEtaMin() const
Definition: CaloCellId.h:26
MonitorElement * pt1pt2Dphi
MonitorElement * dNchdeta2
void Fill(long long x)
MonitorElement * _JM25njets
std::vector< double > hepmcCharge
bool isNeutrino(unsigned int i)
MonitorElement * pt1pt2InvM
edm::ESHandle< HepPDT::ParticleDataTable > fPDGTable
PDT table.
std::vector< double > getEtaRanges()
CaloCellId * getCellFromIndex(unsigned int id)
void removeIsolatedLeptons(const HepMC::GenEvent *all, double deltaR, double sumPt, std::vector< const HepMC::GenParticle * > &pruned)
MonitorElement * eneHFmSel
MonitorElement * nSaFwdTrig
MonitorElement * pt1pt2optot
MonitorElement * pt1pt2optotch
static const unsigned int nCaloCell
MonitorElement * leadChjpt
T sqrt(T t)
Definition: SSEVec.h:28
Cos< T >::type cos(const T &t)
Definition: Cos.h:22
MonitorElement * dNchdpt2
MonitorElement * nEvt1
QCD-09-010 analysis.
System getSubSys() const
Definition: CaloCellId.h:30
TH1 * getTH1(void) const
MonitorElement * dEdetaHFdj
std::vector< double > eneInCell
static const unsigned int nEndcapCell
MonitorElement * pt1pt2balance
edm::InputTag hepmcCollection_
HepPDT::ParticleData ParticleData
static const unsigned int nBarrelEta
bool getByLabel(InputTag const &tag, Handle< PROD > &result) const
Definition: Event.h:355
edm::InputTag genchjetCollection_
MonitorElement * leadChjeta
MonitorElement * nNoFwdTrig
MonitorElement * ncandbquark
unsigned int getHFbin(double eta)
bool isNeutral(unsigned int i)
T perp() const
Magnitude of transverse component.
MonitorElement * dEdetaHFmb
tuple cout
Definition: gather_cfg.py:41
MonitorElement * nChaDenLpt
unsigned int getCellIndexFromAngle(double eta, double phi)
Definition: DDAxes.h:10
MonitorElement * missEtosumJEt
void MBUEandQCDValidation::beginJob ( void  )
virtual

Setting the DQM top directories

Booking the ME's

Reimplemented from edm::EDAnalyzer.

Definition at line 45 of file MBUEandQCDValidation.cc.

References _JM25ht, _JM25njets, _JM25pt1, _JM25pt2, _JM25pt3, _JM25pt4, _JM80ht, _JM80njets, _JM80pt1, _JM80pt2, _JM80pt3, _JM80pt4, _sumEt, _sumEt1, _sumEt2, _sumEt3, _sumEt4, _sumEt5, DQMStore::book1D(), DQMStore::bookProfile(), dbe, dEdetaHFdj, dEdetaHFmb, djr10, djr21, djr32, djr43, dNchdeta1, dNchdeta2, dNchdphi, dNchdpt1, dNchdpt2, dNchdSpt, dNchjdeta, dNchjdpt, dNjdeta, dNjdpt, dSptdphi, elePt, EmpzHFm, eneHFmSel, leadChjeta, leadChjpt, leadTracketa, leadTrackpt, missEtosumJEt, muoPt, nbquark, ncandbquark, nCha, nChaDenLpt, nChj, ncnobquark, nDijet, nEvt, nEvt1, nEvt2, CaloCellManager::nForwardEta, nGamma, nHFflow, nHFSD, nj, nK0s, nKpm, nL0, nNNbar, nNoFwdTrig, nOmega, nphiBin, nPPbar, nSaFwdTrig, ntHFm, nXim, pGamma, pK0s, pKpm, pL0, pNNbar, pOmega, pPPbar, pt1pt2balance, pt1pt2Dphi, pt1pt2InvM, pt1pt2optot, pt1pt2optotch, pt3Frac, pXim, DQMStore::setCurrentFolder(), sptDenLpt, sumChPt, sumJEt, and sumPt.

46 {
47  if(dbe){
49  dbe->setCurrentFolder("Generator/MBUEandQCD");
50 
52 
53  // Number of analyzed events
54  nEvt = dbe->book1D("nEvt", "n analyzed Events", 1, 0., 1.);
55 
56  // Number of events with no forward trigger
57  nNoFwdTrig = dbe->book1D("nNoFwdTrig", "n Events no forward trigger", 1, 0., 1.);
58 
59  // Number of events with a single arm forward trigger
60  nSaFwdTrig = dbe->book1D("nSaFwdTrig", "n Events single arm forward trigger", 1, 0., 1.);
61 
62  // Number of events with b quark
63  nbquark = dbe->book1D("nbquark", "n Events with b quark", 1, 0., 1.);
64 
65  // Number of events with c and b quark
66  ncandbquark = dbe->book1D("ncandbquark", "n Events with c and b quark", 1, 0., 1.);
67 
68  // Number of events with c and no b quark
69  ncnobquark = dbe->book1D("ncnobquark", "n Events with c and no b quark", 1, 0., 1.);
70 
71 
72  // Number of selected events for QCD-09-010
73  nEvt1 = dbe->book1D("nEvt1", "n Events QCD-09-010", 1, 0., 1.);
74  // dNchdpt QCD-09-010
75  dNchdpt1 = dbe->book1D("dNchdpt1", "dNchdpt QCD-09-010", 30, 0., 6.);
76  // dNchdeta QCD-09-010
77  dNchdeta1 = dbe->book1D("dNchdeta1", "dNchdeta QCD-09-010", 10, -2.5, 2.5);
78  // Number of selected events for QCD-10-001
79 
80  nEvt2 = dbe->book1D("nEvt2", "n Events QCD-10-001", 1, 0., 1.);
81  // Leading track pt QCD-10-001
82  leadTrackpt = dbe->book1D("leadTrackpt", "leading track pt QCD-10-001", 200, 0., 100.);
83  // Leading track eta QCD-10-001
84  leadTracketa = dbe->book1D("leadTracketa", "leading track eta QCD-10-001", 50., -2.5,2.5);
85  // transverse charged particle density vs leading track pt
86  nChaDenLpt = dbe->bookProfile("nChaDenLpt", "charged density vs leading pt", 200, 0., 100., 0., 100., " ");
87  // transverse charged particle density vs leading track pt
88  sptDenLpt = dbe->bookProfile("sptDenLpt", "sum pt density vs leading pt", 200, 0., 100., 0., 300., " ");
89  // dNchdpt QCD-10-001 transverse
90  dNchdpt2 = dbe->book1D("dNchdpt2", "dNchdpt QCD-10-001", 200, 0., 100.);
91  // dNchdeta QCD-10-001 transverse
92  dNchdeta2 = dbe->book1D("dNchdeta2", "dNchdeta QCD-10-001", 50, -2.5, 2.5);
93  // nCha QCD-10-001 transverse
94  nCha = dbe->book1D("nCha", "n charged QCD-10-001", 100, 0., 100.);
95  // dNchdSpt transverse
96  dNchdSpt = dbe->book1D("dNchdSpt", "dNchdSpt QCD-10-001", 300, 0., 300.);
97  // dNchdphi
98  dNchdphi = dbe->bookProfile("dNchdphi", "dNchdphi QCD-10-001", nphiBin, -180., 180., 0., 30., " ");
99  // dSptdphi
100  dSptdphi = dbe->bookProfile("dSptdphi", "dSptdphi QCD-10-001", nphiBin, -180., 180., 0., 30., " ");
101 
102  // number of charged jets QCD-10-001
103  nChj = dbe->book1D("nChj", "n charged jets QCD-10-001", 30, 0, 30.);
104  // dNchjdeta QCD-10-001
105  dNchjdeta = dbe->book1D("dNchjdeta", "dNchjdeta QCD-10-001", 50, -2.5, 2.5);
106  // dNchjdpt QCD-10-001
107  dNchjdpt = dbe->book1D("dNchjdpt", "dNchjdpt QCD-10-001", 100, 0., 100.);
108  // leading charged jet pt QCD-10-001
109  leadChjpt = dbe->book1D("leadChjpt", "leadChjpt QCD-10-001", 100, 0., 100.);
110  // leading charged jet eta QCD-10-001
111  leadChjeta = dbe->book1D("leadChjeta", "leadChjeta QCD-10-001", 50, -2.5, 2.5);
112  // (pt1+pt2)/ptot
113  pt1pt2optotch = dbe->bookProfile("pt1pt2optotch", "sum 2 leading jets over ptot", 50, 0., 100., 0., 1., " ");
114 
115  // particle rates in tracker acceptance
116  nPPbar = dbe->book1D("nPPbar", "nPPbar QCD-10-001", 30, 0., 30.);
117  nKpm = dbe->book1D("nKpm", "nKpm QCD-10-001", 30, 0., 30.);
118  nK0s = dbe->book1D("nK0s", "nK0s QCD-10-001", 30, 0., 30.);
119  nL0 = dbe->book1D("nL0", "nL0 QCD-10-001", 30, 0., 30.);
120  nXim = dbe->book1D("nXim", "nXim QCD-10-001", 30, 0., 30.);
121  nOmega = dbe->book1D("nOmega", "nOmega QCD-10-001", 30, 0., 30.);
122 
123  pPPbar = dbe->book1D("pPPbar", "Log10(pt) PPbar QCD-10-001", 25, -2., 3.);
124  pKpm = dbe->book1D("pKpm", "Log10(pt) Kpm QCD-10-001", 25, -2., 3.);
125  pK0s = dbe->book1D("pK0s", "Log10(pt) K0s QCD-10-001", 25, -2., 3.);
126  pL0 = dbe->book1D("pL0", "Log10(pt) L0 QCD-10-001", 25, -2., 3.);
127  pXim = dbe->book1D("pXim", "Log10(pt) Xim QCD-10-001", 25, -2., 3.);
128  pOmega = dbe->book1D("pOmega", "Log10(pt) Omega QCD-10-001", 25, -2., 3.);
129 
130  // neutral rate in the barrel + HF acceptance
131  nNNbar = dbe->book1D("nNNbar", "nNNbar QCD-10-001", 30, 0., 30.);
132  nGamma = dbe->book1D("nGamma", "nGamma QCD-10-001", 50, 0., 200.);
133 
134  pNNbar = dbe->book1D("pNNbar", "Log10(pt) NNbar QCD-10-001", 25, -2., 3.);
135  pGamma = dbe->book1D("pGamma", "Log10(pt) Gamma QCD-10-001", 25, -2., 3.);
136 
137  // highest pt electron spectrum
138  elePt = dbe->book1D("elePt", "highest pt electron Log10(pt)", 30, -2., 4.);
139 
140  // highest pt muon spectrum
141  muoPt = dbe->book1D("muoPt", "highest pt muon Log10(pt)", 30, -2., 4.);
142 
143 
144  // number of selected di-jet events
145  nDijet = dbe->book1D("nDijet", "n Dijet Events", 1, 0., 1.);
146  // number of jets
147  nj = dbe->book1D("nj", "n jets ", 30, 0, 30.);
148  // dNjdeta
149  dNjdeta = dbe->book1D("dNjdeta", "dNjdeta ", 50, -5., 5.);
150  // dNjdpt
151  dNjdpt = dbe->book1D("dNjdpt", "dNjdpt ", 60, 0., 300.);
152  // (pt1+pt2)/ptot
153  pt1pt2optot = dbe->bookProfile("pt1pt2optot", "sum 2 leading jets over Et tot ", 60, 0., 300., 0., 1., " ");
154  // pt1-pt2
155  pt1pt2balance = dbe->book1D("pt1pt2balance", "2 leading jets pt difference ", 10, 0., 1.);
156  // pt1 pt2 Delta phi
157  pt1pt2Dphi = dbe->book1D("pt1pt2Dphi", "pt1 pt2 delta phi ", nphiBin, 0., 180.);
158  // pt1 pt2 invariant mass
159  pt1pt2InvM = dbe->book1D("pt1pt2InvM", "pt1 pt2 invariant mass ", 60, 0., 600.);
160  // pt3 fraction
161  pt3Frac = dbe->book1D("pt3Frac", "2 pt3 over pt1+pt2 ", 30, 0., 1.);
162  // sum of jets Et
163  sumJEt = dbe->book1D("sumJEt", "sum Jet Et ", 60, 0., 300.);
164  // fraction of missing Et over sum of jets Et
165  missEtosumJEt = dbe->book1D("missEtosumJEt", "missing Et over sumJet Et ", 30, 0., 1.);
166  // sum of final state particle Pt
167  sumPt = dbe->book1D("sumPt", "sum particle Pt ", 60, 0., 600.);
168  // sum of final state charged particle Pt
169  sumChPt = dbe->book1D("sumChPt", "sum charged particle Pt ", 60, 0., 300.);
170 
171  //Number of selected events for the HF energy flux analysis
172  nHFflow = dbe->book1D("nHFflow", "n HF flow events", 1, 0., 1.);
173  //Forward energy flow for MinBias BSC selection
174  dEdetaHFmb = dbe->bookProfile("dEdetaHFmb", "dEdeta HF MinBias", (int)CaloCellManager::nForwardEta, 0, (double)CaloCellManager::nForwardEta, 0., 300., " ");
175  //Forward energy flow for QCD dijet selection
176  dEdetaHFdj = dbe->bookProfile("dEdetaHFdj", "dEdeta HF QCD dijet", (int)CaloCellManager::nForwardEta, 0, (double)CaloCellManager::nForwardEta, 0., 300., " ");
177 
178  // FWD-10-001 like diffraction analysis
179  nHFSD = dbe->book1D("nHFSD","n single diffraction in HF", 1, 0., 1.);
180  // E-pz HF-
181  EmpzHFm = dbe->book1D("EmpzHFm", "E-pz HF- SD", 40, 0., 200.);
182  // Number of cells above threshold
183  ntHFm = dbe->book1D("ntHFm", "number of HF- tower SD", 20, 0., 20.);
184  // Energy in HF-
185  eneHFmSel = dbe->book1D("eneHFmSel", "energy in HF-", 40, 0., 200.);
186 
187  // number of jets accepted in the 'Jet-Multiplicity' analysis
188  _JM25njets = dbe->book1D("JM25njets", "n jets", 15, 0, 15.);
189  _JM25ht = dbe->book1D("JM25ht", "HT", 80, 0, 800.);
190  _JM25pt1 = dbe->book1D("JM25pt1", "pt", 40, 0, 200.);
191  _JM25pt2 = dbe->book1D("JM25pt2", "pt", 40, 0, 200.);
192  _JM25pt3 = dbe->book1D("JM25pt3", "pt", 40, 0, 200.);
193  _JM25pt4 = dbe->book1D("JM25pt4", "pt", 40, 0, 200.);
194 
195  _JM80njets = dbe->book1D("JM80njets", "n jets", 15, 0, 15.);
196  _JM80ht = dbe->book1D("JM80ht", "HT", 80, 300, 1100.);
197  _JM80pt1 = dbe->book1D("JM80pt1", "pt", 40, 60, 260.);
198  _JM80pt2 = dbe->book1D("JM80pt2", "pt", 40, 60, 260.);
199  _JM80pt3 = dbe->book1D("JM80pt3", "pt", 40, 60, 260.);
200  _JM80pt4 = dbe->book1D("JM80pt4", "pt", 40, 60, 260.);
201 
202 
203  // differential jet rates
204  djr10 = dbe->book1D("djr10", "Differential Jet Rate 1#rightarrow0", 60, -1., 5.);
205  djr21 = dbe->book1D("djr21", "Differential Jet Rate 2#rightarrow1", 60, -1., 5.);
206  djr32 = dbe->book1D("djr32", "Differential Jet Rate 3#rightarrow2", 60, -1., 5.);
207  djr43 = dbe->book1D("djr43", "Differential Jet Rate 4#rightarrow3", 60, -1., 5.);
208 
209  // sumET analysis
210  _sumEt = dbe->book1D("sumET", "Sum of stable particles Et", 150, 0, 600.);
211  _sumEt1 = dbe->book1D("sumET1", "Sum of stable particles Et (eta<0.5)", 150, 0, 200.);
212  _sumEt2 = dbe->book1D("sumET2", "Sum of stable particles Et (0.5<eta<1.0)", 150, 0, 200.);
213  _sumEt3 = dbe->book1D("sumET3", "Sum of stable particles Et (1.0<eta<1.5)", 150, 0, 200.);
214  _sumEt4 = dbe->book1D("sumET4", "Sum of stable particles Et (1.5<eta<2.0)", 150, 0, 200.);
215  _sumEt5 = dbe->book1D("sumET5", "Sum of stable particles Et (2.0<eta<5.0)", 150, 0, 200.);
216 
217 
218  }
219  return;
220 }
MonitorElement * ncnobquark
MonitorElement * nbquark
static const unsigned int nphiBin
MonitorElement * book1D(const char *name, const char *title, int nchX, double lowX, double highX)
Book 1D histogram.
Definition: DQMStore.cc:514
MonitorElement * sptDenLpt
MonitorElement * leadTracketa
static const unsigned int nForwardEta
MonitorElement * leadTrackpt
MonitorElement * dNchdpt1
MonitorElement * _JM80njets
DQMStore * dbe
ME&#39;s &quot;container&quot;.
MonitorElement * dNchjdeta
MonitorElement * dNchdeta1
MonitorElement * pt1pt2Dphi
MonitorElement * dNchdeta2
MonitorElement * _JM25njets
MonitorElement * pt1pt2InvM
MonitorElement * eneHFmSel
MonitorElement * nSaFwdTrig
MonitorElement * pt1pt2optot
MonitorElement * pt1pt2optotch
MonitorElement * leadChjpt
MonitorElement * dNchdpt2
MonitorElement * nEvt1
QCD-09-010 analysis.
MonitorElement * bookProfile(const char *name, const char *title, int nchX, double lowX, double highX, int nchY, double lowY, double highY, const char *option="s")
Definition: DQMStore.cc:828
MonitorElement * dEdetaHFdj
MonitorElement * pt1pt2balance
MonitorElement * leadChjeta
MonitorElement * nNoFwdTrig
MonitorElement * ncandbquark
MonitorElement * dEdetaHFmb
MonitorElement * nChaDenLpt
void setCurrentFolder(const std::string &fullpath)
Definition: DQMStore.cc:232
MonitorElement * missEtosumJEt
void MBUEandQCDValidation::beginRun ( const edm::Run iRun,
const edm::EventSetup iSetup 
)
virtual

Get PDT Table

Reimplemented from edm::EDAnalyzer.

Definition at line 223 of file MBUEandQCDValidation.cc.

References fPDGTable, and edm::EventSetup::getData().

223  {
225  iSetup.getData( fPDGTable );
226  return;
227 }
void getData(T &iHolder) const
Definition: EventSetup.h:67
edm::ESHandle< HepPDT::ParticleDataTable > fPDGTable
PDT table.
void MBUEandQCDValidation::endJob ( void  )
virtual

Reimplemented from edm::EDAnalyzer.

Definition at line 222 of file MBUEandQCDValidation.cc.

222 {return;}
void MBUEandQCDValidation::endRun ( const edm::Run iRun,
const edm::EventSetup iSetup 
)
virtual

Reimplemented from edm::EDAnalyzer.

Definition at line 228 of file MBUEandQCDValidation.cc.

228 {return;}
unsigned int MBUEandQCDValidation::getHFbin ( double  eta)
private

Definition at line 829 of file MBUEandQCDValidation.cc.

References CaloCellManager::getEtaRanges(), i, CaloCellManager::nBarrelEta, CaloCellManager::nEndcapEta, CaloCellManager::nForwardEta, and theCalo.

Referenced by analyze().

829  {
830 
831  unsigned int iBin = 999;
832 
833  std::vector<double> theEtaRanges(theCalo->getEtaRanges());
834 
837  if ( std::fabs(eta) >= theEtaRanges[i] && std::fabs(eta) < theEtaRanges[i+1] )
839  }
840 
841  return iBin;
842 
843 }
int i
Definition: DBlmapReader.cc:9
static const unsigned int nForwardEta
T eta() const
CaloCellManager * theCalo
manager of calorimetric cell structure
static const unsigned int nEndcapEta
std::vector< double > getEtaRanges()
static const unsigned int nBarrelEta
bool MBUEandQCDValidation::isCharged ( unsigned int  i)
private

Definition at line 800 of file MBUEandQCDValidation.cc.

References hepmcCharge, hepmcGPCollection, i, and ntuplemaker::status.

Referenced by analyze().

800  {
801 
802  bool status = false;
803  if ( hepmcGPCollection.size() < i+1 ) { return status; }
804  else { status = (hepmcCharge[i] != 0. && hepmcCharge[i] != -999.); }
805  return status;
806 
807 }
int i
Definition: DBlmapReader.cc:9
std::vector< const HepMC::GenParticle * > hepmcGPCollection
status 1 GenParticle collection
std::vector< double > hepmcCharge
tuple status
Definition: ntuplemaker.py:245
bool MBUEandQCDValidation::isNeutral ( unsigned int  i)
private

Definition at line 809 of file MBUEandQCDValidation.cc.

References abs, hepmcCharge, hepmcGPCollection, i, benchmark_cfg::pdgId, and ntuplemaker::status.

Referenced by analyze().

809  {
810 
811  bool status = false;
812  int pdgId = std::abs(hepmcGPCollection[i]->pdg_id());
813  if ( hepmcGPCollection.size() < i+1 ) { return status; }
814  else { status = (hepmcCharge[i] == 0. && pdgId != 12 && pdgId != 14 && pdgId != 16) ; }
815  return status;
816 
817 }
int i
Definition: DBlmapReader.cc:9
std::vector< const HepMC::GenParticle * > hepmcGPCollection
status 1 GenParticle collection
#define abs(x)
Definition: mlp_lapack.h:159
std::vector< double > hepmcCharge
tuple status
Definition: ntuplemaker.py:245
bool MBUEandQCDValidation::isNeutrino ( unsigned int  i)
private

Definition at line 819 of file MBUEandQCDValidation.cc.

References abs, hepmcGPCollection, benchmark_cfg::pdgId, and ntuplemaker::status.

Referenced by analyze().

819  {
820 
821  bool status = false;
822  int pdgId = std::abs(hepmcGPCollection[i]->pdg_id());
823  if ( hepmcGPCollection.size() < i+1 ) { return status; }
824  else { status = (pdgId == 12 || pdgId == 14 || pdgId == 16) ; }
825  return status;
826 
827 }
int i
Definition: DBlmapReader.cc:9
std::vector< const HepMC::GenParticle * > hepmcGPCollection
status 1 GenParticle collection
#define abs(x)
Definition: mlp_lapack.h:159
tuple status
Definition: ntuplemaker.py:245

Member Data Documentation

MonitorElement* MBUEandQCDValidation::_JM25ht
private

Definition at line 164 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::_JM25njets
private

Definition at line 163 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::_JM25pt1
private

Definition at line 165 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::_JM25pt2
private

Definition at line 166 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::_JM25pt3
private

Definition at line 167 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::_JM25pt4
private

Definition at line 168 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::_JM80ht
private

Definition at line 170 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::_JM80njets
private

Definition at line 169 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::_JM80pt1
private

Definition at line 171 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::_JM80pt2
private

Definition at line 172 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::_JM80pt3
private

Definition at line 173 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::_JM80pt4
private

Definition at line 174 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::_sumEt
private

Definition at line 180 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::_sumEt1
private

Definition at line 181 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::_sumEt2
private

Definition at line 182 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::_sumEt3
private

Definition at line 183 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::_sumEt4
private

Definition at line 184 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::_sumEt5
private

Definition at line 185 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

DQMStore* MBUEandQCDValidation::dbe
private

ME's "container".

Definition at line 77 of file MBUEandQCDValidation.h.

Referenced by beginJob(), and MBUEandQCDValidation().

MonitorElement* MBUEandQCDValidation::dEdetaHFdj
private

Definition at line 155 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::dEdetaHFmb
private

Definition at line 154 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::djr10
private

Definition at line 177 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement * MBUEandQCDValidation::djr21
private

Definition at line 177 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement * MBUEandQCDValidation::djr32
private

Definition at line 177 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement * MBUEandQCDValidation::djr43
private

Definition at line 177 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::dNchdeta1
private

Definition at line 91 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::dNchdeta2
private

Definition at line 97 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::dNchdphi
private

Definition at line 101 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::dNchdpt1
private

Definition at line 90 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::dNchdpt2
private

Definition at line 98 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::dNchdSpt
private

Definition at line 100 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::dNchjdeta
private

Definition at line 108 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::dNchjdpt
private

Definition at line 109 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::dNjdeta
private

Definition at line 140 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::dNjdpt
private

Definition at line 141 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::dSptdphi
private

Definition at line 102 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::elePt
private

Definition at line 134 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::EmpzHFm
private

Definition at line 158 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::eneHFmSel
private

Definition at line 160 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

std::vector<double> MBUEandQCDValidation::eneInCell
private

Definition at line 74 of file MBUEandQCDValidation.h.

Referenced by analyze(), and MBUEandQCDValidation().

edm::ESHandle<HepPDT::ParticleDataTable> MBUEandQCDValidation::fPDGTable
private

PDT table.

Definition at line 59 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginRun().

edm::InputTag MBUEandQCDValidation::genchjetCollection_
private

Definition at line 53 of file MBUEandQCDValidation.h.

Referenced by analyze().

edm::InputTag MBUEandQCDValidation::genjetCollection_
private

Definition at line 54 of file MBUEandQCDValidation.h.

Referenced by analyze().

std::vector<double> MBUEandQCDValidation::hepmcCharge
private

Definition at line 63 of file MBUEandQCDValidation.h.

Referenced by analyze(), isCharged(), isNeutral(), and MBUEandQCDValidation().

edm::InputTag MBUEandQCDValidation::hepmcCollection_
private

Definition at line 52 of file MBUEandQCDValidation.h.

Referenced by analyze().

std::vector<const HepMC::GenParticle*> MBUEandQCDValidation::hepmcGPCollection
private

status 1 GenParticle collection

Definition at line 62 of file MBUEandQCDValidation.h.

Referenced by analyze(), isCharged(), isNeutral(), isNeutrino(), and MBUEandQCDValidation().

const unsigned int MBUEandQCDValidation::initSize = 1000
staticprivate

Definition at line 190 of file MBUEandQCDValidation.h.

Referenced by MBUEandQCDValidation().

MonitorElement* MBUEandQCDValidation::leadChjeta
private

Definition at line 111 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::leadChjpt
private

Definition at line 110 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::leadTracketa
private

Definition at line 96 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::leadTrackpt
private

Definition at line 95 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::missEtosumJEt
private

Definition at line 148 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::muoPt
private

Definition at line 135 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::nbquark
private

Definition at line 84 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::ncandbquark
private

Definition at line 85 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::nCha
private

Definition at line 99 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::nChaDenLpt
private

Definition at line 103 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::nChj
private

Definition at line 107 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::ncnobquark
private

Definition at line 86 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::nDijet
private

Definition at line 138 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::nEvt
private

Definition at line 79 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::nEvt1
private

QCD-09-010 analysis.

Definition at line 89 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::nEvt2
private

Definition at line 94 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::nGamma
private

Definition at line 120 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::nHFflow
private

Definition at line 153 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::nHFSD
private

Definition at line 157 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::nj
private

Definition at line 139 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::nK0s
private

Definition at line 117 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::nKpm
private

Definition at line 116 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::nL0
private

Definition at line 118 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::nNNbar
private

Definition at line 119 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::nNoFwdTrig
private

Definition at line 81 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::nOmega
private

Definition at line 122 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

const unsigned int MBUEandQCDValidation::nphiBin = 36
staticprivate

Definition at line 188 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::nPPbar
private

Definition at line 115 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::nSaFwdTrig
private

Definition at line 82 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::ntHFm
private

Definition at line 159 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::nXim
private

Definition at line 121 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::pGamma
private

Definition at line 130 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::pK0s
private

Definition at line 127 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::pKpm
private

Definition at line 126 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::pL0
private

Definition at line 128 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::pNNbar
private

Definition at line 129 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::pOmega
private

Definition at line 132 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::pPPbar
private

Definition at line 125 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::pt1pt2balance
private

Definition at line 143 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::pt1pt2Dphi
private

Definition at line 144 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::pt1pt2InvM
private

Definition at line 145 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::pt1pt2optot
private

Definition at line 142 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::pt1pt2optotch
private

Definition at line 112 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::pt3Frac
private

Definition at line 146 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::pXim
private

Definition at line 131 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::sptDenLpt
private

Definition at line 104 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::sumChPt
private

Definition at line 150 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::sumJEt
private

Definition at line 147 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

MonitorElement* MBUEandQCDValidation::sumPt
private

Definition at line 149 of file MBUEandQCDValidation.h.

Referenced by analyze(), and beginJob().

CaloCellManager* MBUEandQCDValidation::theCalo
private

manager of calorimetric cell structure

Definition at line 66 of file MBUEandQCDValidation.h.

Referenced by analyze(), getHFbin(), MBUEandQCDValidation(), and ~MBUEandQCDValidation().

unsigned int MBUEandQCDValidation::verbosity_
private

Definition at line 56 of file MBUEandQCDValidation.h.

Referenced by analyze(), and MBUEandQCDValidation().