CMS 3D CMS Logo

List of all members | Public Types | Public Member Functions | Static Public Member Functions | Private Member Functions | Private Attributes
L1TkFastVertexProducer Class Reference
Inheritance diagram for L1TkFastVertexProducer:
edm::EDProducer edm::ProducerBase edm::EDConsumerBase edm::ProductRegistryHelper

Public Types

typedef std::vector< L1TTTrackTypeL1TTTrackCollectionType
 
typedef TTTrack< Ref_Phase2TrackerDigi_L1TTTrackType
 
- 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
 

Public Member Functions

 L1TkFastVertexProducer (const edm::ParameterSet &)
 
 ~L1TkFastVertexProducer () 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
 
std::vector< bool > const & recordProvenanceList () 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)
 
TypeLabelList const & typeLabelList () const
 used by the fwk to register the list of products of this module More...
 
 ~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 &&)=default
 
 EDConsumerBase (EDConsumerBase const &)=delete
 
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
 
EDConsumerBaseoperator= (EDConsumerBase &&)=default
 
EDConsumerBase const & operator= (EDConsumerBase const &)=delete
 
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)
 

Static Public Member Functions

static void fillDescriptions (edm::ConfigurationDescriptions &descriptions)
 
- 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 ()
 

Private Member Functions

void beginJob () override
 
void endJob () override
 
void produce (edm::Event &, const edm::EventSetup &) override
 

Private Attributes

float chi2Max_
 
float DeltaZ
 
bool doPtComp_
 
bool doTightChi2_
 
const edm::EDGetTokenT< std::vector< reco::GenParticle > > genparticleToken
 
const edm::EDGetTokenT< edm::HepMCProducthepmcToken
 
int highPtTracks_
 
TH1F * htmp_
 
TH1F * htmp_weight_
 
bool monteCarloVertex_
 
int nBinning_
 
int nStubsmin_
 
int nStubsPSmin_
 
float pTMax_
 
float pTMinTra_
 
const edm::EDGetTokenT< std::vector< TTTrack< Ref_Phase2TrackerDigi_ > > > trackToken
 
int weight_
 
float zMax_
 

Additional Inherited Members

- Protected Member Functions inherited from edm::ProducerBase
template<class ProductType >
BranchAliasSetterT< ProductType > produces ()
 declare what type of product will make and with which optional label More...
 
template<typename ProductType , BranchType B>
BranchAliasSetterT< ProductType > produces ()
 
template<typename ProductType , Transition B>
BranchAliasSetterT< ProductType > produces ()
 
BranchAliasSetter produces (const TypeID &id, std::string instanceName=std::string(), bool recordProvenance=true)
 
template<BranchType B>
BranchAliasSetter produces (const TypeID &id, std::string instanceName=std::string(), bool recordProvenance=true)
 
template<Transition B>
BranchAliasSetter produces (const TypeID &id, std::string instanceName=std::string(), bool recordProvenance=true)
 
template<typename ProductType , Transition B>
BranchAliasSetterT< ProductType > produces (std::string instanceName)
 
template<class ProductType >
BranchAliasSetterT< ProductType > produces (std::string instanceName)
 
template<typename ProductType , BranchType B>
BranchAliasSetterT< ProductType > produces (std::string instanceName)
 
ProducesCollector producesCollector ()
 
- Protected Member Functions inherited from edm::EDConsumerBase
EDGetToken consumes (const TypeToGet &id, edm::InputTag const &tag)
 
template<typename ProductType , BranchType B = InEvent>
EDGetTokenT< ProductType > consumes (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)
 
EDGetToken mayConsume (const TypeToGet &id, edm::InputTag const &tag)
 
template<BranchType B>
EDGetToken mayConsume (const TypeToGet &id, edm::InputTag const &tag)
 
template<typename ProductType , BranchType B = InEvent>
EDGetTokenT< ProductType > mayConsume (edm::InputTag const &tag)
 

Detailed Description

Definition at line 49 of file L1TkFastVertexProducer.cc.

Member Typedef Documentation

◆ L1TTTrackCollectionType

Definition at line 52 of file L1TkFastVertexProducer.cc.

◆ L1TTTrackType

