|
VertexRef | chargedHadronVertex (edm::Handle< reco::VertexCollection > verticies, const reco::PFCandidate &pfcand) |
|
float | fGetIsolation (const reco::PFCandidate *pfCandidate, const reco::PFCandidateCollection *pfParticlesColl, reco::VertexRef vtx, edm::Handle< reco::VertexCollection > vertices) |
|
float | fGetIsolation (const reco::Photon *photon, const reco::PFCandidateCollection *pfParticlesColl, reco::VertexRef vtx, edm::Handle< reco::VertexCollection > vertices) |
|
float | fGetIsolation (const reco::GsfElectron *electron, const reco::PFCandidateCollection *pfParticlesColl, const reco::VertexRef vtx, edm::Handle< reco::VertexCollection > vertices) |
|
vector< float > | fGetIsolationInRings (const reco::PFCandidate *pfCandidate, const reco::PFCandidateCollection *pfParticlesColl, reco::VertexRef vtx, edm::Handle< reco::VertexCollection > vertices) |
|
vector< float > | fGetIsolationInRings (const reco::Photon *photon, const reco::PFCandidateCollection *pfParticlesColl, reco::VertexRef vtx, edm::Handle< reco::VertexCollection > vertices) |
|
vector< float > | fGetIsolationInRings (const reco::GsfElectron *electron, const reco::PFCandidateCollection *pfParticlesColl, reco::VertexRef vtx, edm::Handle< reco::VertexCollection > vertices) |
|
float | getIsolationCharged () |
|
float | getIsolationChargedAll () |
|
vector< float > | getIsolationInRingsCharged () |
|
vector< float > | getIsolationInRingsChargedAll () |
|
vector< float > | getIsolationInRingsNeutral () |
|
vector< float > | getIsolationInRingsPhoton () |
|
float | getIsolationNeutral () |
|
float | getIsolationPhoton () |
|
int | getNumbersOfRings () |
|
float | getRingSize () |
|
void | initializeElectronIsolation (Bool_t bApplyVeto) |
|
void | initializeElectronIsolationInRings (Bool_t bApplyVeto, int iNumberOfRings, float fRingSize) |
|
void | initializePhotonIsolation (Bool_t bApplyVeto) |
|
void | initializePhotonIsolationInRings (Bool_t bApplyVeto, int iNumberOfRings, float fRingSize) |
|
void | initializeRings (int iNumberOfRings, float fRingSize) |
|
float | isChargedParticleVetoed (const reco::PFCandidate *pfIsoCand, edm::Handle< reco::VertexCollection > vertices) |
|
float | isChargedParticleVetoed (const reco::PFCandidate *pfIsoCand, reco::VertexRef vtx, edm::Handle< reco::VertexCollection > vertices) |
|
Bool_t | isInitialized () const |
|
float | isNeutralParticleVetoed (const reco::PFCandidate *pfIsoCand) |
|
float | isPhotonParticleVetoed (const reco::PFCandidate *pfIsoCand) |
|
int | matchPFObject (const reco::Photon *photon, const reco::PFCandidateCollection *pfParticlesColl) |
|
int | matchPFObject (const reco::GsfElectron *photon, const reco::PFCandidateCollection *pfParticlesColl) |
|
| PFIsolationEstimator () |
|
void | setApplyDzDxyVeto (Bool_t bValue=kTRUE) |
|
void | setApplyMissHitPhVeto (Bool_t bValue=kFALSE) |
|
void | setApplyPFPUVeto (Bool_t bValue=kFALSE) |
|
void | setApplyVeto (Bool_t bValue=kTRUE) |
|
void | setConeSize (float fValue=0.4) |
|
void | setDeltaRVetoBarrel (Bool_t bValue=kTRUE) |
|
void | setDeltaRVetoBarrelCharged (float fValue=-1.0) |
|
void | setDeltaRVetoBarrelNeutrals (float fValue=-1.0) |
|
void | setDeltaRVetoBarrelPhotons (float fValue=-1.0) |
|
void | setDeltaRVetoEndcap (Bool_t bValue=kTRUE) |
|
void | setDeltaRVetoEndcapCharged (float fValue=-1.0) |
|
void | setDeltaRVetoEndcapNeutrals (float fValue=-1.0) |
|
void | setDeltaRVetoEndcapPhotons (float fValue=-1.0) |
|
void | setNumberOfCrystalEndcapPhotons (float fValue=-1) |
|
void | setNumbersOfRings (int iValue=1) |
|
void | setParticleType (int iValue) |
|
void | setRectangleDeltaEtaVetoBarrelCharged (float fValue=-1.0) |
|
void | setRectangleDeltaEtaVetoBarrelNeutrals (float fValue=-1.0) |
|
void | setRectangleDeltaEtaVetoBarrelPhotons (float fValue=-1.0) |
|
void | setRectangleDeltaEtaVetoEndcapCharged (float fValue=-1.0) |
|
void | setRectangleDeltaEtaVetoEndcapNeutrals (float fValue=-1.0) |
|
void | setRectangleDeltaEtaVetoEndcapPhotons (float fValue=-1.0) |
|
void | setRectangleDeltaPhiVetoBarrelCharged (float fValue=-1.0) |
|
void | setRectangleDeltaPhiVetoBarrelNeutrals (float fValue=-1.0) |
|
void | setRectangleDeltaPhiVetoBarrelPhotons (float fValue=-1.0) |
|
void | setRectangleDeltaPhiVetoEndcapCharged (float fValue=-1.0) |
|
void | setRectangleDeltaPhiVetoEndcapNeutrals (float fValue=-1.0) |
|
void | setRectangleDeltaPhiVetoEndcapPhotons (float fValue=-1.0) |
|
void | setRectangleVetoBarrel (Bool_t bValue=kTRUE) |
|
void | setRectangleVetoEndcap (Bool_t bValue=kTRUE) |
|
void | setRingSize (float fValue=0.4) |
|
void | setUseCrystalSize (Bool_t bValue=kFALSE) |
|
| ~PFIsolationEstimator () |
|
Definition at line 58 of file PFIsolationEstimator.h.
Definition at line 216 of file PFIsolationEstimator.cc.
References funct::abs(), reco::LeafCandidate::eta(), fDeltaR, fEta, fIsolationInRings, fIsolationInRingsCharged, fIsolationInRingsChargedAll, fIsolationInRingsNeutral, fIsolationInRingsPhoton, fPhi, fPt, fRingSize, fVx, fVy, fVz, iNumberOfRings, isChargedParticleVetoed(), isNeutralParticleVetoed(), isPhotonParticleVetoed(), reco::LeafCandidate::pdgId(), reco::LeafCandidate::phi(), pivotInBarrel, reco::PFCandidate::positionAtECALEntrance(), reco::LeafCandidate::pt(), reco::PFCandidate::vx(), reco::PFCandidate::vy(), and reco::PFCandidate::vz().
Referenced by fGetIsolation().
233 fPt = pfCandidate->
pt();
234 fVx = pfCandidate->
vx();
235 fVy = pfCandidate->
vy();
236 fVz = pfCandidate->
vz();
240 for(
unsigned iPF=0; iPF<pfParticlesColl->size(); iPF++) {
244 if(&pfParticle==(pfCandidate))
247 if(pfParticle.
pdgId()==22){
254 }
else if(
abs(pfParticle.
pdgId())==130){
263 }
else if(
abs(pfParticle.
pdgId()) == 211){
virtual int pdgId() const
PDG identifier.
virtual double vz() const
z coordinate of vertex position
vector< float > fIsolationInRingsCharged
virtual float pt() const
transverse momentum
vector< float > fIsolationInRingsChargedAll
virtual float phi() const
momentum azimuthal angle
float isChargedParticleVetoed(const reco::PFCandidate *pfIsoCand, edm::Handle< reco::VertexCollection > vertices)
vector< float > fIsolationInRings
float isPhotonParticleVetoed(const reco::PFCandidate *pfIsoCand)
const math::XYZPointF & positionAtECALEntrance() const
virtual double vx() const
x coordinate of vertex position
vector< float > fIsolationInRingsNeutral
virtual float eta() const
momentum pseudorapidity
Abs< T >::type abs(const T &t)
float isNeutralParticleVetoed(const reco::PFCandidate *pfIsoCand)
virtual double vy() const
y coordinate of vertex position
Particle reconstructed by the particle flow algorithm.
vector< float > fIsolationInRingsPhoton
Definition at line 292 of file PFIsolationEstimator.cc.
References funct::abs(), fDeltaR, fEta, fIsolationInRings, fIsolationInRingsCharged, fIsolationInRingsChargedAll, fIsolationInRingsNeutral, fIsolationInRingsPhoton, fPhi, fRingSize, fVx, fVy, fVz, iMissHits, iNumberOfRings, isChargedParticleVetoed(), isNeutralParticleVetoed(), edm::Ref< C, T, F >::isNonnull(), isPhotonParticleVetoed(), reco::LeafCandidate::pdgId(), pivotInBarrel, reco::LeafCandidate::pt(), refSC, reco::Photon::superCluster(), reco::PFCandidate::superClusterRef(), reco::PFCandidate::vx(), reco::PFCandidate::vy(), and reco::PFCandidate::vz().
309 for(
unsigned iPF=0; iPF<pfParticlesColl->size(); iPF++) {
318 if(pfParticle.
pdgId()==22){
325 fEta = direction.Eta();
326 fPhi = direction.Phi();
327 fVx = pfParticle.
vx();
328 fVy = pfParticle.
vy();
329 fVz = pfParticle.
vz();
336 }
else if(
abs(pfParticle.
pdgId())==130){
343 fEta = direction.Eta();
344 fPhi = direction.Phi();
345 fVx = pfParticle.
vx();
346 fVy = pfParticle.
vy();
347 fVz = pfParticle.
vz();
355 }
else if(
abs(pfParticle.
pdgId()) == 211){
362 fEta = direction.Eta();
363 fPhi = direction.Phi();
virtual int pdgId() const
PDG identifier.
virtual double vz() const
z coordinate of vertex position
vector< float > fIsolationInRingsCharged
virtual float pt() const
transverse momentum
vector< float > fIsolationInRingsChargedAll
float isChargedParticleVetoed(const reco::PFCandidate *pfIsoCand, edm::Handle< reco::VertexCollection > vertices)
vector< float > fIsolationInRings
reco::SuperClusterRef superCluster() const
Ref to SuperCluster.
float isPhotonParticleVetoed(const reco::PFCandidate *pfIsoCand)
virtual double vx() const
x coordinate of vertex position
bool isNonnull() const
Checks for non-null.
vector< float > fIsolationInRingsNeutral
Abs< T >::type abs(const T &t)
float isNeutralParticleVetoed(const reco::PFCandidate *pfIsoCand)
XYZVectorD XYZVector
spatial vector with cartesian internal representation
virtual double vy() const
y coordinate of vertex position
Particle reconstructed by the particle flow algorithm.
vector< float > fIsolationInRingsPhoton
reco::SuperClusterRef superClusterRef() const
return a reference to the corresponding SuperCluster if any
Definition at line 397 of file PFIsolationEstimator.cc.
References funct::abs(), reco::LeafCandidate::eta(), fDeltaR, fEta, fIsolationInRings, fIsolationInRingsCharged, fIsolationInRingsChargedAll, fIsolationInRingsNeutral, fIsolationInRingsPhoton, fPhi, fPt, fRingSize, fVx, fVy, fVz, reco::GsfElectron::gsfTrack(), iMissHits, iNumberOfRings, isChargedParticleVetoed(), isNeutralParticleVetoed(), isPhotonParticleVetoed(), reco::LeafCandidate::pdgId(), reco::LeafCandidate::phi(), pivotInBarrel, reco::LeafCandidate::pt(), refSC, reco::GsfElectron::superCluster(), reco::LeafCandidate::vx(), reco::LeafCandidate::vy(), and reco::LeafCandidate::vz().
414 fPt = electron->
pt();
415 fVx = electron->
vx();
416 fVy = electron->
vy();
417 fVz = electron->
vz();
424 for(
unsigned iPF=0; iPF<pfParticlesColl->size(); iPF++) {
429 if(pfParticle.
pdgId()==22){
437 }
else if(
abs(pfParticle.
pdgId())==130){
445 }
else if(
abs(pfParticle.
pdgId()) == 211){
virtual int pdgId() const
PDG identifier.
vector< float > fIsolationInRingsCharged
virtual float pt() const
transverse momentum
vector< float > fIsolationInRingsChargedAll
virtual float phi() const
momentum azimuthal angle
float isChargedParticleVetoed(const reco::PFCandidate *pfIsoCand, edm::Handle< reco::VertexCollection > vertices)
vector< float > fIsolationInRings
float isPhotonParticleVetoed(const reco::PFCandidate *pfIsoCand)
virtual double vy() const
y coordinate of vertex position
vector< float > fIsolationInRingsNeutral
virtual float eta() const
momentum pseudorapidity
virtual SuperClusterRef superCluster() const
reference to a SuperCluster
Abs< T >::type abs(const T &t)
float isNeutralParticleVetoed(const reco::PFCandidate *pfIsoCand)
virtual double vz() const
z coordinate of vertex position
Particle reconstructed by the particle flow algorithm.
virtual double vx() const
x coordinate of vertex position
vector< float > fIsolationInRingsPhoton
virtual GsfTrackRef gsfTrack() const
reference to a GsfTrack
Definition at line 580 of file PFIsolationEstimator.cc.
References funct::abs(), bApplyDzDxyVeto, bApplyPFPUVeto, bApplyVeto, bDeltaRVetoBarrel, bDeltaRVetoEndcap, bRectangleVetoBarrel, bRectangleVetoEndcap, chargedHadronVertex(), SiPixelRawToDigiRegional_cfi::deltaPhi, deltaR(), reco::LeafCandidate::eta(), fConeSize, fDeltaEta, fDeltaPhi, fDeltaR, fDeltaRVetoBarrelCharged, fDeltaRVetoEndcapCharged, fEta, fPhi, fRectangleDeltaEtaVetoBarrelCharged, fRectangleDeltaEtaVetoEndcapCharged, fRectangleDeltaPhiVetoBarrelCharged, fRectangleDeltaPhiVetoEndcapCharged, fVx, fVy, iParticleType, edm::Ref< C, T, F >::isNull(), kPhoton, reco::LeafCandidate::phi(), pivotInBarrel, reco::LeafCandidate::pt(), reco::LeafCandidate::px(), reco::LeafCandidate::py(), and reco::PFCandidate::trackRef().
588 float fVtxMainZ = (*vtxMain).z();
599 float dz = fabs( pfIsoCand->
trackRef()->dz( (*vtxMain).position() ) );
603 double dxy = pfIsoCand->
trackRef()->dxy( (*vtxMain).position() );
621 float dz = fabs(vtx->z() - fVtxMainZ);
625 double dxy = ( -(vtx->x() -
fVx)*pfIsoCand->
py() + (vtx->y() -
fVy)*pfIsoCand->
px()) / pfIsoCand->
pt();
virtual float pt() const
transverse momentum
float fRectangleDeltaEtaVetoEndcapCharged
virtual float phi() const
momentum azimuthal angle
float fRectangleDeltaEtaVetoBarrelCharged
float fRectangleDeltaPhiVetoBarrelCharged
VertexRef chargedHadronVertex(edm::Handle< reco::VertexCollection > verticies, const reco::PFCandidate &pfcand)
float fRectangleDeltaPhiVetoEndcapCharged
reco::TrackRef trackRef() const
bool isNull() const
Checks for null.
virtual float eta() const
momentum pseudorapidity
float fDeltaRVetoEndcapCharged
Abs< T >::type abs(const T &t)
double deltaR(double eta1, double eta2, double phi1, double phi2)
virtual double px() const
x coordinate of momentum vector
float fDeltaRVetoBarrelCharged
Bool_t bRectangleVetoEndcap
virtual double py() const
y coordinate of momentum vector
Bool_t bRectangleVetoBarrel
float PFIsolationEstimator::isPhotonParticleVetoed |
( |
const reco::PFCandidate * |
pfIsoCand | ) |
|
Definition at line 465 of file PFIsolationEstimator.cc.
References funct::abs(), bApplyMissHitPhVeto, bApplyVeto, bDeltaRVetoBarrel, bDeltaRVetoEndcap, bRectangleVetoBarrel, bRectangleVetoEndcap, bUseCrystalSize, SiPixelRawToDigiRegional_cfi::deltaPhi, deltaR(), reco::LeafCandidate::eta(), fConeSize, fDeltaEta, fDeltaPhi, fDeltaR, fDeltaRVetoBarrelPhotons, fDeltaRVetoEndcapPhotons, fEta, fNumberOfCrystalEndcapPhotons, fPhi, fRectangleDeltaEtaVetoBarrelPhotons, fRectangleDeltaEtaVetoEndcapPhotons, fRectangleDeltaPhiVetoBarrelPhotons, fRectangleDeltaPhiVetoEndcapPhotons, iMissHits, edm::Ref< C, T, F >::isNonnull(), reco::PFCandidate::mva_nothing_gamma(), reco::LeafCandidate::phi(), pivotInBarrel, refSC, and reco::PFCandidate::superClusterRef().
Referenced by fGetIsolationInRings().
float fDeltaRVetoEndcapPhotons
float mva_nothing_gamma() const
mva for gamma detection
virtual float phi() const
momentum azimuthal angle
float fDeltaRVetoBarrelPhotons
float fRectangleDeltaEtaVetoEndcapPhotons
bool isNonnull() const
Checks for non-null.
virtual float eta() const
momentum pseudorapidity
Abs< T >::type abs(const T &t)
float fRectangleDeltaPhiVetoBarrelPhotons
double deltaR(double eta1, double eta2, double phi1, double phi2)
Bool_t bApplyMissHitPhVeto
float fRectangleDeltaEtaVetoBarrelPhotons
Bool_t bRectangleVetoEndcap
Bool_t bRectangleVetoBarrel
float fRectangleDeltaPhiVetoEndcapPhotons
reco::SuperClusterRef superClusterRef() const
return a reference to the corresponding SuperCluster if any
float fNumberOfCrystalEndcapPhotons