CMS 3D CMS Logo

List of all members | Public Member Functions | Static Public Member Functions | Private Member Functions | Private Attributes | Static Private Attributes
PhotonIDValueMapProducer Class Reference
Inheritance diagram for PhotonIDValueMapProducer:
edm::stream::EDProducer<> edm::stream::EDProducerBase edm::ProducerBase edm::EDConsumerBase edm::ProductRegistryHelper

Public Member Functions

 PhotonIDValueMapProducer (const edm::ParameterSet &)
 
 ~PhotonIDValueMapProducer ()
 
- Public Member Functions inherited from edm::stream::EDProducer<>
 EDProducer ()=default
 
- Public Member Functions inherited from edm::stream::EDProducerBase
 EDProducerBase ()
 
ModuleDescription const & moduleDescription () const
 
virtual ~EDProducerBase ()
 
- Public Member Functions inherited from edm::ProducerBase
void callWhenNewProductsRegistered (std::function< void(BranchDescription const &)> const &func)
 
std::vector< edm::ProductResolverIndex > const & indiciesForPutProducts (BranchType iBranchType) const
 
 ProducerBase ()
 
void registerProducts (ProducerBase *, ProductRegistry *, ModuleDescription const &)
 
std::function< void(BranchDescription const &)> registrationCallback () const
 used by the fwk to register list of products More...
 
void resolvePutIndicies (BranchType iBranchType, std::unordered_multimap< std::string, edm::ProductResolverIndex > const &iIndicies, std::string const &moduleLabel)
 
virtual ~ProducerBase () noexcept(false)
 
- Public Member Functions inherited from edm::EDConsumerBase
std::vector< ConsumesInfoconsumesInfo () const
 
 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
 
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::stream::EDProducerBase
static const std::string & baseType ()
 
static void fillDescriptions (ConfigurationDescriptions &descriptions)
 
static void prevalidate (ConfigurationDescriptions &descriptions)
 

Private Member Functions

reco::PFCandidate::ParticleType candidatePdgId (const edm::Ptr< reco::Candidate > candidate, bool isAOD)
 
template<class T , class U >
float computeWorstPFChargedIsolation (const T &photon, const U &pfCandidates, const edm::Handle< reco::VertexCollection > vertices, bool isAOD, float dRmax, float dxyMax, float dzMax)
 
const reco::TrackgetTrackPointer (const edm::Ptr< reco::Candidate > candidate, bool isAOD)
 
virtual void produce (edm::Event &, const edm::EventSetup &) override
 
void writeValueMap (edm::Event &iEvent, const edm::Handle< edm::View< reco::Photon > > &handle, const std::vector< float > &values, const std::string &label) const
 

Private Attributes

edm::EDGetTokenT< EcalRecHitCollectionebReducedRecHitCollection_
 
edm::EDGetTokenT< EcalRecHitCollectionebReducedRecHitCollectionMiniAOD_
 
edm::EDGetTokenT< EcalRecHitCollectioneeReducedRecHitCollection_
 
edm::EDGetTokenT< EcalRecHitCollectioneeReducedRecHitCollectionMiniAOD_
 
edm::EDGetTokenT< EcalRecHitCollectionesReducedRecHitCollection_
 
edm::EDGetTokenT< EcalRecHitCollectionesReducedRecHitCollectionMiniAOD_
 
std::unique_ptr< noZS::EcalClusterLazyToolslazyToolnoZS
 
edm::EDGetTokenT< edm::ValueMap< std::vector< reco::PFCandidateRef > > > particleBasedIsolationToken_
 
edm::EDGetTokenT< edm::ValueMap< std::vector< reco::PFCandidateRef > > > particleBasedIsolationTokenMiniAOD_
 
edm::EDGetTokenT< edm::View< reco::Candidate > > pfCandidatesToken_
 
edm::EDGetTokenT< edm::View< reco::Candidate > > pfCandidatesTokenMiniAOD_
 
edm::EDGetToken src_
 
edm::EDGetToken srcMiniAOD_
 
bool usesES_
 
edm::EDGetTokenT< reco::VertexCollectionvtxToken_
 
edm::EDGetTokenT< reco::VertexCollectionvtxTokenMiniAOD_
 

Static Private Attributes

static char phoChargedIsolation_ [] = "phoChargedIsolation"
 
static char phoESEffSigmaRR_ [] = "phoESEffSigmaRR"
 
static char phoFull5x5E1x3_ [] = "phoFull5x5E1x3"
 
static char phoFull5x5E2x2_ [] = "phoFull5x5E2x2"
 
static char phoFull5x5E2x5Max_ [] = "phoFull5x5E2x5Max"
 
static char phoFull5x5E5x5_ [] = "phoFull5x5E5x5"
 
static char phoFull5x5SigmaIEtaIEta_ [] = "phoFull5x5SigmaIEtaIEta"
 
static char phoFull5x5SigmaIEtaIPhi_ [] = "phoFull5x5SigmaIEtaIPhi"
 
static char phoNeutralHadronIsolation_ [] = "phoNeutralHadronIsolation"
 
static char phoPhotonIsolation_ [] = "phoPhotonIsolation"
 
static char phoWorstChargedIsolation_ [] = "phoWorstChargedIsolation"
 

Additional Inherited Members

- Public Types inherited from edm::stream::EDProducer<>
typedef CacheContexts< T... > CacheTypes
 
typedef CacheTypes::GlobalCache GlobalCache
 
