CMS 3D CMS Logo

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

#include <RecoHI/EvtPlaneProducer/src/EvtPlaneProducer.cc>

Inheritance diagram for EvtPlaneProducer:
edm::stream::EDProducer<>

Public Member Functions

 EvtPlaneProducer (const edm::ParameterSet &)
 
 ~EvtPlaneProducer () override
 
- Public Member Functions inherited from edm::stream::EDProducer<>
 EDProducer ()=default
 
bool hasAbilityToProduceInBeginLumis () const final
 
bool hasAbilityToProduceInBeginProcessBlocks () const final
 
bool hasAbilityToProduceInBeginRuns () const final
 
bool hasAbilityToProduceInEndLumis () const final
 
bool hasAbilityToProduceInEndProcessBlocks () const final
 
bool hasAbilityToProduceInEndRuns () const final
 

Private Member Functions

void fillCastor (const TrackStructure &track, double vz, int bin)
 
void fillHF (const TrackStructure &track, double vz, int bin)
 
void fillTracker (const TrackStructure &track, double vz, int bin)
 
bool passEta (float eta, int i)
 
void produce (edm::Event &, const edm::EventSetup &) override
 

Private Attributes

bool bScalo_particleFlow_
 
bool bStrack_packedPFCandidates_
 
double caloCentRef_
 
double caloCentRefWidth_
 
edm::Handle< CaloTowerCollectioncaloCollection_
 
edm::InputTag caloTag_
 
edm::EDGetTokenT< CaloTowerCollectioncaloToken_
 
edm::EDGetTokenT< reco::PFCandidateCollectioncaloTokenPF_
 
edm::Handle< std::vector< reco::CastorTower > > castorCollection_
 
edm::InputTag castorTag_
 
edm::EDGetTokenT< std::vector< reco::CastorTower > > castorToken_
 
int CentBinCompression_
 
edm::InputTag centralityBinTag_
 
edm::EDGetTokenT< int > centralityBinToken_
 
std::string centralityLabel_
 
std::string centralityMC_
 
std::string centralityVariable_
 
double chi2_
 
edm::InputTag chi2MapLostTag_
 
edm::EDGetTokenT< edm::ValueMap< float > > chi2MapLostToken_
 
edm::InputTag chi2MapTag_
 
edm::EDGetTokenT< edm::ValueMap< float > > chi2MapToken_
 
double chi2perlayer_
 
int cutEra_
 
EPCuts cuts_
 
double d0d0error_
 
double dzdzerror_
 
double dzdzerror_pix_
 
double dzerr_
 
HiEvtPlaneFlattenflat [NumEPNames]
 
double flatdelvtx_
 
double flatminvtx_
 
int flatnvtxbins_
 
int FlatOrder_
 
edm::ESWatcher< HeavyIonRPRcdhirpWatcher_
 
edm::ESWatcher< HeavyIonRcdhiWatcher_
 
bool loadDB_
 
edm::EDGetTokenT< pat::PackedCandidateCollectionlostToken_
 
edm::InputTag losttrackTag_
 
double maxet_
 
double maxpt_
 
double minet_
 
double minpt_
 
double nCentBins_
 
int nhitsValid_
 
int NumFlatBins_
 
edm::EDGetTokenT< pat::PackedCandidateCollectionpackedToken_
 
double pterror_
 
GenPlanerp [NumEPNames]
 
TrackStructure track_
 
edm::Handle< reco::TrackCollectiontrackCollection_
 
edm::InputTag trackTag_
 
edm::EDGetTokenT< reco::TrackCollectiontrackToken_
 
edm::Handle< std::vector< reco::Vertex > > vertex_
 
edm::InputTag vertexTag_
 
edm::EDGetTokenT< std::vector< reco::Vertex > > vertexToken_
 

Additional Inherited Members

- Public Types inherited from edm::stream::EDProducer<>
typedef CacheContexts< T... > CacheTypes
 
typedef CacheTypes::GlobalCache GlobalCache
 
typedef AbilityChecker< T... > HasAbility
 
typedef CacheTypes::LuminosityBlockCache LuminosityBlockCache
 
typedef LuminosityBlockContextT< LuminosityBlockCache, RunCache, GlobalCacheLuminosityBlockContext
 
typedef CacheTypes::LuminosityBlockSummaryCache LuminosityBlockSummaryCache
 
typedef CacheTypes::RunCache RunCache
 
typedef RunContextT< RunCache, GlobalCacheRunContext
 
typedef CacheTypes::RunSummaryCache RunSummaryCache
 

Detailed Description

Description: <one line="" class="" summary>="">

Implementation: <Notes on="" implementation>="">

Definition at line 168 of file EvtPlaneProducer.cc.

Constructor & Destructor Documentation

◆ EvtPlaneProducer()

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

Definition at line 344 of file EvtPlaneProducer.cc.

