CMS 3D CMS Logo

 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Properties Friends Macros Pages
List of all members | Public Member Functions | Public Attributes | Private Member Functions | Private Attributes
Jet.Jet Class Reference
Inheritance diagram for Jet.Jet:

Public Member Functions

def __init__
 
def btag
 
def btagWP
 
def computeQGvars
 
def corrFactor
 
def jetID
 
def l1corrFactor
 
def leadingTrack
 
def leadTrackPt
 
def looseJetId
 
def puJetId
 
def puMva
 
def qgl
 
def rawFactor
 
def setCorrP4
 
def setRawFactor
 

Public Attributes

 hasQGvars
 
 qgl_value
 

Private Member Functions

def _physObjInit
 

Private Attributes

 _leadingTrack
 
 _leadingTrackSearched
 
 _rawFactorMultiplier
 
 _recalibrated
 

Detailed Description

Definition at line 40 of file Jet.py.

Constructor & Destructor Documentation

def Jet.Jet.__init__ (   self,
  args,
  kwargs 
)

Definition at line 41 of file Jet.py.

References Electron.Electron._physObjInit(), and Jet.Jet._physObjInit().

41 
42  def __init__(self, *args, **kwargs):
43  super(Jet, self).__init__(*args, **kwargs)
44  self._physObjInit()
def _physObjInit
Definition: Jet.py:45
def __init__
Definition: Jet.py:41

Member Function Documentation

def Jet.Jet._physObjInit (   self)
private

Definition at line 45 of file Jet.py.

Referenced by Photon.Photon.__init__(), and Jet.Jet.__init__().

45 
46  def _physObjInit(self):
48  self._recalibrated = False
49  self._leadingTrack = None
50  self._leadingTrackSearched = False
_leadingTrack
Definition: Jet.py:48
_recalibrated
Definition: Jet.py:47
def _physObjInit
Definition: Jet.py:45
_rawFactorMultiplier
Definition: Jet.py:46
_leadingTrackSearched
Definition: Jet.py:49
def Jet.Jet.btag (   self,
  name 
)

Definition at line 133 of file Jet.py.

References pat::Jet.bDiscriminator().

Referenced by Jet.Jet.btagWP().

134  def btag(self,name):
135  ret = self.bDiscriminator(name)
136  if ret == -1000 and name.startswith("pf"):
137  ret = self.bDiscriminator(name[2].lower()+name[3:])
138  return ret
def btag
Definition: Jet.py:133
def Jet.Jet.btagWP (   self,
  name 
)

Definition at line 139 of file Jet.py.

References BTagWeightCalculator.BTagWeightCalculator.btag, and Jet.Jet.btag().

140  def btagWP(self,name):
141  global _btagWPs
142  (disc,val) = _btagWPs[name]
143  return self.btag(disc) > val
def btag
Definition: Jet.py:133
def btagWP
Definition: Jet.py:139
def Jet.Jet.computeQGvars (   self)

Definition at line 169 of file Jet.py.

Referenced by Jet.Jet.qgl().

170  def computeQGvars(self):
171  #return immediately if qgvars already computed or if qgl is disabled
172  if not hasattr(self,"qgl_rho") or getattr(self,"hasQGVvars",False) :
173  return self
174  self.hasQGvars = True
175 
176  jet = self
177  jet.mult = 0
178  sum_weight = 0.
179  sum_pt = 0.
180  sum_deta = 0.
181  sum_dphi = 0.
182  sum_deta2 = 0.
183  sum_detadphi = 0.
184  sum_dphi2 = 0.
185 
186 
187 
188  for ii in range(0, jet.numberOfDaughters()) :
189 
190  part = jet.daughter(ii)
191 
192  if part.charge() == 0 : # neutral particles
193 
194  if part.pt() < 1.: continue
195 
196  else : # charged particles
197 
198  if part.trackHighPurity()==False: continue
199  if part.fromPV()<=1: continue
200 
201 
202  jet.mult += 1
203 
204  deta = part.eta() - jet.eta()
205  dphi = deltaPhi(part.phi(), jet.phi())
206  partPt = part.pt()
207  weight = partPt*partPt
208  sum_weight += weight
209  sum_pt += partPt
210  sum_deta += deta*weight
211  sum_dphi += dphi*weight
212  sum_deta2 += deta*deta*weight
213  sum_detadphi += deta*dphi*weight
214  sum_dphi2 += dphi*dphi*weight
215 
216 
217 
218 
219  a = 0.
220  b = 0.
221  c = 0.
222 
223  if sum_weight > 0 :
224  jet.ptd = math.sqrt(sum_weight)/sum_pt
225  ave_deta = sum_deta/sum_weight
226  ave_dphi = sum_dphi/sum_weight
227  ave_deta2 = sum_deta2/sum_weight
228  ave_dphi2 = sum_dphi2/sum_weight
229  a = ave_deta2 - ave_deta*ave_deta
230  b = ave_dphi2 - ave_dphi*ave_dphi
231  c = -(sum_detadphi/sum_weight - ave_deta*ave_dphi)
232  else: jet.ptd = 0.
233 
234  delta = math.sqrt(math.fabs((a-b)*(a-b)+4.*c*c))
235 
236  if a+b-delta > 0: jet.axis2 = -math.log(math.sqrt(0.5*(a+b-delta)))
237  else: jet.axis2 = -1.
238  return jet
239 
240 
def computeQGvars
Definition: Jet.py:169
hasQGvars
Definition: Jet.py:173
def Jet.Jet.corrFactor (   self)

