#include <IsoTrig/IsoTrig/src/IsoTrig.cc>
Public Member Functions | |
IsoTrig (const edm::ParameterSet &) | |
~IsoTrig () | |
Public Member Functions inherited from edm::EDAnalyzer | |
void | callWhenNewProductsRegistered (std::function< void(BranchDescription const &)> const &func) |
EDAnalyzer () | |
ModuleDescription const & | moduleDescription () const |
std::string | workerType () const |
virtual | ~EDAnalyzer () |
Public Member Functions inherited from edm::EDConsumerBase | |
std::vector< ConsumesInfo > | consumesInfo () const |
EDConsumerBase () | |
ProductHolderIndexAndSkipBit | indexFrom (EDGetToken, BranchType, TypeID const &) const |
void | itemsMayGet (BranchType, std::vector< ProductHolderIndexAndSkipBit > &) const |
void | itemsToGet (BranchType, std::vector< ProductHolderIndexAndSkipBit > &) const |
std::vector < ProductHolderIndexAndSkipBit > const & | itemsToGetFromEvent () const |
void | labelsForToken (EDGetToken iToken, Labels &oLabels) const |
void | modulesDependentUpon (const std::string &iProcessName, std::vector< const char * > &oModuleLabels) const |
void | modulesWhoseProductsAreConsumed (std::vector< ModuleDescription const * > &modules, ProductRegistry const &preg, std::map< std::string, ModuleDescription const * > const &labelsToDesc, std::string const &processName) const |
bool | registeredToConsume (ProductHolderIndex, bool, BranchType) const |
bool | registeredToConsumeMany (TypeID const &, BranchType) const |
void | updateLookup (BranchType iBranchType, ProductHolderIndexHelper const &) |
virtual | ~EDConsumerBase () |
Static Public Member Functions | |
static void | fillDescriptions (edm::ConfigurationDescriptions &descriptions) |
Static Public Member Functions inherited from edm::EDAnalyzer | |
static const std::string & | baseType () |
static void | fillDescriptions (ConfigurationDescriptions &descriptions) |
static void | prevalidate (ConfigurationDescriptions &) |
Private Member Functions | |
virtual void | analyze (const edm::Event &, const edm::EventSetup &) |
virtual void | beginJob () |
virtual void | beginLuminosityBlock (edm::LuminosityBlock const &, edm::EventSetup const &) |
virtual void | beginRun (edm::Run const &, edm::EventSetup const &) |
void | chgIsolation (double &etaTriggered, double &phiTriggered, edm::Handle< reco::TrackCollection > &trkCollection, const edm::Event &theEvent) |
void | clearChgIsolnTreeVectors () |
void | clearMipCutTreeVectors () |
double | dEta (math::XYZTLorentzVector &, math::XYZTLorentzVector &) |
double | dinvPt (math::XYZTLorentzVector &, math::XYZTLorentzVector &) |
double | dP (math::XYZTLorentzVector &, math::XYZTLorentzVector &) |
double | dPhi (math::XYZTLorentzVector &, math::XYZTLorentzVector &) |
double | dPt (math::XYZTLorentzVector &, math::XYZTLorentzVector &) |
double | dR (math::XYZTLorentzVector &, math::XYZTLorentzVector &) |
virtual void | endJob () |
virtual void | endLuminosityBlock (edm::LuminosityBlock const &, edm::EventSetup const &) |
virtual void | endRun (edm::Run const &, edm::EventSetup const &) |
std::pair< double, double > | etaPhiTrigger () |
void | fillCuts (int, double, double, double, math::XYZTLorentzVector &, int, bool) |
void | fillDifferences (int, math::XYZTLorentzVector &, math::XYZTLorentzVector &, bool) |
void | fillEnergy (int, int, double, double, math::XYZTLorentzVector &) |
void | fillHist (int, math::XYZTLorentzVector &) |
double | getDistInCM (double eta1, double phi1, double eta2, double phi2) |
std::pair< double, double > | GetEtaPhiAtEcal (double etaIP, double phiIP, double pT, int charge, double vtxZ) |
void | getGoodTracks (const edm::Event &, edm::Handle< reco::TrackCollection > &) |
void | pushChgIsolnTreeVecs (math::XYZTLorentzVector &Pixcand, math::XYZTLorentzVector &Trkcand, std::vector< double > &PixMaxP, double &TrkMaxP, bool &selTk) |
void | pushMipCutTreeVecs (math::XYZTLorentzVector &NFcand, math::XYZTLorentzVector &Trkcand, double &EmipNFcand, double &EmipTrkcand, double &mindR, double &mindP1, std::vector< bool > &Flags, double hCone) |
void | studyIsolation (edm::Handle< reco::TrackCollection > &, std::vector< reco::TrackCollection::const_iterator > &) |
void | studyMipCut (edm::Handle< reco::TrackCollection > &trkCollection, edm::Handle< reco::IsolatedPixelTrackCandidateCollection > &L2cands) |
void | studyTiming (const edm::Event &theEvent) |
void | studyTrigger (edm::Handle< reco::TrackCollection > &, std::vector< reco::TrackCollection::const_iterator > &) |
void | StudyTrkEbyP (edm::Handle< reco::TrackCollection > &trkCollection) |
Additional Inherited Members | |
Public Types inherited from edm::EDAnalyzer | |
typedef EDAnalyzer | 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) |
Description: [one line class summary]
Implementation: [Notes on implementation]
|
explicit |
Definition at line 29 of file IsoTrig.cc.
References a_charIsoR, a_coneR, a_mipR, a_neutIsoR, a_neutR1, a_neutR2, gather_cfg::cout, cutCharge, cutMip, cutNeutral, doChgIsolTree, doL2L3, doMipCutTree, doStudyIsol, doTiming, doTrkResTree, dr_L1, edm::ParameterSet::getParameter(), edm::ParameterSet::getUntrackedParameter(), i, HLT_25ns14e33_v1_cff::InputTag, relval_steps::k, L1candTag_, L2candTag_, spr::trackSelectionParameters::maxChi2, spr::trackSelectionParameters::maxDpOverP, spr::trackSelectionParameters::maxDxyPV, spr::trackSelectionParameters::maxDzPV, spr::trackSelectionParameters::maxInMiss, spr::trackSelectionParameters::maxOutMiss, maxRunNo, spr::trackSelectionParameters::minLayerCrossed, spr::trackSelectionParameters::minOuterHit, spr::trackSelectionParameters::minPt, minPTrackValue_, spr::trackSelectionParameters::minQuality, minRunNo, PixcandTag_, pixelIsolationConeSizeAtEC_, pixelTracksSources_, pLimits, prelimCone_, processName, reco::TrackBase::qualityByName(), rEB_, selectionParameters, AlCaHLTBitMon_QueryRunRegistry::string, tauUnbiasCone_, theTrackQuality, tok_bs_, tok_EB_, tok_EE_, tok_genTrack_, tok_hbhe_, tok_hlt_, tok_l1cand_, tok_l2cand_, tok_lumi, tok_pixtk_, tok_pixtks_, tok_recVtx_, tok_SeedingLayerhb, tok_SeedingLayerhe, tok_SiPixelRecHits, tok_trigEvt, tok_trigRes, tok_verthb_, tok_verthe_, trigNames, verbosity, vtxCutIsol_, vtxCutSeed_, and zEE_.
IsoTrig::~IsoTrig | ( | ) |
Definition at line 157 of file IsoTrig.cc.
References t_ECone, t_NFcandEmip, t_NFcandEta, t_NFcandP, t_NFcandPhi, t_NFcandPt, t_NFTrkcandEmip, t_NFTrkcandEta, t_NFTrkcandP, t_NFTrkcandPhi, t_NFTrkcandPt, t_NFTrkChgIsoFlag, t_NFTrkMinDP1, t_NFTrkMinDR, t_NFTrkMipFlag, t_NFTrkMissFlag, t_NFTrkNeuIsoFlag, t_NFTrkPropFlag, t_NFTrkPVFlag, t_NFTrkqltyFlag, t_NFTrkselTkFlag, t_nGoodTk, t_nPixCand, t_nPixSeed, t_PixcandEta, t_PixcandMaxP, t_PixcandP, t_PixcandPhi, t_PixcandPt, t_PixTrkcandEta, t_PixTrkcandMaxP, t_PixTrkcandP, t_PixTrkcandPhi, t_PixTrkcandPt, t_PixTrkcandselTk, t_timeL2Prod, t_TrkhCone, t_TrkMissFlag, t_TrkNuIsolFlag, t_TrkP, t_TrkPVFlag, t_TrkqltyFlag, and t_TrkselTkFlag.
|
privatevirtual |
Implements edm::EDAnalyzer.
Definition at line 213 of file IsoTrig.cc.
References barrelRecHitsHandle, beamSpotH, SQLiteEnsembleGenerator_cfg::BField, ecalTB2006H4_GenSimDigiReco_cfg::bField, bFieldH, bfVal, edm::EventBase::bunchCrossing(), changed, chgIsolation(), hitfit::clear(), gather_cfg::cout, doChgIsolTree, doL2L3, doMipCutTree, doStudyIsol, doTiming, doTrkResTree, endcapRecHitsHandle, trigger::TriggerObject::energy(), trigger::TriggerObject::eta(), fastmath::etaphi(), etaPhiTrigger(), edm::EventID::event(), HcalObjRepresent::Fill(), trigger::TriggerEvent::filterKeys(), trigger::TriggerEvent::filterTag(), spr::find(), edm::EventSetup::get(), edm::LuminosityBlock::getByToken(), edm::Event::getByToken(), getGoodTracks(), edm::Event::getLuminosityBlock(), trigger::TriggerEvent::getObjects(), h_Filters, h_HLT, h_L1ObjEnergy, h_nHLT, h_nL3Objs, h_Pre, h_PreHLT, h_PreHLTwt, h_PreL1, h_PreL1wt, hbhe, runregparse::hlt, HltComparatorCreateWorkflow::hltConfig, HLTPrescaleProvider::hltConfigProvider(), hltPrescaleProvider_, i, trigger::TriggerObject::id(), edm::EventBase::id(), recoMuon::in, MagneticField::inTesla(), edm::HandleBase::isValid(), LumiDetails::kOCC1, diffTwoXMLs::label, edm::InputTag::label(), leadPV, edm::EventBase::luminosityBlock(), FastTimerService_cff::lumiProducer, PV3DBase< T, PVType, FrameType >::mag(), trigger::TriggerObject::mass(), HLTConfigProvider::moduleLabels(), edmConvertToStreamModule::modules, gen::n, pG, trigger::TriggerObject::phi(), pixelTrackRefsHB, pixelTrackRefsHE, pixelTracksSources_, makeHLTPrescaleTable::prescales, HLTPrescaleProvider::prescaleValues(), edm::Handle< T >::product(), edm::ESHandle< class >::product(), trigger::TriggerObject::pt(), trigger::TriggerObject::px(), trigger::TriggerObject::py(), trigger::TriggerObject::pz(), recVtxs, edm::EventID::run(), HLTConfigProvider::size(), findQualityFiles::size, trigger::TriggerEvent::sizeFilters(), AlCaHLTBitMon_QueryRunRegistry::string, studyIsolation(), studyMipCut(), studyTiming(), studyTrigger(), StudyTrkEbyP(), tok_bs_, tok_EB_, tok_EE_, tok_genTrack_, tok_hbhe_, tok_l1cand_, tok_l2cand_, tok_lumi, tok_pixtk_, tok_pixtks_, tok_recVtx_, tok_trigEvt, tok_trigRes, HLTConfigProvider::triggerIndex(), edm::TriggerNames::triggerNames(), edm::Event::triggerNames(), triggerResults, TrigList, trigNames, TrigPreList, vec, verbosity, x, y, and z.
|
privatevirtual |
Reimplemented from edm::EDAnalyzer.
Definition at line 529 of file IsoTrig.cc.
References ChgIsolnTree, Reconstruction_Data_cff::cuts, doChgIsolTree, doL2L3, doMipCutTree, doTiming, doTrkResTree, fs, h_dEta, h_dEtaL1, h_dinvPt, h_dP, h_dPhi, h_dPhiL1, h_dPt, h_dRL1, h_eCalo, h_eHcal, h_eMaxNearP, h_eMip, h_eNeutIso, h_EnIn, h_EnOut, h_eta, h_etaCalibTracks, h_etaMipTracks, h_Filters, h_HLT, h_L1ObjEnergy, h_mindR, h_MipEnMatch, h_MipEnNoMatch, h_nHLT, h_nL3Objs, h_p, h_phi, h_Pre, h_PreHLT, h_PreHLTwt, h_PreL1, h_PreL1wt, h_pt, i, TFileService::make(), MipCutTree, pLimits, AlCaHLTBitMon_QueryRunRegistry::string, t_ECone, t_NFcandEmip, t_NFcandEta, t_NFcandP, t_NFcandPhi, t_NFcandPt, t_NFTrkcandEmip, t_NFTrkcandEta, t_NFTrkcandP, t_NFTrkcandPhi, t_NFTrkcandPt, t_NFTrkChgIsoFlag, t_NFTrkMinDP1, t_NFTrkMinDR, t_NFTrkMipFlag, t_NFTrkMissFlag, t_NFTrkNeuIsoFlag, t_NFTrkPropFlag, t_NFTrkPVFlag, t_NFTrkqltyFlag, t_NFTrkselTkFlag, t_nGoodTk, t_nPixCand, t_nPixSeed, t_PixcandEta, t_PixcandMaxP, t_PixcandP, t_PixcandPhi, t_PixcandPt, t_PixTrkcandEta, t_PixTrkcandMaxP, t_PixTrkcandP, t_PixTrkcandPhi, t_PixTrkcandPt, t_PixTrkcandselTk, t_timeL2Prod, t_TrkhCone, t_TrkMissFlag, t_TrkNuIsolFlag, t_TrkP, t_TrkPVFlag, t_TrkqltyFlag, t_TrkselTkFlag, TimingTree, and TrkResTree.
|
privatevirtual |
|
privatevirtual |
Reimplemented from edm::EDAnalyzer.
Definition at line 817 of file IsoTrig.cc.
References changed, hltPrescaleProvider_, HLTPrescaleProvider::init(), processName, and edm::RunBase::run().
|
private |
Definition at line 1420 of file IsoTrig.cc.
References a_charIsoR, ecalTB2006H4_GenSimDigiReco_cfg::bField, bFieldH, RecoTauCleanerPlugins::charge, spr::chargeIsolationCone(), ChgIsolnTree, clearChgIsolnTreeVectors(), gather_cfg::cout, deltaR(), dR(), eta, getDistInCM(), GetEtaPhiAtEcal(), spr::goodTrack(), i, j, relval_steps::k, prof2calltree::l, leadPV, minPTrackValue_, AlCaHLTBitMon_ParallelJobs::p, reco::TrackBase::p(), pG, phi, pixelIsolationConeSizeAtEC_, pixelTrackRefsHE, position, prelimCone_, edm::ESHandle< class >::product(), spr::propagateCALO(), EnergyCorrector::pt, pushChgIsolnTreeVecs(), reco::TrackBase::px(), reco::TrackBase::py(), reco::TrackBase::pz(), dttmaxenums::R, recVtxs, edm::second(), selectionParameters, tauUnbiasCone_, theTrackQuality, verbosity, vtxCutIsol_, vtxCutSeed_, and z.
Referenced by analyze().
|
private |
Definition at line 444 of file IsoTrig.cc.
References hitfit::clear(), i, t_PixcandEta, t_PixcandMaxP, t_PixcandP, t_PixcandPhi, t_PixcandPt, t_PixTrkcandEta, t_PixTrkcandMaxP, t_PixTrkcandP, t_PixTrkcandPhi, t_PixTrkcandPt, and t_PixTrkcandselTk.
Referenced by chgIsolation().
|
private |
Definition at line 460 of file IsoTrig.cc.
References t_ECone, t_NFcandEmip, t_NFcandEta, t_NFcandP, t_NFcandPhi, t_NFcandPt, t_NFTrkcandEmip, t_NFTrkcandEta, t_NFTrkcandP, t_NFTrkcandPhi, t_NFTrkcandPt, t_NFTrkChgIsoFlag, t_NFTrkMinDP1, t_NFTrkMinDR, t_NFTrkMipFlag, t_NFTrkMissFlag, t_NFTrkNeuIsoFlag, t_NFTrkPropFlag, t_NFTrkPVFlag, t_NFTrkqltyFlag, and t_NFTrkselTkFlag.
Referenced by studyMipCut().
|
private |
Definition at line 1680 of file IsoTrig.cc.
Referenced by dR(), fillDifferences(), and studyTrigger().
|
private |
|
private |
Definition at line 1706 of file IsoTrig.cc.
References funct::abs().
Referenced by fillDifferences().
|
private |
Definition at line 1684 of file IsoTrig.cc.
References M_PI.
Referenced by dR(), fillDifferences(), and studyTrigger().
|
private |
|
private |
Definition at line 1696 of file IsoTrig.cc.
References dEta(), dPhi(), and mathSSE::sqrt().
Referenced by chgIsolation(), fillDifferences(), getGoodTracks(), studyIsolation(), studyMipCut(), and studyTrigger().
|
privatevirtual |
Reimplemented from edm::EDAnalyzer.
Definition at line 790 of file IsoTrig.cc.
References gather_cfg::cout, plotBeamSpotDB::first, fs, g_Accepts, g_Pre, g_PreHLT, g_PreL1, i, TFileService::make(), maxRunNo, minRunNo, gen::n, edm::second(), TrigList, trigNames, and TrigPreList.
|
privatevirtual |
|
privatevirtual |
|
private |
Definition at line 1714 of file IsoTrig.cc.
References eta, relval_steps::k, phi, EnergyCorrector::pt, and vec.
Referenced by analyze().
|
private |
Definition at line 1648 of file IsoTrig.cc.
References cutCharge, cutMip, cutNeutral, h_eMaxNearP, h_eMip, h_eNeutIso, h_etaCalibTracks, h_etaMipTracks, and pLimits.
Referenced by studyIsolation().
|
static |
Definition at line 205 of file IsoTrig.cc.
References edm::ConfigurationDescriptions::addDefault(), and edm::ParameterSetDescription::setUnknown().
|
private |
Definition at line 1629 of file IsoTrig.cc.
References gather_cfg::cout, dEta(), dinvPt(), dP(), dPhi(), dPt(), dR(), h_dEta, h_dinvPt, h_dP, h_dPhi, h_dPt, and h_mindR.
Referenced by studyMipCut(), and studyTrigger().
|
private |
Definition at line 1666 of file IsoTrig.cc.
References h_eCalo, h_eHcal, GetRecoTauVFromDQM_MC_cff::kk, and pLimits.
Referenced by studyIsolation().
|
private |
Definition at line 1622 of file IsoTrig.cc.
References h_eta, h_p, h_phi, and h_pt.
Referenced by studyIsolation(), and studyTrigger().
|
private |
Definition at line 1789 of file IsoTrig.cc.
References angle(), funct::cos(), create_public_lumi_plots::exp, M_PI, rEB_, funct::sin(), funct::tan(), and zEE_.
Referenced by chgIsolation().
|
private |
Definition at line 1730 of file IsoTrig.cc.
References alpha, bfVal, RecoTauCleanerPlugins::charge, SiPixelRawToDigiRegional_cfi::deltaPhi, create_public_lumi_plots::exp, create_public_lumi_plots::log, M_PI, rEB_, funct::sin(), funct::tan(), theta(), z, and zEE_.
Referenced by chgIsolation().
|
private |
Definition at line 1531 of file IsoTrig.cc.
References a_charIsoR, a_mipR, barrelRecHitsHandle, ecalTB2006H4_GenSimDigiReco_cfg::bField, bFieldH, spr::chargeIsolationCone(), funct::cos(), gather_cfg::cout, dR(), spr::eCone_ecal(), endcapRecHitsHandle, edm::Event::getByToken(), spr::goodTrack(), cuy::ii, edm::HandleBase::isValid(), leadPV, AlCaHLTBitMon_ParallelJobs::p, reco::TrackBase::p(), pG, edm::ESHandle< class >::product(), spr::propagateCALO(), EnergyCorrector::pt, reco::TrackBase::px(), reco::TrackBase::py(), reco::TrackBase::pz(), selectionParameters, funct::sin(), t_nGoodTk, theTrackQuality, tok_l1cand_, trigger::TriggerL1CenJet, trigger::TriggerL1ForJet, trigger::TriggerL1TauJet, and verbosity.
Referenced by analyze().
|
private |
Definition at line 484 of file IsoTrig.cc.
References t_PixcandEta, t_PixcandMaxP, t_PixcandP, t_PixcandPhi, t_PixcandPt, t_PixTrkcandEta, t_PixTrkcandMaxP, t_PixTrkcandP, t_PixTrkcandPhi, t_PixTrkcandPt, and t_PixTrkcandselTk.
Referenced by chgIsolation().
|
private |
Definition at line 501 of file IsoTrig.cc.
References t_ECone, t_NFcandEmip, t_NFcandEta, t_NFcandP, t_NFcandPhi, t_NFcandPt, t_NFTrkcandEmip, t_NFTrkcandEta, t_NFTrkcandP, t_NFTrkcandPhi, t_NFTrkcandPt, t_NFTrkChgIsoFlag, t_NFTrkMinDP1, t_NFTrkMinDR, t_NFTrkMipFlag, t_NFTrkMissFlag, t_NFTrkNeuIsoFlag, t_NFTrkPropFlag, t_NFTrkPVFlag, t_NFTrkqltyFlag, and t_NFTrkselTkFlag.
Referenced by studyMipCut().
|
private |
Definition at line 1303 of file IsoTrig.cc.
References a_charIsoR, a_coneR, a_mipR, a_neutR1, a_neutR2, barrelRecHitsHandle, ecalTB2006H4_GenSimDigiReco_cfg::bField, bFieldH, spr::chargeIsolationCone(), gather_cfg::cout, cutCharge, cutMip, cutNeutral, deltaR(), doL2L3, dR(), dr_L1, spr::eCone_ecal(), spr::eCone_hcal(), endcapRecHitsHandle, fillCuts(), fillEnergy(), fillHist(), spr::find(), spr::goodTrack(), hbhe, hit::id, HcalDetId::ieta(), edm::HandleBase::isValid(), relval_steps::k, leadPV, reco::TrackBase::p(), pG, edm::ESHandle< class >::product(), spr::propagateCALO(), reco::TrackBase::px(), reco::TrackBase::py(), reco::TrackBase::pz(), selectionParameters, theTrackQuality, vec, and verbosity.
Referenced by analyze().
|
private |
Definition at line 1056 of file IsoTrig.cc.
References a_charIsoR, a_coneR, a_mipR, a_neutR1, a_neutR2, funct::abs(), barrelRecHitsHandle, ecalTB2006H4_GenSimDigiReco_cfg::bField, bFieldH, spr::chargeIsolationCone(), clearMipCutTreeVectors(), gather_cfg::cout, cutCharge, cutMip, cutNeutral, dR(), spr::eCone_ecal(), spr::eCone_hcal(), endcapRecHitsHandle, fillDifferences(), spr::goodTrack(), h_EnIn, h_EnOut, h_MipEnMatch, h_MipEnNoMatch, hbhe, i, edm::HandleBase::isValid(), leadPV, spr::trackSelectionParameters::maxDxyPV, spr::trackSelectionParameters::maxDzPV, spr::trackSelectionParameters::maxInMiss, spr::trackSelectionParameters::maxOutMiss, MipCutTree, reco::TrackBase::p(), pG, edm::ESHandle< class >::product(), spr::propagateCALO(), pushMipCutTreeVecs(), reco::TrackBase::px(), reco::TrackBase::py(), reco::TrackBase::pz(), selectionParameters, theTrackQuality, and verbosity.
Referenced by analyze().
|
private |
Definition at line 945 of file IsoTrig.cc.
References gather_cfg::cout, deltaR(), eta, edm::Event::getByToken(), AlCaHLTBitMon_ParallelJobs::p, phi, pixelTrackRefsHB, pixelTrackRefsHE, edm::Handle< T >::product(), EnergyCorrector::pt, FastTimerService::queryModuleTimeByLabel(), dttmaxenums::R, SeedingLayerSetsHits::size(), edmNew::DetSetVector< T >::size(), edm::Event::streamID(), t_nPixCand, t_nPixSeed, t_timeL2Prod, tauUnbiasCone_, TimingTree, tok_l1cand_, tok_SeedingLayerhb, tok_SeedingLayerhe, tok_SiPixelRecHits, tok_verthb_, tok_verthe_, trigger::TriggerL1CenJet, trigger::TriggerL1ForJet, trigger::TriggerL1TauJet, verbosity, and vtxCutSeed_.
Referenced by analyze().
|
private |
Definition at line 1171 of file IsoTrig.cc.
References funct::abs(), gather_cfg::cout, deltaR(), dEta(), dPhi(), dR(), HcalObjRepresent::Fill(), fillDifferences(), fillHist(), h_dEtaL1, h_dPhiL1, h_dRL1, i, edm::HandleBase::isValid(), j, relval_steps::k, mathSSE::sqrt(), vec, and verbosity.
Referenced by analyze().
|
private |
Definition at line 831 of file IsoTrig.cc.
References a_charIsoR, a_coneR, a_mipR, a_neutR1, a_neutR2, barrelRecHitsHandle, ecalTB2006H4_GenSimDigiReco_cfg::bField, bFieldH, spr::chargeIsolationCone(), gather_cfg::cout, cutCharge, cutMip, cutNeutral, spr::eCone_ecal(), spr::eCone_hcal(), endcapRecHitsHandle, spr::goodTrack(), hbhe, edm::HandleBase::isValid(), leadPV, spr::trackSelectionParameters::maxDxyPV, spr::trackSelectionParameters::maxDzPV, spr::trackSelectionParameters::maxInMiss, spr::trackSelectionParameters::maxOutMiss, reco::TrackBase::p(), pG, edm::ESHandle< class >::product(), spr::propagateCALO(), reco::TrackBase::px(), reco::TrackBase::py(), reco::TrackBase::pz(), selectionParameters, t_TrkhCone, t_TrkMissFlag, t_TrkNuIsolFlag, t_TrkP, t_TrkPVFlag, t_TrkqltyFlag, t_TrkselTkFlag, theTrackQuality, TrkResTree, and verbosity.
Referenced by analyze().
|
private |
Definition at line 136 of file IsoTrig.h.
Referenced by chgIsolation(), getGoodTracks(), IsoTrig(), studyIsolation(), studyMipCut(), and StudyTrkEbyP().
|
private |
Definition at line 136 of file IsoTrig.h.
Referenced by IsoTrig(), studyIsolation(), studyMipCut(), and StudyTrkEbyP().
|
private |
Definition at line 136 of file IsoTrig.h.
Referenced by getGoodTracks(), IsoTrig(), studyIsolation(), studyMipCut(), and StudyTrkEbyP().
|
private |
|
private |
Definition at line 137 of file IsoTrig.h.
Referenced by IsoTrig(), studyIsolation(), studyMipCut(), and StudyTrkEbyP().
|
private |
Definition at line 137 of file IsoTrig.h.
Referenced by IsoTrig(), studyIsolation(), studyMipCut(), and StudyTrkEbyP().
|
private |
Definition at line 162 of file IsoTrig.h.
Referenced by analyze(), getGoodTracks(), studyIsolation(), studyMipCut(), and StudyTrkEbyP().
|
private |
|
private |
Definition at line 159 of file IsoTrig.h.
Referenced by analyze(), chgIsolation(), getGoodTracks(), studyIsolation(), studyMipCut(), and StudyTrkEbyP().
|
private |
Definition at line 130 of file IsoTrig.h.
Referenced by analyze(), and GetEtaPhiAtEcal().
|
private |
Definition at line 170 of file IsoTrig.h.
Referenced by analyze(), and beginRun().
|
private |
Definition at line 172 of file IsoTrig.h.
Referenced by beginJob(), and chgIsolation().
|
private |
Definition at line 137 of file IsoTrig.h.
Referenced by fillCuts(), IsoTrig(), studyIsolation(), studyMipCut(), and StudyTrkEbyP().
|
private |
Definition at line 137 of file IsoTrig.h.
Referenced by fillCuts(), IsoTrig(), studyIsolation(), studyMipCut(), and StudyTrkEbyP().
|
private |
Definition at line 137 of file IsoTrig.h.
Referenced by fillCuts(), IsoTrig(), studyIsolation(), studyMipCut(), and StudyTrkEbyP().
|
private |
Definition at line 128 of file IsoTrig.h.
Referenced by analyze(), beginJob(), and IsoTrig().
|
private |
Definition at line 127 of file IsoTrig.h.
Referenced by analyze(), beginJob(), IsoTrig(), and studyIsolation().
|
private |
Definition at line 127 of file IsoTrig.h.
Referenced by analyze(), beginJob(), and IsoTrig().
|
private |
|
private |
Definition at line 127 of file IsoTrig.h.
Referenced by analyze(), beginJob(), and IsoTrig().
|
private |
Definition at line 128 of file IsoTrig.h.
Referenced by analyze(), beginJob(), and IsoTrig().
|
private |
Definition at line 136 of file IsoTrig.h.
Referenced by IsoTrig(), and studyIsolation().
|
private |
Definition at line 163 of file IsoTrig.h.
Referenced by analyze(), getGoodTracks(), studyIsolation(), studyMipCut(), and StudyTrkEbyP().
|
private |
Definition at line 171 of file IsoTrig.h.
Referenced by beginJob(), and endJob().
|
private |
Definition at line 227 of file IsoTrig.h.
Referenced by beginJob(), and fillDifferences().
|
private |
Definition at line 226 of file IsoTrig.h.
Referenced by beginJob(), and studyTrigger().
|
private |
Definition at line 228 of file IsoTrig.h.
Referenced by beginJob(), and fillDifferences().
|
private |
Definition at line 227 of file IsoTrig.h.
Referenced by beginJob(), and fillDifferences().
|
private |
Definition at line 227 of file IsoTrig.h.
Referenced by beginJob(), and fillDifferences().
|
private |
Definition at line 226 of file IsoTrig.h.
Referenced by beginJob(), and studyTrigger().
|
private |
Definition at line 227 of file IsoTrig.h.
Referenced by beginJob(), and fillDifferences().
|
private |
Definition at line 226 of file IsoTrig.h.
Referenced by beginJob(), and studyTrigger().
|
private |
Definition at line 231 of file IsoTrig.h.
Referenced by beginJob(), and fillEnergy().
|
private |
Definition at line 231 of file IsoTrig.h.
Referenced by beginJob(), and fillEnergy().
|
private |
Definition at line 229 of file IsoTrig.h.
Referenced by beginJob(), and fillCuts().
|
private |
Definition at line 228 of file IsoTrig.h.
Referenced by beginJob(), and fillCuts().
|
private |
Definition at line 229 of file IsoTrig.h.
Referenced by beginJob(), and fillCuts().
|
private |
Definition at line 220 of file IsoTrig.h.
Referenced by beginJob(), and studyMipCut().
|
private |
Definition at line 220 of file IsoTrig.h.
Referenced by beginJob(), and studyMipCut().
|
private |
Definition at line 225 of file IsoTrig.h.
Referenced by beginJob(), and fillHist().
|
private |
Definition at line 230 of file IsoTrig.h.
Referenced by beginJob(), and fillCuts().
|
private |
Definition at line 230 of file IsoTrig.h.
Referenced by beginJob(), and fillCuts().
|
private |
Definition at line 223 of file IsoTrig.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 222 of file IsoTrig.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 224 of file IsoTrig.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 228 of file IsoTrig.h.
Referenced by beginJob(), and fillDifferences().
|
private |
Definition at line 221 of file IsoTrig.h.
Referenced by beginJob(), and studyMipCut().
|
private |
Definition at line 221 of file IsoTrig.h.
Referenced by beginJob(), and studyMipCut().
|
private |
Definition at line 222 of file IsoTrig.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 223 of file IsoTrig.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 225 of file IsoTrig.h.
Referenced by beginJob(), and fillHist().
|
private |
Definition at line 225 of file IsoTrig.h.
Referenced by beginJob(), and fillHist().
|
private |
Definition at line 223 of file IsoTrig.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 222 of file IsoTrig.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 224 of file IsoTrig.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 222 of file IsoTrig.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 224 of file IsoTrig.h.
Referenced by analyze(), and beginJob().
|
private |
Definition at line 225 of file IsoTrig.h.
Referenced by beginJob(), and fillHist().
|
private |
Definition at line 161 of file IsoTrig.h.
Referenced by analyze(), studyIsolation(), studyMipCut(), and StudyTrkEbyP().
|
private |
Definition at line 123 of file IsoTrig.h.
Referenced by analyze(), and beginRun().
|
private |
|
private |
|
private |
Definition at line 166 of file IsoTrig.h.
Referenced by analyze(), chgIsolation(), getGoodTracks(), studyIsolation(), studyMipCut(), and StudyTrkEbyP().
|
private |
|
private |
Definition at line 132 of file IsoTrig.h.
Referenced by chgIsolation(), and IsoTrig().
|
private |
|
private |
Definition at line 172 of file IsoTrig.h.
Referenced by beginJob(), and studyMipCut().
|
private |
Definition at line 160 of file IsoTrig.h.
Referenced by analyze(), chgIsolation(), getGoodTracks(), studyIsolation(), studyMipCut(), and StudyTrkEbyP().
|
private |
|
private |
Definition at line 131 of file IsoTrig.h.
Referenced by chgIsolation(), and IsoTrig().
|
private |
Definition at line 158 of file IsoTrig.h.
Referenced by analyze(), and studyTiming().
|
private |
Definition at line 158 of file IsoTrig.h.
Referenced by analyze(), chgIsolation(), and studyTiming().
|
private |
|
private |
Definition at line 139 of file IsoTrig.h.
Referenced by beginJob(), fillCuts(), fillEnergy(), and IsoTrig().
|
private |
Definition at line 133 of file IsoTrig.h.
Referenced by chgIsolation(), and IsoTrig().
|
private |
Definition at line 135 of file IsoTrig.h.
Referenced by beginRun(), core.TriggerBitAnalyzer.TriggerBitAnalyzer::declareHandles(), core.TriggerBitFilter.TriggerBitFilter::declareHandles(), and IsoTrig().
|
private |
Definition at line 130 of file IsoTrig.h.
Referenced by getDistInCM(), GetEtaPhiAtEcal(), and IsoTrig().
|
private |
Definition at line 165 of file IsoTrig.h.
Referenced by analyze(), and chgIsolation().
|
private |
Definition at line 134 of file IsoTrig.h.
Referenced by chgIsolation(), getGoodTracks(), IsoTrig(), studyIsolation(), studyMipCut(), and StudyTrkEbyP().
|
private |
Definition at line 218 of file IsoTrig.h.
Referenced by beginJob(), clearMipCutTreeVectors(), pushMipCutTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 202 of file IsoTrig.h.
Referenced by beginJob(), clearMipCutTreeVectors(), pushMipCutTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 200 of file IsoTrig.h.
Referenced by beginJob(), clearMipCutTreeVectors(), pushMipCutTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 198 of file IsoTrig.h.
Referenced by beginJob(), clearMipCutTreeVectors(), pushMipCutTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 201 of file IsoTrig.h.
Referenced by beginJob(), clearMipCutTreeVectors(), pushMipCutTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 199 of file IsoTrig.h.
Referenced by beginJob(), clearMipCutTreeVectors(), pushMipCutTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 207 of file IsoTrig.h.
Referenced by beginJob(), clearMipCutTreeVectors(), pushMipCutTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 205 of file IsoTrig.h.
Referenced by beginJob(), clearMipCutTreeVectors(), pushMipCutTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 203 of file IsoTrig.h.
Referenced by beginJob(), clearMipCutTreeVectors(), pushMipCutTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 206 of file IsoTrig.h.
Referenced by beginJob(), clearMipCutTreeVectors(), pushMipCutTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 204 of file IsoTrig.h.
Referenced by beginJob(), clearMipCutTreeVectors(), pushMipCutTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 215 of file IsoTrig.h.
Referenced by beginJob(), clearMipCutTreeVectors(), pushMipCutTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 209 of file IsoTrig.h.
Referenced by beginJob(), clearMipCutTreeVectors(), pushMipCutTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 208 of file IsoTrig.h.
Referenced by beginJob(), clearMipCutTreeVectors(), pushMipCutTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 217 of file IsoTrig.h.
Referenced by beginJob(), clearMipCutTreeVectors(), pushMipCutTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 212 of file IsoTrig.h.
Referenced by beginJob(), clearMipCutTreeVectors(), pushMipCutTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 216 of file IsoTrig.h.
Referenced by beginJob(), clearMipCutTreeVectors(), pushMipCutTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 214 of file IsoTrig.h.
Referenced by beginJob(), clearMipCutTreeVectors(), pushMipCutTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 213 of file IsoTrig.h.
Referenced by beginJob(), clearMipCutTreeVectors(), pushMipCutTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 211 of file IsoTrig.h.
Referenced by beginJob(), clearMipCutTreeVectors(), pushMipCutTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 210 of file IsoTrig.h.
Referenced by beginJob(), clearMipCutTreeVectors(), pushMipCutTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 176 of file IsoTrig.h.
Referenced by beginJob(), getGoodTracks(), and ~IsoTrig().
|
private |
Definition at line 174 of file IsoTrig.h.
Referenced by beginJob(), studyTiming(), and ~IsoTrig().
|
private |
Definition at line 175 of file IsoTrig.h.
Referenced by beginJob(), studyTiming(), and ~IsoTrig().
|
private |
Definition at line 188 of file IsoTrig.h.
Referenced by beginJob(), clearChgIsolnTreeVectors(), pushChgIsolnTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 190 of file IsoTrig.h.
Referenced by beginJob(), clearChgIsolnTreeVectors(), pushChgIsolnTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 186 of file IsoTrig.h.
Referenced by beginJob(), clearChgIsolnTreeVectors(), pushChgIsolnTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 189 of file IsoTrig.h.
Referenced by beginJob(), clearChgIsolnTreeVectors(), pushChgIsolnTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 187 of file IsoTrig.h.
Referenced by beginJob(), clearChgIsolnTreeVectors(), pushChgIsolnTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 193 of file IsoTrig.h.
Referenced by beginJob(), clearChgIsolnTreeVectors(), pushChgIsolnTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 195 of file IsoTrig.h.
Referenced by beginJob(), clearChgIsolnTreeVectors(), pushChgIsolnTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 191 of file IsoTrig.h.
Referenced by beginJob(), clearChgIsolnTreeVectors(), pushChgIsolnTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 194 of file IsoTrig.h.
Referenced by beginJob(), clearChgIsolnTreeVectors(), pushChgIsolnTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 192 of file IsoTrig.h.
Referenced by beginJob(), clearChgIsolnTreeVectors(), pushChgIsolnTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 196 of file IsoTrig.h.
Referenced by beginJob(), clearChgIsolnTreeVectors(), pushChgIsolnTreeVecs(), and ~IsoTrig().
|
private |
Definition at line 173 of file IsoTrig.h.
Referenced by beginJob(), studyTiming(), and ~IsoTrig().
|
private |
Definition at line 178 of file IsoTrig.h.
Referenced by beginJob(), StudyTrkEbyP(), and ~IsoTrig().
|
private |
Definition at line 182 of file IsoTrig.h.
Referenced by beginJob(), StudyTrkEbyP(), and ~IsoTrig().
|
private |
Definition at line 184 of file IsoTrig.h.
Referenced by beginJob(), StudyTrkEbyP(), and ~IsoTrig().
|
private |
Definition at line 179 of file IsoTrig.h.
Referenced by beginJob(), StudyTrkEbyP(), and ~IsoTrig().
|
private |
Definition at line 183 of file IsoTrig.h.
Referenced by beginJob(), StudyTrkEbyP(), and ~IsoTrig().
|
private |
Definition at line 181 of file IsoTrig.h.
Referenced by beginJob(), StudyTrkEbyP(), and ~IsoTrig().
|
private |
Definition at line 180 of file IsoTrig.h.
Referenced by beginJob(), StudyTrkEbyP(), and ~IsoTrig().
|
private |
Definition at line 133 of file IsoTrig.h.
Referenced by chgIsolation(), IsoTrig(), and studyTiming().
|
private |
Definition at line 135 of file IsoTrig.h.
Referenced by chgIsolation(), getGoodTracks(), IsoTrig(), studyIsolation(), studyMipCut(), and StudyTrkEbyP().
|
private |
Definition at line 172 of file IsoTrig.h.
Referenced by beginJob(), and studyTiming().
|
private |
|
private |
|
private |
|
private |
|
private |
|
private |
|
private |
Definition at line 154 of file IsoTrig.h.
Referenced by analyze(), getGoodTracks(), IsoTrig(), and studyTiming().
|
private |
|
private |
|
private |
|
private |
|
private |
|
private |
Definition at line 151 of file IsoTrig.h.
Referenced by IsoTrig(), and studyTiming().
|
private |
Definition at line 151 of file IsoTrig.h.
Referenced by IsoTrig(), and studyTiming().
|
private |
Definition at line 152 of file IsoTrig.h.
Referenced by IsoTrig(), and studyTiming().
|
private |
|
private |
|
private |
Definition at line 150 of file IsoTrig.h.
Referenced by IsoTrig(), and studyTiming().
|
private |
Definition at line 150 of file IsoTrig.h.
Referenced by IsoTrig(), and studyTiming().
|
private |
|
private |
|
private |
|
private |
Definition at line 172 of file IsoTrig.h.
Referenced by beginJob(), and StudyTrkEbyP().
|
private |
Definition at line 233 of file IsoTrig.h.
Referenced by analyze(), etaPhiTrigger(), studyIsolation(), and studyTrigger().
|
private |
Definition at line 129 of file IsoTrig.h.
Referenced by analyze(), chgIsolation(), getGoodTracks(), IsoTrig(), studyIsolation(), studyMipCut(), studyTiming(), studyTrigger(), and StudyTrkEbyP().
|
private |
Definition at line 132 of file IsoTrig.h.
Referenced by chgIsolation(), and IsoTrig().
|
private |
Definition at line 132 of file IsoTrig.h.
Referenced by chgIsolation(), IsoTrig(), and studyTiming().
|
private |
Definition at line 130 of file IsoTrig.h.
Referenced by getDistInCM(), GetEtaPhiAtEcal(), and IsoTrig().