345  : centralityVariable_(iConfig.getParameter<std::string>("centralityVariable")),
346  centralityBinTag_(iConfig.getParameter<edm::InputTag>("centralityBinTag")),
347  vertexTag_(iConfig.getParameter<edm::InputTag>("vertexTag")),
348  caloTag_(iConfig.getParameter<edm::InputTag>("caloTag")),
349  castorTag_(iConfig.getParameter<edm::InputTag>("castorTag")),
350  trackTag_(iConfig.getParameter<edm::InputTag>("trackTag")),
351  losttrackTag_(iConfig.getParameter<edm::InputTag>("lostTag")),
352  chi2MapTag_(iConfig.getParameter<edm::InputTag>("chi2MapTag")),
353  chi2MapLostTag_(iConfig.getParameter<edm::InputTag>("chi2MapLostTag")),
354  loadDB_(iConfig.getParameter<bool>("loadDB")),
355  minet_(iConfig.getParameter<double>("minet")),
356  maxet_(iConfig.getParameter<double>("maxet")),
357  minpt_(iConfig.getParameter<double>("minpt")),
358  maxpt_(iConfig.getParameter<double>("maxpt")),
359  flatnvtxbins_(iConfig.getParameter<int>("flatnvtxbins")),
360  flatminvtx_(iConfig.getParameter<double>("flatminvtx")),
361  flatdelvtx_(iConfig.getParameter<double>("flatdelvtx")),
362  dzdzerror_(iConfig.getParameter<double>("dzdzerror")),
363  d0d0error_(iConfig.getParameter<double>("d0d0error")),
364  pterror_(iConfig.getParameter<double>("pterror")),
365  chi2perlayer_(iConfig.getParameter<double>("chi2perlayer")),
366  dzdzerror_pix_(iConfig.getParameter<double>("dzdzerror_pix")),
367  chi2_(iConfig.getParameter<double>("chi2")),
368  nhitsValid_(iConfig.getParameter<int>("nhitsValid")),
369  FlatOrder_(iConfig.getParameter<int>("FlatOrder")),
370  NumFlatBins_(iConfig.getParameter<int>("NumFlatBins")),
371  caloCentRef_(iConfig.getParameter<double>("caloCentRef")),
372  caloCentRefWidth_(iConfig.getParameter<double>("caloCentRefWidth")),
373  CentBinCompression_(iConfig.getParameter<int>("CentBinCompression")),
374  cutEra_(iConfig.getParameter<int>("cutEra"))
375 
376 {
377  if (cutEra_ > 3)
378  throw edm::Exception(edm::errors::Configuration) << "wrong range in cutEra parameter";
379  cuts_ = EPCuts(
381  nCentBins_ = 200.;
382 
383  if (iConfig.exists("nonDefaultGlauberModel")) {
384  centralityMC_ = iConfig.getParameter<std::string>("nonDefaultGlauberModel");
385  }
387 
388  centralityBinToken_ = consumes<int>(centralityBinTag_);
389 
390  vertexToken_ = consumes<std::vector<reco::Vertex>>(vertexTag_);
391 
392  bStrack_packedPFCandidates_ = (trackTag_.label().find("packedPFCandidates") != std::string::npos);
393  bScalo_particleFlow_ = (caloTag_.label().find("particleFlow") != std::string::npos);
395  packedToken_ = consumes<pat::PackedCandidateCollection>(trackTag_);
396  lostToken_ = consumes<pat::PackedCandidateCollection>(losttrackTag_);
397  chi2MapToken_ = consumes<edm::ValueMap<float>>(chi2MapTag_);
398  chi2MapLostToken_ = consumes<edm::ValueMap<float>>(chi2MapLostTag_);
399 
400  } else {
401  if (bScalo_particleFlow_) {
402  caloTokenPF_ = consumes<reco::PFCandidateCollection>(caloTag_);
403  } else {
404  caloToken_ = consumes<CaloTowerCollection>(caloTag_);
405  }
406  castorToken_ = consumes<std::vector<reco::CastorTower>>(castorTag_);
407  trackToken_ = consumes<reco::TrackCollection>(trackTag_);
408  }
409 
410  produces<reco::EvtPlaneCollection>();
411  for (int i = 0; i < NumEPNames; i++) {
413  }
414  for (int i = 0; i < NumEPNames; i++) {
415  flat[i] = new HiEvtPlaneFlatten();
417  }
418 }

References bScalo_particleFlow_, bStrack_packedPFCandidates_, caloTag_, caloToken_, caloTokenPF_, castorTag_, castorToken_, centralityBinTag_, centralityBinToken_, centralityLabel_, centralityMC_, centralityVariable_, chi2_, chi2MapLostTag_, chi2MapLostToken_, chi2MapTag_, chi2MapToken_, chi2perlayer_, edm::errors::Configuration, cutEra_, cuts_, d0d0error_, dzdzerror_, dzdzerror_pix_, hi::EPEtaMax1, hi::EPEtaMax2, hi::EPEtaMin1, hi::EPEtaMin2, hi::EPNames, hi::EPOrder, Exception, edm::ParameterSet::exists(), flat, flatdelvtx_, flatminvtx_, flatnvtxbins_, FlatOrder_, edm::ParameterSet::getParameter(), mps_fire::i, HiEvtPlaneFlatten::init(), edm::InputTag::label(), lostToken_, losttrackTag_, nCentBins_, nhitsValid_, hi::NumEPNames, NumFlatBins_, packedToken_, pterror_, rp, AlCaHLTBitMon_QueryRunRegistry::string, trackTag_, trackToken_, vertexTag_, and vertexToken_.

◆ ~EvtPlaneProducer()

EvtPlaneProducer::~EvtPlaneProducer ( )
override

Definition at line 420 of file EvtPlaneProducer.cc.

420  {
421  // do anything here that needs to be done at desctruction time
422  // (e.g. close files, deallocate resources etc.)
423  for (int i = 0; i < NumEPNames; i++) {
424  delete flat[i];
425  }
426 }

References flat, mps_fire::i, and hi::NumEPNames.

Member Function Documentation

◆ fillCastor()

void EvtPlaneProducer::fillCastor ( const TrackStructure track,
double  vz,
int  bin 
)
inlineprivate

Definition at line 272 of file EvtPlaneProducer.cc.

272  {
273  double minet = minet_;
274  double maxet = maxet_;
275  for (int i = 0; i < NumEPNames; i++) {
276  if (EPDet[i] == Castor) {
277  if (minet_ < 0)
278  minet = minTransverse[i];
279  if (maxet_ < 0)
280  maxet = maxTransverse[i];
281  if (track.et < minet)
282  continue;
283  if (track.et > maxet)
284  continue;
285  if (not passEta(track.eta, i))
286  continue;
287  double w = track.et;
288  if (EPOrder[i] == 1) {
289  if (MomConsWeight[i][0] == 'y' && loadDB_) {
290  w = flat[i]->getW(track.et, vz, bin);
291  }
292  }
293  rp[i]->addParticle(w, track.et, sin(EPOrder[i] * track.phi), cos(EPOrder[i] * track.phi), track.eta);
294  }
295  }
296  }

References hi::GenPlane::addParticle(), newFWLiteAna::bin, funct::cos(), hi::EPDet, hi::EPOrder, HiEvtPlaneFlatten::getW(), mps_fire::i, HiEvtPlane_cfi::maxet, hi::maxTransverse, HiEvtPlane_cfi::minet, hi::minTransverse, hi::MomConsWeight, hi::NumEPNames, funct::sin(), HLT_FULL_cff::track, and w.

Referenced by produce().

◆ fillHF()

void EvtPlaneProducer::fillHF ( const TrackStructure track,
double  vz,
int  bin 
)
inlineprivate

Definition at line 244 of file EvtPlaneProducer.cc.

244  {
245  double minet = minet_;
246  double maxet = maxet_;
247  for (int i = 0; i < NumEPNames; i++) {
248  if (EPDet[i] != HF)
249  continue;
250  if (minet_ < 0)
251  minet = minTransverse[i];
252  if (maxet_ < 0)
253  maxet = maxTransverse[i];
254  if (track.et < minet)
255  continue;
256  if (track.et > maxet)
257  continue;
258  if (not passEta(track.eta, i))
259  continue;
260  double w = track.et;
261  if (loadDB_)
262  w = track.et * flat[i]->etScale(vz, bin);
263  if (EPOrder[i] == 1) {
264  if (MomConsWeight[i][0] == 'y' && loadDB_) {
265  w = flat[i]->getW(track.et, vz, bin);
266  }
267  }
268  rp[i]->addParticle(w, track.et, sin(EPOrder[i] * track.phi), cos(EPOrder[i] * track.phi), track.eta);
269  }
270  };