Definition at line 113 of file Jet.py.

References Jet.Jet.rawFactor().

114  def corrFactor(self):
115  return 1.0/self.rawFactor()
def corrFactor
Definition: Jet.py:113
def rawFactor
Definition: Jet.py:107
def Jet.Jet.jetID (   self,
  name = "" 
)

Definition at line 51 of file Jet.py.

References funct.abs(), reco::JPTJet.chargedEmEnergy(), reco::PFJet.chargedEmEnergy(), JetTester.chargedEmEnergy, pat::Jet.chargedEmEnergy(), ScoutingPFJet.chargedHadronEnergy(), reco::JPTJet.chargedHadronEnergy(), reco::PFJet.chargedHadronEnergy(), JetTester.chargedHadronEnergy, pat::Jet.chargedHadronEnergy(), ScoutingPFJet.chargedHadronMultiplicity(), reco::PFJet.chargedHadronMultiplicity(), JetTester.chargedHadronMultiplicity, pat::Jet.chargedHadronMultiplicity(), reco::JPTJet.chargedMultiplicity(), reco::PFJet.chargedMultiplicity(), JetTester.chargedMultiplicity, pat::Jet.chargedMultiplicity(), relval_parameters_module.energy, eetest::CandForTest.eta(), DBlmapWriter::_LMapRowHBEF.eta, res::HelperElectron.eta(), res::HelperMuon.eta(), res::HelperJet.eta(), MSLayersKeeperX0AtEta.eta(), RecoObj.eta, muonisolation::NominalEfficiencyThresholds::ThresholdLocation.eta, HcalCellType::HcalCell.eta, res::HelperMET.eta(), SimG4HcalHitCluster.eta(), Raddam_ch.eta, ScoutingParticle.eta(), jetData.eta, SuperClusterHelper.eta(), ScoutingPhoton.eta(), Residual1DHit.eta, CaloHit.eta(), DDHCalTBZposAlgo.eta, DDHCalTestBeamAlgo.eta, ScoutingElectron.eta(), MatchStruct.eta, HcalChannelId.eta, BenchmarkTreeEntry.eta, PtEtaPhiMass.eta(), HcalDDDRecConstants::HcalID.eta, HcalHardcodeGeometryLoader::HBHOCellParameters.eta, ScoutingMuon.eta(), HcalFlexiHardcodeGeometryLoader::HBHOCellParameters.eta, ScoutingCaloJet.eta(), learn_.eta, ImpactPoint.eta, L2TauPixelTrackMatch::TinyTrack.eta, reco::isodeposit::Direction.eta(), EnergyResolutionVsLumi::DegradationAtEta.eta, egHLT::BinData.eta, ScoutingPFJet.eta(), ShallowClustersProducer::NearDigis.eta(), LMapLoader::_LMapRowHBEF.eta, TrackerValidationVariables::AVHitStruct.eta, LMapRow.eta, DTMuonLocalAlignment.eta, HcalTestHistoClass::Hit.eta, ElectronMVAEstimator.eta, HcalDDDRecConstants::HcalActiveLength.eta, ZMuMuIsolationAnalyzer.eta, HcalHardcodeGeometryLoader::HECellParameters.eta, PatTrackAnalyzer::Plots.eta, BeamProfileVtxGenerator.eta(), PHcalTB04Info.eta(), lhef::JetClustering::Jet.eta(), IdealZPrism.eta(), MaterialBudgetCastorHistos.eta, PHcalTB06Info::Hit.eta, StripCPEgeometric::WrappedCluster.eta(), GloballyPositioned< float >.eta(), GloballyPositioned< align::Scalar >.eta(), HcalFlexiHardcodeGeometryLoader::HECellParameters.eta, GloballyPositioned< T >.eta(), RotationType.eta(), QcdLowPtDQM::Pixel.eta(), IdealObliquePrism.eta(), jpt::Map.eta(), PGlobalSimHit::CalHit.eta, OnePiRange< T >.eta(), Geom::OnePiRange< T >.eta(), MaterialBudget.eta, HLTJetsCleanedFromLeadingLeptons< JetType >::EtaPhiE.eta(), L1MuGMTEtaLUT.eta(), FWPFCandidateDetailView.eta(), JetCalibrationParameterSetTauJet.eta(), trigger::TriggerObject.eta(), MaterialBudgetForward.eta, PFECALSuperClusterAlgo::CalibratedPFCluster.eta(), XMLHTRZeroSuppressionLoader::_datasetDBConfig.eta, IsolatedPixelTrackCandidateProducer::seedAtEC.eta, reco::GhostTrackPrediction.eta(), TrackerValidationVariables::AVTrackStruct.eta, PGlobalSimHit::FwdHit.eta, HcalTB02HistoClass.eta(), MaterialBudgetHcalHistos.eta, reco::PattRecoPeak< double >.eta(), reco::PattRecoPeak< float >.eta(), PattRecoPeak< Real >.eta(), HcalHardcodeGeometryLoader::HFCellParameters.eta, reco::PattRecoPeak< Real >.eta(), goodseedhelpers::HeavyObjectCache.eta, reco::CaloMuon.eta(), SimpleL1MuGMTCand.eta(), PHcalTB06Info.eta(), HTrackVariables.eta(), PdtPdgMini.eta, SoftElectronMVAEstimator.eta, MuScleFitMuon.eta(), CSCSP_SPblock.eta(), EleRelPoint.eta(), XMLProcessor::_LMapRowHBEF.eta, ValidationMisalignedTracker.eta, HcalFlexiHardcodeGeometryLoader::HFCellParameters.eta, reco::CastorCell.eta(), PhotonFix.eta(), cms::MinBias.eta, L1MuDTEtaPattern.eta(), HcalDDDRecConstantsTemp::HcalActiveLength.eta, LMapDetId.eta, PGlobalSimHit::BrlHit.eta, PatPhotonSimpleAnalyzer::struct_recPhoton.eta, PhotonIDSimpleAnalyzer::struct_recPhoton.eta, reco::IsoDeposit.eta(), reco::CastorEgamma.eta(), reco::CastorJet.eta(), PV3DBase< T, PointTag, GlobalTag >.eta(), Vector3DBase< U, LocalTag >.eta(), PV3DBase< align::Scalar, PointTag, GlobalTag >.eta(), Vector3DBase< T, Frame >.eta(), Point3DBase< U, Frame >.eta(), Vector3DBase< T, FrameTag >.eta(), PV3DBase< float, VectorTag, LocalTag >.eta(), PV3DBase< float, PointTag, LocalTag >.eta(), PV3DBase< float, VectorTag, MeasurementTag >.eta(), PV3DBase< float, PointTag, MeasurementTag >.eta(), PV3DBase< Scalar, VectorTag, GlobalTag >.eta(), PV3DBase< T, VectorTag, FrameTag >.eta(), PV3DBase< float, VectorTag, GlobalTag >.eta(), PV3DBase< Scalar, PointTag, GlobalTag >.eta(), PV3DBase< float, PointTag, GlobalTag >.eta(), PV3DBase< long double, PointTag, GlobalTag >.eta(), Point3DBase< U, LocalTag >.eta(), Point3DBase< U, GlobalTag >.eta(), Point3DBase< T, Frame >.eta(), Point3DBase< U, FrameTag >.eta(), Vector3DBase< U, FrameTag >.eta(), Vector3DBase< U, Frame >.eta(), Vector3DBase< double, LocalTag >.eta(), PV3DBase< T, PVType, FrameType >.eta(), PV3DBase< T, PointTag, FrameTag >.eta(), QcdLowPtDQM::Tracklet.eta(), Vector3DBase< U, GlobalTag >.eta(), L1MuDTTrack.eta(), MuonDTLocalMillepedeAlgorithm.eta, BPhysicsValidation::ParticleMonitor.eta, HcalTB02Analysis.eta, L1MuDTEtaProcessor.eta(), MuonGmtPair.eta(), EgammaTowerIsolationNew< NC >.eta, L1TDEMON.eta, cms::Analyzer_minbias.eta, reco::PreId.eta(), reco::CastorCluster.eta(), Lepton.eta, L1TdeGCT.eta, TrackStruct::TrackParameterStruct.eta, reco::Candidate.eta(), egHLT::OffPho.eta(), JetPartonNamespace::JetPartonCalibrationParameterSet.eta(), AnalyzerMinbias.eta, reco::Particle.eta(), reco::ParticleState.eta(), L1GctInternJetData.eta(), egHLT::OffEle.eta(), EcalTestPulseAnalyzer.eta, EcalABAnalyzer.eta, MuonGeometryArrange::MGACollection.eta, Basic3DVector< long double >.eta(), CandidateWithRef< Ref >.eta(), reco::LeafCandidate.eta(), EcalPerEvtLaserAnalyzer.eta, JetAnalyzer_HeavyIons_matching::MyJet.eta, reco::IsoDeposit::const_iterator.eta(), Basic3DVector< U >.eta(), Basic3DVector< Scalar >.eta(), Basic3DVector< float >.eta(), Basic3DVector< align::Scalar >.eta(), Basic3DVector< float > pos GlobalPoint.eta(), Basic3DVector< T >.eta(), Basic3DVector< double >.eta(), Basic3DVector< float > mom GlobalVector.eta(), reco::CaloCluster.eta(), GoodSeedProducer.eta, pat::PackedGenParticle.eta(), EcalLaserAnalyzer.eta, TrackingParticle.eta(), RawParticle.eta(), EcalLaserAnalyzer2.eta, SiPixelErrorEstimation.eta, HLTEgamma::OpenHLTPhoton.eta, HLTEgamma::OpenHLTElectron.eta, reco::TrackBase.eta(), pat::PackedCandidate.eta(), EcalSelectiveReadoutValidation::energiesEb_t.eta, EcalSelectiveReadoutValidation::energiesEe_t.eta, SiPixelTrackingRecHitsValid.eta, PMuonSimHit::Trk.eta, PTrackerSimHit::Trk.eta, JetTester.isPFJet, pat::Jet.isPFJet(), JetAnalyzer_HeavyIons.isPFJet, JetTester_HeavyIons.isPFJet, Jet.Jet.jetID(), JetMETHLTOfflineSource.jetID, ExoticaDQM.jetID, HLTJets.jetID, pat::Jet.jetID(), ScoutingPFJet.muonEnergy(), reco::PFJet.muonEnergy(), JetTester.muonEnergy, pat::Jet.muonEnergy(), reco::JPTJet.neutralEmEnergy(), reco::PFJet.neutralEmEnergy(), JetTester.neutralEmEnergy, pat::Jet.neutralEmEnergy(), ScoutingPFJet.neutralHadronEnergy(), reco::JPTJet.neutralHadronEnergy(), reco::PFJet.neutralHadronEnergy(), JetTester.neutralHadronEnergy, pat::Jet.neutralHadronEnergy(), reco::PFJet.neutralMultiplicity(), JetTester.neutralMultiplicity, pat::Jet.neutralMultiplicity(), InvariantMassFromVertex.p4(), CondFormats_SiPixelObjects::dictionary.p4, reco::PUSubMETCandInfo.p4(), lhef::JetClustering::Jet.p4(), tauImpactParameter::LorentzVectorParticle.p4(), MuScleFitMuon.p4(), reco::Candidate.p4(), reco::Particle.p4(), reco::ParticleState.p4(), TopDecaySubset.p4(), PrimaryVertexAnalyzer4PUSlimmed::simPrimaryVertex.p4, @582.p4, reco::LeafCandidate.p4(), CandidateWithRef< Ref >.p4(), TrackingParticle.p4(), egHLT::OffPho.p4(), egHLT::OffEle.p4(), CaloTower.p4(), reco::tau::RecoTauConstructor.p4(), pat::PackedGenParticle.p4(), reco::Vertex.p4(), reco::Photon.p4(), pat::PackedCandidate.p4(), Electron.Electron.p4(), reco::GsfElectron.p4(), and Jet.Jet.rawFactor().

