CMS 3D CMS Logo

List of all members | Public Member Functions | Protected Member Functions | Private Member Functions | Private Attributes
FFTJetPFPileupCleaner Class Reference

#include <RecoJets/FFTJetProducers/plugins/FFTJetPFPileupCleaner.cc>

Inheritance diagram for FFTJetPFPileupCleaner:
edm::EDProducer edm::ProducerBase edm::EDConsumerBase edm::ProductRegistryHelper

Public Member Functions

 FFTJetPFPileupCleaner (const edm::ParameterSet &)
 
 ~FFTJetPFPileupCleaner () override
 
- Public Member Functions inherited from edm::EDProducer
 EDProducer ()
 
SerialTaskQueueglobalLuminosityBlocksQueue ()
 
SerialTaskQueueglobalRunsQueue ()
 
ModuleDescription const & moduleDescription () const
 
 ~EDProducer () override
 
- 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 ()
 
std::vector< edm::ProductResolverIndex > const & putTokenIndexToProductResolverIndex () const
 
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, ModuleToResolverIndicies const &iIndicies, std::string const &moduleLabel)
 
 ~ProducerBase () noexcept(false) override
 
- Public Member Functions inherited from edm::EDConsumerBase
std::vector< ConsumesInfoconsumesInfo () const
 
void convertCurrentProcessAlias (std::string const &processName)
 Convert "@currentProcess" in InputTag process names to the actual current process name. More...
 
 EDConsumerBase ()
 
 EDConsumerBase (EDConsumerBase const &)=delete
 
 EDConsumerBase (EDConsumerBase &&)=default
 
ESProxyIndex const * esGetTokenIndices (edm::Transition iTrans) const
 
ProductResolverIndexAndSkipBit indexFrom (EDGetToken, BranchType, TypeID const &) const
 
void itemsMayGet (BranchType, std::vector< ProductResolverIndexAndSkipBit > &) const
 
void itemsToGet (BranchType, std::vector< ProductResolverIndexAndSkipBit > &) const
 
std::vector< ProductResolverIndexAndSkipBit > const & itemsToGetFrom (BranchType iType) const
 
void labelsForToken (EDGetToken iToken, Labels &oLabels) const
 
void modulesWhoseProductsAreConsumed (std::vector< ModuleDescription const * > &modules, ProductRegistry const &preg, std::map< std::string, ModuleDescription const * > const &labelsToDesc, std::string const &processName) const
 
EDConsumerBase const & operator= (EDConsumerBase const &)=delete
 
EDConsumerBaseoperator= (EDConsumerBase &&)=default
 
bool registeredToConsume (ProductResolverIndex, bool, BranchType) const
 
bool registeredToConsumeMany (TypeID const &, BranchType) const
 
ProductResolverIndexAndSkipBit uncheckedIndexFrom (EDGetToken) const
 
void updateLookup (BranchType iBranchType, ProductResolverIndexHelper const &, bool iPrefetchMayGet)
 
void updateLookup (eventsetup::ESRecordsToProxyIndices const &)
 
virtual ~EDConsumerBase () noexcept(false)
 

Protected Member Functions

void beginJob () override
 
void endJob () override
 
void produce (edm::Event &, const edm::EventSetup &) override
 
- Protected Member Functions inherited from edm::ProducerBase
ProducesCollector producesCollector ()
 
- 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 ESProduct , typename ESRecord , Transition Tr = Transition::Event>
auto esConsumes ()
 
template<typename ESProduct , typename ESRecord , Transition Tr = Transition::Event>
auto esConsumes (ESInputTag const &tag)
 
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)
 

Private Member Functions

void buildRemovalMask ()
 
 FFTJetPFPileupCleaner ()=delete
 
 FFTJetPFPileupCleaner (const FFTJetPFPileupCleaner &)=delete
 
reco::VertexRef findSomeVertexWFakes (const edm::Handle< reco::VertexCollection > &vertices, const edm::Handle< reco::VertexCollection > &fakeVertices, const reco::PFCandidate &pfcand, bool *fromFakeSet) const
 
bool isAcceptableVtx (reco::VertexCollection::const_iterator iv) const
 
bool isRemovable (reco::PFCandidate::ParticleType ptype) const
 