Definition at line 51 of file L1TkFastVertexProducer.cc.

Constructor & Destructor Documentation

◆ L1TkFastVertexProducer()

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

Definition at line 108 of file L1TkFastVertexProducer.cc.

109  : hepmcToken(consumes<edm::HepMCProduct>(iConfig.getParameter<edm::InputTag>("HepMCInputTag"))),
111  consumes<std::vector<reco::GenParticle> >(iConfig.getParameter<edm::InputTag>("GenParticleInputTag"))),
113  iConfig.getParameter<edm::InputTag>("L1TrackInputTag"))) {
114  zMax_ = (float)iConfig.getParameter<double>("ZMAX");
115  chi2Max_ = (float)iConfig.getParameter<double>("CHI2MAX");
116  pTMinTra_ = (float)iConfig.getParameter<double>("PTMINTRA");
117 
118  pTMax_ = (float)iConfig.getParameter<double>("PTMAX");
119  highPtTracks_ = iConfig.getParameter<int>("HighPtTracks");
120 
121  nStubsmin_ = iConfig.getParameter<int>("nStubsmin");
122  nStubsPSmin_ = iConfig.getParameter<int>("nStubsPSmin");
123  nBinning_ = iConfig.getParameter<int>("nBinning");
124 
125  monteCarloVertex_ = iConfig.getParameter<bool>("MonteCarloVertex");
126  doPtComp_ = iConfig.getParameter<bool>("doPtComp");
127  doTightChi2_ = iConfig.getParameter<bool>("doTightChi2");
128 
129  weight_ = iConfig.getParameter<int>("WEIGHT");
130 
131  int nbins = nBinning_; // should be odd
132  float xmin = -30;
133  float xmax = +30;
134 
135  htmp_ = new TH1F("htmp_", ";z (cm); Tracks", nbins, xmin, xmax);
136  htmp_weight_ = new TH1F("htmp_weight_", ";z (cm); Tracks", nbins, xmin, xmax);
137 
138  produces<TkPrimaryVertexCollection>();
139 }

References chi2Max_, doPtComp_, doTightChi2_, dqmMemoryStats::float, edm::ParameterSet::getParameter(), highPtTracks_, htmp_, htmp_weight_, monteCarloVertex_, nBinning_, LaserClient_cfi::nbins, nStubsmin_, nStubsPSmin_, pTMax_, pTMinTra_, weight_, TrackerOfflineValidation_Dqm_cff::xmax, TrackerOfflineValidation_Dqm_cff::xmin, and zMax_.

◆ ~L1TkFastVertexProducer()

L1TkFastVertexProducer::~L1TkFastVertexProducer ( )
override

Definition at line 141 of file L1TkFastVertexProducer.cc.

141  {
142  // do anything here that needs to be done at desctruction time
143  // (e.g. close files, deallocate resources etc.)
144 }

Member Function Documentation

◆ beginJob()

void L1TkFastVertexProducer::beginJob ( void  )
overrideprivatevirtual

Reimplemented from edm::EDProducer.

Definition at line 367 of file L1TkFastVertexProducer.cc.

367 {}

◆ endJob()

void L1TkFastVertexProducer::endJob ( void  )
overrideprivatevirtual

Reimplemented from edm::EDProducer.

Definition at line 370 of file L1TkFastVertexProducer.cc.

370 {}

◆ fillDescriptions()

void L1TkFastVertexProducer::fillDescriptions ( edm::ConfigurationDescriptions descriptions)
static

Definition at line 376 of file L1TkFastVertexProducer.cc.

376  {
377  //The following says we do not know what parameters are allowed so do no validation
378  // Please change this to state exactly what you do use, even if it is no parameters
380  desc.setUnknown();
381  descriptions.addDefault(desc);
382 }

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

◆ produce()

void L1TkFastVertexProducer::produce ( edm::Event iEvent,
const edm::EventSetup iSetup 
)
overrideprivatevirtual

Implements edm::EDProducer.

Definition at line 151 of file L1TkFastVertexProducer.cc.

