CMS 3D CMS Logo

List of all members | Public Member Functions | Static Public Member Functions | Private Member Functions | Private Attributes
IsoTrackCalib Class Reference
Inheritance diagram for IsoTrackCalib:
edm::one::EDAnalyzer< edm::one::WatchRuns, edm::one::SharedResources > edm::one::EDAnalyzerBase edm::EDConsumerBase

Public Member Functions

 IsoTrackCalib (const edm::ParameterSet &)
 
 ~IsoTrackCalib () override
 
- Public Member Functions inherited from edm::one::EDAnalyzer< edm::one::WatchRuns, edm::one::SharedResources >
 EDAnalyzer ()=default
 
SerialTaskQueueglobalLuminosityBlocksQueue () final
 
SerialTaskQueueglobalRunsQueue () final
 
bool wantsGlobalLuminosityBlocks () const final
 
bool wantsGlobalRuns () const final
 
- Public Member Functions inherited from edm::one::EDAnalyzerBase
void callWhenNewProductsRegistered (std::function< void(BranchDescription const &)> const &func)
 
 EDAnalyzerBase ()
 
ModuleDescription const & moduleDescription () const
 
bool wantsStreamLuminosityBlocks () const
 
bool wantsStreamRuns () const
 
 ~EDAnalyzerBase () override
 
- Public Member Functions inherited from edm::EDConsumerBase
std::vector< ConsumesInfoconsumesInfo () const
 
void convertCurrentProcessAlias (std::string const &processName)
 Convert "@currentProcess" in InputTag process names to the actual current process name. More...
 
 EDConsumerBase ()
 
 EDConsumerBase (EDConsumerBase const &)=delete
 
 EDConsumerBase (EDConsumerBase &&)=default
 
ProductResolverIndexAndSkipBit indexFrom (EDGetToken, BranchType, TypeID const &) const
 
void itemsMayGet (BranchType, std::vector< ProductResolverIndexAndSkipBit > &) const
 
void itemsToGet (BranchType, std::vector< ProductResolverIndexAndSkipBit > &) const
 
std::vector< ProductResolverIndexAndSkipBit > const & itemsToGetFrom (BranchType iType) const
 
void labelsForToken (EDGetToken iToken, Labels &oLabels) const
 
void modulesWhoseProductsAreConsumed (std::vector< ModuleDescription const * > &modules, ProductRegistry const &preg, std::map< std::string, ModuleDescription const * > const &labelsToDesc, std::string const &processName) const
 
EDConsumerBase const & operator= (EDConsumerBase const &)=delete
 
EDConsumerBaseoperator= (EDConsumerBase &&)=default
 
bool registeredToConsume (ProductResolverIndex, bool, BranchType) const
 
bool registeredToConsumeMany (TypeID const &, BranchType) const
 
ProductResolverIndexAndSkipBit uncheckedIndexFrom (EDGetToken) const
 
void updateLookup (BranchType iBranchType, ProductResolverIndexHelper const &, bool iPrefetchMayGet)
 
virtual ~EDConsumerBase () noexcept(false)
 

Static Public Member Functions

static void fillDescriptions (edm::ConfigurationDescriptions &descriptions)
 
- Static Public Member Functions inherited from edm::one::EDAnalyzerBase
static const std::string & baseType ()
 
static void fillDescriptions (ConfigurationDescriptions &descriptions)
 
static void prevalidate (ConfigurationDescriptions &descriptions)
 

Private Member Functions

void analyze (const edm::Event &, const edm::EventSetup &) override
 
void beginJob () override
 
void beginRun (edm::Run const &, edm::EventSetup const &) override
 
double deltaR (double eta1, double eta2, double phi1, double phi2)
 
double dEta (math::XYZTLorentzVector &, math::XYZTLorentzVector &)
 
double dPhi (math::XYZTLorentzVector &, math::XYZTLorentzVector &)
 
double dR (math::XYZTLorentzVector &, math::XYZTLorentzVector &)
 
void endJob () override
 
void endRun (edm::Run const &, edm::EventSetup const &) override
 

Private Attributes

const double a_charIsoR_
 
const double a_coneR_
 
const double a_mipR_
 
edm::Service< TFileServicefs_
 
TH1I * h_iEta
 
TH1F * h_jetp
 
TH1F * h_jetpt [4]
 
TH1F * h_Rechit_E
 
TProfile * h_RecHit_iEta
 
TProfile * h_RecHit_num
 
TH1I * h_tkEta0 [5]
 
TH1I * h_tketa0 [6]
 
TH1I * h_tkEta1 [5]
 
TH1I * h_tketa1 [6]
 
TH1I * h_tkEta2 [5]
 
TH1I * h_tketa2 [6]
 
TH1I * h_tkEta3 [5]
 
TH1I * h_tketa3 [6]
 
TH1I * h_tkEta4 [5]
 
TH1I * h_tketa4 [6]
 
TH1I * h_tkEta5 [5]
 
TH1I * h_tketa5 [6]
 
HLTConfigProvider hltConfig_
 
std::map< std::pair< unsigned int, std::string >, int > l1AlgoMap_
 
const std::vector< std::string > l1Names_
 
const L1GtTriggerMenum_l1GtMenu
 
L1GtUtils m_l1GtUtils
 
std::vector< double > pbin
 
spr::trackSelectionParameters selectionParameters_
 
std::vector< unsigned int > * t_DetIds
 
double t_eHcal
 
double t_eMipDR
 
int t_Event
 
double t_EventWeight
 
std::vector< double > * t_HitEnergies
 
double t_hmaxNearP
 
int t_ieta
 
std::vector< bool > * t_l1bits
 
double t_l1eta
 
double t_l1phi
 
double t_l1pt
 
double t_l3eta
 
double t_l3phi
 
double t_l3pt
 
double t_mindR1
 
double t_mindR2
 
double t_p
 
bool t_qltyFlag
 
bool t_qltyMissFlag
 
bool t_qltyPVFlag
 
int t_Run
 
bool t_selectTk
 
const std::string theTrackQuality_
 
const edm::EDGetTokenT< reco::BeamSpottok_bs_
 
edm::EDGetTokenT< EcalRecHitCollectiontok_EB_
 
edm::EDGetTokenT< EcalRecHitCollectiontok_EE_
 
const edm::EDGetTokenT< GenEventInfoProducttok_ew_
 
const edm::EDGetTokenT< reco::TrackCollectiontok_genTrack_
 
edm::EDGetTokenT< HBHERecHitCollectiontok_hbhe_
 
const edm::EDGetTokenT< reco::GenJetCollectiontok_jets_
 
edm::EDGetTokenT< l1extra::L1JetParticleCollectiontok_L1extCenJet_
 
edm::EDGetTokenT< l1extra::L1JetParticleCollectiontok_L1extFwdJet_
 
edm::EDGetTokenT< l1extra::L1JetParticleCollectiontok_L1extTauJet_
 
const edm::EDGetTokenT< reco::PFJetCollectiontok_pfjets_
 
const edm::EDGetTokenT< reco::VertexCollectiontok_recVtx_
 
TTree * tree
 
const int verbosity_
 

Additional Inherited Members

- Public Types inherited from edm::one::EDAnalyzerBase
typedef EDAnalyzerBase ModuleType
 
- Public Types inherited from edm::EDConsumerBase
typedef ProductLabels Labels
 
- Protected Member Functions inherited from edm::EDConsumerBase
template<typename ProductType , BranchType B = InEvent>
EDGetTokenT< ProductType > consumes (edm::InputTag const &tag)
 
EDGetToken consumes (const TypeToGet &id, edm::InputTag const &tag)
 
template<BranchType B>
EDGetToken consumes (TypeToGet const &id, edm::InputTag const &tag)
 
ConsumesCollector consumesCollector ()
 Use a ConsumesCollector to gather consumes information from helper functions. More...
 
template<typename ProductType , BranchType B = InEvent>
void consumesMany ()
 
void consumesMany (const TypeToGet &id)
 
template<BranchType B>
void consumesMany (const TypeToGet &id)
 
template<typename ProductType , BranchType B = InEvent>
EDGetTokenT< ProductType > mayConsume (edm::InputTag const &tag)
 
EDGetToken mayConsume (const TypeToGet &id, edm::InputTag const &tag)
 
template<BranchType B>
EDGetToken mayConsume (const TypeToGet &id, edm::InputTag const &tag)
 

Detailed Description