Referenced by Jet.Jet.jetID(), and Jet.Jet.looseJetId().

51 
52  def jetID(self,name=""):
53  if not self.isPFJet():
54  raise RuntimeError, "jetID implemented only for PF Jets"
55  eta = abs(self.eta());
56  energy = (self.p4()*self.rawFactor()).energy();
57  chf = self.chargedHadronEnergy()/energy;
58  nhf = self.neutralHadronEnergy()/energy;
59  phf = self.neutralEmEnergy()/energy;
60  muf = self.muonEnergy()/energy;
61  elf = self.chargedEmEnergy()/energy;
62  chm = self.chargedHadronMultiplicity();
63  npr = self.chargedMultiplicity() + self.neutralMultiplicity();
64  npn = self.neutralMultiplicity();
65  #if npr != self.nConstituents():
66  # import pdb; pdb.set_trace()
67  if name == "POG_PFID":
68 
69  if self.jetID("PAG_monoID_Tight") and self.jetID("POG_PFID_Tight") : return 5;
70  if self.jetID("PAG_monoID_Loose") and self.jetID("POG_PFID_Tight") : return 4;
71  if self.jetID("POG_PFID_Tight") : return 3;
72  #elif self.jetID("POG_PFID_Medium") : return 2; commented this line because this working point doesn't exist anymore (as 12/05/15)
73  elif self.jetID("POG_PFID_Loose") : return 1;
74  else : return 0;
75 
76  # jetID from here: https://twiki.cern.ch/twiki/bin/viewauth/CMS/JetID#Recommendations_for_13_TeV_data
77  if name == "POG_PFID_Loose": return ((eta<3.0 and ((npr>1 and phf<0.99 and nhf<0.99) and (eta>2.4 or (elf<0.99 and chf>0 and chm>0)))) or (eta>3.0 and (phf<0.90 and npn>10)));
78  if name == "POG_PFID_Medium": return (npr>1 and phf<0.95 and nhf<0.95 and muf < 0.8) and (eta>2.4 or (elf<0.99 and chf>0 and chm>0));
79  if name == "POG_PFID_Tight": return ((eta<3.0 and ((npr>1 and phf<0.90 and nhf<0.90) and (eta>2.4 or (elf<0.99 and chf>0 and chm>0)))) or (eta>3.0 and (phf<0.90 and npn>10)));
80  if name == "VBFHBB_PFID_Loose": return (npr>1 and phf<0.99 and nhf<0.99);
81  if name == "VBFHBB_PFID_Medium": return (npr>1 and phf<0.99 and nhf<0.99) and ((eta<=2.4 and nhf<0.9 and phf<0.9 and elf<0.99 and muf<0.99 and chf>0 and chm>0) or eta>2.4);
82  if name == "VBFHBB_PFID_Tight": return (npr>1 and phf<0.99 and nhf<0.99) and ((eta<=2.4 and nhf<0.9 and phf<0.9 and elf<0.70 and muf<0.70 and chf>0 and chm>0) or eta>2.4);
83  if name == "PAG_monoID_Loose": return (eta<3.0 and chf>0.05 and nhf<0.7 and phf<0.8);
84  if name == "PAG_monoID_Tight": return (eta<3.0 and chf>0.2 and nhf<0.7 and phf<0.7);
85 
86  raise RuntimeError, "jetID '%s' not supported" % name
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
def jetID
Definition: Jet.py:51
def rawFactor
Definition: Jet.py:107
def Jet.Jet.l1corrFactor (   self)