References hi::GenPlane::addParticle(), newFWLiteAna::bin, funct::cos(), hi::EPDet, hi::EPOrder, HiEvtPlaneFlatten::etScale(), HiEvtPlaneFlatten::getW(), DigiToRawDM_cff::HF, mps_fire::i, HiEvtPlane_cfi::maxet, hi::maxTransverse, HiEvtPlane_cfi::minet, hi::minTransverse, hi::MomConsWeight, hi::NumEPNames, funct::sin(), HLT_FULL_cff::track, and w.

Referenced by produce().

◆ fillTracker()

void EvtPlaneProducer::fillTracker ( const TrackStructure track,
double  vz,
int  bin 
)
inlineprivate

Definition at line 315 of file EvtPlaneProducer.cc.

315  {
316  double minpt = minpt_;
317  double maxpt = maxpt_;
318  for (int i = 0; i < NumEPNames; i++) {
319  if (EPDet[i] == Tracker) {
320  if (minpt_ < 0)
321  minpt = minTransverse[i];
322  if (maxpt_ < 0)
323  maxpt = maxTransverse[i];
324  if (track.pt < minpt)
325  continue;
326  if (track.pt > maxpt)
327  continue;
328  if (not passEta(track.eta, i))
329  continue;
330  double w = track.pt;
331  if (w > 2.5)
332  w = 2.0; //v2 starts decreasing above ~2.5 GeV/c
333  if (EPOrder[i] == 1) {
334  if (MomConsWeight[i][0] == 'y' && loadDB_) {
335  w = flat[i]->getW(track.pt, vz, bin);
336  }
337  }
338  rp[i]->addParticle(w, track.pt, sin(EPOrder[i] * track.phi), cos(EPOrder[i] * track.phi), track.eta);
339  }
340  }
341  };

References hi::GenPlane::addParticle(), newFWLiteAna::bin, funct::cos(), hi::EPDet, hi::EPOrder, HiEvtPlaneFlatten::getW(), mps_fire::i, HiEvtPlane_cfi::maxpt, hi::maxTransverse, HiEvtPlane_cfi::minpt, hi::minTransverse, hi::MomConsWeight, hi::NumEPNames, funct::sin(), HLT_FULL_cff::track, align::Tracker, and w.

Referenced by produce().

◆ passEta()

bool EvtPlaneProducer::passEta ( float  eta,
int  i 
)
inlineprivate

Definition at line 298 of file EvtPlaneProducer.cc.

298  {
299  if (EPEtaMin2[i] == EPEtaMax2[i]) {
300  if (eta < EPEtaMin1[i])
301  return false;
302  if (eta > EPEtaMax1[i])
303  return false;
304  } else {
305  if (eta < EPEtaMin1[i])
306  return false;
307  if (eta > EPEtaMax2[i])
308  return false;
309  if (eta > EPEtaMax1[i] && eta < EPEtaMin2[i])
310  return false;
311  }
312  return true;
313  }

References hi::EPEtaMax1, hi::EPEtaMax2, hi::EPEtaMin1, hi::EPEtaMin2, PVValHelper::eta, and mps_fire::i.

◆ produce()

void EvtPlaneProducer::produce ( edm::Event iEvent,
const edm::EventSetup iSetup 
)
overrideprivate

Definition at line 433 of file EvtPlaneProducer.cc.