151  {
152  using namespace edm;
153 
154  std::unique_ptr<TkPrimaryVertexCollection> result(new TkPrimaryVertexCollection);
155 
156  // Tracker Topology
157  edm::ESHandle<TrackerTopology> tTopoHandle_;
158  iSetup.get<TrackerTopologyRcd>().get(tTopoHandle_);
159  const TrackerTopology* tTopo = tTopoHandle_.product();
160 
161  htmp_->Reset();
162  htmp_weight_->Reset();
163 
164  // ----------------------------------------------------------------------
165 
166  if (monteCarloVertex_) {
167  // MC info ... retrieve the zvertex
169  iEvent.getByToken(hepmcToken, HepMCEvt);
170 
171  edm::Handle<std::vector<reco::GenParticle> > GenParticleHandle;
172  iEvent.getByToken(genparticleToken, GenParticleHandle);
173 
174  const double mm = 0.1;
175  float zvtx_gen = -999;
176 
177  if (HepMCEvt.isValid()) {
178  // using HepMCEvt
179 
180  const HepMC::GenEvent* MCEvt = HepMCEvt->GetEvent();
181  for (HepMC::GenEvent::vertex_const_iterator ivertex = MCEvt->vertices_begin(); ivertex != MCEvt->vertices_end();
182  ++ivertex) {
183  bool hasParentVertex = false;
184 
185  // Loop over the parents looking to see if they are coming from a production vertex
186  for (HepMC::GenVertex::particle_iterator iparent = (*ivertex)->particles_begin(HepMC::parents);
187  iparent != (*ivertex)->particles_end(HepMC::parents);
188  ++iparent)
189  if ((*iparent)->production_vertex()) {
190  hasParentVertex = true;
191  break;
192  }
193 
194  // Reject those vertices with parent vertices
195  if (hasParentVertex)
196  continue;
197  // Get the position of the vertex
198  HepMC::FourVector pos = (*ivertex)->position();
199  zvtx_gen = pos.z() * mm;
200  break; // there should be one single primary vertex
201  } // end loop over gen vertices
202 
203  } else if (GenParticleHandle.isValid()) {
204  std::vector<reco::GenParticle>::const_iterator genpartIter;
205  for (genpartIter = GenParticleHandle->begin(); genpartIter != GenParticleHandle->end(); ++genpartIter) {
206  int status = genpartIter->status();
207  if (status != 3)
208  continue;
209  if (genpartIter->numberOfMothers() == 0)
210  continue; // the incoming hadrons
211  float part_zvertex = genpartIter->vz();
212  zvtx_gen = part_zvertex;
213  break; //
214  }
215  } else {
216  throw cms::Exception("L1TkFastVertexProducer")
217  << "\nerror: try to retrieve the MC vertex (monteCarloVertex_ = True) "
218  << "\nbut the input file contains neither edm::HepMCProduct> nor vector<reco::GenParticle>. Exit"
219  << std::endl;
220  }
221 
222  // std::cout<<zvtx_gen<<endl;
223 
224  TkPrimaryVertex genvtx(zvtx_gen, -999.);
225 
226  result->push_back(genvtx);
227  iEvent.put(std::move(result));
228  return;
229  }
230 
231  edm::Handle<L1TTTrackCollectionType> L1TTTrackHandle;
232  iEvent.getByToken(trackToken, L1TTTrackHandle);
233 
234  if (!L1TTTrackHandle.isValid()) {
235  throw cms::Exception("L1TkFastVertexProducer")
236  << "\nWarning: L1TkTrackCollection with not found in the event. Exit" << std::endl;
237  return;
238  }
239 
240  L1TTTrackCollectionType::const_iterator trackIter;
241  for (trackIter = L1TTTrackHandle->begin(); trackIter != L1TTTrackHandle->end(); ++trackIter) {
242  float z = trackIter->POCA().z();
243  float chi2 = trackIter->chi2();
244  float pt = trackIter->momentum().perp();
245  float eta = trackIter->momentum().eta();
246 
247  //..............................................................
248  float wt = pow(pt, weight_); // calculating the weight for tks in as pt^0,pt^1 or pt^2 based on weight_
249 
250  if (std::abs(z) > zMax_)
251  continue;
252  if (chi2 > chi2Max_)
253  continue;
254  if (pt < pTMinTra_)
255  continue;
256 
257  // saturation or truncation :
258  if (pTMax_ > 0 && pt > pTMax_) {
259  if (highPtTracks_ == 0)
260  continue; // ignore this track
261  if (highPtTracks_ == 1)
262  pt = pTMax_; // saturate
263  }
264 
265  // get the number of stubs and the number of stubs in PS layers
266  float nPS = 0.; // number of stubs in PS modules
267  float nstubs = 0;
268 
269  // get pointers to stubs associated to the L1 track
270  const std::vector<edm::Ref<edmNew::DetSetVector<TTStub<Ref_Phase2TrackerDigi_> >, TTStub<Ref_Phase2TrackerDigi_> > >&
271  theStubs = trackIter->getStubRefs();
272 
273  int tmp_trk_nstub = (int)theStubs.size();
274  if (tmp_trk_nstub < 0) {
275  LogTrace("L1TkFastVertexProducer")
276  << " ... could not retrieve the vector of stubs in L1TkFastVertexProducer::SumPtVertex " << std::endl;
277  continue;
278  }
279 
280  // loop over the stubs
281  for (unsigned int istub = 0; istub < (unsigned int)theStubs.size(); istub++) {
282  nstubs++;
283  bool isPS = false;
284  DetId detId(theStubs.at(istub)->getDetId());
285  if (detId.det() == DetId::Detector::Tracker) {
286  if (detId.subdetId() == StripSubdetector::TOB && tTopo->tobLayer(detId) <= 3)
287  isPS = true;
288  else if (detId.subdetId() == StripSubdetector::TID && tTopo->tidRing(detId) <= 9)
289  isPS = true;
290  }
291  if (isPS)
292  nPS++;
293  } // end loop over stubs
294  if (nstubs < nStubsmin_)
295  continue;
296  if (nPS < nStubsPSmin_)
297  continue;
298 
299  // quality cuts from Louise S, based on the pt-stub compatibility (June 20, 2014)
300  int trk_nstub = (int)trackIter->getStubRefs().size();
301  float chi2dof = chi2 / (2 * trk_nstub - 4);
302 
303  if (doPtComp_) {
304  float trk_consistency = trackIter->stubPtConsistency();
305  //if (trk_nstub < 4) continue; // done earlier
306  //if (chi2 > 100.0) continue; // done earlier
307  if (trk_nstub == 4) {
308  if (std::abs(eta) < 2.2 && trk_consistency > 10)
309  continue;
310  else if (std::abs(eta) > 2.2 && chi2dof > 5.0)
311  continue;
312  }
313  }
314  if (doTightChi2_) {
315  if (pt > 10.0 && chi2dof > 5.0)
316  continue;
317  }
318 
319  htmp_->Fill(z);
320  htmp_weight_->Fill(z, wt); // changed from "pt" to "wt" which is some power of pt (0,1 or 2)
321 
322  } // end loop over tracks
323 
324  // sliding windows... maximize bin i + i-1 + i+1
325 
326  float zvtx_sliding = -999;
327  float sigma_max = -999;
328  int nb = htmp_->GetNbinsX();
329  for (int i = 2; i <= nb - 1; i++) {
330  float a0 = htmp_->GetBinContent(i - 1);
331  float a1 = htmp_->GetBinContent(i);
332  float a2 = htmp_->GetBinContent(i + 1);
333  float sigma = a0 + a1 + a2;
334  if (sigma > sigma_max) {
335  sigma_max = sigma;
336  float z0 = htmp_->GetBinCenter(i - 1);
337  float z1 = htmp_->GetBinCenter(i);
338  float z2 = htmp_->GetBinCenter(i + 1);
339  zvtx_sliding = (a0 * z0 + a1 * z1 + a2 * z2) / sigma;
340  }
341  }
342 
343  zvtx_sliding = -999;
344  sigma_max = -999;
345  for (int i = 2; i <= nb - 1; i++) {
346  float a0 = htmp_weight_->GetBinContent(i - 1);
347  float a1 = htmp_weight_->GetBinContent(i);
348  float a2 = htmp_weight_->GetBinContent(i + 1);
349  float sigma = a0 + a1 + a2;
350  if (sigma > sigma_max) {
351  sigma_max = sigma;
352  float z0 = htmp_weight_->GetBinCenter(i - 1);
353  float z1 = htmp_weight_->GetBinCenter(i);
354  float z2 = htmp_weight_->GetBinCenter(i + 1);
355  zvtx_sliding = (a0 * z0 + a1 * z1 + a2 * z2) / sigma;
356  }
357  }
358 
359  TkPrimaryVertex vtx4(zvtx_sliding, sigma_max);
360 
361  result->push_back(vtx4);
362 
363  iEvent.put(std::move(result));
364 }