Definition at line 122 of file Jet.py.

References Jet.Jet._recalibrated.

123  def l1corrFactor(self):
124  if hasattr(self, 'CorrFactor_L1'):
125  return self.CorrFactor_L1
126  if self._recalibrated:
127  raise RuntimeError, "The jet was recalibrated, but without calculateSeparateCorrections. L1 is not available"
128  jecLevels = self.physObj.availableJECLevels()
129  for level in jecLevels:
130  if "L1" in level:
131  return self.physObj.jecFactor(level)/self.physObj.jecFactor('Uncorrected')
132  return 1.0 # Jet does not have any L1 correction
_recalibrated
Definition: Jet.py:47
def l1corrFactor
Definition: Jet.py:122
def Jet.Jet.leadingTrack (   self)

Definition at line 144 of file Jet.py.

References Jet.Jet._leadingTrack, Jet.Jet._leadingTrackSearched, reco::CompositePtrCandidate.daughterPtrVector(), and bookConverter.max.

Referenced by Jet.Jet.leadTrackPt().

145  def leadingTrack(self):
146  if self._leadingTrackSearched :
147  return self._leadingTrack
148  self._leadingTrackSearched = True
149  self._leadingTrack = max( self.daughterPtrVector() , key = lambda x : x.pt() if x.charge()!=0 else 0. )
150  if self._leadingTrack.charge()==0: #in case of "all neutral"
151  self._leadingTrack = None
152  return self._leadingTrack
_leadingTrack
Definition: Jet.py:48
def leadingTrack
Definition: Jet.py:144
_leadingTrackSearched
Definition: Jet.py:49
def Jet.Jet.leadTrackPt (   self)