433  {
434  using namespace edm;
435  using namespace std;
436  using namespace reco;
437  if (hiWatcher_.check(iSetup)) {
438  //
439  //Get Size of Centrality Table
440  //
442  iSetup.get<HeavyIonRcd>().get(centralityLabel_, centDB_);
443  nCentBins_ = centDB_->m_table.size();
444  for (int i = 0; i < NumEPNames; i++) {
445  if (caloCentRef_ > 0) {
446  int minbin = (caloCentRef_ - caloCentRefWidth_ / 2.) * nCentBins_ / 100.;
447  int maxbin = (caloCentRef_ + caloCentRefWidth_ / 2.) * nCentBins_ / 100.;
448  minbin /= CentBinCompression_;
449  maxbin /= CentBinCompression_;
450  if (minbin > 0 && maxbin >= minbin) {
451  if (EPDet[i] == HF || EPDet[i] == Castor)
452  flat[i]->setCaloCentRefBins(minbin, maxbin);
453  }
454  }
455  }
456  }
457  //
458  //Get flattening parameter file.
459  //
460  if (loadDB_ && hirpWatcher_.check(iSetup)) {
461  edm::ESHandle<RPFlatParams> flatparmsDB_;
462  iSetup.get<HeavyIonRPRcd>().get(flatparmsDB_);
463  LoadEPDB db(flatparmsDB_, flat);
464  if (!db.IsSuccess()) {
465  loadDB_ = kFALSE;
466  }
467  }
468  //
469  //Get Centrality
470  //
471  int bin = 0;
472  int cbin = 0;
473  if (loadDB_) {
474  cbin = iEvent.get(centralityBinToken_);
475  bin = cbin / CentBinCompression_;
476  }
477  //
478  //Get Vertex
479  //
480  //best vertex
481  const reco::Vertex &vtx = iEvent.get(vertexToken_)[0];
482  double bestvz = vtx.z();
483  double bestvx = vtx.x();
484  double bestvy = vtx.y();
485  double bestvzError = vtx.zError();
486  math::XYZPoint bestvtx(bestvx, bestvy, bestvz);
487  math::Error<3>::type vtx_cov = vtx.covariance();
488 
489  for (int i = 0; i < NumEPNames; i++)
490  rp[i]->reset();
495  for (int idx = 1; idx < 3; idx++) {
496  if (idx == 1) {
497  iEvent.getByToken(packedToken_, cands);
498  iEvent.getByToken(chi2MapToken_, chi2Map);
499  }
500  if (idx == 2) {
501  iEvent.getByToken(lostToken_, cands);
502  iEvent.getByToken(chi2MapLostToken_, chi2Map);
503  }
504  for (unsigned int i = 0, n = cands->size(); i < n; ++i) {
505  track_ = {};
506  track_.centbin = cbin;
507  const pat::PackedCandidate &pf = (*cands)[i];
508  track_.et = pf.et();
509  track_.eta = pf.eta();
510  track_.phi = pf.phi();
511  track_.pdgid = pf.pdgId();
512  if ((idx == 1) and cuts_.isGoodHF(track_)) {
513  fillHF(track_, bestvz, bin);
514  }
515  if (!pf.hasTrackDetails())
516  continue;
517  const reco::Track &trk = pf.pseudoTrack();
518  track_.highPurity = pf.trackHighPurity();
519  track_.charge = trk.charge();
520  if (!track_.highPurity || track_.charge == 0)
521  continue;
523  track_.eta = trk.eta();
524  track_.phi = trk.phi();
525  track_.pt = trk.pt();
526  track_.ptError = trk.ptError();
528  track_.algos = trk.algo();
529  track_.dz = std::abs(trk.dz(bestvtx));
530  track_.dxy = std::abs(trk.dxy(bestvtx));
531  track_.dzError = std::hypot(trk.dzError(), bestvzError);
532  track_.dxyError = trk.dxyError(bestvtx, vtx_cov);
535  const reco::HitPattern &hit_pattern = trk.hitPattern();
538  if (cuts_.isGoodTrack(track_)) {
539  fillTracker(track_, bestvz, bin);
540  }
541  }
542  }
543  } else {
544  //calorimetry part
545  if (bScalo_particleFlow_) {
546  iEvent.getByToken(caloTokenPF_, calocands);
547  for (unsigned int i = 0, n = calocands->size(); i < n; ++i) {
548  track_ = {};
549  track_.centbin = cbin;
550  const reco::PFCandidate &pf = (*calocands)[i];
551  track_.et = pf.et();
552  track_.eta = pf.eta();
553  track_.phi = pf.phi();
554  track_.pdgid = pf.pdgId();
555  if (cuts_.isGoodHF(track_)) {
556  fillHF(track_, bestvz, bin);
557  }
558  }
559  } else {
560  iEvent.getByToken(caloToken_, caloCollection_);
561  for (const auto &tower : *caloCollection_) {
562  track_.eta = tower.eta();
563  track_.phi = tower.phi();
564  track_.et = tower.emEt() + tower.hadEt();
565  track_.pdgid = 1;
566  if (cuts_.isGoodHF(track_))
567  fillHF(track_, bestvz, bin);
568  }
569  }
570 
571  //Castor part
573  for (const auto &tower : *castorCollection_) {
574  track_.eta = tower.eta();
575  track_.phi = tower.phi();
576  track_.et = tower.et();
577  track_.pdgid = 1;
579  fillCastor(track_, bestvz, bin);
580  }
581  //Tracking part
582  iEvent.getByToken(trackToken_, trackCollection_);
583  for (const auto &trk : *trackCollection_) {
585  track_.charge = trk.charge();
586  if (!track_.highPurity || track_.charge == 0)
587  continue;
588  track_.centbin = cbin;
589  track_.collection = 0;
590  track_.eta = trk.eta();
591  track_.phi = trk.phi();
592  track_.pt = trk.pt();
593  track_.ptError = trk.ptError();
595  track_.algos = trk.algo();
596  track_.dz = std::abs(trk.dz(bestvtx));
597  track_.dxy = std::abs(trk.dxy(bestvtx));
598  track_.dzError = std::hypot(trk.dzError(), bestvzError);
599  track_.dxyError = trk.dxyError(bestvtx, vtx_cov);
604  if (cuts_.isGoodTrack(track_))
605  fillTracker(track_, bestvz, bin);
606  }
607  }
608 
609  auto evtplaneOutput = std::make_unique<EvtPlaneCollection>();
610 
611  double ang = -10;
612  double sv = 0;
613  double cv = 0;
614  double svNoWgt = 0;
615  double cvNoWgt = 0;
616 
617  double wv = 0;
618  double wv2 = 0;
619  double pe = 0;
620  double pe2 = 0;
621  uint epmult = 0;
622 
623  for (int i = 0; i < NumEPNames; i++) {
624  rp[i]->getAngle(ang, sv, cv, svNoWgt, cvNoWgt, wv, wv2, pe, pe2, epmult);
625  evtplaneOutput->push_back(EvtPlane(i, 0, ang, sv, cv, wv, wv2, pe, pe2, epmult));
626  evtplaneOutput->back().addLevel(3, 0., svNoWgt, cvNoWgt);
627  }
628 
629  iEvent.put(std::move(evtplaneOutput));
630 }

References funct::abs(), reco::TrackBase::algo(), hi::TrackStructure::algos, newFWLiteAna::bin, bScalo_particleFlow_, bStrack_packedPFCandidates_, caloCentRef_, caloCentRefWidth_, caloCollection_, caloToken_, caloTokenPF_, HLT_FULL_cff::cands, castorCollection_, castorToken_, hi::TrackStructure::centbin, CentBinCompression_, centralityBinToken_, centralityLabel_, hi::TrackStructure::charge, reco::TrackBase::charge(), edm::ESWatcher< T >::check(), hi::TrackStructure::chi2layer, chi2MapLostToken_, chi2MapToken_, hi::TrackStructure::collection, cuts_, cuy::cv, dqmiodatasetharvest::db, hi::TrackStructure::dxy, reco::TrackBase::dxy(), hi::TrackStructure::dxyError, reco::TrackBase::dxyError(), hi::TrackStructure::dxySig, hi::TrackStructure::dz, reco::TrackBase::dz(), hi::TrackStructure::dzError, reco::TrackBase::dzError(), hi::TrackStructure::dzSig, hi::EPDet, hi::TrackStructure::et, hi::TrackStructure::eta, reco::TrackBase::eta(), fillCastor(), fillHF(), fillTracker(), flat, edm::EventSetup::get(), get, hi::GenPlane::getAngle(), DigiToRawDM_cff::HF, hi::TrackStructure::highPurity, reco::TrackBase::highPurity, hirpWatcher_, reco::TrackBase::hitPattern(), hiWatcher_, mps_fire::i, heavyIonCSV_trainingSettings::idx, iEvent, hi::EPCuts::isGoodCastor(), hi::EPCuts::isGoodHF(), hi::EPCuts::isGoodTrack(), loadDB_, lostToken_, CentralityTable::m_table, eostools::move(), dqmiodumpmetadata::n, nCentBins_, hi::TrackStructure::normalizedChi2, hi::TrackStructure::numberOfValidHits, reco::TrackBase::numberOfValidHits(), hi::NumEPNames, packedToken_, hi::TrackStructure::pdgid, packedPFCandidateRefMixer_cfi::pf, hi::TrackStructure::phi, reco::TrackBase::phi(), hi::TrackStructure::pt, reco::TrackBase::pt(), hi::TrackStructure::ptError, reco::TrackBase::ptError(), reset(), rp, HiEvtPlaneFlatten::setCaloCentRefBins(), pfDeepBoostedJetPreprocessParams_cfi::sv, hgcalTowerProducer_cfi::tower, track_, trackCollection_, reco::HitPattern::trackerLayersWithMeasurement(), trackToken_, parallelization::uint, vertexToken_, and extraflags_cff::vtx.

Member Data Documentation

◆ bScalo_particleFlow_

bool EvtPlaneProducer::bScalo_particleFlow_
private

Definition at line 206 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer(), and produce().

◆ bStrack_packedPFCandidates_

bool EvtPlaneProducer::bStrack_packedPFCandidates_
private

Definition at line 205 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer(), and produce().

◆ caloCentRef_

double EvtPlaneProducer::caloCentRef_
private