FFTJetPFPileupCleaneroperator= (const FFTJetPFPileupCleaner &)=delete
 
void setRemovalBit (reco::PFCandidate::ParticleType ptype, bool onOff)
 

Private Attributes

bool checkClosestZVertex
 
double etaMax
 
double etaMin
 
edm::InputTag FakePrimaryVertices
 
edm::EDGetTokenT< reco::VertexCollectionFakePrimaryVerticesToken
 
bool keepIfPVneighbor
 
edm::InputTag PFCandidates
 
edm::EDGetTokenT< reco::PFCandidateCollectionPFCandidatesToken
 
unsigned removalMask
 
bool remove_e
 
bool remove_egamma_HF
 
bool remove_gamma
 
bool remove_h
 
bool remove_h0
 
bool remove_h_HF
 
bool remove_mu
 
bool remove_X
 
bool removeMainVertex
 
bool removeUnassociated
 
bool reverseRemovalDecision
 
bool useFakePrimaryVertex
 
double vertexNdofCut
 
double vertexRhoCut
 
double vertexZmaxCut
 
edm::InputTag Vertices
 
edm::EDGetTokenT< reco::VertexCollectionVerticesToken
 
std::vector< std::pair< double, unsigned > > zAssoc
 

Additional Inherited Members

- Public Types inherited from edm::EDProducer
typedef EDProducer ModuleType
 
- Public Types inherited from edm::ProducerBase
using ModuleToResolverIndicies = std::unordered_multimap< std::string, std::tuple< edm::TypeID const *, const char *, edm::ProductResolverIndex >>
 
typedef ProductRegistryHelper::TypeLabelList TypeLabelList
 
- Public Types inherited from edm::EDConsumerBase
typedef ProductLabels Labels
 
- Static Public Member Functions inherited from edm::EDProducer
static const std::string & baseType ()
 
static void fillDescriptions (ConfigurationDescriptions &descriptions)
 
static void prevalidate (ConfigurationDescriptions &descriptions)
 
static bool wantsGlobalLuminosityBlocks ()
 
static bool wantsGlobalRuns ()
 
static bool wantsStreamLuminosityBlocks ()
 
static bool wantsStreamRuns ()
 

Detailed Description

Description: cleans up a collection of partice flow objects

Implementation: [Notes on implementation]

Definition at line 45 of file FFTJetPFPileupCleaner.cc.

Constructor & Destructor Documentation

FFTJetPFPileupCleaner::FFTJetPFPileupCleaner ( const edm::ParameterSet ps)
explicit

Definition at line 139 of file FFTJetPFPileupCleaner.cc.

References buildRemovalMask(), FakePrimaryVertices, FakePrimaryVerticesToken, PFCandidates, PFCandidatesToken, useFakePrimaryVertex, Vertices, and VerticesToken.

149  init_param(bool, remove_X),
150  init_param(bool, remove_h),
151  init_param(bool, remove_e),
152  init_param(bool, remove_mu),
153  init_param(bool, remove_gamma),
154  init_param(bool, remove_h0),
155  init_param(bool, remove_h_HF),
157  removalMask(0),
158  init_param(double, etaMin),
159  init_param(double, etaMax),
160  init_param(double, vertexNdofCut),
161  init_param(double, vertexZmaxCut),
162  init_param(double, vertexRhoCut) {
164 
165  PFCandidatesToken = consumes<reco::PFCandidateCollection>(PFCandidates);
166  VerticesToken = consumes<reco::VertexCollection>(Vertices);
168  FakePrimaryVerticesToken = consumes<reco::VertexCollection>(FakePrimaryVertices);
169 
170  produces<reco::PFCandidateCollection>();
171 }
edm::EDGetTokenT< reco::VertexCollection > FakePrimaryVerticesToken
edm::EDGetTokenT< reco::VertexCollection > VerticesToken
edm::EDGetTokenT< reco::PFCandidateCollection > PFCandidatesToken
#define init_param(type, varname)
FFTJetPFPileupCleaner::~FFTJetPFPileupCleaner ( )
override

Definition at line 173 of file FFTJetPFPileupCleaner.cc.