Definition at line 82 of file IsoTrackCalib.cc.

Constructor & Destructor Documentation

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

Definition at line 146 of file IsoTrackCalib.cc.

References a_charIsoR_, a_coneR_, a_mipR_, edm::ParameterSet::getParameter(), edm::ParameterSet::getUntrackedParameter(), gen::k, TFileService::kSharedResource, l1Names_, spr::trackSelectionParameters::maxChi2, spr::trackSelectionParameters::maxDpOverP, spr::trackSelectionParameters::maxDxyPV, spr::trackSelectionParameters::maxDzPV, spr::trackSelectionParameters::maxInMiss, spr::trackSelectionParameters::maxOutMiss, spr::trackSelectionParameters::minLayerCrossed, spr::trackSelectionParameters::minOuterHit, spr::trackSelectionParameters::minPt, spr::trackSelectionParameters::minQuality, reco::TrackBase::qualityByName(), selectionParameters_, theTrackQuality_, tok_EB_, tok_EE_, tok_hbhe_, tok_L1extCenJet_, tok_L1extFwdJet_, tok_L1extTauJet_, and verbosity_.

146  :
148  verbosity_(iConfig.getUntrackedParameter<int>("Verbosity",0)),
149  l1Names_(iConfig.getUntrackedParameter<std::vector<std::string> >("L1Seed")),
150  theTrackQuality_(iConfig.getUntrackedParameter<std::string>("TrackQuality","highPurity")),
151  a_coneR_(iConfig.getUntrackedParameter<double>("ConeRadius",34.98)),
152  a_charIsoR_(a_coneR_+28.9),
153  a_mipR_(iConfig.getUntrackedParameter<double>("ConeRadiusMIP",14.0)),
154  tok_genTrack_(consumes<reco::TrackCollection>(edm::InputTag("generalTracks"))),
155  tok_recVtx_(consumes<reco::VertexCollection>(edm::InputTag("offlinePrimaryVertices"))),
156  tok_bs_(consumes<reco::BeamSpot>(edm::InputTag("offlineBeamSpot"))),
157  tok_ew_(consumes<GenEventInfoProduct>(edm::InputTag("generatorSmeared"))),
158  tok_jets_(consumes<reco::GenJetCollection>(iConfig.getParameter<edm::InputTag>("JetSource"))),
159  tok_pfjets_(consumes<reco::PFJetCollection>(edm::InputTag("ak5PFJets"))) {
160 
161  usesResource(TFileService::kSharedResource);
162 
163  //now do whatever initialization is needed
165  selectionParameters_.minPt = iConfig.getUntrackedParameter<double>("MinTrackPt", 10.0);
166  selectionParameters_.minQuality = trackQuality_;
167  selectionParameters_.maxDxyPV = iConfig.getUntrackedParameter<double>("MaxDxyPV", 0.2);
168  selectionParameters_.maxDzPV = iConfig.getUntrackedParameter<double>("MaxDzPV", 5.0);
169  selectionParameters_.maxChi2 = iConfig.getUntrackedParameter<double>("MaxChi2", 5.0);
170  selectionParameters_.maxDpOverP = iConfig.getUntrackedParameter<double>("MaxDpOverP", 0.1);
171  selectionParameters_.minOuterHit = iConfig.getUntrackedParameter<int>("MinOuterHit", 4);
172  selectionParameters_.minLayerCrossed= iConfig.getUntrackedParameter<int>("MinLayerCrossed", 8);
173  selectionParameters_.maxInMiss = iConfig.getUntrackedParameter<int>("MaxInMiss", 0);
174  selectionParameters_.maxOutMiss = iConfig.getUntrackedParameter<int>("MaxOutMiss", 0);
175  bool isItAOD = iConfig.getUntrackedParameter<bool>("IsItAOD", false);
176  edm::InputTag L1extraTauJetSource_ = iConfig.getParameter<edm::InputTag> ("L1extraTauJetSource" );
177  edm::InputTag L1extraCenJetSource_ = iConfig.getParameter<edm::InputTag> ("L1extraCenJetSource" );
178  edm::InputTag L1extraFwdJetSource_ = iConfig.getParameter<edm::InputTag> ("L1extraFwdJetSource" );
179 
180  // define tokens for access
181  if (isItAOD) {
182  tok_EB_ = consumes<EcalRecHitCollection>(edm::InputTag("reducedEcalRecHitsEB"));
183  tok_EE_ = consumes<EcalRecHitCollection>(edm::InputTag("reducedEcalRecHitsEE"));
184  tok_hbhe_ = consumes<HBHERecHitCollection>(edm::InputTag("reducedHcalRecHits", "hbhereco"));
185  } else {
186  tok_EB_ = consumes<EcalRecHitCollection>(edm::InputTag("ecalRecHit","EcalRecHitsEB"));
187  tok_EE_ = consumes<EcalRecHitCollection>(edm::InputTag("ecalRecHit","EcalRecHitsEE"));
188  tok_hbhe_ = consumes<HBHERecHitCollection>(edm::InputTag("hbhereco"));
189  }
190  tok_L1extTauJet_ = consumes<l1extra::L1JetParticleCollection>(L1extraTauJetSource_);
191  tok_L1extCenJet_ = consumes<l1extra::L1JetParticleCollection>(L1extraCenJetSource_);
192  tok_L1extFwdJet_ = consumes<l1extra::L1JetParticleCollection>(L1extraFwdJetSource_);
193  if (verbosity_>=0) {
194  edm::LogInfo("IsoTrack")
195  <<"Parameters read from config file \n"
196  <<"\t minPt " << selectionParameters_.minPt
197  <<"\t theTrackQuality " << theTrackQuality_
198  <<"\t minQuality " << selectionParameters_.minQuality
199  <<"\t maxDxyPV " << selectionParameters_.maxDxyPV
200  <<"\t maxDzPV " << selectionParameters_.maxDzPV
201  <<"\t maxChi2 " << selectionParameters_.maxChi2
202  <<"\t maxDpOverP " << selectionParameters_.maxDpOverP
203  <<"\t minOuterHit " << selectionParameters_.minOuterHit
204  <<"\t minLayerCrossed " << selectionParameters_.minLayerCrossed
205  <<"\t maxInMiss " << selectionParameters_.maxInMiss
206  <<"\t maxOutMiss " << selectionParameters_.maxOutMiss
207  <<"\t a_coneR " << a_coneR_
208  <<"\t a_charIsoR " << a_charIsoR_
209  <<"\t a_mipR " << a_mipR_
210  <<"\t isItAOD " << isItAOD;
211  edm::LogInfo("IsoTrack") << l1Names_.size() << " triggers to be studied";
212  for (unsigned int k=0; k<l1Names_.size(); ++k)
213  edm::LogInfo("IsoTrack") << "[" << k << "]: " << l1Names_[k];
214  }
215 
216 }
static const std::string kSharedResource
Definition: TFileService.h:76
T getParameter(std::string const &) const
spr::trackSelectionParameters selectionParameters_
T getUntrackedParameter(std::string const &, T const &) const
const edm::EDGetTokenT< reco::TrackCollection > tok_genTrack_
const edm::EDGetTokenT< GenEventInfoProduct > tok_ew_
const double a_mipR_
edm::EDGetTokenT< EcalRecHitCollection > tok_EE_
edm::EDGetTokenT< l1extra::L1JetParticleCollection > tok_L1extCenJet_
const int verbosity_
TrackQuality
track quality
Definition: TrackBase.h:151
const edm::EDGetTokenT< reco::BeamSpot > tok_bs_
edm::EDGetTokenT< l1extra::L1JetParticleCollection > tok_L1extTauJet_
edm::EDGetTokenT< HBHERecHitCollection > tok_hbhe_
const std::string theTrackQuality_
static const bool useL1GtTriggerMenuLite(true)
ConsumesCollector consumesCollector()
Use a ConsumesCollector to gather consumes information from helper functions.
edm::EDGetTokenT< EcalRecHitCollection > tok_EB_
const double a_charIsoR_
const edm::EDGetTokenT< reco::VertexCollection > tok_recVtx_
edm::EDGetTokenT< l1extra::L1JetParticleCollection > tok_L1extFwdJet_
const edm::EDGetTokenT< reco::GenJetCollection > tok_jets_
int k[5][pyjets_maxn]
static TrackQuality qualityByName(const std::string &name)
Definition: TrackBase.cc:125
L1GtUtils m_l1GtUtils
reco::TrackBase::TrackQuality minQuality
const edm::EDGetTokenT< reco::PFJetCollection > tok_pfjets_
const double a_coneR_
const std::vector< std::string > l1Names_
IsoTrackCalib::~IsoTrackCalib ( )
override