References a0, testProducerWithPsetDescEmpty_cfi::a2, funct::abs(), hltPixelTracks_cff::chi2, chi2Max_, doPtComp_, doTightChi2_, PVValHelper::eta, Exception, genparticleToken, edm::EventSetup::get(), get, edm::HepMCProduct::GetEvent(), hepmcToken, highPtTracks_, htmp_, htmp_weight_, mps_fire::i, iEvent, createfilelist::int, edm::HandleBase::isValid(), LogTrace, monteCarloVertex_, eostools::move(), nStubsmin_, nStubsPSmin_, parents, funct::pow(), edm::ESHandle< T >::product(), DiDispStaMuonMonitor_cfi::pt, pTMax_, pTMinTra_, mps_fire::result, mps_update::status, StripSubdetector::TID, TrackerTopology::tidRing(), StripSubdetector::TOB, TrackerTopology::tobLayer(), align::Tracker, trackToken, weight_, z, HLTMuonOfflineAnalyzer_cfi::z0, testProducerWithPsetDescEmpty_cfi::z2, and zMax_.

Member Data Documentation

◆ chi2Max_

float L1TkFastVertexProducer::chi2Max_
private

Definition at line 70 of file L1TkFastVertexProducer.cc.

Referenced by L1TkFastVertexProducer(), and produce().