173 {}
FFTJetPFPileupCleaner::FFTJetPFPileupCleaner ( )
privatedelete
FFTJetPFPileupCleaner::FFTJetPFPileupCleaner ( const FFTJetPFPileupCleaner )
privatedelete

Member Function Documentation

void FFTJetPFPileupCleaner::beginJob ( void  )
overrideprotectedvirtual

Reimplemented from edm::EDProducer.

Definition at line 450 of file FFTJetPFPileupCleaner.cc.

450 {}
void FFTJetPFPileupCleaner::buildRemovalMask ( )
private

Definition at line 438 of file FFTJetPFPileupCleaner.cc.

References reco::PFCandidate::e, reco::PFCandidate::egamma_HF, reco::PFCandidate::gamma, reco::PFCandidate::h, reco::PFCandidate::h0, reco::PFCandidate::h_HF, reco::PFCandidate::mu, remove_e, remove_egamma_HF, remove_gamma, remove_h, remove_h0, remove_h_HF, remove_mu, remove_X, setRemovalBit(), and reco::PFCandidate::X.

Referenced by FFTJetPFPileupCleaner().

438  {
447 }
void setRemovalBit(reco::PFCandidate::ParticleType ptype, bool onOff)
void FFTJetPFPileupCleaner::endJob ( void  )
overrideprotectedvirtual

Reimplemented from edm::EDProducer.

Definition at line 453 of file FFTJetPFPileupCleaner.cc.

References DEFINE_FWK_MODULE.

453 {}
reco::VertexRef FFTJetPFPileupCleaner::findSomeVertexWFakes ( const edm::Handle< reco::VertexCollection > &  vertices,
const edm::Handle< reco::VertexCollection > &  fakeVertices,
const reco::PFCandidate pfcand,
bool *  fromFakeSet 
) const
private

Definition at line 263 of file FFTJetPFPileupCleaner.cc.

References funct::abs(), checkClosestZVertex, PVValHelper::dz, dqmdumpme::first, isAcceptableVtx(), keepIfPVneighbor, reco::PFCandidate::trackRef(), reco::Vertex::tracks_begin(), reco::Vertex::tracks_end(), reco::Vertex::trackWeight(), mitigatedMETSequence_cff::U, useFakePrimaryVertex, reco::PFCandidate::vertex(), badGlobalMuonTaggersAOD_cff::vtx, w, z, and zAssoc.

Referenced by produce().