Definition at line 218 of file IsoTrackCalib.cc.

218  {
219  // do anything here that needs to be done at desctruction time
220  // (e.g. close files, deallocate resources etc.)
221 
222 }

Member Function Documentation

void IsoTrackCalib::analyze ( const edm::Event iEvent,
const edm::EventSetup iSetup 
)
overrideprivate

Definition at line 249 of file IsoTrackCalib.cc.

References a_charIsoR_, a_coneR_, a_mipR_, L1GtUtils::availableL1Configuration(), edm::SortedCollection< T, SORT >::begin(), ecalTB2006H4_GenSimDigiReco_cfg::bField, edm::EventBase::bunchCrossing(), spr::chargeIsolationCone(), L1GtUtils::decision(), deltaR(), spr::eCone_ecal(), spr::eCone_hcal(), edm::SortedCollection< T, SORT >::end(), reco::LeafCandidate::eta(), reco::TrackBase::eta(), edm::EventID::event(), particlelevel_cff::genEventInfo, ttbarCategorization_cff::genJets, edm::EventSetup::get(), edm::Event::getByToken(), L1GtUtils::getL1GtRunCache(), spr::goodTrack(), L1GtTriggerMenu::gtAlgorithmMap(), L1GtTriggerMenu::gtTriggerMenuName(), h_iEta, h_jetpt, h_Rechit_E, h_RecHit_iEta, h_RecHit_num, h_tketa0, h_tketa1, h_tketa2, h_tketa3, h_tketa4, h_tketa5, photonIsolationHIProducer_cfi::hbhe, mps_fire::i, edm::EventBase::id(), electrons_cff::ids, HcalDetId::ieta(), edm::HandleBase::isValid(), gen::k, l1Names_, edm::EventBase::luminosityBlock(), m_l1GtMenu, m_l1GtUtils, spr::trackSelectionParameters::maxDxyPV, spr::trackSelectionParameters::maxDzPV, spr::trackSelectionParameters::maxInMiss, spr::trackSelectionParameters::maxOutMiss, nTracks(), reco::TrackBase::p(), pbin, pfJetBenchmark_cfi::pfJets, reco::TrackBase::phi(), reco::BeamSpot::position(), edm::ESHandle< T >::product(), spr::propagateCALO(), reco::LeafCandidate::pt(), reco::TrackBase::pt(), reco::TrackBase::px(), reco::TrackBase::py(), reco::TrackBase::pz(), edm::EventID::run(), selectionParameters_, AlCaHLTBitMon_QueryRunRegistry::string, t_DetIds, t_eHcal, t_eMipDR, t_Event, t_EventWeight, t_HitEnergies, t_hmaxNearP, t_ieta, t_l1bits, t_l1eta, t_l1phi, t_l1pt, t_l3eta, t_l3phi, t_l3pt, t_mindR1, t_mindR2, t_p, t_qltyFlag, t_qltyMissFlag, t_qltyPVFlag, t_Run, t_selectTk, theTrackQuality_, tok_bs_, tok_EB_, tok_EE_, tok_ew_, tok_genTrack_, tok_hbhe_, tok_jets_, tok_L1extCenJet_, tok_L1extFwdJet_, tok_L1extTauJet_, tok_pfjets_, tok_recVtx_, useL1EventSetup(), useL1GtTriggerMenuLite(), verbosity_, GenEventInfoProduct::weight(), x, y, and z.