◆ DeltaZ

float L1TkFastVertexProducer::DeltaZ
private

Definition at line 69 of file L1TkFastVertexProducer.cc.

◆ doPtComp_

bool L1TkFastVertexProducer::doPtComp_
private

Definition at line 84 of file L1TkFastVertexProducer.cc.

Referenced by L1TkFastVertexProducer(), and produce().

◆ doTightChi2_

bool L1TkFastVertexProducer::doTightChi2_
private

Definition at line 85 of file L1TkFastVertexProducer.cc.

Referenced by L1TkFastVertexProducer(), and produce().

◆ genparticleToken

const edm::EDGetTokenT<std::vector<reco::GenParticle> > L1TkFastVertexProducer::genparticleToken
private

Definition at line 93 of file L1TkFastVertexProducer.cc.

Referenced by produce().

◆ hepmcToken

const edm::EDGetTokenT<edm::HepMCProduct> L1TkFastVertexProducer::hepmcToken
private

Definition at line 92 of file L1TkFastVertexProducer.cc.

Referenced by produce().

◆ highPtTracks_

int L1TkFastVertexProducer::highPtTracks_
private

Definition at line 74 of file L1TkFastVertexProducer.cc.

Referenced by L1TkFastVertexProducer(), and produce().

◆ htmp_

TH1F* L1TkFastVertexProducer::htmp_
private

Definition at line 89 of file L1TkFastVertexProducer.cc.

Referenced by L1TkFastVertexProducer(), and produce().

◆ htmp_weight_

TH1F* L1TkFastVertexProducer::htmp_weight_
private

Definition at line 90 of file L1TkFastVertexProducer.cc.

Referenced by L1TkFastVertexProducer(), and produce().

◆ monteCarloVertex_

bool L1TkFastVertexProducer::monteCarloVertex_
private

Definition at line 81 of file L1TkFastVertexProducer.cc.

Referenced by L1TkFastVertexProducer(), and produce().

◆ nBinning_

int L1TkFastVertexProducer::nBinning_
private

Definition at line 79 of file L1TkFastVertexProducer.cc.

Referenced by L1TkFastVertexProducer().

◆ nStubsmin_