Definition at line 153 of file Jet.py.

References Jet.Jet.leadingTrack().

154  def leadTrackPt(self):
155  lt=self.leadingTrack()
156  if lt :
157  return lt.pt()
158  else :
return 0.
def leadingTrack
Definition: Jet.py:144
def leadTrackPt
Definition: Jet.py:153
def Jet.Jet.looseJetId (   self)
PF Jet ID (loose operation point) [method provided for convenience only]

Definition at line 87 of file Jet.py.

References Jet.Jet.jetID(), JetMETHLTOfflineSource.jetID, ExoticaDQM.jetID, HLTJets.jetID, and pat::Jet.jetID().

87 
88  def looseJetId(self):
89  '''PF Jet ID (loose operation point) [method provided for convenience only]'''
90  return self.jetID("POG_PFID_Loose")
def looseJetId
Definition: Jet.py:87
def jetID
Definition: Jet.py:51
def Jet.Jet.puJetId (   self,
  label = "pileupJetId:fullDiscriminant" 
)
Full mva PU jet id

Definition at line 94 of file Jet.py.

References funct.abs(), eetest::CandForTest.eta(), DBlmapWriter::_LMapRowHBEF.eta, res::HelperElectron.eta(), res::HelperMuon.eta(), res::HelperJet.eta(), MSLayersKeeperX0AtEta.eta(), RecoObj.eta, muonisolation::NominalEfficiencyThresholds::ThresholdLocation.eta, HcalCellType::HcalCell.eta, res::HelperMET.eta(), SimG4HcalHitCluster.eta(), ScoutingParticle.eta(), Raddam_ch.eta, jetData.eta, SuperClusterHelper.eta(), ScoutingPhoton.eta(), Residual1DHit.eta, CaloHit.eta(), DDHCalTBZposAlgo.eta, DDHCalTestBeamAlgo.eta, ScoutingElectron.eta(), HcalChannelId.eta, MatchStruct.eta, PtEtaPhiMass.eta(), BenchmarkTreeEntry.eta, HcalDDDRecConstants::HcalID.eta, HcalHardcodeGeometryLoader::HBHOCellParameters.eta, ScoutingMuon.eta(), HcalFlexiHardcodeGeometryLoader::HBHOCellParameters.eta, ScoutingCaloJet.eta(), learn_.eta, ImpactPoint.eta, L2TauPixelTrackMatch::TinyTrack.eta, reco::isodeposit::Direction.eta(), EnergyResolutionVsLumi::DegradationAtEta.eta, egHLT::BinData.eta, ScoutingPFJet.eta(), ShallowClustersProducer::NearDigis.eta(), LMapLoader::_LMapRowHBEF.eta, TrackerValidationVariables::AVHitStruct.eta, LMapRow.eta, HcalTestHistoClass::Hit.eta, DTMuonLocalAlignment.eta, ElectronMVAEstimator.eta, HcalDDDRecConstants::HcalActiveLength.eta, ZMuMuIsolationAnalyzer.eta, HcalHardcodeGeometryLoader::HECellParameters.eta, PatTrackAnalyzer::Plots.eta, BeamProfileVtxGenerator.eta(), PHcalTB04Info.eta(), lhef::JetClustering::Jet.eta(), IdealZPrism.eta(), MaterialBudgetCastorHistos.eta, PHcalTB06Info::Hit.eta, StripCPEgeometric::WrappedCluster.eta(), GloballyPositioned< float >.eta(), GloballyPositioned< align::Scalar >.eta(), HcalFlexiHardcodeGeometryLoader::HECellParameters.eta, GloballyPositioned< T >.eta(), RotationType.eta(), QcdLowPtDQM::Pixel.eta(), IdealObliquePrism.eta(), jpt::Map.eta(), PGlobalSimHit::CalHit.eta, OnePiRange< T >.eta(), Geom::OnePiRange< T >.eta(), MaterialBudget.eta, HLTJetsCleanedFromLeadingLeptons< JetType >::EtaPhiE.eta(), L1MuGMTEtaLUT.eta(), JetCalibrationParameterSetTauJet.eta(), trigger::TriggerObject.eta(), FWPFCandidateDetailView.eta(), MaterialBudgetForward.eta, PFECALSuperClusterAlgo::CalibratedPFCluster.eta(), XMLHTRZeroSuppressionLoader::_datasetDBConfig.eta, IsolatedPixelTrackCandidateProducer::seedAtEC.eta, reco::GhostTrackPrediction.eta(), TrackerValidationVariables::AVTrackStruct.eta, PGlobalSimHit::FwdHit.eta, HcalTB02HistoClass.eta(), MaterialBudgetHcalHistos.eta, reco::PattRecoPeak< double >.eta(), reco::PattRecoPeak< float >.eta(), PattRecoPeak< Real >.eta(), HcalHardcodeGeometryLoader::HFCellParameters.eta, reco::PattRecoPeak< Real >.eta(), reco::CaloMuon.eta(), goodseedhelpers::HeavyObjectCache.eta, PHcalTB06Info.eta(), PdtPdgMini.eta, HTrackVariables.eta(), SoftElectronMVAEstimator.eta, SimpleL1MuGMTCand.eta(), MuScleFitMuon.eta(), CSCSP_SPblock.eta(), XMLProcessor::_LMapRowHBEF.eta, EleRelPoint.eta(), ValidationMisalignedTracker.eta, HcalFlexiHardcodeGeometryLoader::HFCellParameters.eta, reco::CastorCell.eta(), PhotonFix.eta(), cms::MinBias.eta, HcalDDDRecConstantsTemp::HcalActiveLength.eta, L1MuDTEtaPattern.eta(), LMapDetId.eta, PGlobalSimHit::BrlHit.eta, PatPhotonSimpleAnalyzer::struct_recPhoton.eta, PhotonIDSimpleAnalyzer::struct_recPhoton.eta, reco::IsoDeposit.eta(), reco::CastorEgamma.eta(), reco::CastorJet.eta(), PV3DBase< float, PointTag, GlobalTag >.eta(), PV3DBase< long double, PointTag, GlobalTag >.eta(), QcdLowPtDQM::Tracklet.eta(), Vector3DBase< U, FrameTag >.eta(), Point3DBase< U, Frame >.eta(), PV3DBase< align::Scalar, PointTag, GlobalTag >.eta(), PV3DBase< float, VectorTag, LocalTag >.eta(), PV3DBase< float, PointTag, LocalTag >.eta(), PV3DBase< Scalar, PointTag, GlobalTag >.eta(), PV3DBase< T, PointTag, GlobalTag >.eta(), PV3DBase< float, VectorTag, GlobalTag >.eta(), PV3DBase< T, PointTag, FrameTag >.eta(), Point3DBase< U, LocalTag >.eta(), Point3DBase< T, Frame >.eta(), Point3DBase< U, FrameTag >.eta(), PV3DBase< T, PVType, FrameType >.eta(), PV3DBase< float, VectorTag, MeasurementTag >.eta(), Vector3DBase< T, FrameTag >.eta(), Vector3DBase< double, LocalTag >.eta(), PV3DBase< Scalar, VectorTag, GlobalTag >.eta(), PV3DBase< T, VectorTag, FrameTag >.eta(), Vector3DBase< U, LocalTag >.eta(), Point3DBase< U, GlobalTag >.eta(), Vector3DBase< T, Frame >.eta(), PV3DBase< float, PointTag, MeasurementTag >.eta(), Vector3DBase< U, GlobalTag >.eta(), Vector3DBase< U, Frame >.eta(), L1MuDTTrack.eta(), MuonDTLocalMillepedeAlgorithm.eta, BPhysicsValidation::ParticleMonitor.eta, HcalTB02Analysis.eta, L1MuDTEtaProcessor.eta(), MuonGmtPair.eta(), EgammaTowerIsolationNew< NC >.eta, L1TDEMON.eta, cms::Analyzer_minbias.eta, reco::PreId.eta(), reco::CastorCluster.eta(), Lepton.eta, L1TdeGCT.eta, TrackStruct::TrackParameterStruct.eta, reco::Candidate.eta(), egHLT::OffPho.eta(), JetPartonNamespace::JetPartonCalibrationParameterSet.eta(), AnalyzerMinbias.eta, reco::Particle.eta(), L1GctInternJetData.eta(), reco::ParticleState.eta(), egHLT::OffEle.eta(), EcalTestPulseAnalyzer.eta, EcalABAnalyzer.eta, MuonGeometryArrange::MGACollection.eta, Basic3DVector< long double >.eta(), reco::LeafCandidate.eta(), CandidateWithRef< Ref >.eta(), JetAnalyzer_HeavyIons_matching::MyJet.eta, EcalPerEvtLaserAnalyzer.eta, reco::IsoDeposit::const_iterator.eta(), Basic3DVector< double >.eta(), Basic3DVector< Scalar >.eta(), Basic3DVector< align::Scalar >.eta(), Basic3DVector< float > pos GlobalPoint.eta(), Basic3DVector< float >.eta(), Basic3DVector< U >.eta(), Basic3DVector< float > mom GlobalVector.eta(), Basic3DVector< T >.eta(), reco::CaloCluster.eta(), GoodSeedProducer.eta, pat::PackedGenParticle.eta(), EcalLaserAnalyzer.eta, TrackingParticle.eta(), RawParticle.eta(), EcalLaserAnalyzer2.eta, SiPixelErrorEstimation.eta, HLTEgamma::OpenHLTPhoton.eta, HLTEgamma::OpenHLTElectron.eta, reco::TrackBase.eta(), pat::PackedCandidate.eta(), EcalSelectiveReadoutValidation::energiesEb_t.eta, EcalSelectiveReadoutValidation::energiesEe_t.eta, SiPixelTrackingRecHitsValid.eta, PMuonSimHit::Trk.eta, PTrackerSimHit::Trk.eta, and Jet.Jet.puMva().

