CMS 3D CMS Logo

FastjetJetProducer.cc
Go to the documentation of this file.
1 //
3 // FastjetJetProducer
4 // ------------------
5 //
6 // 04/21/2009 Philipp Schieferdecker <philipp.schieferdecker@cern.ch>
8 
12 
21 
27 
30 
31 #include "fastjet/SISConePlugin.hh"
32 #include "fastjet/CMSIterativeConePlugin.hh"
33 #include "fastjet/ATLASConePlugin.hh"
34 #include "fastjet/CDFMidPointPlugin.hh"
35 #include "fastjet/tools/Filter.hh"
36 #include "fastjet/tools/Pruner.hh"
37 #include "fastjet/tools/MassDropTagger.hh"
38 #include "fastjet/contrib/SoftDrop.hh"
39 #include "fastjet/tools/JetMedianBackgroundEstimator.hh"
40 #include "fastjet/tools/GridMedianBackgroundEstimator.hh"
41 #include "fastjet/tools/Subtractor.hh"
42 #include "fastjet/contrib/ConstituentSubtractor.hh"
44 
45 #include <iostream>
46 #include <memory>
47 #include <algorithm>
48 #include <limits>
49 #include <cmath>
50 //#include <fstream>
51 
52 using namespace std;
53 using namespace edm;
54 
56 // construction / destruction
58 
59 //______________________________________________________________________________
61  useOnlyVertexTracks_ = iConfig.getParameter<bool>("UseOnlyVertexTracks");
62  useOnlyOnePV_ = iConfig.getParameter<bool>("UseOnlyOnePV");
63  dzTrVtxMax_ = iConfig.getParameter<double>("DzTrVtxMax");
64  dxyTrVtxMax_ = iConfig.getParameter<double>("DxyTrVtxMax");
65  minVtxNdof_ = iConfig.getParameter<int>("MinVtxNdof");
66  maxVtxZ_ = iConfig.getParameter<double>("MaxVtxZ");
67 
68  useMassDropTagger_ = iConfig.getParameter<bool>("useMassDropTagger");
69  muCut_ = iConfig.getParameter<double>("muCut");
70  yCut_ = iConfig.getParameter<double>("yCut");
71 
72  useFiltering_ = iConfig.getParameter<bool>("useFiltering");
73  rFilt_ = iConfig.getParameter<double>("rFilt");
74  nFilt_ = iConfig.getParameter<int>("nFilt");
75  useDynamicFiltering_ = iConfig.getParameter<bool>("useDynamicFiltering");
76  if (useDynamicFiltering_)
78  rFiltFactor_ = iConfig.getParameter<double>("rFiltFactor");
79 
80  useTrimming_ = iConfig.getParameter<bool>("useTrimming");
81  trimPtFracMin_ = iConfig.getParameter<double>("trimPtFracMin");
82 
83  usePruning_ = iConfig.getParameter<bool>("usePruning");
84  zCut_ = iConfig.getParameter<double>("zcut");
85  RcutFactor_ = iConfig.getParameter<double>("rcut_factor");
86  nFilt_ = iConfig.getParameter<int>("nFilt");
87  useKtPruning_ = iConfig.getParameter<bool>("useKtPruning");
88 
89  useCMSBoostedTauSeedingAlgorithm_ = iConfig.getParameter<bool>("useCMSBoostedTauSeedingAlgorithm");
90  subjetPtMin_ = iConfig.getParameter<double>("subjetPtMin");
91  muMin_ = iConfig.getParameter<double>("muMin");
92  muMax_ = iConfig.getParameter<double>("muMax");
93  yMin_ = iConfig.getParameter<double>("yMin");
94  yMax_ = iConfig.getParameter<double>("yMax");
95  dRMin_ = iConfig.getParameter<double>("dRMin");
96  dRMax_ = iConfig.getParameter<double>("dRMax");
97  maxDepth_ = iConfig.getParameter<int>("maxDepth");
98 
99  useConstituentSubtraction_ = iConfig.getParameter<bool>("useConstituentSubtraction");
100  csRho_EtaMax_ = iConfig.getParameter<double>("csRho_EtaMax");
101  csRParam_ = iConfig.getParameter<double>("csRParam");
102 
103  useSoftDrop_ = iConfig.getParameter<bool>("useSoftDrop");
104  zCut_ = iConfig.getParameter<double>("zcut");
105  beta_ = iConfig.getParameter<double>("beta");
106  R0_ = iConfig.getParameter<double>("R0");
107 
108  correctShape_ = iConfig.getParameter<bool>("correctShape");
109  gridMaxRapidity_ = iConfig.getParameter<double>("gridMaxRapidity");
110  gridSpacing_ = iConfig.getParameter<double>("gridSpacing");
111 
113  consumes<edm::View<reco::RecoChargedRefCandidate>>(iConfig.getParameter<edm::InputTag>("src"));
114 
115  if (useFiltering_ || useTrimming_ || usePruning_ || useMassDropTagger_ || useCMSBoostedTauSeedingAlgorithm_ ||
116  useConstituentSubtraction_ || useSoftDrop_ || correctShape_)
117  useExplicitGhosts_ = true;
118 
120 
121  if ((useMassDropTagger_) && ((muCut_ == -1) || (yCut_ == -1)))
122  throw cms::Exception("useMassDropTagger")
123  << "Parameters muCut and/or yCut for Mass Drop are not defined." << std::endl;
124 
125  if ((useFiltering_) && ((rFilt_ == -1) || (nFilt_ == -1))) {
126  throw cms::Exception("useFiltering") << "Parameters rFilt and/or nFilt for Filtering are not defined." << std::endl;
127  if ((useDynamicFiltering_) && (rFiltFactor_ == -1))
128  throw cms::Exception("useDynamicFiltering")
129  << "Parameters rFiltFactor for DynamicFiltering is not defined." << std::endl;
130  }
131 
132  if ((useTrimming_) && ((rFilt_ == -1) || (trimPtFracMin_ == -1)))
133  throw cms::Exception("useTrimming") << "Parameters rFilt and/or trimPtFracMin for Trimming are not defined."
134  << std::endl;
135 
136  if ((usePruning_) && ((zCut_ == -1) || (RcutFactor_ == -1) || (nFilt_ == -1)))
137  throw cms::Exception("usePruning") << "Parameters zCut and/or RcutFactor and/or nFilt for Pruning are not defined."
138  << std::endl;
139 
140  if ((useCMSBoostedTauSeedingAlgorithm_) &&
141  ((subjetPtMin_ == -1) || (maxDepth_ == -1) || (muMin_ == -1) || (muMax_ == -1) || (yMin_ == -1) ||
142  (yMax_ == -1) || (dRMin_ == -1) || (dRMax_ == -1)))
143  throw cms::Exception("useCMSBoostedTauSeedingAlgorithm")
144  << "Parameters subjetPtMin, muMin, muMax, yMin, yMax, dRmin, dRmax, maxDepth for CMSBoostedTauSeedingAlgorithm "
145  "are not defined."
146  << std::endl;
147 
148  if (useConstituentSubtraction_ && (fjAreaDefinition_.get() == nullptr))
149  throw cms::Exception("AreaMustBeSet")
150  << "Logic error. The area definition must be set if you use constituent subtraction." << std::endl;
151 
152  if ((useConstituentSubtraction_) && ((csRho_EtaMax_ == -1) || (csRParam_ == -1)))
153  throw cms::Exception("useConstituentSubtraction")
154  << "Parameters csRho_EtaMax and/or csRParam for ConstituentSubtraction are not defined." << std::endl;
155 
156  if (useSoftDrop_ && usePruning_)
157  throw cms::Exception("PruningAndSoftDrop")
158  << "Logic error. Soft drop is a generalized pruning, do not run them together." << std::endl;
159 
160  if ((useSoftDrop_) && ((zCut_ == -1) || (beta_ == -1) || (R0_ == -1)))
161  throw cms::Exception("useSoftDrop") << "Parameters zCut and/or beta and/or R0 for SoftDrop are not defined."
162  << std::endl;
163 
164  if ((correctShape_) && ((gridMaxRapidity_ == -1) || (gridSpacing_ == -1)))
165  throw cms::Exception("correctShape")
166  << "Parameters gridMaxRapidity and/or gridSpacing for SoftDrop are not defined." << std::endl;
167 }
168 
169 //______________________________________________________________________________
171 
173 // implementation of member functions
175 
177  // for everything but track jets
178  if (!makeTrackJet(jetTypeE)) {
179  // use the default production from one collection
180  VirtualJetProducer::produce(iEvent, iSetup);
181 
182  } else { // produce trackjets from tracks grouped per primary vertex
183 
184  produceTrackJets(iEvent, iSetup);
185  }
186 
187  // fjClusterSeq_ retains quite a lot of memory - about 1 to 7Mb at 200 pileup
188  // depending on the exact configuration; and there are 24 FastjetJetProducers in the
189  // sequence so this adds up to about 60 Mb. It's allocated every time runAlgorithm
190  // is called, so safe to delete here.
191  fjClusterSeq_.reset();
192 }
193 
195  // read in the track candidates
197  iEvent.getByToken(input_chrefcand_token_, inputsHandle);
198 
199  // make collection with pointers so we can play around with it
200  std::vector<edm::Ptr<reco::RecoChargedRefCandidate>> allInputs;
201  std::vector<edm::Ptr<reco::Candidate>> origInputs;
202  for (size_t i = 0; i < inputsHandle->size(); ++i) {
203  allInputs.push_back(inputsHandle->ptrAt(i));
204  origInputs.push_back(inputsHandle->ptrAt(i));
205  }
206 
207  // read in the PV collection
209  iEvent.getByToken(input_vertex_token_, pvCollection);
210  // define the overall output jet container
211  auto jets = std::make_unique<std::vector<reco::TrackJet>>();
212 
213  // loop over the good vertices, clustering for each vertex separately
214  for (reco::VertexCollection::const_iterator itVtx = pvCollection->begin(); itVtx != pvCollection->end(); ++itVtx) {
215  if (itVtx->isFake() || itVtx->ndof() < minVtxNdof_ || fabs(itVtx->z()) > maxVtxZ_)
216  continue;
217 
218  // clear the intermediate containers
219  inputs_.clear();
220  fjInputs_.clear();
221  fjJets_.clear();
222 
223  // if only vertex-associated tracks should be used
224  if (useOnlyVertexTracks_) {
225  // loop over the tracks associated to the vertex
226  for (reco::Vertex::trackRef_iterator itTr = itVtx->tracks_begin(); itTr != itVtx->tracks_end(); ++itTr) {
227  // whether a match was found in the track candidate input
228  bool found = false;
229  // loop over input track candidates
230  for (std::vector<edm::Ptr<reco::RecoChargedRefCandidate>>::iterator itIn = allInputs.begin();
231  itIn != allInputs.end();
232  ++itIn) {
233  // match the input track candidate to the track from the vertex
234  reco::TrackRef trref(itTr->castTo<reco::TrackRef>());
235  // check if the tracks match
236  if ((*itIn)->track() == trref) {
237  found = true;
238  // add this track candidate to the input for clustering
239  inputs_.push_back(*itIn);
240  // erase the track candidate from the total list of input, so we don't reuse it later
241  allInputs.erase(itIn);
242  // found the candidate track corresponding to the vertex track, so stop the loop
243  break;
244  } // end if match found
245  } // end loop over input tracks
246  // give an info message in case no match is found (can happen if candidates are subset of tracks used for clustering)
247  if (!found)
248  edm::LogInfo("FastjetTrackJetProducer")
249  << "Ignoring a track at vertex which is not in input track collection!";
250  } // end loop over tracks associated to vertex
251  // if all inpt track candidates should be used
252  } else {
253  // loop over input track candidates
254  for (std::vector<edm::Ptr<reco::RecoChargedRefCandidate>>::iterator itIn = allInputs.begin();
255  itIn != allInputs.end();
256  ++itIn) {
257  // check if the track is close enough to the vertex
258  float dz = (*itIn)->track()->dz(itVtx->position());
259  float dxy = (*itIn)->track()->dxy(itVtx->position());
260  if (fabs(dz) > dzTrVtxMax_)
261  continue;
262  if (fabs(dxy) > dxyTrVtxMax_)
263  continue;
264  bool closervtx = false;
265  // now loop over the good vertices a second time
266  for (reco::VertexCollection::const_iterator itVtx2 = pvCollection->begin(); itVtx2 != pvCollection->end();
267  ++itVtx2) {
268  if (itVtx->isFake() || itVtx->ndof() < minVtxNdof_ || fabs(itVtx->z()) > maxVtxZ_)
269  continue;
270  // and check this track is closer to any other vertex (if more than 1 vertex considered)
271  if (!useOnlyOnePV_ && itVtx != itVtx2 && fabs((*itIn)->track()->dz(itVtx2->position())) < fabs(dz)) {
272  closervtx = true;
273  break; // 1 closer vertex makes the track already not matched, so break
274  }
275  }
276  // don't add this track if another vertex is found closer
277  if (closervtx)
278  continue;
279  // add this track candidate to the input for clustering
280  inputs_.push_back(*itIn);
281  // erase the track candidate from the total list of input, so we don't reuse it later
282  allInputs.erase(itIn);
283  // take a step back in the loop since we just erased
284  --itIn;
285  }
286  }
287 
288  // convert candidates in inputs_ to fastjet::PseudoJets in fjInputs_
289  fjInputs_.reserve(inputs_.size());
290  inputTowers();
291  LogDebug("FastjetTrackJetProducer") << "Inputted towers\n";
292 
293  // run algorithm, using fjInputs_, modifying fjJets_ and allocating fjClusterSeq_
294  runAlgorithm(iEvent, iSetup);
295  LogDebug("FastjetTrackJetProducer") << "Ran algorithm\n";
296 
297  // convert our jets and add to the overall jet vector
298  for (unsigned int ijet = 0; ijet < fjJets_.size(); ++ijet) {
299  // get the constituents from fastjet
300  std::vector<fastjet::PseudoJet> fjConstituents = sorted_by_pt(fjClusterSeq_->constituents(fjJets_[ijet]));
301  // convert them to CandidatePtr vector
302  std::vector<reco::CandidatePtr> constituents = getConstituents(fjConstituents);
303  // fill the trackjet
305  // write the specifics to the jet (simultaneously sets 4-vector, vertex).
307  jet,
308  reco::Particle::LorentzVector(fjJets_[ijet].px(), fjJets_[ijet].py(), fjJets_[ijet].pz(), fjJets_[ijet].E()),
309  vertex_,
310  constituents,
311  iSetup);
312  jet.setJetArea(0);
313  jet.setPileup(0);
314  jet.setPrimaryVertex(edm::Ref<reco::VertexCollection>(pvCollection, (int)(itVtx - pvCollection->begin())));
315  jet.setVertex(itVtx->position());
316  jets->push_back(jet);
317  }
318 
319  if (useOnlyOnePV_)
320  break; // stop vertex loop if only one vertex asked for
321  } // end loop over vertices
322 
323  // put the jets in the collection
324  LogDebug("FastjetTrackJetProducer") << "Put " << jets->size() << " jets in the event.\n";
325  iEvent.put(std::move(jets));
326 
327  // Clear the work vectors so that memory is free for other modules.
328  // Use the trick of swapping with an empty vector so that the memory
329  // is actually given back rather than silently kept.
330  decltype(fjInputs_)().swap(fjInputs_);
331  decltype(fjJets_)().swap(fjJets_);
332  decltype(inputs_)().swap(inputs_);
333 }
334 
335 //______________________________________________________________________________
337  // run algorithm
338  /*
339  fjInputs_.clear();
340  double px, py , pz, E;
341  string line;
342  std::ifstream fin("dump3.txt");
343  while (getline(fin, line)){
344  if (line == "#END") break;
345  if (line.substr(0,1) == "#") {continue;}
346  istringstream istr(line);
347  istr >> px >> py >> pz >> E;
348  // create a fastjet::PseudoJet with these components and put it onto
349  // back of the input_particles vector
350  fastjet::PseudoJet j(px,py,pz,E);
351  //if ( fabs(j.rap()) < inputEtaMax )
352  fjInputs_.push_back(fastjet::PseudoJet(px,py,pz,E));
353  }
354  fin.close();
355  */
356 
357  if (!doAreaFastjet_ && !doRhoFastjet_) {
358  fjClusterSeq_ = ClusterSequencePtr(new fastjet::ClusterSequence(fjInputs_, *fjJetDefinition_));
359  } else if (voronoiRfact_ <= 0) {
360  fjClusterSeq_ =
361  ClusterSequencePtr(new fastjet::ClusterSequenceArea(fjInputs_, *fjJetDefinition_, *fjAreaDefinition_));
362  } else {
364  new fastjet::ClusterSequenceVoronoiArea(fjInputs_, *fjJetDefinition_, fastjet::VoronoiAreaSpec(voronoiRfact_)));
365  }
366 
369  fjJets_ = fastjet::sorted_by_pt(fjClusterSeq_->inclusive_jets(jetPtMin_));
370  } else {
371  fjJets_.clear();
372 
373  transformer_coll transformers;
374 
375  std::vector<fastjet::PseudoJet> tempJets = fastjet::sorted_by_pt(fjClusterSeq_->inclusive_jets(jetPtMin_));
376 
377  unique_ptr<fastjet::JetMedianBackgroundEstimator> bge_rho;
379  fastjet::Selector rho_range = fastjet::SelectorAbsRapMax(csRho_EtaMax_);
380  bge_rho = unique_ptr<fastjet::JetMedianBackgroundEstimator>(new fastjet::JetMedianBackgroundEstimator(
381  rho_range, fastjet::JetDefinition(fastjet::kt_algorithm, csRParam_), *fjAreaDefinition_));
382  bge_rho->set_particles(fjInputs_);
383  fastjet::contrib::ConstituentSubtractor* constituentSubtractor =
384  new fastjet::contrib::ConstituentSubtractor(bge_rho.get());
385 
386  transformers.push_back(transformer_ptr(constituentSubtractor));
387  };
388  if (useMassDropTagger_) {
389  fastjet::MassDropTagger* md_tagger = new fastjet::MassDropTagger(muCut_, yCut_);
390  transformers.push_back(transformer_ptr(md_tagger));
391  }
393  fastjet::contrib::CMSBoostedTauSeedingAlgorithm* tau_tagger = new fastjet::contrib::CMSBoostedTauSeedingAlgorithm(
395  transformers.push_back(transformer_ptr(tau_tagger));
396  }
397  if (useTrimming_) {
398  fastjet::Filter* trimmer = new fastjet::Filter(fastjet::JetDefinition(fastjet::kt_algorithm, rFilt_),
399  fastjet::SelectorPtFractionMin(trimPtFracMin_));
400  transformers.push_back(transformer_ptr(trimmer));
401  }
402  if ((useFiltering_) && (!useDynamicFiltering_)) {
403  fastjet::Filter* filter = new fastjet::Filter(fastjet::JetDefinition(fastjet::cambridge_algorithm, rFilt_),
404  fastjet::SelectorNHardest(nFilt_));
405  transformers.push_back(transformer_ptr(filter));
406  }
407 
408  if ((usePruning_) && (!useKtPruning_)) {
409  fastjet::Pruner* pruner = new fastjet::Pruner(fastjet::cambridge_algorithm, zCut_, RcutFactor_);
410  transformers.push_back(transformer_ptr(pruner));
411  }
412 
413  if (useDynamicFiltering_) {
415  new fastjet::Filter(fastjet::Filter(&*rFiltDynamic_, fastjet::SelectorNHardest(nFilt_)));
416  transformers.push_back(transformer_ptr(filter));
417  }
418 
419  if (useKtPruning_) {
420  fastjet::Pruner* pruner = new fastjet::Pruner(fastjet::kt_algorithm, zCut_, RcutFactor_);
421  transformers.push_back(transformer_ptr(pruner));
422  }
423 
424  if (useSoftDrop_) {
425  fastjet::contrib::SoftDrop* sd = new fastjet::contrib::SoftDrop(beta_, zCut_, R0_);
426  transformers.push_back(transformer_ptr(sd));
427  }
428 
429  unique_ptr<fastjet::Subtractor> subtractor;
430  unique_ptr<fastjet::GridMedianBackgroundEstimator> bge_rho_grid;
431  if (correctShape_) {
432  bge_rho_grid = unique_ptr<fastjet::GridMedianBackgroundEstimator>(
433  new fastjet::GridMedianBackgroundEstimator(gridMaxRapidity_, gridSpacing_));
434  bge_rho_grid->set_particles(fjInputs_);
435  subtractor = unique_ptr<fastjet::Subtractor>(new fastjet::Subtractor(bge_rho_grid.get()));
436  subtractor->set_use_rho_m();
437  //subtractor->use_common_bge_for_rho_and_rhom(true);
438  }
439 
440  for (std::vector<fastjet::PseudoJet>::const_iterator ijet = tempJets.begin(), ijetEnd = tempJets.end();
441  ijet != ijetEnd;
442  ++ijet) {
443  fastjet::PseudoJet transformedJet = *ijet;
444  bool passed = true;
445  for (transformer_coll::const_iterator itransf = transformers.begin(), itransfEnd = transformers.end();
446  itransf != itransfEnd;
447  ++itransf) {
448  if (transformedJet != 0) {
449  transformedJet = (**itransf)(transformedJet);
450  } else {
451  passed = false;
452  }
453  }
454 
455  if (correctShape_) {
456  transformedJet = (*subtractor)(transformedJet);
457  }
458 
459  if (passed) {
460  fjJets_.push_back(transformedJet);
461  }
462  }
463  }
464 }
465 
466 //______________________________________________________________________________
468  edm::ParameterSetDescription descFastjetJetProducer;
470  fillDescriptionsFromFastJetProducer(descFastjetJetProducer);
474  descFastjetJetProducer.add<string>("jetCollInstanceName", "");
475  descFastjetJetProducer.add<bool>("sumRecHits", false);
476 
478  descriptions.add("FastjetJetProducer", descFastjetJetProducer);
479 }
480 
482  desc.add<bool>("useMassDropTagger", false);
483  desc.add<bool>("useFiltering", false);
484  desc.add<bool>("useDynamicFiltering", false);
485  desc.add<bool>("useTrimming", false);
486  desc.add<bool>("usePruning", false);
487  desc.add<bool>("useCMSBoostedTauSeedingAlgorithm", false);
488  desc.add<bool>("useKtPruning", false);
489  desc.add<bool>("useConstituentSubtraction", false);
490  desc.add<bool>("useSoftDrop", false);
491  desc.add<bool>("correctShape", false);
492  desc.add<bool>("UseOnlyVertexTracks", false);
493  desc.add<bool>("UseOnlyOnePV", false);
494  desc.add<double>("muCut", -1.0);
495  desc.add<double>("yCut", -1.0);
496  desc.add<double>("rFilt", -1.0);
497  desc.add<double>("rFiltFactor", -1.0);
498  desc.add<double>("trimPtFracMin", -1.0);
499  desc.add<double>("zcut", -1.0);
500  desc.add<double>("rcut_factor", -1.0);
501  desc.add<double>("csRho_EtaMax", -1.0);
502  desc.add<double>("csRParam", -1.0);
503  desc.add<double>("beta", -1.0);
504  desc.add<double>("R0", -1.0);
505  desc.add<double>("gridMaxRapidity", -1.0); // For fixed-grid rho
506  desc.add<double>("gridSpacing", -1.0); // For fixed-grid rho
507  desc.add<double>("DzTrVtxMax", 999999.);
508  desc.add<double>("DxyTrVtxMax", 999999.);
509  desc.add<double>("MaxVtxZ", 15.0);
510  desc.add<double>("subjetPtMin", -1.0);
511  desc.add<double>("muMin", -1.0);
512  desc.add<double>("muMax", -1.0);
513  desc.add<double>("yMin", -1.0);
514  desc.add<double>("yMax", -1.0);
515  desc.add<double>("dRMin", -1.0);
516  desc.add<double>("dRMax", -1.0);
517  desc.add<int>("maxDepth", -1);
518  desc.add<int>("nFilt", -1);
519  desc.add<int>("MinVtxNdof", 5);
520 }
521 
523 // define as cmssw plugin
525 
#define LogDebug(id)
double muMin_
for CMSBoostedTauSeedingAlgorithm : subjet pt min
JetType::Type jetTypeE
T getParameter(std::string const &) const
double yMin_
for CMSBoostedTauSeedingAlgorithm : max mass-drop
bool useFiltering_
Mass-drop tagging for boosted Higgs.
bool correctShape_
Soft drop.
double rFilt_
for mass-drop tagging, symmetry cut: min(pt1^2,pt2^2) * dR(1,2) / mjet > ycut
OrphanHandle< PROD > put(std::unique_ptr< PROD > product)
Put a new product.
Definition: Event.h:131
reco::Particle::Point vertex_
double dRMax_
for CMSBoostedTauSeedingAlgorithm : min dR
double subjetPtMin_
for shape subtraction, get the grid spacing
virtual std::vector< reco::CandidatePtr > getConstituents(const std::vector< fastjet::PseudoJet > &fjConstituents)
std::vector< fastjet::PseudoJet > fjJets_
bool getByToken(EDGetToken token, Handle< PROD > &result) const
Definition: Event.h:525
virtual void setPileup(float fEnergy)
Set pileup energy contribution as calculated by algorithm.
Definition: Jet.h:106
virtual void inputTowers()
bool useDynamicFiltering_
Jet filtering technique.
std::shared_ptr< fastjet::ClusterSequence > ClusterSequencePtr
double RcutFactor_
for pruning OR soft drop: constituent minimum pt fraction of parent cluster
bool useSoftDrop_
constituent subtraction technique
double yMax_
for CMSBoostedTauSeedingAlgorithm : min asymmetry
double gridSpacing_
for shape subtraction, get the fixed-grid rho
bool useKtPruning_
algorithm for seeding reconstruction of boosted Taus (similar to mass-drop tagging) ...
FastjetJetProducer(const edm::ParameterSet &iConfig)
void swap(Association< C > &lhs, Association< C > &rhs)
Definition: Association.h:117
bool useTrimming_
Use dynamic filtering radius (as in arXiv:0802.2470)
double csRParam_
for constituent subtraction : maximum rapidity for ghosts
void setVertex(const Point &vertex) override
set vertex
void produce(edm::Event &iEvent, const edm::EventSetup &iSetup) override
bool makeTrackJet(const JetType::Type &fTag)
virtual void setJetArea(float fArea)
set jet area
Definition: Jet.h:101
std::vector< fastjet::PseudoJet > fjInputs_
std::vector< transformer_ptr > transformer_coll
double trimPtFracMin_
for filtering, pruning: number of subjets expected
double gridMaxRapidity_
for soft drop : R0 (angular distance normalization - should be set to jet radius in most cases) ...
int iEvent
Definition: GenABIO.cc:224
#define DEFINE_FWK_MODULE(type)
Definition: MakerMacros.h:16
bool usePruning_
Jet trimming technique.
std::vector< edm::Ptr< reco::Candidate > > inputs_
bool useCMSBoostedTauSeedingAlgorithm_
Jet pruning technique.
ClusterSequencePtr fjClusterSeq_
virtual void produceTrackJets(edm::Event &iEvent, const edm::EventSetup &iSetup)
edm::EDGetTokenT< edm::View< reco::RecoChargedRefCandidate > > input_chrefcand_token_
for CMSBoostedTauSeedingAlgorithm : max depth for descending into clustering sequence ...
double csRho_EtaMax_
for pruning: constituent dR * pt/2m < rcut_factor
static void fillDescriptions(edm::ConfigurationDescriptions &descriptions)
double muMax_
for CMSBoostedTauSeedingAlgorithm : min mass-drop
double muCut_
Correct the shape of the jets.
double rFiltFactor_
for dynamic filtering radius (as in arXiv:0802.2470)
DynamicRfiltPtr rFiltDynamic_
for filtering, trimming: dR scale of sub-clustering
void setPrimaryVertex(const reco::VertexRef &vtx)
set associated primary vertex
Definition: TrackJet.cc:59
double dRMin_
for CMSBoostedTauSeedingAlgorithm : max asymmetry
double beta_
for constituent subtraction : R parameter for KT alg in jet median background estimator ...
ParameterDescriptionBase * add(U const &iLabel, T const &value)
double zCut_
for trimming: constituent minimum pt fraction of full jet
Jets made out of tracks.
Definition: TrackJet.h:24
int nFilt_
for dynamic filtering radius (as in arXiv:0802.2470)
int maxDepth_
for CMSBoostedTauSeedingAlgorithm : max dR
static void fillDescriptionsFromFastJetProducer(edm::ParameterSetDescription &desc)
cms::Filter Filter
double sd
edm::EDGetTokenT< reco::VertexCollection > input_vertex_token_
double R0_
for soft drop : beta (angular exponent)
void add(std::string const &label, ParameterSetDescription const &psetDescription)
std::unique_ptr< transformer > transformer_ptr
std::shared_ptr< DynamicRfilt > DynamicRfiltPtr
double yCut_
for mass-drop tagging, m0/mjet (m0 = mass of highest mass subjet)
void runAlgorithm(edm::Event &iEvent, const edm::EventSetup &iSetup) override
void produce(edm::Event &iEvent, const edm::EventSetup &iSetup) override
HLT enums.
bool useConstituentSubtraction_
Use Kt clustering algorithm for pruning (default is Cambridge/Aachen)
AreaDefinitionPtr fjAreaDefinition_
static void fillDescriptionsFromVirtualJetProducer(edm::ParameterSetDescription &desc)
math::XYZTLorentzVector LorentzVector
Lorentz vector.
Definition: Particle.h:21
def move(src, dest)
Definition: eostools.py:511
std::vector< TrackBaseRef >::const_iterator trackRef_iterator
The iteratator for the vector<TrackRef>
Definition: Vertex.h:37
void writeSpecific(reco::CaloJet &jet, reco::Particle::LorentzVector const &p4, reco::Particle::Point const &point, std::vector< reco::CandidatePtr > const &constituents, edm::EventSetup const &c)
Definition: JetSpecific.cc:34