typedef AbilityChecker< T... > HasAbility
 
typedef CacheTypes::LuminosityBlockCache LuminosityBlockCache
 
typedef LuminosityBlockContextT< LuminosityBlockCache, RunCache, GlobalCacheLuminosityBlockContext
 
typedef CacheTypes::LuminosityBlockSummaryCache LuminosityBlockSummaryCache
 
typedef CacheTypes::RunCache RunCache
 
typedef RunContextT< RunCache, GlobalCacheRunContext
 
typedef CacheTypes::RunSummaryCache RunSummaryCache
 
- Public Types inherited from edm::stream::EDProducerBase
typedef EDProducerAdaptorBase ModuleType
 
- Public Types inherited from edm::ProducerBase
typedef ProductRegistryHelper::TypeLabelList TypeLabelList
 
- 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 40 of file PhotonIDValueMapProducer.cc.

Constructor & Destructor Documentation

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

Definition at line 135 of file PhotonIDValueMapProducer.cc.

References ebReducedRecHitCollection_, ebReducedRecHitCollectionMiniAOD_, eeReducedRecHitCollection_, eeReducedRecHitCollectionMiniAOD_, esReducedRecHitCollection_, esReducedRecHitCollectionMiniAOD_, edm::ParameterSet::getParameter(), edm::InputTag::label(), diffTwoXMLs::label, particleBasedIsolationToken_, pfCandidatesToken_, pfCandidatesTokenMiniAOD_, phoChargedIsolation_, phoESEffSigmaRR_, phoFull5x5E1x3_, phoFull5x5E2x2_, phoFull5x5E2x5Max_, phoFull5x5E5x5_, phoFull5x5SigmaIEtaIEta_, phoFull5x5SigmaIEtaIPhi_, phoNeutralHadronIsolation_, phoPhotonIsolation_, phoWorstChargedIsolation_, src_, srcMiniAOD_, usesES_, vtxToken_, and vtxTokenMiniAOD_.

135  {
136 
137  //
138  // Declare consummables, handle both AOD and miniAOD case
139  //
140  ebReducedRecHitCollection_ = mayConsume<EcalRecHitCollection>(iConfig.getParameter<edm::InputTag>
141  ("ebReducedRecHitCollection"));
142  ebReducedRecHitCollectionMiniAOD_ = mayConsume<EcalRecHitCollection>(iConfig.getParameter<edm::InputTag>
143  ("ebReducedRecHitCollectionMiniAOD"));
144 
145  eeReducedRecHitCollection_ = mayConsume<EcalRecHitCollection>(iConfig.getParameter<edm::InputTag>
146  ("eeReducedRecHitCollection"));
147  eeReducedRecHitCollectionMiniAOD_ = mayConsume<EcalRecHitCollection>(iConfig.getParameter<edm::InputTag>
148  ("eeReducedRecHitCollectionMiniAOD"));
149 
150  if (!iConfig.getParameter<edm::InputTag>("esReducedRecHitCollection").label().empty() ||
151  !iConfig.getParameter<edm::InputTag>("esReducedRecHitCollectionMiniAOD").label().empty()) {
152  usesES_ = true;
153  esReducedRecHitCollection_ = mayConsume<EcalRecHitCollection>(iConfig.getParameter<edm::InputTag>
154  ("esReducedRecHitCollection"));
155  esReducedRecHitCollectionMiniAOD_ = mayConsume<EcalRecHitCollection>(iConfig.getParameter<edm::InputTag>
156  ("esReducedRecHitCollectionMiniAOD"));
157 
158  } else {
159  usesES_ = false;
160  }
161 
162  vtxToken_ = mayConsume<reco::VertexCollection>(iConfig.getParameter<edm::InputTag>("vertices"));
163  vtxTokenMiniAOD_ = mayConsume<reco::VertexCollection>(iConfig.getParameter<edm::InputTag>("verticesMiniAOD"));
164 
165  // reco photons are castable into pat photons, so no need to handle reco/pat seprately
166  src_ = mayConsume<edm::View<reco::Photon> >(iConfig.getParameter<edm::InputTag>("src"));
167  srcMiniAOD_ = mayConsume<edm::View<reco::Photon> >(iConfig.getParameter<edm::InputTag>("srcMiniAOD"));
168 
169  // The particleBasedIsolation object is relevant only for AOD, RECO format
170  particleBasedIsolationToken_ = mayConsume<edm::ValueMap<std::vector<reco::PFCandidateRef > > >
171  (iConfig.getParameter<edm::InputTag>("particleBasedIsolation"));
172 
173  // AOD has reco::PFCandidate vector, and miniAOD has pat::PackedCandidate vector.
174  // Both inherit from reco::Candidate, so we go to the base class. We can cast into
175  // the full type later if needed. Since the collection names are different, we
176  // introduce both collections
177  pfCandidatesToken_ = mayConsume< edm::View<reco::Candidate> >(iConfig.getParameter<edm::InputTag>("pfCandidates"));
178  pfCandidatesTokenMiniAOD_ = mayConsume< edm::View<reco::Candidate> >(iConfig.getParameter<edm::InputTag>("pfCandidatesMiniAOD"));
179 
180  //
181  // Declare producibles
182  //
183  // Cluster shapes
184  produces<edm::ValueMap<float> >(phoFull5x5SigmaIEtaIEta_);
185  produces<edm::ValueMap<float> >(phoFull5x5SigmaIEtaIPhi_);
186  produces<edm::ValueMap<float> >(phoFull5x5E1x3_);
187  produces<edm::ValueMap<float> >(phoFull5x5E2x2_);
188  produces<edm::ValueMap<float> >(phoFull5x5E2x5Max_);
189  produces<edm::ValueMap<float> >(phoFull5x5E5x5_);
190  produces<edm::ValueMap<float> >(phoESEffSigmaRR_);
191  // Isolations
192  produces<edm::ValueMap<float> >(phoChargedIsolation_);
193  produces<edm::ValueMap<float> >(phoNeutralHadronIsolation_);
194  produces<edm::ValueMap<float> >(phoPhotonIsolation_);
195  produces<edm::ValueMap<float> >(phoWorstChargedIsolation_);
196 
197 }
T getParameter(std::string const &) const
edm::EDGetTokenT< EcalRecHitCollection > esReducedRecHitCollectionMiniAOD_
edm::EDGetTokenT< reco::VertexCollection > vtxToken_
edm::EDGetTokenT< reco::VertexCollection > vtxTokenMiniAOD_
edm::EDGetTokenT< EcalRecHitCollection > eeReducedRecHitCollectionMiniAOD_
edm::EDGetTokenT< EcalRecHitCollection > ebReducedRecHitCollection_
edm::EDGetTokenT< edm::ValueMap< std::vector< reco::PFCandidateRef > > > particleBasedIsolationToken_
edm::EDGetTokenT< EcalRecHitCollection > ebReducedRecHitCollectionMiniAOD_
edm::EDGetTokenT< edm::View< reco::Candidate > > pfCandidatesTokenMiniAOD_
edm::EDGetTokenT< EcalRecHitCollection > eeReducedRecHitCollection_
edm::EDGetTokenT< edm::View< reco::Candidate > > pfCandidatesToken_
edm::EDGetTokenT< EcalRecHitCollection > esReducedRecHitCollection_
std::string const & label() const
Definition: InputTag.h:36
PhotonIDValueMapProducer::~PhotonIDValueMapProducer ( )