250  {
251 
252  t_Run = iEvent.id().run();
253  t_Event = iEvent.id().event();
254  if (verbosity_%10 > 0)
255  edm::LogInfo("IsoTrack")
256  << "Run " << t_Run << " Event " << t_Event << " Luminosity "
257  << iEvent.luminosityBlock() << " Bunch " << iEvent.bunchCrossing()
258  << " starts ==========";
259 
260  //Get magnetic field and ECAL channel status
262  iSetup.get<IdealMagneticFieldRecord>().get(bFieldH);
263  const MagneticField *bField = bFieldH.product();
264 
266  iSetup.get<EcalSeverityLevelAlgoRcd>().get(sevlv);
267 
268  // get handles to calogeometry and calotopology
270  iSetup.get<CaloGeometryRecord>().get(pG);
271  const CaloGeometry* geo = pG.product();
272 
273  //Get track collection
275  iEvent.getByToken(tok_genTrack_, trkCollection);
276  reco::TrackCollection::const_iterator trkItr;
277 
278  //event weight for FLAT sample
279  t_EventWeight = 1.0;
281  iEvent.getByToken(tok_ew_, genEventInfo);
282  if (genEventInfo.isValid()) t_EventWeight = genEventInfo->weight();
283 
284  // genJet information
286  iEvent.getByToken(tok_jets_, genJets);
287  if (genJets.isValid()) {
288  for (unsigned iGenJet = 0; iGenJet < genJets->size(); ++iGenJet) {
289  const reco::GenJet& genJet = (*genJets) [iGenJet];
290  double genJetPt = genJet.pt();
291  double genJetEta = genJet.eta();
292  h_jetpt[0]->Fill(genJetPt);
293  h_jetpt[1]->Fill(genJetPt,t_EventWeight);
294  if (genJetEta>-2.5 && genJetEta<2.5) {
295  h_jetpt[2]->Fill(genJetPt);
296  h_jetpt[3]->Fill(genJetPt,t_EventWeight);
297  }
298  break;
299  }
300  }
301 
302  //pf jets
304  iEvent.getByToken(tok_pfjets_, pfJets);
305  reco::PFJetCollection::const_iterator pfItr;
306 
307  //Define the best vertex and the beamspot
309  iEvent.getByToken(tok_recVtx_, recVtxs);
310  edm::Handle<reco::BeamSpot> beamSpotH;
311  iEvent.getByToken(tok_bs_, beamSpotH);
312  math::XYZPoint leadPV(0,0,0);
313  if (!recVtxs->empty() && !((*recVtxs)[0].isFake())) {
314  leadPV = math::XYZPoint( (*recVtxs)[0].x(),(*recVtxs)[0].y(), (*recVtxs)[0].z() );
315  } else if (beamSpotH.isValid()) {
316  leadPV = beamSpotH->position();
317  }
318  if (verbosity_>10) {
319  if ((verbosity_%100)/10>2)
320  edm::LogInfo("IsoTrack") << "Primary Vertex " << leadPV;
321  if (beamSpotH.isValid()) edm::LogInfo("IsoTrack") << " Beam Spot "
322  << beamSpotH->position();
323  }
324 
325  // RecHits
326  edm::Handle<EcalRecHitCollection> barrelRecHitsHandle;
327  edm::Handle<EcalRecHitCollection> endcapRecHitsHandle;
328  iEvent.getByToken(tok_EB_, barrelRecHitsHandle);
329  iEvent.getByToken(tok_EE_, endcapRecHitsHandle);
331  iEvent.getByToken(tok_hbhe_, hbhe);
333 
334  for (rhitItr=hbhe->begin();rhitItr!=hbhe->end();rhitItr++) {
335  double rec_energy = rhitItr->energy();
336  int rec_ieta = rhitItr->id().ieta();
337  int rec_depth = rhitItr->id().depth();
338  int rec_zside = rhitItr->id().zside();
339  double num1_1 = rec_zside*(rec_ieta+0.2*(rec_depth-1));
340  if (verbosity_%10>0)
341  edm::LogInfo("IsoTrack") << "detid/rechit/ieta/zside/depth/num " << " = "
342  << rhitItr->id() << "/" << rec_energy << "/"
343  << rec_ieta << "/" << rec_zside << "/"
344  << rec_depth << "/" << num1_1;
345  h_iEta->Fill(rec_ieta);
346  h_Rechit_E->Fill(rec_energy);
347  h_RecHit_iEta->Fill(rec_ieta,rec_energy);
348  h_RecHit_num->Fill(num1_1,rec_energy);
349  }
350 
351  //Propagate tracks to calorimeter surface)
352  std::vector<spr::propagatedTrackDirection> trkCaloDirections;
353  spr::propagateCALO(trkCollection, geo, bField, theTrackQuality_,
354  trkCaloDirections, ((verbosity_/100)%10>2));
355  std::vector<spr::propagatedTrackDirection>::const_iterator trkDetItr;
356  for (trkDetItr = trkCaloDirections.begin();
357  trkDetItr != trkCaloDirections.end(); trkDetItr++) {
358  if (trkDetItr->okHCAL) {
359  HcalDetId detId = (HcalDetId)(trkDetItr->detIdHCAL);
360  int tk_ieta = detId.ieta();
361  const reco::Track* pTrack = &(*(trkDetItr->trkItr));
362  double tk_p = pTrack->p();
363  h_tketa0[0]->Fill(tk_ieta);
364  for (unsigned int k=1; k<pbin.size(); ++k) {
365  if (tk_p >= pbin[k-1] && tk_p < pbin[k]) {
366  h_tketa0[k]->Fill(tk_ieta);
367  break;
368  }
369  }
370  }
371  }
373  t_l1bits->clear();
374  for (unsigned int i=0; i<l1Names_.size(); ++i) t_l1bits->push_back(false);
375  bool useL1EventSetup = true;
376  bool useL1GtTriggerMenuLite = true;
377 
378  m_l1GtUtils.getL1GtRunCache(iEvent, iSetup, useL1EventSetup, useL1GtTriggerMenuLite);
379  int iErrorCode = -1;
380  int l1ConfCode = -1;
381  const bool l1Conf = m_l1GtUtils.availableL1Configuration(iErrorCode, l1ConfCode);
382  if( !l1Conf) {
383  edm::LogInfo("IsoTrack") << "\nL1 configuration code:" << l1ConfCode
384  << "\nNo valid L1 trigger configuration available."
385  << "\nSee text above for error code interpretation"
386  << "\nNo return here, in order to test each method"
387  << ", protected against configuration error.";
388  }
389 
390  const AlgorithmMap& algorithmMap = m_l1GtMenu->gtAlgorithmMap();
391  const std::string& menuName = m_l1GtMenu->gtTriggerMenuName();
392  if (verbosity_%10>0)
393  edm::LogInfo("IsoTrack") << "menuName " << menuName << std::endl;
394 
395  std::vector<int> algbits;
396  for (CItAlgo itAlgo = algorithmMap.begin(); itAlgo != algorithmMap.end();
397  itAlgo++) {
398  std::string algName = itAlgo->first;
399  int algBitNumber = ( itAlgo->second ).algoBitNumber();
400  bool decision = m_l1GtUtils.decision(iEvent, itAlgo->first, iErrorCode);
401 
402  bool l1ok(false);
403  if (verbosity_%10>0)
404  edm::LogInfo("IsoTrack") << algName <<" "<< algBitNumber << " "
405  << decision;
406  for (unsigned int i=0; i<l1Names_.size(); ++i) {
407  if (algName.find(l1Names_[i])!=std::string::npos){
408  if (verbosity_%10>0)
409  edm::LogInfo("IsoTrack") << "match found" << " " << algName << " "
410  << decision;
411  t_l1bits->at(i) = (decision>0);
412  if (decision > 0) l1ok = true;
413  }
414  }
415  if (verbosity_%10>0) edm::LogInfo("IsoTrack") << "l1 ok =" << l1ok;
416 
417  if(l1ok){
419  iEvent.getByToken(tok_L1extTauJet_,l1TauHandle);
420  l1extra::L1JetParticleCollection::const_iterator itr;
421  double ptTriggered = -10;
422  double etaTriggered = -100;
423  double phiTriggered = -100;
424 
425  for(itr = l1TauHandle->begin(); itr != l1TauHandle->end(); ++itr) {
426  if(itr->pt()>ptTriggered){
427  ptTriggered = itr->pt();
428  etaTriggered = itr->eta();
429  phiTriggered = itr->phi() ;
430  }
431  if (verbosity_%10>0)
432  edm::LogInfo("IsoTrack") << "tauJ pt " << itr->pt() << " eta/phi "
433  << itr->eta() << " " << itr->phi();
434  }
436  iEvent.getByToken(tok_L1extCenJet_,l1CenJetHandle);
437  for (itr = l1CenJetHandle->begin(); itr != l1CenJetHandle->end(); ++itr){
438  if (itr->pt()>ptTriggered) {
439  ptTriggered = itr->pt();
440  etaTriggered = itr->eta();
441  phiTriggered = itr->phi() ;
442  }
443  if (verbosity_%10>0)
444  edm::LogInfo("IsoTrack") << "cenJ pt " << itr->pt()
445  << " eta/phi " << itr->eta() << " "
446  << itr->phi();
447  }
449  iEvent.getByToken(tok_L1extFwdJet_,l1FwdJetHandle);
450  for (itr = l1FwdJetHandle->begin(); itr != l1FwdJetHandle->end(); ++itr) {
451  if (itr->pt()>ptTriggered) {
452  ptTriggered = itr->pt();
453  etaTriggered = itr->eta();
454  phiTriggered = itr->phi() ;
455  }
456  if (verbosity_%10>0)
457  edm::LogInfo("IsoTrack") << "forJ pt " << itr->pt() << " eta/phi "
458  << itr->eta() << " " << itr->phi();
459  }
460  if (verbosity_%10>0)
461  edm::LogInfo("IsoTrack") << "jets pt/eta/phi = " << ptTriggered << "/"
462  << etaTriggered << "/" <<phiTriggered;
464  unsigned int nTracks(0),nselTracks(0);
465  for (trkDetItr = trkCaloDirections.begin(),nTracks=0;
466  trkDetItr != trkCaloDirections.end(); trkDetItr++,nTracks++) {
467  const reco::Track* pTrack = &(*(trkDetItr->trkItr));
468  math::XYZTLorentzVector v4(pTrack->px(), pTrack->py(),
469  pTrack->pz(), pTrack->p());
470 
471  t_mindR1 = deltaR(etaTriggered,v4.eta(),phiTriggered,v4.phi());
472  t_mindR2 = -999;
473  if (verbosity_%10>0)
474  edm::LogInfo("IsoTrack") << "This track : " << nTracks << " (pt/eta/phi/p) :"
475  << pTrack->pt() << "/" << pTrack->eta() << "/"
476  << pTrack->phi() << "/" << pTrack->p();
477 
478  if (verbosity_%10>0) edm::LogInfo("IsoTrack") << "dr values are = " << t_mindR1;
479 
480  t_l1pt = ptTriggered;
481  t_l1eta = etaTriggered;
482  t_l1phi = phiTriggered;
483  t_l3pt = -999;
484  t_l3eta = -999;
485  t_l3phi = -999;
486 
487  //Selection of good track
488  t_selectTk = spr::goodTrack(pTrack,leadPV,selectionParameters_,((verbosity_/100)%10>2));
490  oneCutParameters.maxDxyPV = 10;
491  oneCutParameters.maxDzPV = 100;
492  oneCutParameters.maxInMiss = 2;
493  oneCutParameters.maxOutMiss= 2;
494  bool qltyFlag = spr::goodTrack(pTrack,leadPV,oneCutParameters,((verbosity_/100)%10>2));
495  oneCutParameters = selectionParameters_;
496  oneCutParameters.maxDxyPV = 10;
497  oneCutParameters.maxDzPV = 100;
498  t_qltyMissFlag = spr::goodTrack(pTrack,leadPV,oneCutParameters,((verbosity_/100)%10>2));
499  oneCutParameters = selectionParameters_;
500  oneCutParameters.maxInMiss = 2;
501  oneCutParameters.maxOutMiss= 2;
502  t_qltyPVFlag = spr::goodTrack(pTrack,leadPV,oneCutParameters,((verbosity_/100)%10>2));
503  t_ieta = 0;
504  if (trkDetItr->okHCAL) {
505  HcalDetId detId = (HcalDetId)(trkDetItr->detIdHCAL);
506  t_ieta = detId.ieta();
507  }
508  if (verbosity_%10 > 0)
509  edm::LogInfo("IsoTrack") << "qltyFlag|okECAL|okHCAL : " << qltyFlag << "|"
510  << trkDetItr->okECAL << "/" << trkDetItr->okHCAL;
511  t_qltyFlag = (qltyFlag && trkDetItr->okECAL && trkDetItr->okHCAL);
512  t_p = pTrack->p();
513  h_tketa1[0]->Fill(t_ieta);
514  for (unsigned int k=1; k<pbin.size(); ++k) {
515  if (t_p >= pbin[k-1] && t_p < pbin[k]) {
516  h_tketa1[k]->Fill(t_ieta);
517  break;
518  }
519  }
520  if (t_qltyFlag) {
521  nselTracks++;
522  h_tketa2[0]->Fill(t_ieta);
523  for (unsigned int k=1; k<pbin.size(); ++k) {
524  if (t_p >= pbin[k-1] && t_p < pbin[k]) {
525  h_tketa2[k]->Fill(t_ieta);
526  break;
527  }
528  }
529  int nRH_eMipDR(0), nNearTRKs(0), nRecHits(-999);
530  t_eMipDR = spr::eCone_ecal(geo, barrelRecHitsHandle,
531  endcapRecHitsHandle,
532  trkDetItr->pointHCAL,
533  trkDetItr->pointECAL,
534  a_mipR_, trkDetItr->directionECAL,
535  nRH_eMipDR);
536  t_DetIds->clear(); t_HitEnergies->clear();
537  std::vector<DetId> ids;
538  t_eHcal = spr::eCone_hcal(geo, hbhe, trkDetItr->pointHCAL,
539  trkDetItr->pointECAL, a_coneR_,
540  trkDetItr->directionHCAL,nRecHits,
541  ids, *t_HitEnergies);
542  for (unsigned int k=0; k<ids.size(); ++k) {
543  t_DetIds->push_back(ids[k].rawId());
544  }
545  t_hmaxNearP = spr::chargeIsolationCone(nTracks,trkCaloDirections,
546  a_charIsoR_, nNearTRKs,
547  ((verbosity_/100)%10>2));
548  if (t_hmaxNearP < 2) {
549  h_tketa3[0]->Fill(t_ieta);
550  for (unsigned int k=1; k<pbin.size(); ++k) {
551  if (t_p >= pbin[k-1] && t_p < pbin[k]) {
552  h_tketa3[k]->Fill(t_ieta);
553  break;
554  }
555  }
556  if (t_eMipDR < 1) {
557  h_tketa4[0]->Fill(t_ieta);
558  for (unsigned int k=1; k<pbin.size(); ++k) {
559  if (t_p >= pbin[k-1] && t_p < pbin[k]) {
560  h_tketa4[k]->Fill(t_ieta);
561  break;
562  }
563  }
564  if (t_mindR1 > 1) {
565  h_tketa5[0]->Fill(t_ieta);
566  for (unsigned int k=1; k<pbin.size(); ++k) {
567  if (t_p >= pbin[k-1] && t_p < pbin[k]) {
568  h_tketa5[k]->Fill(t_ieta);
569  break;
570  }
571  }
572  }
573  }
574  }
575  if (verbosity_%10 > 0) {
576  edm::LogInfo("IsoTrack") << "This track : " << nTracks << " (pt/eta/phi/p) :"
577  << pTrack->pt() << "/" << pTrack->eta() << "/"
578  << pTrack->phi() << "/" << t_p;
579  edm::LogInfo("IsoTrack") << "e_MIP " << t_eMipDR << " Chg Isolation "
580  << t_hmaxNearP << " eHcal" << t_eHcal << " ieta "
581  << t_ieta << " Quality " << t_qltyMissFlag
582  << ":" << t_qltyPVFlag << ":" << t_selectTk;
583  for (unsigned int lll=0;lll<t_DetIds->size();lll++) {
584  edm::LogInfo("IsoTrack") << "det id is = " << t_DetIds->at(lll) << " "
585  << " hit enery is = " << t_HitEnergies->at(lll);
586  }
587  }
588  if (t_p>20.0 && t_eMipDR<2.0 && t_hmaxNearP<10.0) {
589  tree->Fill();
590  }
591  }
592  }
593  }
594  }
595 }
RunNumber_t run() const
Definition: EventID.h:39
double p() const
momentum vector magnitude
Definition: TrackBase.h:615
double eCone_hcal(const CaloGeometry *geo, edm::Handle< T > &hits, const GlobalPoint &hpoint1, const GlobalPoint &point1, double dR, const GlobalVector &trackMom, int &nRecHits, double hbThr=-100, double heThr=-100, double hfThr=-100, double hoThr=-100, double tMin=-500, double tMax=500, int detOnly=-1, int useRaw=0, bool debug=false)
const std::string & gtTriggerMenuName() const
EventNumber_t event() const
Definition: EventID.h:41
spr::trackSelectionParameters selectionParameters_
std::vector< double > * t_HitEnergies
const edm::EDGetTokenT< reco::TrackCollection > tok_genTrack_
std::vector< spr::propagatedTrackID > propagateCALO(edm::Handle< reco::TrackCollection > &trkCollection, const CaloGeometry *geo, const MagneticField *bField, const std::string &theTrackQuality, bool debug=false)
const unsigned int nTracks(const reco::Vertex &sv)
const L1GtTriggerMenu * m_l1GtMenu
const edm::EDGetTokenT< GenEventInfoProduct > tok_ew_
std::vector< unsigned int > * t_DetIds
double eta() const final
momentum pseudorapidity
const double a_mipR_
edm::EDGetTokenT< EcalRecHitCollection > tok_EE_
TProfile * h_RecHit_num
edm::EDGetTokenT< l1extra::L1JetParticleCollection > tok_L1extCenJet_
const int verbosity_
bool getByToken(EDGetToken token, Handle< PROD > &result) const
Definition: Event.h:579
std::map< std::string, L1GtAlgorithm > AlgorithmMap
map containing the algorithms
const bool availableL1Configuration(int &errorCode, int &l1ConfCode) const
Definition: L1GtUtils.cc:1948
const edm::EDGetTokenT< reco::BeamSpot > tok_bs_
TH1I * h_tketa0[6]
std::vector< HBHERecHit >::const_iterator const_iterator
int bunchCrossing() const
Definition: EventBase.h:66
TH1I * h_tketa3[6]
edm::LuminosityBlockNumber_t luminosityBlock() const
Definition: EventBase.h:63
double phi() const
azimuthal angle of momentum vector
Definition: TrackBase.h:645
double pt() const final
transverse momentum
const bool decision(const edm::Event &iEvent, const std::string &nameAlgoTechTrig, int &errorCode) const
Definition: L1GtUtils.cc:1208
double chargeIsolationCone(unsigned int trkIndex, std::vector< spr::propagatedTrackDirection > &trkDirs, double dR, int &nNearTRKs, bool debug=false)
double px() const
x coordinate of momentum vector
Definition: TrackBase.h:627
double weight() const
edm::EDGetTokenT< l1extra::L1JetParticleCollection > tok_L1extTauJet_
edm::EDGetTokenT< HBHERecHitCollection > tok_hbhe_
const std::string theTrackQuality_
TH1I * h_tketa5[6]
TH1I * h_tketa1[6]
AlgorithmMap::const_iterator CItAlgo
iterators through map containing the algorithms
XYZTLorentzVectorD XYZTLorentzVector
Lorentz vector with cylindrical internal representation using pseudorapidity.
Definition: LorentzVector.h:29
TH1I * h_tketa4[6]
static const bool useL1EventSetup(false)
double eta() const
pseudorapidity of momentum vector
Definition: TrackBase.h:651
std::vector< double > pbin
static const bool useL1GtTriggerMenuLite(true)
double deltaR(double eta1, double eta2, double phi1, double phi2)
bool goodTrack(const reco::Track *pTrack, math::XYZPoint leadPV, trackSelectionParameters parameters, bool debug=false)
std::vector< bool > * t_l1bits
double pt() const
track transverse momentum
Definition: TrackBase.h:621
TH1I * h_tketa2[6]
int ieta() const
get the cell ieta
Definition: HcalDetId.h:155
edm::EDGetTokenT< EcalRecHitCollection > tok_EB_
const double a_charIsoR_
Jets made from MC generator particles.
Definition: GenJet.h:24
const edm::EDGetTokenT< reco::VertexCollection > tok_recVtx_
double eCone_ecal(const CaloGeometry *geo, edm::Handle< T > &barrelhits, edm::Handle< T > &endcaphits, const GlobalPoint &hpoint1, const GlobalPoint &point1, double dR, const GlobalVector &trackMom, int &nRecHits, double ebThr=-100, double eeThr=-100, double tMin=-500, double tMax=500, bool debug=false)
edm::EDGetTokenT< l1extra::L1JetParticleCollection > tok_L1extFwdJet_
const edm::EDGetTokenT< reco::GenJetCollection > tok_jets_
bool isValid() const
Definition: HandleBase.h:74
double pz() const
z coordinate of momentum vector
Definition: TrackBase.h:639
int k[5][pyjets_maxn]
const_iterator end() const
double t_EventWeight
L1GtUtils m_l1GtUtils
TProfile * h_RecHit_iEta
XYZPointD XYZPoint
point in space with cartesian internal representation
Definition: Point3D.h:12
edm::EventID id() const
Definition: EventBase.h:60
void getL1GtRunCache(const edm::Run &, const edm::EventSetup &, const bool, const bool)
get all the run-constant quantities for L1 trigger and cache them
Definition: L1GtUtils.cc:319
T get() const
Definition: EventSetup.h:63
const AlgorithmMap & gtAlgorithmMap() const
get / set the algorithm map (by name)
const Point & position() const
position
Definition: BeamSpot.h:62
Definition: tree.py:1
const edm::EDGetTokenT< reco::PFJetCollection > tok_pfjets_
const double a_coneR_
TH1F * h_jetpt[4]
T const * product() const
Definition: ESHandle.h:86
const std::vector< std::string > l1Names_
const_iterator begin() const
double py() const
y coordinate of momentum vector
Definition: TrackBase.h:633
void IsoTrackCalib::beginJob ( void  )
overrideprivatevirtual