94 
95  def puJetId(self, label="pileupJetId:fullDiscriminant"):
96  '''Full mva PU jet id'''
97 
98  puMva = self.puMva(label)
99  wp = loose_53X_WP
100  eta = abs(self.eta())
101 
102  for etamin, etamax, cut in wp:
103  if not(eta>=etamin and eta<etamax):
104  continue
105  return puMva>cut
106  return -99
def puMva
Definition: Jet.py:91
def puJetId
Definition: Jet.py:94
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
def Jet.Jet.puMva (   self,
  label = "pileupJetId:fullDiscriminant" 
)

Definition at line 91 of file Jet.py.

References pat::PATObject< ObjectType >.userFloat(), Lepton< LeptonType >.userFloat(), pat::PATObject< reco::Muon >.userFloat(), pat::PATObject< reco::LeafCandidate >.userFloat(), pat::PATObject< reco::GsfElectron >.userFloat(), pat::PATObject< reco::MET >.userFloat(), pat::PATObject< reco::Photon >.userFloat(), pat::PATObject< reco::RecoCandidate >.userFloat(), pat::PATObject< reco::BaseTau >.userFloat(), pat::PATObject< reco::PFCandidate >.userFloat(), pat::PATObject< reco::CompositeCandidate >.userFloat(), pat::PATObject< LeptonType >.userFloat(), and pat::PATObject< reco::Jet >.userFloat().