Definition at line 199 of file PhotonIDValueMapProducer.cc.

199  {
200 }

Member Function Documentation

reco::PFCandidate::ParticleType PhotonIDValueMapProducer::candidatePdgId ( const edm::Ptr< reco::Candidate candidate,
bool  isAOD 
)
private

Definition at line 515 of file PhotonIDValueMapProducer.cc.

References funct::abs(), reco::PFCandidate::gamma, reco::PFCandidate::h, reco::PFCandidate::h0, cosmictrackingParticleSelector_cfi::pdgId, and reco::PFCandidate::X.

Referenced by computeWorstPFChargedIsolation(), and produce().

516  {
517 
519  if( isAOD )
520  thisCandidateType = ( (const recoCandPtr)candidate)->particleId();
521  else {
522  // the neutral hadrons and charged hadrons can be of pdgId types
523  // only 130 (K0L) and +-211 (pi+-) in packed candidates
524  const int pdgId = ( (const patCandPtr)candidate)->pdgId();
525  if( pdgId == 22 )
526  thisCandidateType = reco::PFCandidate::gamma;
527  else if( abs(pdgId) == 130) // PDG ID for K0L
528  thisCandidateType = reco::PFCandidate::h0;
529  else if( abs(pdgId) == 211) // PDG ID for pi+-
530  thisCandidateType = reco::PFCandidate::h;
531  }
532  return thisCandidateType;
533 }
ParticleType
particle types
Definition: PFCandidate.h:44
edm::Ptr< pat::PackedCandidate > patCandPtr
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
edm::Ptr< reco::PFCandidate > recoCandPtr
template<class T , class U >
float PhotonIDValueMapProducer::computeWorstPFChargedIsolation ( const T photon,
const U &  pfCandidates,
const edm::Handle< reco::VertexCollection vertices,
bool  isAOD,
float  dRmax,
float  dxyMax,
float  dzMax 
)
private

Definition at line 448 of file PhotonIDValueMapProducer.cc.

References candidatePdgId(), reco::deltaR2(), particleFlowDisplacedVertexCandidate_cfi::dxy, reco::TrackBase::dxy(), allConversions_cfi::dz, reco::TrackBase::dz(), AlignmentTrackSelector_cfi::dzMax, getTrackPointer(), reco::PFCandidate::h, mps_fire::i, ALCARECOTkAlBeamHalo_cff::ptMin, and badGlobalMuonTaggersAOD_cff::vtx.

Referenced by fillDescriptions(), and produce().