Reimplemented from edm::one::EDAnalyzerBase.

Definition at line 597 of file IsoTrackCalib.cc.

References fs_, h_iEta, h_jetpt, h_Rechit_E, h_RecHit_iEta, h_RecHit_num, h_tketa0, h_tketa1, h_tketa2, h_tketa3, h_tketa4, h_tketa5, gen::k, TFileService::make(), dataset::name, pbin, AlCaHLTBitMon_QueryRunRegistry::string, t_DetIds, t_eHcal, t_eMipDR, t_Event, t_EventWeight, t_HitEnergies, t_hmaxNearP, t_ieta, t_l1bits, t_l1eta, t_l1phi, t_l1pt, t_l3eta, t_l3phi, t_l3pt, t_mindR1, t_mindR2, t_p, t_qltyFlag, t_qltyMissFlag, t_qltyPVFlag, t_Run, t_selectTk, and fftjetcommon_cfi::title.

597  {
598  h_RecHit_iEta = fs_->make<TProfile>("rechit_ieta","Rec hit vs. ieta",60,-30,30,0,1000);
599  h_RecHit_num = fs_->make<TProfile>("rechit_num","Rec hit vs. num",100,0,20,0,1000);
600  h_iEta = fs_->make<TH1I>("iEta","iEta",60,-30,30);
601  h_Rechit_E = fs_->make<TH1F>("Rechit_E","Rechit_E",100,0,1000);
602 
603  double prange[5] = {20,30,40,60,100};
604  for (int k=0; k<5; ++k) pbin.push_back(prange[k]);
605  std::string type[6] = {"All", "Trigger OK", "Tree Selected",
606  "Charge Isolation", "MIP Cut", "L1 Cut"};
607  for (unsigned int k=0; k<pbin.size(); ++k) {
608  char name[20], namp[20], title[100];
609  if (k == 0) sprintf (namp, "all momentum");
610  else sprintf (namp, "p = %4.0f:%4.0f GeV", pbin[k-1], pbin[k]);
611  sprintf (name, "TrackEta0%d", k);
612  sprintf (title, "Track #eta for tracks with %s (%s)",namp,type[0].c_str());
613  h_tketa0[k] = fs_->make<TH1I>(name, title, 60, -30, 30);
614  sprintf (name, "TrackEta1%d", k);
615  sprintf (title, "Track #eta for tracks with %s (%s)",namp,type[1].c_str());
616  h_tketa1[k] = fs_->make<TH1I>(name, title, 60, -30, 30);
617  sprintf (name, "TrackEta2%d", k);
618  sprintf (title, "Track #eta for tracks with %s (%s)",namp,type[2].c_str());
619  h_tketa2[k] = fs_->make<TH1I>(name, title, 60, -30, 30);
620  sprintf (name, "TrackEta3%d", k);
621  sprintf (title, "Track #eta for tracks with %s (%s)",namp,type[3].c_str());
622  h_tketa3[k] = fs_->make<TH1I>(name, title, 60, -30, 30);
623  sprintf (name, "TrackEta4%d", k);
624  sprintf (title, "Track #eta for tracks with %s (%s)",namp,type[4].c_str());
625  h_tketa4[k] = fs_->make<TH1I>(name, title, 60, -30, 30);
626  sprintf (name, "TrackEta5%d", k);
627  sprintf (title, "Track #eta for tracks with %s (%s)",namp,type[5].c_str());
628  h_tketa5[k] = fs_->make<TH1I>(name, title, 60, -30, 30);
629  }
630  h_jetpt[0] = fs_->make<TH1F>("Jetpt0","Jet p_T (All)", 500,0.,2500.);
631  h_jetpt[1] = fs_->make<TH1F>("Jetpt1","Jet p_T (All Weighted)", 500,0.,2500.);
632  h_jetpt[2] = fs_->make<TH1F>("Jetpt2","Jet p_T (|#eta| < 2.5)", 500,0.,2500.);
633  h_jetpt[3] = fs_->make<TH1F>("Jetpt3","Jet p_T (|#eta| < 2.5 Weighted)", 500,0.,2500.);
634 
635  tree = fs_->make<TTree>("CalibTree", "CalibTree");
636 
637  tree->Branch("t_Run", &t_Run, "t_Run/I");
638  tree->Branch("t_Event", &t_Event, "t_Event/I");
639  tree->Branch("t_ieta", &t_ieta, "t_ieta/I");
640  tree->Branch("t_EventWeight", &t_EventWeight, "t_EventWeight/D");
641  tree->Branch("t_l1pt", &t_l1pt, "t_l1pt/D");
642  tree->Branch("t_l1eta", &t_l1eta, "t_l1eta/D");
643  tree->Branch("t_l1phi", &t_l1phi, "t_l1phi/D");
644  tree->Branch("t_l3pt", &t_l3pt, "t_l3pt/D");
645  tree->Branch("t_l3eta", &t_l3eta, "t_l3eta/D");
646  tree->Branch("t_l3phi", &t_l3phi, "t_l3phi/D");
647  tree->Branch("t_p", &t_p, "t_p/D");
648  tree->Branch("t_mindR1", &t_mindR1, "t_mindR1/D");
649  tree->Branch("t_mindR2", &t_mindR2, "t_mindR2/D");
650  tree->Branch("t_eMipDR", &t_eMipDR, "t_eMipDR/D");
651  tree->Branch("t_eHcal", &t_eHcal, "t_eHcal/D");
652  tree->Branch("t_hmaxNearP", &t_hmaxNearP, "t_hmaxNearP/D");
653  tree->Branch("t_selectTk", &t_selectTk, "t_selectTk/O");
654  tree->Branch("t_qltyFlag", &t_qltyFlag, "t_qltyFlag/O");
655  tree->Branch("t_qltyMissFlag",&t_qltyMissFlag,"t_qltyMissFlag/O");
656  tree->Branch("t_qltyPVFlag", &t_qltyPVFlag, "t_qltyPVFlag/O)");
657 
658  t_DetIds = new std::vector<unsigned int>();
659  t_HitEnergies = new std::vector<double>();
660  t_l1bits = new std::vector<bool>();
661  tree->Branch("t_DetIds", "std::vector<unsigned int>", &t_DetIds);
662  tree->Branch("t_HitEnergies", "std::vector<double>", &t_HitEnergies);
663  tree->Branch("t_l1bits","std::vector<bool>", &t_l1bits);
664 }
type
Definition: HCALResponse.h:21
std::vector< double > * t_HitEnergies
std::vector< unsigned int > * t_DetIds
TProfile * h_RecHit_num
TH1I * h_tketa0[6]
TH1I * h_tketa3[6]
T * make(const Args &...args) const
make new ROOT object
Definition: TFileService.h:64
TH1I * h_tketa5[6]
TH1I * h_tketa1[6]
TH1I * h_tketa4[6]
std::vector< double > pbin
edm::Service< TFileService > fs_
std::vector< bool > * t_l1bits
TH1I * h_tketa2[6]
int k[5][pyjets_maxn]
double t_EventWeight
TProfile * h_RecHit_iEta
Definition: tree.py:1
TH1F * h_jetpt[4]
void IsoTrackCalib::beginRun ( edm::Run const &  iRun,
edm::EventSetup const &  iSetup 
)
overrideprivate