int L1TkFastVertexProducer::nStubsmin_
private

Definition at line 76 of file L1TkFastVertexProducer.cc.

Referenced by L1TkFastVertexProducer(), and produce().

◆ nStubsPSmin_

int L1TkFastVertexProducer::nStubsPSmin_
private

Definition at line 77 of file L1TkFastVertexProducer.cc.

Referenced by L1TkFastVertexProducer(), and produce().

◆ pTMax_

float L1TkFastVertexProducer::pTMax_
private

Definition at line 73 of file L1TkFastVertexProducer.cc.

Referenced by L1TkFastVertexProducer(), and produce().

◆ pTMinTra_

float L1TkFastVertexProducer::pTMinTra_
private

Definition at line 71 of file L1TkFastVertexProducer.cc.

Referenced by L1TkFastVertexProducer(), and produce().

◆ trackToken

const edm::EDGetTokenT<std::vector<TTTrack<Ref_Phase2TrackerDigi_> > > L1TkFastVertexProducer::trackToken
private

Definition at line 94 of file L1TkFastVertexProducer.cc.

Referenced by produce().

◆ weight_

int L1TkFastVertexProducer::weight_
private

Definition at line 87 of file L1TkFastVertexProducer.cc.

Referenced by L1TkFastVertexProducer(), and produce().

◆ zMax_

float L1TkFastVertexProducer::zMax_
private

Definition at line 68 of file L1TkFastVertexProducer.cc.

Referenced by L1TkFastVertexProducer(), and produce().