Definition at line 234 of file EvtPlaneProducer.cc.

Referenced by produce().

◆ caloCentRefWidth_

double EvtPlaneProducer::caloCentRefWidth_
private

Definition at line 235 of file EvtPlaneProducer.cc.

Referenced by produce().

◆ caloCollection_

edm::Handle<CaloTowerCollection> EvtPlaneProducer::caloCollection_
private

Definition at line 194 of file EvtPlaneProducer.cc.

Referenced by produce().

◆ caloTag_

edm::InputTag EvtPlaneProducer::caloTag_
private

Definition at line 192 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer().

◆ caloToken_

edm::EDGetTokenT<CaloTowerCollection> EvtPlaneProducer::caloToken_
private

Definition at line 193 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer(), and produce().

◆ caloTokenPF_

edm::EDGetTokenT<reco::PFCandidateCollection> EvtPlaneProducer::caloTokenPF_
private

Definition at line 195 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer(), and produce().

◆ castorCollection_

edm::Handle<std::vector<reco::CastorTower> > EvtPlaneProducer::castorCollection_
private

Definition at line 199 of file EvtPlaneProducer.cc.

Referenced by produce().

◆ castorTag_

edm::InputTag EvtPlaneProducer::castorTag_
private

Definition at line 197 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer().

◆ castorToken_

edm::EDGetTokenT<std::vector<reco::CastorTower> > EvtPlaneProducer::castorToken_
private

Definition at line 198 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer(), and produce().

◆ CentBinCompression_

int EvtPlaneProducer::CentBinCompression_
private

Definition at line 236 of file EvtPlaneProducer.cc.

Referenced by produce().

◆ centralityBinTag_

edm::InputTag EvtPlaneProducer::centralityBinTag_
private

Definition at line 185 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer().

◆ centralityBinToken_

edm::EDGetTokenT<int> EvtPlaneProducer::centralityBinToken_
private

Definition at line 186 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer(), and produce().

◆ centralityLabel_

std::string EvtPlaneProducer::centralityLabel_
private

Definition at line 182 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer(), and produce().

◆ centralityMC_

std::string EvtPlaneProducer::centralityMC_
private

Definition at line 183 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer().

◆ centralityVariable_

std::string EvtPlaneProducer::centralityVariable_
private

Definition at line 181 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer().

◆ chi2_

double EvtPlaneProducer::chi2_
private

Definition at line 229 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer().

◆ chi2MapLostTag_

edm::InputTag EvtPlaneProducer::chi2MapLostTag_
private

Definition at line 212 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer().

◆ chi2MapLostToken_

edm::EDGetTokenT<edm::ValueMap<float> > EvtPlaneProducer::chi2MapLostToken_
private

Definition at line 213 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer(), and produce().

◆ chi2MapTag_

edm::InputTag EvtPlaneProducer::chi2MapTag_
private

Definition at line 210 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer().

◆ chi2MapToken_

edm::EDGetTokenT<edm::ValueMap<float> > EvtPlaneProducer::chi2MapToken_
private

Definition at line 211 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer(), and produce().

◆ chi2perlayer_

double EvtPlaneProducer::chi2perlayer_
private

Definition at line 226 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer().

◆ cutEra_

int EvtPlaneProducer::cutEra_
private

Definition at line 237 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer().

◆ cuts_

EPCuts EvtPlaneProducer::cuts_
private

Definition at line 179 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer(), and produce().

◆ d0d0error_

double EvtPlaneProducer::d0d0error_
private

Definition at line 224 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer().

◆ dzdzerror_

double EvtPlaneProducer::dzdzerror_
private

Definition at line 223 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer().

◆ dzdzerror_pix_

double EvtPlaneProducer::dzdzerror_pix_
private

Definition at line 228 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer().

◆ dzerr_

double EvtPlaneProducer::dzerr_
private

Definition at line 227 of file EvtPlaneProducer.cc.

◆ flat

HiEvtPlaneFlatten* EvtPlaneProducer::flat[NumEPNames]
private

Definition at line 238 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer(), produce(), and ~EvtPlaneProducer().

◆ flatdelvtx_

double EvtPlaneProducer::flatdelvtx_
private

Definition at line 222 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer().

◆ flatminvtx_

double EvtPlaneProducer::flatminvtx_
private

Definition at line 221 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer().

◆ flatnvtxbins_

int EvtPlaneProducer::flatnvtxbins_
private

Definition at line 220 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer().

◆ FlatOrder_

int EvtPlaneProducer::FlatOrder_
private

Definition at line 231 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer().

◆ hirpWatcher_

edm::ESWatcher<HeavyIonRPRcd> EvtPlaneProducer::hirpWatcher_
private

Definition at line 242 of file EvtPlaneProducer.cc.

Referenced by produce().

◆ hiWatcher_

edm::ESWatcher<HeavyIonRcd> EvtPlaneProducer::hiWatcher_
private

Definition at line 241 of file EvtPlaneProducer.cc.

Referenced by produce().

◆ loadDB_

bool EvtPlaneProducer::loadDB_
private

Definition at line 215 of file EvtPlaneProducer.cc.

Referenced by produce().

◆ lostToken_

edm::EDGetTokenT<pat::PackedCandidateCollection> EvtPlaneProducer::lostToken_
private

Definition at line 208 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer(), and produce().

◆ losttrackTag_

edm::InputTag EvtPlaneProducer::losttrackTag_
private

Definition at line 203 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer().

◆ maxet_

double EvtPlaneProducer::maxet_
private

Definition at line 217 of file EvtPlaneProducer.cc.

◆ maxpt_

double EvtPlaneProducer::maxpt_
private

Definition at line 219 of file EvtPlaneProducer.cc.

◆ minet_

double EvtPlaneProducer::minet_
private

Definition at line 216 of file EvtPlaneProducer.cc.

◆ minpt_

double EvtPlaneProducer::minpt_
private

Definition at line 218 of file EvtPlaneProducer.cc.

◆ nCentBins_

double EvtPlaneProducer::nCentBins_
private

Definition at line 233 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer(), and produce().

◆ nhitsValid_

int EvtPlaneProducer::nhitsValid_
private

Definition at line 230 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer().

◆ NumFlatBins_

int EvtPlaneProducer::NumFlatBins_
private

Definition at line 232 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer().

◆ packedToken_

edm::EDGetTokenT<pat::PackedCandidateCollection> EvtPlaneProducer::packedToken_
private

Definition at line 207 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer(), and produce().

◆ pterror_

double EvtPlaneProducer::pterror_
private

Definition at line 225 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer().

◆ rp

GenPlane* EvtPlaneProducer::rp[NumEPNames]
private

Definition at line 174 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer(), and produce().

◆ track_

TrackStructure EvtPlaneProducer::track_
private

Definition at line 239 of file EvtPlaneProducer.cc.