Definition at line 667 of file IsoTrackCalib.cc.

References plotBeamSpotDB::first, L1GtTriggerMenu::gtAlgorithmMap(), L1GtTriggerMenu::gtTriggerMenuName(), hltConfig_, HLTConfigProvider::init(), l1AlgoMap_, m_l1GtMenu, m_l1GtUtils, convertSQLiteXML::ok, L1GtUtils::ptrL1TriggerMenuEventSetup(), edm::RunBase::run(), AlCaHLTBitMon_QueryRunRegistry::string, and verbosity_.

Referenced by endJob().

667  {
668  bool changed = false;
669  bool ok = hltConfig_.init(iRun,iSetup,"HLT",changed);
670  edm::LogInfo("IsoTrack") << "Run " << iRun.run() << " hltconfig.init " << ok;
671 
672  int iErrorCode = -1;
674  const AlgorithmMap& algorithmMap = m_l1GtMenu->gtAlgorithmMap();
675  const std::string& menuName = m_l1GtMenu->gtTriggerMenuName();
676 
677  if (verbosity_%10>0) edm::LogInfo("IsoTrack") << "menuName " << menuName;
678  for (CItAlgo itAlgo = algorithmMap.begin(); itAlgo != algorithmMap.end();
679  itAlgo++) {
680  std::string algName = itAlgo->first;
681  int algBitNumber = ( itAlgo->second ).algoBitNumber();
682  l1AlgoMap_.insert( std::pair<std::pair<unsigned int,std::string>,int>( std::pair<unsigned int,std::string>(algBitNumber, algName) , 0) ) ;
683  }
684  std::map< std::pair<unsigned int,std::string>, int>::iterator itr;
685  for (itr=l1AlgoMap_.begin(); itr!=l1AlgoMap_.end(); itr++) {
686  if (verbosity_%10>0)
687  edm::LogInfo("IsoTrack") << " ********** " << (itr->first).first << " "
688  << (itr->first).second <<" "<<itr->second;
689  }
690 }
const std::string & gtTriggerMenuName() const
const L1GtTriggerMenu * m_l1GtMenu
HLTConfigProvider hltConfig_
const int verbosity_
std::map< std::pair< unsigned int, std::string >, int > l1AlgoMap_
std::map< std::string, L1GtAlgorithm > AlgorithmMap
map containing the algorithms
AlgorithmMap::const_iterator CItAlgo
iterators through map containing the algorithms
L1GtUtils m_l1GtUtils
bool init(const edm::Run &iRun, const edm::EventSetup &iSetup, const std::string &processName, bool &changed)
d&#39;tor
const AlgorithmMap & gtAlgorithmMap() const
get / set the algorithm map (by name)
const L1GtTriggerMenu * ptrL1TriggerMenuEventSetup(int &errorCode)
return a pointer to the L1 trigger menu from event setup
Definition: L1GtUtils.cc:1883
double IsoTrackCalib::deltaR ( double  eta1,
double  eta2,
double  phi1,
double  phi2 
)
private