266  {
267  typedef reco::VertexCollection::const_iterator IV;
269 
270  *fromFakeSet = false;
271  reco::TrackBaseRef trackBaseRef(pfcand.trackRef());
272 
273  size_t iVertex = 0;
274  unsigned nFoundVertex = 0;
275  const IV vertend(vertices->end());
276 
277  {
278  unsigned index = 0;
279  double bestweight = 0.0;
280  for (IV iv = vertices->begin(); iv != vertend; ++iv, ++index)
281  if (isAcceptableVtx(iv)) {
282  const reco::Vertex& vtx = *iv;
283 
284  // loop on tracks in vertices
285  IT trackend(vtx.tracks_end());
286  for (IT iTrack = vtx.tracks_begin(); iTrack != trackend; ++iTrack) {
287  const reco::TrackBaseRef& baseRef = *iTrack;
288 
289  // one of the tracks in the vertex is the same as
290  // the track considered in the function
291  if (baseRef == trackBaseRef) {
292  // select the vertex for which the track has the highest weight
293  const double w = vtx.trackWeight(baseRef);
294  if (w > bestweight) {
295  bestweight = w;
296  iVertex = index;
297  nFoundVertex++;
298  }
299  }
300  }
301  }
302  }
303 
304  if (nFoundVertex > 0) {
305  if (nFoundVertex != 1)
306  edm::LogWarning("TrackOnTwoVertex") << "a track is shared by at least two vertices. "
307  << "Used to be an assert";
308 
309  // Check if we can re-associate this track with one
310  // of the fake vertices
311  if (useFakePrimaryVertex) {
312  const double ztrack = pfcand.vertex().z();
313  double dzmin = std::abs(ztrack - ((*vertices)[iVertex]).z());
314 
315  const IV fakeEnd(fakeVertices->end());
316  unsigned index = 0;
317  for (IV iv = fakeVertices->begin(); iv != fakeEnd; ++iv, ++index)
318  if (isAcceptableVtx(iv)) {
319  const double dz = std::abs(ztrack - iv->z());
320  if (dz < dzmin) {
321  dzmin = dz;
322  iVertex = index;
323  *fromFakeSet = true;
324  }
325  }
326  }
327 
328  return reco::VertexRef(*fromFakeSet ? fakeVertices : vertices, iVertex);
329  }
330 
331  // optional: as a secondary solution, associate the closest vertex in z
332  if (checkClosestZVertex) {
333  const double ztrack = pfcand.vertex().z();
334  bool foundVertex = false;
335 
336  if (keepIfPVneighbor) {
337  // Sort all vertices according to their Z coordinate
338  zAssoc.clear();
339  unsigned index = 0;
340  for (IV iv = vertices->begin(); iv != vertend; ++iv, ++index)
341  if (isAcceptableVtx(iv))
342  zAssoc.push_back(std::pair<double, unsigned>(iv->z(), index));
343  const unsigned numRealVertices = index;
344 
345  // Mix the fake vertex collection into zAssoc.
346  // Note that we do not reset "index" before doing this.
347  if (useFakePrimaryVertex) {
348  const IV fakeEnd(fakeVertices->end());
349  for (IV iv = fakeVertices->begin(); iv != fakeEnd; ++iv, ++index)
350  if (isAcceptableVtx(iv))
351  zAssoc.push_back(std::pair<double, unsigned>(iv->z(), index));
352  }
353 
354  // Check where the track z position fits into this sequence
355  if (!zAssoc.empty()) {
356  std::sort(zAssoc.begin(), zAssoc.end());
357  std::pair<double, unsigned> tPair(ztrack, UINT_MAX);
358  const unsigned iAbove = std::upper_bound(zAssoc.begin(), zAssoc.end(), tPair) - zAssoc.begin();
359 
360  // Check whether one of the vertices with indices
361  // iAbove or (iAbove - 1) is a primary vertex.
362  // If so, return it. Otherwise return the one
363  // with closest distance to the track.
364  unsigned ich[2] = {0U, 0U};
365  unsigned nch = 1;
366  if (iAbove) {
367  ich[0] = iAbove - 1U;
368  ich[1] = iAbove;
369  if (iAbove < zAssoc.size())
370  nch = 2;
371  }
372 
373  double dzmin = 1.0e100;
374  unsigned bestVertexNum = UINT_MAX;
375  for (unsigned icheck = 0; icheck < nch; ++icheck) {
376  const unsigned zAssocIndex = ich[icheck];
377  const unsigned vertexNum = zAssoc[zAssocIndex].second;
378 
379  if (vertexNum == numRealVertices || (!useFakePrimaryVertex && vertexNum == 0U)) {
380  bestVertexNum = vertexNum;
381  break;
382  }
383 
384  const double dz = std::abs(ztrack - zAssoc[zAssocIndex].first);
385  if (dz < dzmin) {
386  dzmin = dz;
387  bestVertexNum = vertexNum;
388  }
389  }
390 
391  foundVertex = bestVertexNum < UINT_MAX;
392  if (foundVertex) {
393  iVertex = bestVertexNum;
394  if (iVertex >= numRealVertices) {
395  *fromFakeSet = true;
396  iVertex -= numRealVertices;
397  }
398  }
399  }
400  } else {
401  // This is a simple association algorithm (from PFPileUp)
402  // extended to take fake vertices into account
403  double dzmin = 1.0e100;
404  unsigned index = 0;
405  for (IV iv = vertices->begin(); iv != vertend; ++iv, ++index)
406  if (isAcceptableVtx(iv)) {
407  const double dz = std::abs(ztrack - iv->z());
408  if (dz < dzmin) {
409  dzmin = dz;
410  iVertex = index;
411  foundVertex = true;
412  }
413  }
414 
415  if (useFakePrimaryVertex) {
416  const IV fakeEnd(fakeVertices->end());
417  index = 0;
418  for (IV iv = fakeVertices->begin(); iv != fakeEnd; ++iv, ++index)
419  if (isAcceptableVtx(iv)) {
420  const double dz = std::abs(ztrack - iv->z());
421  if (dz < dzmin) {
422  dzmin = dz;
423  iVertex = index;
424  *fromFakeSet = true;
425  foundVertex = true;
426  }
427  }
428  }
429  }
430 
431  if (foundVertex)
432  return reco::VertexRef(*fromFakeSet ? fakeVertices : vertices, iVertex);
433  }
434 
435  return reco::VertexRef();
436 }
const double w
Definition: UKUtility.cc:23
trackRef_iterator tracks_end() const
last iterator over tracks
Definition: Vertex.cc:73
reco::TrackRef trackRef() const
Definition: PFCandidate.cc:408
const Point & vertex() const override
vertex position (overwritten by PF...)
Definition: PFCandidate.cc:602
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
float trackWeight(const TREF &r) const
returns the weight with which a Track has contributed to the vertex-fit.
Definition: Vertex.h:84
std::vector< LinkConnSpec >::const_iterator IT
edm::Ref< VertexCollection > VertexRef
persistent reference to a Vertex
Definition: VertexFwd.h:13
std::vector< std::pair< double, unsigned > > zAssoc
trackRef_iterator tracks_begin() const
first iterator over tracks
Definition: Vertex.cc:71
std::vector< TrackBaseRef >::const_iterator trackRef_iterator
The iteratator for the vector<TrackRef>
Definition: Vertex.h:37
bool isAcceptableVtx(reco::VertexCollection::const_iterator iv) const
bool FFTJetPFPileupCleaner::isAcceptableVtx ( reco::VertexCollection::const_iterator  iv) const
private