Referenced by Jet.Jet.puJetId().

91 
92  def puMva(self, label="pileupJetId:fullDiscriminant"):
93  return self.userFloat(label)
def puMva
Definition: Jet.py:91
def Jet.Jet.qgl (   self)

Definition at line 159 of file Jet.py.

References Jet.Jet.computeQGvars().

160  def qgl(self) :
161  if not hasattr(self,"qgl_value") :
162  if hasattr(self,"qgl_rho") : #check if qgl calculator is configured
164  self.qgl_value=self.qgl_calc(self,self.qgl_rho)
165  else :
166  self.qgl_value=-1. #if no qgl calculator configured
167 
168  return self.qgl_value
def qgl
Definition: Jet.py:159
qgl_value
Definition: Jet.py:163
def computeQGvars
Definition: Jet.py:169
def Jet.Jet.rawFactor (   self)

Definition at line 107 of file Jet.py.

References Jet.Jet._rawFactorMultiplier, pat::Jet.jecFactor(), and pat::Tau.jecFactor().

Referenced by Jet.Jet.corrFactor(), Jet.Jet.jetID(), and Jet.Jet.setCorrP4().

108  def rawFactor(self):
109  return self.jecFactor('Uncorrected') * self._rawFactorMultiplier
_rawFactorMultiplier
Definition: Jet.py:46
def rawFactor
Definition: Jet.py:107
def Jet.Jet.setCorrP4 (   self,
  newP4 
)

Definition at line 116 of file Jet.py.