Definition at line 719 of file IsoTrackCalib.cc.

References DEFINE_FWK_MODULE, M_PI, and mathSSE::sqrt().

Referenced by analyze(), and endJob().

719  {
720  double deta = eta1-eta2;
721  if (phi1 < 0) phi1 += 2.0*M_PI;
722  if (phi2 < 0) phi2 += 2.0*M_PI;
723  double dphi = phi1-phi2;
724  if (dphi > M_PI) dphi -= 2.*M_PI;
725  else if (dphi < -M_PI) dphi += 2.*M_PI;
726  return std::sqrt(deta*deta + dphi*dphi);
727 }
T sqrt(T t)
Definition: SSEVec.h:18
#define M_PI
double IsoTrackCalib::dEta ( math::XYZTLorentzVector vec1,
math::XYZTLorentzVector vec2 
)
private

Definition at line 697 of file IsoTrackCalib.cc.

Referenced by dR(), and endJob().

697  {
698  return (vec1.eta()-vec2.eta());
699 }
std::vector< double > vec1
Definition: HCALResponse.h:15
std::vector< vec1 > vec2
Definition: HCALResponse.h:16
double IsoTrackCalib::dPhi ( math::XYZTLorentzVector vec1,
math::XYZTLorentzVector vec2 
)
private

Definition at line 701 of file IsoTrackCalib.cc.

References M_PI.

Referenced by dR(), and endJob().

701  {
702 
703  double phi1 = vec1.phi();
704  if (phi1 < 0) phi1 += 2.0*M_PI;
705  double phi2 = vec2.phi();
706  if (phi2 < 0) phi2 += 2.0*M_PI;
707  double dphi = phi1-phi2;
708  if (dphi > M_PI) dphi -= 2.*M_PI;
709  else if (dphi < -M_PI) dphi += 2.*M_PI;
710  return dphi;
711 }
std::vector< double > vec1
Definition: HCALResponse.h:15
#define M_PI
std::vector< vec1 > vec2
Definition: HCALResponse.h:16
double IsoTrackCalib::dR ( math::XYZTLorentzVector vec1,
math::XYZTLorentzVector vec2 
)
private

Definition at line 713 of file IsoTrackCalib.cc.

References dEta(), dPhi(), and mathSSE::sqrt().

Referenced by endJob().

713  {
714  double deta = dEta(vec1,vec2);
715  double dphi = dPhi(vec1,vec2);
716  return std::sqrt(deta*deta + dphi*dphi);
717 }
std::vector< double > vec1
Definition: HCALResponse.h:15
T sqrt(T t)
Definition: SSEVec.h:18
double dEta(math::XYZTLorentzVector &, math::XYZTLorentzVector &)
double dPhi(math::XYZTLorentzVector &, math::XYZTLorentzVector &)
std::vector< vec1 > vec2
Definition: HCALResponse.h:16
void IsoTrackCalib::endJob ( void  )
inlineoverrideprivatevirtual

Reimplemented from edm::one::EDAnalyzerBase.

Definition at line 93 of file IsoTrackCalib.cc.

References beginRun(), deltaR(), dEta(), dPhi(), dR(), and endRun().

Referenced by o2olib.O2ORunMgr::executeJob().

93 {}
void IsoTrackCalib::endRun ( edm::Run const &  iRun,
edm::EventSetup const &   
)
overrideprivate

Definition at line 693 of file IsoTrackCalib.cc.

References edm::RunBase::run().

Referenced by endJob().

693  {
694  edm::LogInfo("IsoTrack") << "endRun " << iRun.run() << std::endl;
695 }
void IsoTrackCalib::fillDescriptions ( edm::ConfigurationDescriptions descriptions)
static

Definition at line 225 of file IsoTrackCalib.cc.

References edm::ConfigurationDescriptions::add(), edm::ParameterSetDescription::addUntracked(), and AlCaHLTBitMon_QueryRunRegistry::string.

225  {
226 
227  std::vector<std::string> seeds = {"L1_SingleJet36","L1_SingleJet52",
228  "L1_SingleJet68","L1_SingleJet92",
229  "L1_SingleJet128"};
231  desc.addUntracked<int>("Verbosity", 0);
232  desc.addUntracked<std::vector<std::string> >("L1Seed", seeds);
233  desc.addUntracked<std::string>("TrackQuality", "highPurity");
234  desc.addUntracked<double>("MinTrackPt", 10.0);
235  desc.addUntracked<double>("MaxDxyPV", 0.02);
236  desc.addUntracked<double>("MaxDzPV", 0.02);
237  desc.addUntracked<double>("MaxChi2", 5.0);
238  desc.addUntracked<double>("MaxDpOverP", 0.1);
239  desc.addUntracked<int>("MinOuterHit", 4);
240  desc.addUntracked<int>("MinLayerCrossed", 8);
241  desc.addUntracked<int>("MaxInMiss", 0);
242  desc.addUntracked<int>("MaxOutMiss", 0);
243  desc.addUntracked<double>("ConeRadius", 34.98);
244  desc.addUntracked<double>("ConeRadiusMIP",14.0);
245  desc.addUntracked<bool>("IsItAOD", false);
246  descriptions.add("isoTrackCalib",desc);
247 }
ParameterDescriptionBase * addUntracked(U const &iLabel, T const &value)
void add(std::string const &label, ParameterSetDescription const &psetDescription)

Member Data Documentation