Referenced by produce().

◆ trackCollection_

edm::Handle<reco::TrackCollection> EvtPlaneProducer::trackCollection_
private

Definition at line 204 of file EvtPlaneProducer.cc.

Referenced by produce().

◆ trackTag_

edm::InputTag EvtPlaneProducer::trackTag_
private

Definition at line 201 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer().

◆ trackToken_

edm::EDGetTokenT<reco::TrackCollection> EvtPlaneProducer::trackToken_
private

Definition at line 202 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer(), and produce().

◆ vertex_

edm::Handle<std::vector<reco::Vertex> > EvtPlaneProducer::vertex_
private

Definition at line 190 of file EvtPlaneProducer.cc.

◆ vertexTag_

edm::InputTag EvtPlaneProducer::vertexTag_
private

Definition at line 188 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer().

◆ vertexToken_

edm::EDGetTokenT<std::vector<reco::Vertex> > EvtPlaneProducer::vertexToken_
private

Definition at line 189 of file EvtPlaneProducer.cc.

Referenced by EvtPlaneProducer(), and produce().

EvtPlaneProducer::rp
GenPlane * rp[NumEPNames]
Definition: EvtPlaneProducer.cc:174
edm::ESWatcher::check
bool check(const edm::EventSetup &iSetup)
Definition: ESWatcher.h:52
EvtPlaneProducer::castorToken_
edm::EDGetTokenT< std::vector< reco::CastorTower > > castorToken_
Definition: EvtPlaneProducer.cc:198
hi::EPEtaMax1
const std::array< double, NumEPNames > EPEtaMax1
Definition: HiEvtPlaneList.h:56
hi::EPCuts
Definition: EPCuts.h:34
mps_fire.i
i
Definition: mps_fire.py:428
HLT_FULL_cff.track
track
Definition: HLT_FULL_cff.py:11713
reco::TrackBase::ptError
double ptError() const
error on Pt (set to 1000 TeV if charge==0 for safety)
Definition: TrackBase.h:754
EvtPlaneProducer::centralityBinTag_
edm::InputTag centralityBinTag_
Definition: EvtPlaneProducer.cc:185
dqmiodumpmetadata.n
n
Definition: dqmiodumpmetadata.py:28
EvtPlaneProducer::FlatOrder_
int FlatOrder_
Definition: EvtPlaneProducer.cc:231
HiEvtPlaneFlatten::setCaloCentRefBins
void setCaloCentRefBins(const int caloCentRefMinBin, const int caloCentRefMaxBin)
Definition: HiEvtPlaneFlatten.h:139
hi::EPCuts::isGoodHF
bool isGoodHF(const TrackStructure &track) const
Definition: EPCuts.h:54
hi::TrackStructure::collection
int collection
Definition: EPCuts.h:18
hi::TrackStructure::phi
float phi
Definition: EPCuts.h:11
hi::GenPlane
Definition: EvtPlaneProducer.cc:79
HiEvtPlaneFlatten::getW
double getW(double pt, double vtx, int centbin) const
Definition: HiEvtPlaneFlatten.h:160
EvtPlaneProducer::lostToken_
edm::EDGetTokenT< pat::PackedCandidateCollection > lostToken_
Definition: EvtPlaneProducer.cc:208
cuy.cv
cv
Definition: cuy.py:364
EvtPlaneProducer::losttrackTag_
edm::InputTag losttrackTag_
Definition: EvtPlaneProducer.cc:203
hi::GenPlane::addParticle
void addParticle(double w, double PtOrEt, double s, double c, double eta)
Definition: EvtPlaneProducer.cc:96
hi::TrackStructure::dxyError
float dxyError
Definition: EPCuts.h:22
edm
HLT enums.
Definition: AlignableModifier.h:19
hi::TrackStructure::dxy
float dxy
Definition: EPCuts.h:20
HiEvtPlaneFlatten
Definition: HiEvtPlaneFlatten.h:27
EvtPlaneProducer::maxpt_
double maxpt_
Definition: EvtPlaneProducer.cc:219
LoadEPDB
Definition: LoadEPDB.h:28
EvtPlaneProducer::flatdelvtx_
double flatdelvtx_
Definition: EvtPlaneProducer.cc:222
EvtPlaneProducer::dzdzerror_pix_
double dzdzerror_pix_
Definition: EvtPlaneProducer.cc:228
HeavyIonRPRcd
Definition: HeavyIonRPRcd.h:24
hi::TrackStructure::dxySig
float dxySig
Definition: EPCuts.h:26
hi::TrackStructure::chi2layer
float chi2layer
Definition: EPCuts.h:29
hgcalTowerProducer_cfi.tower
tower
Definition: hgcalTowerProducer_cfi.py:4
EvtPlaneProducer::loadDB_
bool loadDB_
Definition: EvtPlaneProducer.cc:215
hi::EPNames
const std::array< std::string, NumEPNames > EPNames
Definition: HiEvtPlaneList.h:30
EvtPlaneProducer::minet_
double minet_
Definition: EvtPlaneProducer.cc:216
hi::EPCuts::isGoodTrack
bool isGoodTrack(const TrackStructure &track) const
Definition: EPCuts.h:64
EvtPlaneProducer::trackTag_
edm::InputTag trackTag_
Definition: EvtPlaneProducer.cc:201
hi::TrackStructure::dzSig
float dzSig
Definition: EPCuts.h:25
hi::EPEtaMin1
const std::array< double, NumEPNames > EPEtaMin1
Definition: HiEvtPlaneList.h:50
reco
fixed size matrix
Definition: AlignmentAlgorithmBase.h:45
hi::EPOrder
const std::array< int, NumEPNames > EPOrder
Definition: HiEvtPlaneList.h:44
hi::TrackStructure::algos
int algos
Definition: EPCuts.h:17
edm::Handle
Definition: AssociativeIterator.h:50
reco::TrackBase::numberOfValidHits
unsigned short numberOfValidHits() const
number of valid hits found
Definition: TrackBase.h:798
HiEvtPlane_cfi.minpt
minpt
Definition: HiEvtPlane_cfi.py:17
parallelization.uint
uint
Definition: parallelization.py:124
reco::TrackBase::dxyError
double dxyError() const
error on dxy
Definition: TrackBase.h:769
EvtPlaneProducer::nhitsValid_
int nhitsValid_
Definition: EvtPlaneProducer.cc:230
EvtPlaneProducer::hiWatcher_
edm::ESWatcher< HeavyIonRcd > hiWatcher_
Definition: EvtPlaneProducer.cc:241
HiEvtPlane_cfi.minet
minet
Definition: HiEvtPlane_cfi.py:15
EvtPlaneProducer::passEta
bool passEta(float eta, int i)
Definition: EvtPlaneProducer.cc:298
EvtPlaneProducer::caloTag_
edm::InputTag caloTag_
Definition: EvtPlaneProducer.cc:192
hi::TrackStructure::dzError
float dzError
Definition: EPCuts.h:21
heavyIonCSV_trainingSettings.idx
idx
Definition: heavyIonCSV_trainingSettings.py:5
hi::EPEtaMax2
const std::array< double, NumEPNames > EPEtaMax2
Definition: HiEvtPlaneList.h:68
funct::sin
Sin< T >::type sin(const T &t)
Definition: Sin.h:22
align::Tracker
Definition: StructureType.h:70
EvtPlaneProducer::track_
TrackStructure track_
Definition: EvtPlaneProducer.cc:239
hi::TrackStructure::eta
float eta
Definition: EPCuts.h:10
EvtPlaneProducer::flat
HiEvtPlaneFlatten * flat[NumEPNames]
Definition: EvtPlaneProducer.cc:238
dqmiodatasetharvest.db
db
Definition: dqmiodatasetharvest.py:119
reco::TrackBase::pt
double pt() const
track transverse momentum
Definition: TrackBase.h:637
edm::InputTag::label
std::string const & label() const
Definition: InputTag.h:36
reco::HitPattern
Definition: HitPattern.h:147
EvtPlaneProducer::chi2_
double chi2_
Definition: EvtPlaneProducer.cc:229
EvtPlaneProducer::caloCentRefWidth_
double caloCentRefWidth_
Definition: EvtPlaneProducer.cc:235
EvtPlaneProducer::centralityLabel_
std::string centralityLabel_
Definition: EvtPlaneProducer.cc:182
funct::cos
Cos< T >::type cos(const T &t)
Definition: Cos.h:22
edm::EventSetup::get
T get() const
Definition: EventSetup.h:80
EvtPlaneProducer::centralityVariable_
std::string centralityVariable_
Definition: EvtPlaneProducer.cc:181
reco::HitPattern::trackerLayersWithMeasurement
int trackerLayersWithMeasurement() const
Definition: HitPattern.cc:513
PVValHelper::eta
Definition: PVValidationHelpers.h:69
w
const double w
Definition: UKUtility.cc:23
EvtPlaneProducer::centralityMC_
std::string centralityMC_
Definition: EvtPlaneProducer.cc:183
EvtPlaneProducer::pterror_
double pterror_
Definition: EvtPlaneProducer.cc:225
pfDeepBoostedJetPreprocessParams_cfi.sv
sv
Definition: pfDeepBoostedJetPreprocessParams_cfi.py:352
CentralityTable::m_table
std::vector< CBin > m_table
Definition: CentralityTable.h:39
reco::Track
Definition: Track.h:27
edm::ESHandle< CentralityTable >
hi::TrackStructure::pdgid
int pdgid
Definition: EPCuts.h:15
EvtPlaneProducer::nCentBins_
double nCentBins_
Definition: EvtPlaneProducer.cc:233
EvtPlaneProducer::CentBinCompression_
int CentBinCompression_
Definition: EvtPlaneProducer.cc:236
EvtPlaneProducer::vertexTag_
edm::InputTag vertexTag_
Definition: EvtPlaneProducer.cc:188
EvtPlaneProducer::chi2MapToken_
edm::EDGetTokenT< edm::ValueMap< float > > chi2MapToken_
Definition: EvtPlaneProducer.cc:211
reco::TrackBase::charge
int charge() const
track electric charge
Definition: TrackBase.h:596
reco::TrackBase::dz
double dz() const
dz parameter (= dsz/cos(lambda)). This is the track z0 w.r.t (0,0,0) only if the refPoint is close to...
Definition: TrackBase.h:622
EvtPlaneProducer::d0d0error_
double d0d0error_
Definition: EvtPlaneProducer.cc:224
reco::TrackBase::phi
double phi() const
azimuthal angle of momentum vector
Definition: TrackBase.h:649
HiEvtPlaneFlatten::etScale
double etScale(double vtx, int centbin) const
Definition: HiEvtPlaneFlatten.h:144
AlCaHLTBitMon_QueryRunRegistry.string
string
Definition: AlCaHLTBitMon_QueryRunRegistry.py:256
Castor
EvtPlaneProducer::caloToken_
edm::EDGetTokenT< CaloTowerCollection > caloToken_
Definition: EvtPlaneProducer.cc:193
hi::TrackStructure::centbin
int centbin
Definition: EPCuts.h:9
EvtPlaneProducer::minpt_
double minpt_
Definition: EvtPlaneProducer.cc:218
edm::ParameterSet::exists
bool exists(std::string const &parameterName) const
checks if a parameter exists
Definition: ParameterSet.cc:681
HLT_FULL_cff.cands
cands
Definition: HLT_FULL_cff.py:15142
EvtPlaneProducer::castorCollection_
edm::Handle< std::vector< reco::CastorTower > > castorCollection_
Definition: EvtPlaneProducer.cc:199
math::XYZPoint
XYZPointD XYZPoint
point in space with cartesian internal representation
Definition: Point3D.h:12
EvtPlaneProducer::fillHF
void fillHF(const TrackStructure &track, double vz, int bin)
Definition: EvtPlaneProducer.cc:244
hi::TrackStructure::ptError
float ptError
Definition: EPCuts.h:23
EvtPlaneProducer::fillTracker
void fillTracker(const TrackStructure &track, double vz, int bin)
Definition: EvtPlaneProducer.cc:315
EvtPlaneProducer::trackToken_
edm::EDGetTokenT< reco::TrackCollection > trackToken_
Definition: EvtPlaneProducer.cc:202
pat::PackedCandidate
Definition: PackedCandidate.h:22
EvtPlaneProducer::caloTokenPF_
edm::EDGetTokenT< reco::PFCandidateCollection > caloTokenPF_
Definition: EvtPlaneProducer.cc:195
reco::EvtPlane
Definition: EvtPlane.h:20
reco::TrackBase::eta
double eta() const
pseudorapidity of momentum vector
Definition: TrackBase.h:652
hi::TrackStructure::highPurity
bool highPurity
Definition: EPCuts.h:24
reco::TrackBase::dzError
double dzError() const
error on dz
Definition: TrackBase.h:778
hi::TrackStructure::normalizedChi2
float normalizedChi2
Definition: EPCuts.h:27
iEvent
int iEvent
Definition: GenABIO.cc:224
EvtPlaneProducer::centralityBinToken_
edm::EDGetTokenT< int > centralityBinToken_
Definition: EvtPlaneProducer.cc:186
hi::TrackStructure::numberOfValidHits
int numberOfValidHits
Definition: EPCuts.h:30
EvtPlaneProducer::dzdzerror_
double dzdzerror_
Definition: EvtPlaneProducer.cc:223
EvtPlaneProducer::hirpWatcher_
edm::ESWatcher< HeavyIonRPRcd > hirpWatcher_
Definition: EvtPlaneProducer.cc:242
reco::TrackBase::normalizedChi2
double normalizedChi2() const
chi-squared divided by n.d.o.f. (or chi-squared * 1e6 if n.d.o.f. is zero)
Definition: TrackBase.h:593
hi::MomConsWeight
const std::array< std::string, NumEPNames > MomConsWeight
Definition: HiEvtPlaneList.h:92
EvtPlaneProducer::bScalo_particleFlow_
bool bScalo_particleFlow_
Definition: EvtPlaneProducer.cc:206
get
#define get
hi::TrackStructure::pt
float pt
Definition: EPCuts.h:13
EvtPlaneProducer::caloCollection_
edm::Handle< CaloTowerCollection > caloCollection_
Definition: EvtPlaneProducer.cc:194
hi::TrackStructure::dz
float dz
Definition: EPCuts.h:19
hi::EPDet
const std::array< int, NumEPNames > EPDet
Definition: HiEvtPlaneList.h:38
newFWLiteAna.bin
bin
Definition: newFWLiteAna.py:161
reco::TrackBase::algo
TrackAlgorithm algo() const
Definition: TrackBase.h:547
EvtPlaneProducer::cutEra_
int cutEra_
Definition: EvtPlaneProducer.cc:237
reco::TrackBase::hitPattern
const HitPattern & hitPattern() const
Access the hit pattern, indicating in which Tracker layers the track has hits.
Definition: TrackBase.h:504
EvtPlaneProducer::chi2MapLostTag_
edm::InputTag chi2MapLostTag_
Definition: EvtPlaneProducer.cc:212
hi::EPCuts::isGoodCastor
bool isGoodCastor(const TrackStructure &track) const
Definition: EPCuts.h:62
EvtPlaneProducer::cuts_
EPCuts cuts_
Definition: EvtPlaneProducer.cc:179
eostools.move
def move(src, dest)
Definition: eostools.py:511
std
Definition: JetResolutionObject.h:76
EvtPlaneProducer::caloCentRef_
double caloCentRef_
Definition: EvtPlaneProducer.cc:234
HiEvtPlane_cfi.maxpt
maxpt
Definition: HiEvtPlane_cfi.py:18
extraflags_cff.vtx
vtx
Definition: extraflags_cff.py:18
packedPFCandidateRefMixer_cfi.pf
pf
Definition: packedPFCandidateRefMixer_cfi.py:4
hi::GenPlane::getAngle
double getAngle(double &ang, double &sv, double &cv, double &svNoWgt, double &cvNoWgt, double &w, double &w2, double &PtOrEt, double &PtOrEt2, uint &epmult)
Definition: EvtPlaneProducer.cc:111
EvtPlaneProducer::castorTag_
edm::InputTag castorTag_
Definition: EvtPlaneProducer.cc:197
math::Error::type
ErrorD< N >::type type
Definition: Error.h:32
hi::EPEtaMin2
const std::array< double, NumEPNames > EPEtaMin2
Definition: HiEvtPlaneList.h:62
Exception
Definition: hltDiff.cc:246
hi::minTransverse
const std::array< double, NumEPNames > minTransverse
Definition: HiEvtPlaneList.h:74
EvtPlaneProducer::flatnvtxbins_
int flatnvtxbins_
Definition: EvtPlaneProducer.cc:220
EvtPlaneProducer::NumFlatBins_
int NumFlatBins_
Definition: EvtPlaneProducer.cc:232
hi::maxTransverse
const std::array< double, NumEPNames > maxTransverse
Definition: HiEvtPlaneList.h:80
edm::ParameterSet::getParameter
T getParameter(std::string const &) const
Definition: ParameterSet.h:303
EvtPlaneProducer::chi2MapLostToken_
edm::EDGetTokenT< edm::ValueMap< float > > chi2MapLostToken_
Definition: EvtPlaneProducer.cc:213
EvtPlaneProducer::chi2MapTag_
edm::InputTag chi2MapTag_
Definition: EvtPlaneProducer.cc:210
reco::PFCandidate
Particle reconstructed by the particle flow algorithm.
Definition: PFCandidate.h:41
reset
void reset(double vett[256])
Definition: TPedValues.cc:11
EvtPlaneProducer::chi2perlayer_
double chi2perlayer_
Definition: EvtPlaneProducer.cc:226
hi::NumEPNames
static const int NumEPNames
Definition: HiEvtPlaneList.h:28
EvtPlaneProducer::maxet_
double maxet_
Definition: EvtPlaneProducer.cc:217
EvtPlaneProducer::trackCollection_
edm::Handle< reco::TrackCollection > trackCollection_
Definition: EvtPlaneProducer.cc:204
HiEvtPlaneFlatten::init
void init(int order, int nbins, int nvtxbins=10, double minvtx=-25, double delvtx=5, std::string tag="", int vord=2)
Definition: HiEvtPlaneFlatten.h:35
funct::abs
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
HeavyIonRcd
Definition: HeavyIonRcd.h:24
EvtPlaneProducer::fillCastor
void fillCastor(const TrackStructure &track, double vz, int bin)
Definition: EvtPlaneProducer.cc:272
EvtPlaneProducer::vertexToken_
edm::EDGetTokenT< std::vector< reco::Vertex > > vertexToken_
Definition: EvtPlaneProducer.cc:189
DigiToRawDM_cff.HF
HF
Definition: DigiToRawDM_cff.py:22
reco::TrackBase::dxy
double dxy() const
dxy parameter. (This is the transverse impact parameter w.r.t. to (0,0,0) ONLY if refPoint is close t...
Definition: TrackBase.h:608
edm::errors::Configuration
Definition: EDMException.h:36
reco::TrackBase::quality
bool quality(const TrackQuality) const
Track quality.
Definition: TrackBase.h:552
EvtPlaneProducer::packedToken_
edm::EDGetTokenT< pat::PackedCandidateCollection > packedToken_
Definition: EvtPlaneProducer.cc:207
edm::InputTag
Definition: InputTag.h:15
hi::TrackStructure::charge
int charge
Definition: EPCuts.h:14
reco::Vertex
Definition: Vertex.h:35
EvtPlaneProducer::bStrack_packedPFCandidates_
bool bStrack_packedPFCandidates_
Definition: EvtPlaneProducer.cc:205
HiEvtPlane_cfi.maxet
maxet
Definition: HiEvtPlane_cfi.py:16
hi::TrackStructure::et
float et
Definition: EPCuts.h:12
EvtPlaneProducer::flatminvtx_
double flatminvtx_
Definition: EvtPlaneProducer.cc:221
pat::PackedCandidateRef
edm::Ref< pat::PackedCandidateCollection > PackedCandidateRef
Definition: PackedCandidate.h:1131
reco::TrackBase::highPurity
Definition: TrackBase.h:154