Definition at line 175 of file FFTJetPFPileupCleaner.cc.

References funct::abs(), vertexNdofCut, vertexRhoCut, and vertexZmaxCut.

Referenced by findSomeVertexWFakes().

175  {
176  return !iv->isFake() && static_cast<double>(iv->ndof()) > vertexNdofCut && std::abs(iv->z()) < vertexZmaxCut &&
177  iv->position().rho() < vertexRhoCut;
178 }
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
bool FFTJetPFPileupCleaner::isRemovable ( reco::PFCandidate::ParticleType  ptype) const
private

Definition at line 244 of file FFTJetPFPileupCleaner.cc.

References OfflineHarvestingSequence_cosmic::ptype, removalMask, edm::shift, and mitigatedMETSequence_cff::U.

Referenced by produce().

244  {
245  const unsigned shift = static_cast<unsigned>(ptype);
246  assert(shift < 32U);
247  return removalMask & (1U << shift);
248 }
static unsigned int const shift
FFTJetPFPileupCleaner& FFTJetPFPileupCleaner::operator= ( const FFTJetPFPileupCleaner )
privatedelete
void FFTJetPFPileupCleaner::produce ( edm::Event iEvent,
const edm::EventSetup iSetup 
)
overrideprotected

Definition at line 181 of file FFTJetPFPileupCleaner.cc.

References PVValHelper::eta, etaMax, FakePrimaryVerticesToken, findSomeVertexWFakes(), edm::Event::getByToken(), mps_fire::i, edm::Ref< C, T, F >::isNull(), isRemovable(), edm::HandleBase::isValid(), edm::Ref< C, T, F >::key(), eostools::move(), zmumugammaAnalyzer_cfi::pfCandidates, PFCandidatesToken, edm::Event::put(), removeMainVertex, removeUnassociated, reverseRemovalDecision, useFakePrimaryVertex, pwdgSkimBPark_cfi::vertices, and VerticesToken.