const double IsoTrackCalib::a_charIsoR_
private

Definition at line 110 of file IsoTrackCalib.cc.

Referenced by analyze(), and IsoTrackCalib().

const double IsoTrackCalib::a_coneR_
private

Definition at line 110 of file IsoTrackCalib.cc.

Referenced by analyze(), and IsoTrackCalib().

const double IsoTrackCalib::a_mipR_
private

Definition at line 110 of file IsoTrackCalib.cc.

Referenced by analyze(), and IsoTrackCalib().

edm::Service<TFileService> IsoTrackCalib::fs_
private

Definition at line 102 of file IsoTrackCalib.cc.

Referenced by beginJob().

TH1I* IsoTrackCalib::h_iEta
private

Definition at line 136 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

TH1F * IsoTrackCalib::h_jetp
private

Definition at line 138 of file IsoTrackCalib.cc.

TH1F* IsoTrackCalib::h_jetpt[4]
private

Definition at line 139 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

TH1F* IsoTrackCalib::h_Rechit_E
private

Definition at line 138 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

TProfile* IsoTrackCalib::h_RecHit_iEta
private

Definition at line 135 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

TProfile * IsoTrackCalib::h_RecHit_num
private

Definition at line 135 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

TH1I * IsoTrackCalib::h_tkEta0[5]
private

Definition at line 136 of file IsoTrackCalib.cc.

TH1I* IsoTrackCalib::h_tketa0[6]
private

Definition at line 140 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

TH1I * IsoTrackCalib::h_tkEta1[5]
private

Definition at line 136 of file IsoTrackCalib.cc.

TH1I * IsoTrackCalib::h_tketa1[6]
private

Definition at line 140 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

TH1I * IsoTrackCalib::h_tkEta2[5]
private

Definition at line 136 of file IsoTrackCalib.cc.

TH1I * IsoTrackCalib::h_tketa2[6]
private

Definition at line 140 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

TH1I* IsoTrackCalib::h_tkEta3[5]
private

Definition at line 137 of file IsoTrackCalib.cc.

TH1I* IsoTrackCalib::h_tketa3[6]
private

Definition at line 141 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

TH1I * IsoTrackCalib::h_tkEta4[5]
private

Definition at line 137 of file IsoTrackCalib.cc.

TH1I * IsoTrackCalib::h_tketa4[6]
private

Definition at line 141 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

TH1I * IsoTrackCalib::h_tkEta5[5]
private

Definition at line 137 of file IsoTrackCalib.cc.

TH1I * IsoTrackCalib::h_tketa5[6]
private

Definition at line 141 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

HLTConfigProvider IsoTrackCalib::hltConfig_
private

Definition at line 103 of file IsoTrackCalib.cc.

Referenced by beginRun().

std::map< std::pair<unsigned int,std::string>, int> IsoTrackCalib::l1AlgoMap_
private

Definition at line 142 of file IsoTrackCalib.cc.

Referenced by beginRun().

const std::vector<std::string> IsoTrackCalib::l1Names_
private

Definition at line 107 of file IsoTrackCalib.cc.

Referenced by analyze(), and IsoTrackCalib().

const L1GtTriggerMenu* IsoTrackCalib::m_l1GtMenu
private

Definition at line 105 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginRun().

L1GtUtils IsoTrackCalib::m_l1GtUtils
private

Definition at line 104 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginRun().

std::vector<double> IsoTrackCalib::pbin
private

Definition at line 134 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

spr::trackSelectionParameters IsoTrackCalib::selectionParameters_
private

Definition at line 108 of file IsoTrackCalib.cc.

Referenced by analyze(), and IsoTrackCalib().

std::vector<unsigned int>* IsoTrackCalib::t_DetIds
private

Definition at line 133 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

double IsoTrackCalib::t_eHcal
private

Definition at line 130 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

double IsoTrackCalib::t_eMipDR
private

Definition at line 130 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

int IsoTrackCalib::t_Event
private

Definition at line 127 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

double IsoTrackCalib::t_EventWeight
private

Definition at line 128 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

std::vector<double>* IsoTrackCalib::t_HitEnergies
private

Definition at line 134 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

double IsoTrackCalib::t_hmaxNearP
private

Definition at line 130 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

int IsoTrackCalib::t_ieta
private

Definition at line 127 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

std::vector<bool>* IsoTrackCalib::t_l1bits
private

Definition at line 111 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

double IsoTrackCalib::t_l1eta
private

Definition at line 128 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

double IsoTrackCalib::t_l1phi
private

Definition at line 128 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

double IsoTrackCalib::t_l1pt
private

Definition at line 128 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

double IsoTrackCalib::t_l3eta
private

Definition at line 129 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

double IsoTrackCalib::t_l3phi
private

Definition at line 129 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

double IsoTrackCalib::t_l3pt
private

Definition at line 129 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

double IsoTrackCalib::t_mindR1
private

Definition at line 129 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

double IsoTrackCalib::t_mindR2
private

Definition at line 130 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

double IsoTrackCalib::t_p
private

Definition at line 129 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

bool IsoTrackCalib::t_qltyFlag
private

Definition at line 132 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

bool IsoTrackCalib::t_qltyMissFlag
private

Definition at line 132 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

bool IsoTrackCalib::t_qltyPVFlag
private

Definition at line 132 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

int IsoTrackCalib::t_Run
private

Definition at line 127 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

bool IsoTrackCalib::t_selectTk
private

Definition at line 132 of file IsoTrackCalib.cc.

Referenced by analyze(), and beginJob().

const std::string IsoTrackCalib::theTrackQuality_
private

Definition at line 109 of file IsoTrackCalib.cc.

Referenced by analyze(), and IsoTrackCalib().

const edm::EDGetTokenT<reco::BeamSpot> IsoTrackCalib::tok_bs_
private

Definition at line 115 of file IsoTrackCalib.cc.

Referenced by analyze().

edm::EDGetTokenT<EcalRecHitCollection> IsoTrackCalib::tok_EB_
private

Definition at line 116 of file IsoTrackCalib.cc.

Referenced by analyze(), and IsoTrackCalib().

edm::EDGetTokenT<EcalRecHitCollection> IsoTrackCalib::tok_EE_
private

Definition at line 117 of file IsoTrackCalib.cc.

Referenced by analyze(), and IsoTrackCalib().

const edm::EDGetTokenT<GenEventInfoProduct> IsoTrackCalib::tok_ew_
private

Definition at line 119 of file IsoTrackCalib.cc.

Referenced by analyze().

const edm::EDGetTokenT<reco::TrackCollection> IsoTrackCalib::tok_genTrack_
private

Definition at line 113 of file IsoTrackCalib.cc.

Referenced by analyze().

edm::EDGetTokenT<HBHERecHitCollection> IsoTrackCalib::tok_hbhe_
private

Definition at line 118 of file IsoTrackCalib.cc.

Referenced by analyze(), and IsoTrackCalib().

const edm::EDGetTokenT<reco::GenJetCollection> IsoTrackCalib::tok_jets_
private

Definition at line 120 of file IsoTrackCalib.cc.

Referenced by analyze().

edm::EDGetTokenT<l1extra::L1JetParticleCollection> IsoTrackCalib::tok_L1extCenJet_
private

Definition at line 123 of file IsoTrackCalib.cc.

Referenced by analyze(), and IsoTrackCalib().

edm::EDGetTokenT<l1extra::L1JetParticleCollection> IsoTrackCalib::tok_L1extFwdJet_
private

Definition at line 124 of file IsoTrackCalib.cc.

Referenced by analyze(), and IsoTrackCalib().

edm::EDGetTokenT<l1extra::L1JetParticleCollection> IsoTrackCalib::tok_L1extTauJet_
private

Definition at line 122 of file IsoTrackCalib.cc.

Referenced by analyze(), and IsoTrackCalib().

const edm::EDGetTokenT<reco::PFJetCollection> IsoTrackCalib::tok_pfjets_
private

Definition at line 121 of file IsoTrackCalib.cc.

Referenced by analyze().

const edm::EDGetTokenT<reco::VertexCollection> IsoTrackCalib::tok_recVtx_
private

Definition at line 114 of file IsoTrackCalib.cc.

Referenced by analyze().

TTree* IsoTrackCalib::tree
private
const int IsoTrackCalib::verbosity_
private

Definition at line 106 of file IsoTrackCalib.cc.

Referenced by analyze(), beginRun(), and IsoTrackCalib().