451  {
452 
453  float worstIsolation = 999;
454  std::vector<float> allIsolations;
455 
456  // Constants below: there are no vetos and no min pt requirement,
457  // just like in the original H->gamma gamma code.
458  const float dRvetoBarrel = 0.0;
459  const float dRvetoEndcap = 0.0;
460  const float ptMin = 0.0;
461 
462  float dRveto;
463  if (photon->isEB())
464  dRveto = dRvetoBarrel;
465  else
466  dRveto = dRvetoEndcap;
467 
468  //Calculate isolation sum separately for each vertex
469  for(unsigned int ivtx=0; ivtx<vertices->size(); ++ivtx) {
470 
471  // Shift the photon according to the vertex
472  reco::VertexRef vtx(vertices, ivtx);
473  math::XYZVector photon_directionWrtVtx(photon->superCluster()->x() - vtx->x(),
474  photon->superCluster()->y() - vtx->y(),
475  photon->superCluster()->z() - vtx->z());
476 
477  float sum = 0;
478  // Loop over the PFCandidates
479  for(unsigned i=0; i<pfCandidates->size(); i++) {
480 
481  const auto& iCand = pfCandidates->ptrAt(i);
482 
483  //require that PFCandidate is a charged hadron
484  reco::PFCandidate::ParticleType thisCandidateType = candidatePdgId(iCand, isAOD);
485  if (thisCandidateType != reco::PFCandidate::h)
486  continue;
487 
488  if (iCand->pt() < ptMin)
489  continue;
490 
491  const reco::Track *theTrack = getTrackPointer( iCand, isAOD );
492  float dxy = theTrack->dxy(vtx->position());
493  if( fabs(dxy) > dxyMax) continue;
494 
495  float dz = theTrack->dz(vtx->position());
496  if ( fabs(dz) > dzMax) continue;
497 
498  float dR2 = deltaR2(photon_directionWrtVtx.Eta(), photon_directionWrtVtx.Phi(),
499  iCand->eta(), iCand->phi());
500  if(dR2 > dRmax*dRmax || dR2 < dRveto*dRveto) continue;
501 
502  sum += iCand->pt();
503  }
504 
505  allIsolations.push_back(sum);
506  }
507 
508  if( allIsolations.size()>0 )
509  worstIsolation = * std::max_element( allIsolations.begin(), allIsolations.end() );
510 
511  return worstIsolation;
512 }
const reco::Track * getTrackPointer(const edm::Ptr< reco::Candidate > candidate, bool isAOD)
ParticleType
particle types
Definition: PFCandidate.h:44
reco::PFCandidate::ParticleType candidatePdgId(const edm::Ptr< reco::Candidate > candidate, bool isAOD)
double dz() const
dz parameter (= dsz/cos(lambda)). This is the track z0 w.r.t (0,0,0) only if the refPoint is close to...
Definition: TrackBase.h:604
XYZVectorD XYZVector
spatial vector with cartesian internal representation
Definition: Vector3D.h:30
T1 deltaR2(T1 eta1, T2 phi1, T3 eta2, T4 phi2)
Definition: deltaR.h:36
double dxy() const
dxy parameter. (This is the transverse impact parameter w.r.t. to (0,0,0) ONLY if refPoint is close t...
Definition: TrackBase.h:586
void PhotonIDValueMapProducer::fillDescriptions ( edm::ConfigurationDescriptions descriptions)
static

Definition at line 436 of file PhotonIDValueMapProducer.cc.

References edm::ConfigurationDescriptions::addDefault(), computeWorstPFChargedIsolation(), and edm::ParameterSetDescription::setUnknown().

436  {
437  //The following says we do not know what parameters are allowed so do no validation
438  // Please change this to state exactly what you do use, even if it is no parameters
440  desc.setUnknown();
441  descriptions.addDefault(desc);
442 }
void addDefault(ParameterSetDescription const &psetDescription)
const reco::Track * PhotonIDValueMapProducer::getTrackPointer ( const edm::Ptr< reco::Candidate candidate,
bool  isAOD 
)
private

Definition at line 536 of file PhotonIDValueMapProducer.cc.

References DEFINE_FWK_MODULE.

Referenced by computeWorstPFChargedIsolation(), and produce().

536  {
537 
538  const reco::Track* theTrack = nullptr;
539  if( isAOD )
540  theTrack = &*( ((const recoCandPtr) candidate)->trackRef());
541  else
542  theTrack = &( ((const patCandPtr) candidate)->pseudoTrack());
543 
544  return theTrack;
545 }
edm::Ptr< pat::PackedCandidate > patCandPtr
edm::Ptr< reco::PFCandidate > recoCandPtr
void PhotonIDValueMapProducer::produce ( edm::Event iEvent,
const edm::EventSetup iSetup 
)
overrideprivatevirtual

Definition at line 202 of file PhotonIDValueMapProducer.cc.

References candidatePdgId(), computeWorstPFChargedIsolation(), reco::deltaR2(), particleFlowDisplacedVertexCandidate_cfi::dxy, reco::TrackBase::dxy(), allConversions_cfi::dz, reco::TrackBase::dz(), AlignmentTrackSelector_cfi::dzMax, heepElectronID_HEEPV50_CSA14_25ns_cff::e5x5, ebReducedRecHitCollection_, ebReducedRecHitCollectionMiniAOD_, eeReducedRecHitCollection_, eeReducedRecHitCollectionMiniAOD_, esReducedRecHitCollection_, esReducedRecHitCollectionMiniAOD_, Exception, reco::PFCandidate::gamma, edm::Event::getByToken(), getTrackPointer(), reco::PFCandidate::h, reco::PFCandidate::h0, iEvent, isInFootprint(), edm::detail::isnan(), edm::HandleBase::isValid(), lazyToolnoZS, particleBasedIsolationToken_, pfCandidatesToken_, pfCandidatesTokenMiniAOD_, egammaObjectModificationsInMiniAOD_cff::phoChargedIsolation, phoChargedIsolation_, phoESEffSigmaRR_, phoFull5x5E1x3_, phoFull5x5E2x2_, phoFull5x5E2x5Max_, phoFull5x5E5x5_, phoFull5x5SigmaIEtaIEta_, phoFull5x5SigmaIEtaIPhi_, egammaObjectModificationsInMiniAOD_cff::phoNeutralHadronIsolation, phoNeutralHadronIsolation_, egammaObjectModificationsInMiniAOD_cff::phoPhotonIsolation, phoPhotonIsolation_, egammaObjectModificationsInMiniAOD_cff::phoWorstChargedIsolation, phoWorstChargedIsolation_, reco::Vertex::position(), MetAnalyzer::pv(), mathSSE::sqrt(), TrackRefitter_38T_cff::src, src_, srcMiniAOD_, PFTauMVAInputDiscriminatorTranslator_cfi::test, usesES_, ecalDrivenElectronSeedsParameters_cff::vertices, vtxToken_, vtxTokenMiniAOD_, writeValueMap(), reco::Vertex::x(), reco::Vertex::y(), and reco::Vertex::z().

202  {
203 
204  using namespace edm;
205 
206  // Constants
207  const float coneSizeDR = 0.3;
208  const float dxyMax = 0.1;
209  const float dzMax = 0.2;
210 
212 
213  bool isAOD = true;
214  iEvent.getByToken(src_, src);
215  if( !src.isValid() ){
216  isAOD = false;
217  iEvent.getByToken(srcMiniAOD_,src);
218  }
219  if( !src.isValid() ) {
220  throw cms::Exception("IllDefinedDataTier")
221  << "DataFormat does not contain a photon source!";
222  }
223 
224  // Configure Lazy Tools
225  if (usesES_) {
226  if( isAOD )
227  lazyToolnoZS = std::make_unique<noZS::EcalClusterLazyTools>(iEvent, iSetup,
231  else
232  lazyToolnoZS = std::make_unique<noZS::EcalClusterLazyTools>(iEvent, iSetup,
236  } else {
237  if( isAOD )
238  lazyToolnoZS = std::make_unique<noZS::EcalClusterLazyTools>(iEvent, iSetup,
241  else
242  lazyToolnoZS = std::make_unique<noZS::EcalClusterLazyTools>(iEvent, iSetup,
245 
246  }
247 
248  // Get PV
250  iEvent.getByToken(vtxToken_, vertices);
251  if( !vertices.isValid() )
252  iEvent.getByToken(vtxTokenMiniAOD_, vertices);
253  if (vertices->empty()) return; // skip the event if no PV found
254  const reco::Vertex &pv = vertices->front();
255 
257  if( isAOD ){
258  // this exists only in AOD
259  iEvent.getByToken(particleBasedIsolationToken_, particleBasedIsolationMap);
260  }
261 
262  edm::Handle< edm::View<reco::Candidate> > pfCandidatesHandle;
263 
264  iEvent.getByToken(pfCandidatesToken_, pfCandidatesHandle);
265  if( !pfCandidatesHandle.isValid() )
266  iEvent.getByToken(pfCandidatesTokenMiniAOD_, pfCandidatesHandle);
267 
268  if( !isAOD && src->size() ) {
269  edm::Ptr<pat::Photon> test(src->ptrAt(0));
270  if( test.isNull() || !test.isAvailable() ) {
271  throw cms::Exception("InvalidConfiguration")
272  <<"DataFormat is detected as miniAOD but cannot cast to pat::Photon!";
273  }
274  }
275 
276  // size_t n = src->size();
277  // Cluster shapes
278  std::vector<float> phoFull5x5SigmaIEtaIEta;
279  std::vector<float> phoFull5x5SigmaIEtaIPhi;
280  std::vector<float> phoFull5x5E1x3;
281  std::vector<float> phoFull5x5E2x2;
282  std::vector<float> phoFull5x5E2x5Max;
283  std::vector<float> phoFull5x5E5x5;
284  std::vector<float> phoESEffSigmaRR;
285  // Isolations
286  std::vector<float> phoChargedIsolation;
287  std::vector<float> phoNeutralHadronIsolation;
288  std::vector<float> phoPhotonIsolation;
289  std::vector<float> phoWorstChargedIsolation;
290 
291  // reco::Photon::superCluster() is virtual so we can exploit polymorphism
292  for (unsigned idxpho = 0; idxpho < src->size(); ++idxpho) {
293  const auto& iPho = src->ptrAt(idxpho);
294 
295  //
296  // Compute full 5x5 quantities
297  //
298  const auto& theseed = *(iPho->superCluster()->seed());
299 
300  // For full5x5_sigmaIetaIeta, for 720 we use: lazy tools for AOD,
301  // and userFloats or lazy tools for miniAOD. From some point in 72X and on, one can
302  // retrieve the full5x5 directly from the object with ->full5x5_sigmaIetaIeta()
303  // for both formats.
304  float see = -999;
305  std::vector<float> vCov = lazyToolnoZS->localCovariances( theseed );
306  see = (isnan(vCov[0]) ? 0. : sqrt(vCov[0]));
307  float sep = vCov[1];
308  phoFull5x5SigmaIEtaIEta.push_back(see);
309  phoFull5x5SigmaIEtaIPhi.push_back(sep);
310 
311  phoFull5x5E1x3 .push_back(lazyToolnoZS-> e1x3 (theseed) );
312  phoFull5x5E2x2 .push_back(lazyToolnoZS-> e2x2 (theseed) );
313  phoFull5x5E2x5Max.push_back(lazyToolnoZS-> e2x5Max(theseed) );
314  phoFull5x5E5x5 .push_back(lazyToolnoZS-> e5x5 (theseed) );
315 
316  phoESEffSigmaRR .push_back(lazyToolnoZS->eseffsirir( *(iPho->superCluster()) ) );
317 
318  //
319  // Compute absolute uncorrected isolations with footprint removal
320  //
321 
322  // First, find photon direction with respect to the good PV
323  math::XYZVector photon_directionWrtVtx(iPho->superCluster()->x() - pv.x(),
324  iPho->superCluster()->y() - pv.y(),
325  iPho->superCluster()->z() - pv.z());
326 
327  // Zero the isolation sums
328  float chargedIsoSum = 0;
329  float neutralHadronIsoSum = 0;
330  float photonIsoSum = 0;
331 
332  // Loop over all PF candidates
333  for (unsigned idxcand = 0; idxcand < pfCandidatesHandle->size(); ++idxcand ){
334 
335  // Here, the type will be a simple reco::Candidate. We cast it
336  // for full PFCandidate or PackedCandidate below as necessary
337  const auto& iCand = pfCandidatesHandle->ptrAt(idxcand);
338 
339  // One would think that we should check that this iCand from
340  // the generic PF collection is not identical to the iPho photon
341  // for which we are computing the isolations. However, it turns out
342  // to be unnecessary. Below, in the function isInFootprint(), we drop
343  // this iCand if it is in the footprint, and this always removes
344  // the iCand if it matches the iPho.
345  // The explicit check at this point is not totally trivial because
346  // of non-triviality of implementation of this check for miniAOD (PackedCandidates
347  // of the PF collection do not contain the supercluser link, so can't use that).
348  // if( isAOD ){
349  // if( ((const recoCandPtr)iCand)->superClusterRef() == iPho->superCluster() ) continue;
350  // }
351 
352 
353  // Check if this candidate is within the isolation cone
354  float dR2 = deltaR2(photon_directionWrtVtx.Eta(),photon_directionWrtVtx.Phi(),
355  iCand->eta(), iCand->phi());
356  if( dR2 > coneSizeDR*coneSizeDR ) continue;
357 
358  // Check if this candidate is not in the footprint
359  bool inFootprint = false;
360  if(isAOD) {
361  inFootprint = isInFootprint( (*particleBasedIsolationMap)[iPho], iCand );
362  } else {
363  edm::Ptr<pat::Photon> patPhotonPtr(src->ptrAt(idxpho));
364  inFootprint = isInFootprint(patPhotonPtr->associatedPackedPFCandidates(), iCand);
365  }
366 
367  if( inFootprint ) continue;
368 
369  // Find candidate type
370  reco::PFCandidate::ParticleType thisCandidateType = candidatePdgId(iCand, isAOD);
371 
372  // Increment the appropriate isolation sum
373  if( thisCandidateType == reco::PFCandidate::h ){
374  // for charged hadrons, additionally check consistency
375  // with the PV
376  const reco::Track *theTrack = getTrackPointer( iCand, isAOD );
377 
378  float dxy = theTrack->dxy(pv.position());
379  if(fabs(dxy) > dxyMax) continue;
380 
381  float dz = theTrack->dz(pv.position());
382  if (fabs(dz) > dzMax) continue;
383 
384  // The candidate is eligible, increment the isolaiton
385  chargedIsoSum += iCand->pt();
386  }
387 
388  if( thisCandidateType == reco::PFCandidate::h0 )
389  neutralHadronIsoSum += iCand->pt();
390 
391  if( thisCandidateType == reco::PFCandidate::gamma )
392  photonIsoSum += iCand->pt();
393  }
394 
395  phoChargedIsolation .push_back( chargedIsoSum );
396  phoNeutralHadronIsolation.push_back( neutralHadronIsoSum );
397  phoPhotonIsolation .push_back( photonIsoSum );
398 
399  float worstChargedIso =
400  computeWorstPFChargedIsolation(iPho, pfCandidatesHandle, vertices,
401  isAOD, coneSizeDR, dxyMax, dzMax);
402  phoWorstChargedIsolation .push_back( worstChargedIso );
403 
404 
405  }
406 
407  // Cluster shapes
408  writeValueMap(iEvent, src, phoFull5x5SigmaIEtaIEta, phoFull5x5SigmaIEtaIEta_);
409  writeValueMap(iEvent, src, phoFull5x5SigmaIEtaIPhi, phoFull5x5SigmaIEtaIPhi_);
410  writeValueMap(iEvent, src, phoFull5x5E1x3 , phoFull5x5E1x3_);
411  writeValueMap(iEvent, src, phoFull5x5E2x2 , phoFull5x5E2x2_);
412  writeValueMap(iEvent, src, phoFull5x5E2x5Max, phoFull5x5E2x5Max_);
413  writeValueMap(iEvent, src, phoFull5x5E5x5 , phoFull5x5E5x5_);
414  writeValueMap(iEvent, src, phoESEffSigmaRR , phoESEffSigmaRR_);
415  // Isolations
416  writeValueMap(iEvent, src, phoChargedIsolation, phoChargedIsolation_);
417  writeValueMap(iEvent, src, phoNeutralHadronIsolation, phoNeutralHadronIsolation_);
418  writeValueMap(iEvent, src, phoPhotonIsolation, phoPhotonIsolation_);
419  writeValueMap(iEvent, src, phoWorstChargedIsolation, phoWorstChargedIsolation_);
420 }
void writeValueMap(edm::Event &iEvent, const edm::Handle< edm::View< reco::Photon > > &handle, const std::vector< float > &values, const std::string &label) const
edm::EDGetTokenT< EcalRecHitCollection > esReducedRecHitCollectionMiniAOD_
const reco::Track * getTrackPointer(const edm::Ptr< reco::Candidate > candidate, bool isAOD)
edm::EDGetTokenT< reco::VertexCollection > vtxToken_
ParticleType
particle types
Definition: PFCandidate.h:44
edm::EDGetTokenT< reco::VertexCollection > vtxTokenMiniAOD_
bool getByToken(EDGetToken token, Handle< PROD > &result) const
Definition: Event.h:460
std::unique_ptr< noZS::EcalClusterLazyTools > lazyToolnoZS
edm::EDGetTokenT< EcalRecHitCollection > eeReducedRecHitCollectionMiniAOD_
double y() const
y coordinate
Definition: Vertex.h:113
reco::PFCandidate::ParticleType candidatePdgId(const edm::Ptr< reco::Candidate > candidate, bool isAOD)
edm::EDGetTokenT< EcalRecHitCollection > ebReducedRecHitCollection_
edm::EDGetTokenT< edm::ValueMap< std::vector< reco::PFCandidateRef > > > particleBasedIsolationToken_
edm::EDGetTokenT< EcalRecHitCollection > ebReducedRecHitCollectionMiniAOD_
const Point & position() const
position
Definition: Vertex.h:109
int iEvent
Definition: GenABIO.cc:230
edm::EDGetTokenT< edm::View< reco::Candidate > > pfCandidatesTokenMiniAOD_
edm::EDGetTokenT< EcalRecHitCollection > eeReducedRecHitCollection_
bool isnan(float x)
Definition: math.h:13
T sqrt(T t)
Definition: SSEVec.h:18
bool isInFootprint(const T &thefootprint, const U &theCandidate)
def pv(vc)
Definition: MetAnalyzer.py:6
double z() const
z coordinate
Definition: Vertex.h:115
edm::EDGetTokenT< edm::View< reco::Candidate > > pfCandidatesToken_
bool isValid() const
Definition: HandleBase.h:74
float computeWorstPFChargedIsolation(const T &photon, const U &pfCandidates, const edm::Handle< reco::VertexCollection > vertices, bool isAOD, float dRmax, float dxyMax, float dzMax)
double dz() const
dz parameter (= dsz/cos(lambda)). This is the track z0 w.r.t (0,0,0) only if the refPoint is close to...
Definition: TrackBase.h:604
double x() const
x coordinate
Definition: Vertex.h:111
XYZVectorD XYZVector
spatial vector with cartesian internal representation
Definition: Vector3D.h:30
edm::EDGetTokenT< EcalRecHitCollection > esReducedRecHitCollection_
T1 deltaR2(T1 eta1, T2 phi1, T3 eta2, T4 phi2)
Definition: deltaR.h:36
edm::Ptr< pat::Photon > patPhotonPtr
HLT enums.
double dxy() const
dxy parameter. (This is the transverse impact parameter w.r.t. to (0,0,0) ONLY if refPoint is close t...
Definition: TrackBase.h:586
void PhotonIDValueMapProducer::writeValueMap ( edm::Event iEvent,
const edm::Handle< edm::View< reco::Photon > > &  handle,
const std::vector< float > &  values,
const std::string &  label 
) const
private

Definition at line 422 of file PhotonIDValueMapProducer.cc.

References objects.autophobj::filler, cmsBatch::handle, eostools::move(), and edm::Event::put().

Referenced by produce().

426 {
427  using namespace edm;
428  using namespace std;
429  auto valMap = std::make_unique<ValueMap<float>>();
431  filler.insert(handle, values.begin(), values.end());
432  filler.fill();
433  iEvent.put(std::move(valMap), label);
434 }
OrphanHandle< PROD > put(std::unique_ptr< PROD > product)
Put a new product.
Definition: Event.h:122
HLT enums.
def move(src, dest)
Definition: eostools.py:510

Member Data Documentation

edm::EDGetTokenT<EcalRecHitCollection> PhotonIDValueMapProducer::ebReducedRecHitCollection_
private

Definition at line 85 of file PhotonIDValueMapProducer.cc.

Referenced by PhotonIDValueMapProducer(), and produce().

edm::EDGetTokenT<EcalRecHitCollection> PhotonIDValueMapProducer::ebReducedRecHitCollectionMiniAOD_
private

Definition at line 94 of file PhotonIDValueMapProducer.cc.

Referenced by PhotonIDValueMapProducer(), and produce().

edm::EDGetTokenT<EcalRecHitCollection> PhotonIDValueMapProducer::eeReducedRecHitCollection_
private

Definition at line 86 of file PhotonIDValueMapProducer.cc.

Referenced by PhotonIDValueMapProducer(), and produce().

edm::EDGetTokenT<EcalRecHitCollection> PhotonIDValueMapProducer::eeReducedRecHitCollectionMiniAOD_
private

Definition at line 95 of file PhotonIDValueMapProducer.cc.

Referenced by PhotonIDValueMapProducer(), and produce().

edm::EDGetTokenT<EcalRecHitCollection> PhotonIDValueMapProducer::esReducedRecHitCollection_
private

Definition at line 87 of file PhotonIDValueMapProducer.cc.

Referenced by PhotonIDValueMapProducer(), and produce().

edm::EDGetTokenT<EcalRecHitCollection> PhotonIDValueMapProducer::esReducedRecHitCollectionMiniAOD_
private

Definition at line 96 of file PhotonIDValueMapProducer.cc.

Referenced by PhotonIDValueMapProducer(), and produce().

std::unique_ptr<noZS::EcalClusterLazyTools> PhotonIDValueMapProducer::lazyToolnoZS
private

Definition at line 82 of file PhotonIDValueMapProducer.cc.

Referenced by produce().

edm::EDGetTokenT<edm::ValueMap<std::vector<reco::PFCandidateRef > > > PhotonIDValueMapProducer::particleBasedIsolationToken_
private

Definition at line 89 of file PhotonIDValueMapProducer.cc.

Referenced by PhotonIDValueMapProducer(), and produce().

edm::EDGetTokenT<edm::ValueMap<std::vector<reco::PFCandidateRef > > > PhotonIDValueMapProducer::particleBasedIsolationTokenMiniAOD_
private

Definition at line 98 of file PhotonIDValueMapProducer.cc.

edm::EDGetTokenT<edm::View<reco::Candidate> > PhotonIDValueMapProducer::pfCandidatesToken_
private

Definition at line 90 of file PhotonIDValueMapProducer.cc.

Referenced by PhotonIDValueMapProducer(), and produce().

edm::EDGetTokenT<edm::View<reco::Candidate> > PhotonIDValueMapProducer::pfCandidatesTokenMiniAOD_
private

Definition at line 99 of file PhotonIDValueMapProducer.cc.

Referenced by PhotonIDValueMapProducer(), and produce().

char PhotonIDValueMapProducer::phoChargedIsolation_ = "phoChargedIsolation"
staticprivate

Definition at line 114 of file PhotonIDValueMapProducer.cc.

Referenced by PhotonIDValueMapProducer(), and produce().

char PhotonIDValueMapProducer::phoESEffSigmaRR_ = "phoESEffSigmaRR"
staticprivate

Definition at line 112 of file PhotonIDValueMapProducer.cc.

Referenced by PhotonIDValueMapProducer(), and produce().

char PhotonIDValueMapProducer::phoFull5x5E1x3_ = "phoFull5x5E1x3"
staticprivate

Definition at line 108 of file PhotonIDValueMapProducer.cc.

Referenced by PhotonIDValueMapProducer(), and produce().

char PhotonIDValueMapProducer::phoFull5x5E2x2_ = "phoFull5x5E2x2"
staticprivate

Definition at line 109 of file PhotonIDValueMapProducer.cc.

Referenced by PhotonIDValueMapProducer(), and produce().

char PhotonIDValueMapProducer::phoFull5x5E2x5Max_ = "phoFull5x5E2x5Max"
staticprivate

Definition at line 110 of file PhotonIDValueMapProducer.cc.

Referenced by PhotonIDValueMapProducer(), and produce().

char PhotonIDValueMapProducer::phoFull5x5E5x5_ = "phoFull5x5E5x5"
staticprivate

Definition at line 111 of file PhotonIDValueMapProducer.cc.

Referenced by PhotonIDValueMapProducer(), and produce().

char PhotonIDValueMapProducer::phoFull5x5SigmaIEtaIEta_ = "phoFull5x5SigmaIEtaIEta"
staticprivate

Definition at line 106 of file PhotonIDValueMapProducer.cc.

Referenced by PhotonIDValueMapProducer(), and produce().

char PhotonIDValueMapProducer::phoFull5x5SigmaIEtaIPhi_ = "phoFull5x5SigmaIEtaIPhi"
staticprivate

Definition at line 107 of file PhotonIDValueMapProducer.cc.

Referenced by PhotonIDValueMapProducer(), and produce().

char PhotonIDValueMapProducer::phoNeutralHadronIsolation_ = "phoNeutralHadronIsolation"
staticprivate

Definition at line 115 of file PhotonIDValueMapProducer.cc.

Referenced by PhotonIDValueMapProducer(), and produce().

char PhotonIDValueMapProducer::phoPhotonIsolation_ = "phoPhotonIsolation"
staticprivate

Definition at line 116 of file PhotonIDValueMapProducer.cc.

Referenced by PhotonIDValueMapProducer(), and produce().

char PhotonIDValueMapProducer::phoWorstChargedIsolation_ = "phoWorstChargedIsolation"
staticprivate

Definition at line 117 of file PhotonIDValueMapProducer.cc.

Referenced by PhotonIDValueMapProducer(), and produce().

edm::EDGetToken PhotonIDValueMapProducer::src_
private

Definition at line 91 of file PhotonIDValueMapProducer.cc.

Referenced by PhotonIDValueMapProducer(), and produce().

edm::EDGetToken PhotonIDValueMapProducer::srcMiniAOD_
private

Definition at line 100 of file PhotonIDValueMapProducer.cc.

Referenced by PhotonIDValueMapProducer(), and produce().

bool PhotonIDValueMapProducer::usesES_
private

Definition at line 103 of file PhotonIDValueMapProducer.cc.

Referenced by PhotonIDValueMapProducer(), and produce().

edm::EDGetTokenT<reco::VertexCollection> PhotonIDValueMapProducer::vtxToken_
private

Definition at line 88 of file PhotonIDValueMapProducer.cc.

Referenced by PhotonIDValueMapProducer(), and produce().

edm::EDGetTokenT<reco::VertexCollection> PhotonIDValueMapProducer::vtxTokenMiniAOD_
private

Definition at line 97 of file PhotonIDValueMapProducer.cc.

Referenced by PhotonIDValueMapProducer(), and produce().