References Jet.Jet._recalibrated, eetest::CandForTest.pt(), mypt.pt, res::HelperElectron.pt(), res::HelperMuon.pt(), res::HelperJet.pt(), reco::VoronoiBackground.pt(), RecoObj.pt, tauImpactParameter::LorentzVectorParticle.pt, ScoutingParticle.pt(), L1MuCSCPtLut.pt(), ScoutingPhoton.pt(), Residual1DHit.pt, reco::MuonMETCorrectionData.pt(), ScoutingElectron.pt(), PtHatReweightUserHook.pt, MatchStruct.pt, PtEtaPhiMass.pt(), ALILine.pt(), ScoutingMuon.pt(), ScoutingCaloJet.pt(), L2TauPixelTrackMatch::TinyTrack.pt, TrackMultiSelector::Block.pt, ScoutingPFJet.pt(), DTMuonLocalAlignment.pt, TtFullHadSignalSel.pt(), ElectronMVAEstimator.pt, PGlobalSimHit::Trk.pt, lhef::JetClustering::Jet.pt(), ZMuMuIsolationAnalyzer.pt, PatTrackAnalyzer::Plots.pt, jpt::Map.pt(), SiStripLAProfileBooker.pt, PhysicsObjectsMonitor.pt, reco::CaloMuon.pt(), TrackerValidationVariables::AVTrackStruct.pt, trigger::TriggerObject.pt(), BSTrkParameters.pt(), ElectronMVAEstimatorRun2Phys14NonTrig::AllVariables.pt, goodseedhelpers::HeavyObjectCache.pt, MuScleFitMuon.pt(), SoftElectronMVAEstimator.pt, SimpleL1MuGMTCand.pt(), ValidationMisalignedTracker.pt, HTrackVariables.pt(), PTrajectoryStateOnDet.pt(), HepLine3D.pt(), L1MuDTTrack.pt(), ElectronMVAEstimatorRun2Spring15NonTrig::AllVariables.pt, TrajectoryStateClosestToPoint.pt(), ElectronMVAEstimatorRun2Spring15Trig::AllVariables.pt, MuonDTLocalMillepedeAlgorithm.pt, BPhysicsValidation::ParticleMonitor.pt, PhotonPair.pt(), susybsm::HSCParticle.pt(), QualityCutsAnalyzer::histogram_element_t.pt, MuonGmtPair.pt(), reco::PreId.pt(), Lepton.pt, reco::Candidate.pt(), egHLT::OffPho.pt(), TrackStruct::TrackParameterStruct.pt, reco::Particle.pt(), reco::ParticleState.pt(), contrib::CMSBoostedTauSeedingAlgorithmStructure.pt(), PtHatRapReweightUserHook.pt, MuonResidualsFitter::MuonAlignmentTreeRow.pt, AlignmentMonitorMuonSystemMap1D::MyTrack.pt, CandidateWithRef< Ref >.pt(), reco::LeafCandidate.pt(), reco::PFCluster.pt(), JetAnalyzer_HeavyIons_matching::MyJet.pt, TrackingParticle.pt(), pat::MET::Vector2.pt(), GoodSeedProducer.pt, pat::PackedGenParticle.pt(), reco::TrackBase.pt(), pat::PackedCandidate.pt(), PMuonSimHit::Trk.pt, PTrackerSimHit::Trk.pt, Jet.Jet.rawFactor(), reco::PUSubMETCandInfo.setP4(), reco::Candidate.setP4(), reco::Particle.setP4(), reco::ParticleState.setP4(), reco::LeafCandidate.setP4(), CandidateWithRef< Ref >.setP4(), pat::PackedGenParticle.setP4(), reco::Photon.setP4(), pat::PackedCandidate.setP4(), reco::GsfElectron.setP4(), and Jet.Jet.setRawFactor().

117  def setCorrP4(self,newP4):
118  self._recalibrated = True
119  corr = newP4.Pt() / (self.pt() * self.rawFactor())
120  self.setP4(newP4);
121  self.setRawFactor(1.0/corr);
def setRawFactor
Definition: Jet.py:110
_recalibrated
Definition: Jet.py:47
def setCorrP4
Definition: Jet.py:116
def rawFactor
Definition: Jet.py:107
def Jet.Jet.setRawFactor (   self,
  factor 
)

Definition at line 110 of file Jet.py.

References Jet.Jet._rawFactorMultiplier, pat::Jet.jecFactor(), and pat::Tau.jecFactor().

Referenced by Jet.Jet.setCorrP4().

111  def setRawFactor(self, factor):
112  self._rawFactorMultiplier = factor/self.jecFactor('Uncorrected')
def setRawFactor
Definition: Jet.py:110
_rawFactorMultiplier
Definition: Jet.py:46

Member Data Documentation

Jet.Jet._leadingTrack
private

Definition at line 48 of file Jet.py.

Referenced by Jet.Jet.leadingTrack().

Jet.Jet._leadingTrackSearched
private

Definition at line 49 of file Jet.py.

Referenced by Jet.Jet.leadingTrack().

Jet.Jet._rawFactorMultiplier
private

Definition at line 46 of file Jet.py.

Referenced by Jet.Jet.rawFactor(), and Jet.Jet.setRawFactor().

Jet.Jet._recalibrated
private

Definition at line 47 of file Jet.py.

Referenced by Jet.Jet.l1corrFactor(), and Jet.Jet.setCorrP4().

Jet.Jet.hasQGvars

Definition at line 173 of file Jet.py.

Jet.Jet.qgl_value

Definition at line 163 of file Jet.py.