181  {
182  // get PFCandidates
183  auto pOutput = std::make_unique<reco::PFCandidateCollection>();
184 
186  iEvent.getByToken(PFCandidatesToken, pfCandidates);
187 
188  // get vertices
190  iEvent.getByToken(VerticesToken, vertices);
191 
193  if (useFakePrimaryVertex) {
194  iEvent.getByToken(FakePrimaryVerticesToken, fakeVertices);
195  if (!fakeVertices.isValid())
196  throw cms::Exception("FFTJetBadConfig") << "ERROR in FFTJetPFPileupCleaner:"
197  " could not find fake vertices"
198  << std::endl;
199  }
200 
201  const unsigned ncand = pfCandidates->size();
202  for (unsigned i = 0; i < ncand; ++i) {
203  reco::PFCandidatePtr candptr(pfCandidates, i);
204  bool remove = false;
205 
206  if (isRemovable(candptr->particleId())) {
207  bool fromFakeSet = false;
208  reco::VertexRef vertexref(findSomeVertexWFakes(vertices, fakeVertices, *candptr, &fromFakeSet));
209  if (vertexref.isNull()) {
210  // Track is not associated with any vertex
211  // in any of the vertex sets
212  remove = removeUnassociated;
213  } else if (vertexref.key() == 0 && (!useFakePrimaryVertex || fromFakeSet)) {
214  // Track is associated with the main primary vertex
215  // However, if we are using fake vertices, this only
216  // matters if the vertex comes from the fake set. If
217  // it comes from the real set, remove the track anyway
218  // because in the combined set the associated vertex
219  // would not be the main primary vertex.
220  remove = removeMainVertex;
221  } else
222  remove = true;
223  }
224 
225  // Check the eta range
226  if (!remove) {
227  const double eta = candptr->p4().Eta();
228  remove = eta < etaMin || eta > etaMax;
229  }
230 
231  // Should we remember this candidate?
233  remove = !remove;
234  if (!remove) {
235  const reco::PFCandidate& cand = (*pfCandidates)[i];
236  pOutput->push_back(cand);
237  pOutput->back().setSourceCandidatePtr(candptr);
238  }
239  }
240 
241  iEvent.put(std::move(pOutput));
242 }
OrphanHandle< PROD > put(std::unique_ptr< PROD > product)
Put a new product.
Definition: Event.h:131
bool getByToken(EDGetToken token, Handle< PROD > &result) const
Definition: Event.h:525
edm::EDGetTokenT< reco::VertexCollection > FakePrimaryVerticesToken
bool isRemovable(reco::PFCandidate::ParticleType ptype) const
edm::EDGetTokenT< reco::VertexCollection > VerticesToken
bool isValid() const
Definition: HandleBase.h:70
edm::EDGetTokenT< reco::PFCandidateCollection > PFCandidatesToken
Particle reconstructed by the particle flow algorithm.
Definition: PFCandidate.h:40
reco::VertexRef findSomeVertexWFakes(const edm::Handle< reco::VertexCollection > &vertices, const edm::Handle< reco::VertexCollection > &fakeVertices, const reco::PFCandidate &pfcand, bool *fromFakeSet) const
def move(src, dest)
Definition: eostools.py:511
void FFTJetPFPileupCleaner::setRemovalBit ( reco::PFCandidate::ParticleType  ptype,
bool  onOff 
)
private

Definition at line 250 of file FFTJetPFPileupCleaner.cc.

References OfflineHarvestingSequence_cosmic::ptype, removalMask, edm::shift, and mitigatedMETSequence_cff::U.

Referenced by buildRemovalMask().

250  {
251  const unsigned shift = static_cast<unsigned>(ptype);
252  assert(shift < 32U);
253  const unsigned mask = (1U << shift);
254  if (value)
255  removalMask |= mask;
256  else
257  removalMask &= ~mask;
258 }
Definition: value.py:1
static unsigned int const shift

Member Data Documentation

bool FFTJetPFPileupCleaner::checkClosestZVertex
private

Definition at line 85 of file FFTJetPFPileupCleaner.cc.

Referenced by findSomeVertexWFakes().

double FFTJetPFPileupCleaner::etaMax
private

Definition at line 121 of file FFTJetPFPileupCleaner.cc.

Referenced by produce().

double FFTJetPFPileupCleaner::etaMin
private

Definition at line 120 of file FFTJetPFPileupCleaner.cc.

edm::InputTag FFTJetPFPileupCleaner::FakePrimaryVertices
private

Definition at line 73 of file FFTJetPFPileupCleaner.cc.

Referenced by FFTJetPFPileupCleaner().

edm::EDGetTokenT<reco::VertexCollection> FFTJetPFPileupCleaner::FakePrimaryVerticesToken
private

Definition at line 77 of file FFTJetPFPileupCleaner.cc.

Referenced by FFTJetPFPileupCleaner(), and produce().