edm::ESHandle::product
T const * product() const
Definition: ESHandle.h:86
L1TkFastVertexProducer::monteCarloVertex_
bool monteCarloVertex_
Definition: L1TkFastVertexProducer.cc:81
mps_fire.i
i
Definition: mps_fire.py:355
dqmMemoryStats.float
float
Definition: dqmMemoryStats.py:127
L1TkFastVertexProducer::nStubsPSmin_
int nStubsPSmin_
Definition: L1TkFastVertexProducer.cc:77
DiDispStaMuonMonitor_cfi.pt
pt
Definition: DiDispStaMuonMonitor_cfi.py:39
mps_update.status
status
Definition: mps_update.py:69
edm
HLT enums.
Definition: AlignableModifier.h:19
TrackerTopology
Definition: TrackerTopology.h:16
pos
Definition: PixelAliasList.h:18
edm::ParameterSetDescription
Definition: ParameterSetDescription.h:52
L1TkFastVertexProducer::trackToken
const edm::EDGetTokenT< std::vector< TTTrack< Ref_Phase2TrackerDigi_ > > > trackToken
Definition: L1TkFastVertexProducer.cc:94
TTTrack
Class to store the L1 Track Trigger tracks.
Definition: TTTrack.h:26
L1TkFastVertexProducer::weight_
int weight_
Definition: L1TkFastVertexProducer.cc:87
L1TkFastVertexProducer::doTightChi2_
bool doTightChi2_
Definition: L1TkFastVertexProducer.cc:85
L1TkFastVertexProducer::hepmcToken
const edm::EDGetTokenT< edm::HepMCProduct > hepmcToken
Definition: L1TkFastVertexProducer.cc:92
hltPixelTracks_cff.chi2
chi2
Definition: hltPixelTracks_cff.py:25
edm::Handle< edm::HepMCProduct >
L1TkFastVertexProducer::htmp_
TH1F * htmp_
Definition: L1TkFastVertexProducer.cc:89
TrackerTopology::tidRing
unsigned int tidRing(const DetId &id) const
Definition: TrackerTopology.h:218
HepMC::GenEvent
Definition: hepmc_rootio.cc:9
testProducerWithPsetDescEmpty_cfi.a2
a2
Definition: testProducerWithPsetDescEmpty_cfi.py:35
align::Tracker
Definition: StructureType.h:70
testProducerWithPsetDescEmpty_cfi.z2
z2
Definition: testProducerWithPsetDescEmpty_cfi.py:41
DetId
Definition: DetId.h:17
L1TkFastVertexProducer::htmp_weight_
TH1F * htmp_weight_
Definition: L1TkFastVertexProducer.cc:90
L1TkFastVertexProducer::pTMinTra_
float pTMinTra_
Definition: L1TkFastVertexProducer.cc:71
edm::EventSetup::get
T get() const
Definition: EventSetup.h:73
L1TkFastVertexProducer::nBinning_
int nBinning_
Definition: L1TkFastVertexProducer.cc:79
l1t::TkPrimaryVertexCollection
std::vector< TkPrimaryVertex > TkPrimaryVertexCollection
Definition: TkPrimaryVertex.h:28
PVValHelper::eta
Definition: PVValidationHelpers.h:69
L1TkFastVertexProducer::nStubsmin_
int nStubsmin_
Definition: L1TkFastVertexProducer.cc:76
TTStub
Class to store the L1 Track Trigger stubs.
Definition: TTStub.h:22
DDAxes::z
edm::ESHandle< TrackerTopology >
LaserClient_cfi.nbins
nbins
Definition: LaserClient_cfi.py:51
HLTMuonOfflineAnalyzer_cfi.z0
z0
Definition: HLTMuonOfflineAnalyzer_cfi.py:98
L1TkFastVertexProducer::highPtTracks_
int highPtTracks_
Definition: L1TkFastVertexProducer.cc:74
L1TkFastVertexProducer::pTMax_
float pTMax_
Definition: L1TkFastVertexProducer.cc:73
createfilelist.int
int
Definition: createfilelist.py:10
iEvent
int iEvent
Definition: GenABIO.cc:224
edm::ParameterSetDescription::setUnknown
void setUnknown()
Definition: ParameterSetDescription.cc:39
edm::HepMCProduct::GetEvent
const HepMC::GenEvent * GetEvent() const
Definition: HepMCProduct.h:34
get
#define get
L1TkFastVertexProducer::zMax_
float zMax_
Definition: L1TkFastVertexProducer.cc:68
l1t::TkPrimaryVertex
Definition: TkPrimaryVertex.h:12
L1TkFastVertexProducer::genparticleToken
const edm::EDGetTokenT< std::vector< reco::GenParticle > > genparticleToken
Definition: L1TkFastVertexProducer.cc:93
edm::ParameterSet::getParameter
T getParameter(std::string const &) const
TrackerTopology::tobLayer
unsigned int tobLayer(const DetId &id) const
Definition: TrackerTopology.h:147
eostools.move
def move(src, dest)
Definition: eostools.py:511
TrackerOfflineValidation_Dqm_cff.xmax
xmax
Definition: TrackerOfflineValidation_Dqm_cff.py:11
Exception
Definition: hltDiff.cc:246
StripSubdetector::TOB
static constexpr auto TOB
Definition: StripSubdetector.h:18
L1TkFastVertexProducer::chi2Max_
float chi2Max_
Definition: L1TkFastVertexProducer.cc:70
L1TkFastVertexProducer::doPtComp_
bool doPtComp_
Definition: L1TkFastVertexProducer.cc:84
funct::pow
Power< A, B >::type pow(const A &a, const B &b)
Definition: Power.h:30
mps_fire.result
result
Definition: mps_fire.py:303
funct::abs
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
LogTrace
#define LogTrace(id)
Definition: MessageLogger.h:671
TrackerTopologyRcd
Definition: TrackerTopologyRcd.h:10
edm::EDConsumerBase::consumes
EDGetTokenT< ProductType > consumes(edm::InputTag const &tag)
Definition: EDConsumerBase.h:126
TrackerOfflineValidation_Dqm_cff.xmin
xmin
Definition: TrackerOfflineValidation_Dqm_cff.py:10
parents
TPRegexp parents
Definition: eve_filter.cc:21
edm::HandleBase::isValid
bool isValid() const
Definition: HandleBase.h:70
edm::ConfigurationDescriptions::addDefault
void addDefault(ParameterSetDescription const &psetDescription)
Definition: ConfigurationDescriptions.cc:99
a0
static constexpr float a0
Definition: L1EGammaCrystalsEmulatorProducer.cc:81
edm::InputTag
Definition: InputTag.h:15
StripSubdetector::TID
static constexpr auto TID
Definition: StripSubdetector.h:17