bool FFTJetPFPileupCleaner::keepIfPVneighbor
private

Definition at line 92 of file FFTJetPFPileupCleaner.cc.

Referenced by findSomeVertexWFakes().

edm::InputTag FFTJetPFPileupCleaner::PFCandidates
private

Definition at line 71 of file FFTJetPFPileupCleaner.cc.

Referenced by FFTJetPFPileupCleaner().

edm::EDGetTokenT<reco::PFCandidateCollection> FFTJetPFPileupCleaner::PFCandidatesToken
private

Definition at line 75 of file FFTJetPFPileupCleaner.cc.

Referenced by FFTJetPFPileupCleaner(), and produce().

unsigned FFTJetPFPileupCleaner::removalMask
private

Definition at line 117 of file FFTJetPFPileupCleaner.cc.

Referenced by isRemovable(), and setRemovalBit().

bool FFTJetPFPileupCleaner::remove_e
private

Definition at line 109 of file FFTJetPFPileupCleaner.cc.

Referenced by buildRemovalMask().

bool FFTJetPFPileupCleaner::remove_egamma_HF
private

Definition at line 114 of file FFTJetPFPileupCleaner.cc.

Referenced by buildRemovalMask().

bool FFTJetPFPileupCleaner::remove_gamma
private

Definition at line 111 of file FFTJetPFPileupCleaner.cc.

Referenced by buildRemovalMask().

bool FFTJetPFPileupCleaner::remove_h
private

Definition at line 108 of file FFTJetPFPileupCleaner.cc.

Referenced by buildRemovalMask().

bool FFTJetPFPileupCleaner::remove_h0
private

Definition at line 112 of file FFTJetPFPileupCleaner.cc.

Referenced by buildRemovalMask().

bool FFTJetPFPileupCleaner::remove_h_HF
private

Definition at line 113 of file FFTJetPFPileupCleaner.cc.

Referenced by buildRemovalMask().

bool FFTJetPFPileupCleaner::remove_mu
private

Definition at line 110 of file FFTJetPFPileupCleaner.cc.

Referenced by buildRemovalMask().

bool FFTJetPFPileupCleaner::remove_X
private

Definition at line 107 of file FFTJetPFPileupCleaner.cc.

Referenced by buildRemovalMask().

bool FFTJetPFPileupCleaner::removeMainVertex
private

Definition at line 96 of file FFTJetPFPileupCleaner.cc.

Referenced by produce().

bool FFTJetPFPileupCleaner::removeUnassociated
private

Definition at line 100 of file FFTJetPFPileupCleaner.cc.

Referenced by produce().

bool FFTJetPFPileupCleaner::reverseRemovalDecision
private

Definition at line 103 of file FFTJetPFPileupCleaner.cc.

Referenced by produce().

bool FFTJetPFPileupCleaner::useFakePrimaryVertex
private

Definition at line 81 of file FFTJetPFPileupCleaner.cc.

Referenced by FFTJetPFPileupCleaner(), findSomeVertexWFakes(), and produce().

double FFTJetPFPileupCleaner::vertexNdofCut
private

Definition at line 124 of file FFTJetPFPileupCleaner.cc.

Referenced by isAcceptableVtx().

double FFTJetPFPileupCleaner::vertexRhoCut
private

Definition at line 130 of file FFTJetPFPileupCleaner.cc.

Referenced by isAcceptableVtx().

double FFTJetPFPileupCleaner::vertexZmaxCut
private

Definition at line 127 of file FFTJetPFPileupCleaner.cc.

Referenced by isAcceptableVtx().

edm::InputTag FFTJetPFPileupCleaner::Vertices
private

Definition at line 72 of file FFTJetPFPileupCleaner.cc.

Referenced by FFTJetPFPileupCleaner().

edm::EDGetTokenT<reco::VertexCollection> FFTJetPFPileupCleaner::VerticesToken
private

Definition at line 76 of file FFTJetPFPileupCleaner.cc.

Referenced by FFTJetPFPileupCleaner(), and produce().

std::vector<std::pair<double, unsigned> > FFTJetPFPileupCleaner::zAssoc
mutableprivate

Definition at line 133 of file FFTJetPFPileupCleaner.cc.

Referenced by findSomeVertexWFakes().