CMS 3D CMS Logo

List of all members | Public Types | Public Member Functions | Static Public Member Functions | Private Member Functions | Private Attributes
IPProducer< Container, Base, Helper > Class Template Reference

#include <IPProducer.h>

Inheritance diagram for IPProducer< Container, Base, Helper >:
edm::stream::EDProducer<>

Public Types

typedef std::vector< reco::IPTagInfo< Container, Base > > Product
 
- 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 Member Functions

template<>
void fillDescriptions (edm::ConfigurationDescriptions &descriptions)
 
template<>
void fillDescriptions (edm::ConfigurationDescriptions &descriptions)
 
 IPProducer (const edm::ParameterSet &)
 
void produce (edm::Event &, const edm::EventSetup &) override
 
 ~IPProducer () override
 
- Public Member Functions inherited from edm::stream::EDProducer<>
 EDProducer ()=default
 
bool hasAbilityToProduceInBeginLumis () const final
 
bool hasAbilityToProduceInBeginRuns () const final
 
bool hasAbilityToProduceInEndLumis () const final
 
bool hasAbilityToProduceInEndRuns () const final
 

Static Public Member Functions

static void fillDescriptions (edm::ConfigurationDescriptions &descriptions)
 

Private Member Functions

void checkEventSetup (const edm::EventSetup &iSetup)
 

Private Attributes

unsigned long long m_calibrationCacheId2D
 
unsigned long long m_calibrationCacheId3D
 
bool m_computeGhostTrack
 
bool m_computeProbabilities
 
const edm::ParameterSetm_config
 
double m_cutMaxChiSquared
 
double m_cutMaxLIP
 
double m_cutMaxTIP
 
double m_cutMinPt
 
int m_cutPixelHits
 
int m_cutTotalHits
 
bool m_directionWithGhostTrack
 
bool m_directionWithTracks
 
double m_ghostTrackPriorDeltaR
 
Helper m_helper
 
std::unique_ptr< HistogramProbabilityEstimatorm_probabilityEstimator
 
bool m_useDB
 
bool m_useTrackQuality
 
edm::EDGetTokenT< reco::VertexCollectiontoken_primaryVertex
 

Detailed Description

template<class Container, class Base, class Helper>
class IPProducer< Container, Base, Helper >

Description: <one line="" class="" summary>="">

Implementation: <Notes on="" implementation>="">

Definition at line 129 of file IPProducer.h.

Member Typedef Documentation

template<class Container , class Base , class Helper >
typedef std::vector<reco::IPTagInfo<Container, Base> > IPProducer< Container, Base, Helper >::Product

Definition at line 131 of file IPProducer.h.

Constructor & Destructor Documentation

template<class Container , class Base , class Helper >
IPProducer< Container, Base, Helper >::IPProducer ( const edm::ParameterSet iConfig)
explicit

Definition at line 187 of file IPProducer.h.

References edm::ParameterSet::getParameter(), IPProducer< Container, Base, Helper >::m_calibrationCacheId2D, IPProducer< Container, Base, Helper >::m_calibrationCacheId3D, IPProducer< Container, Base, Helper >::m_computeGhostTrack, IPProducer< Container, Base, Helper >::m_computeProbabilities, IPProducer< Container, Base, Helper >::m_config, IPProducer< Container, Base, Helper >::m_cutMaxChiSquared, IPProducer< Container, Base, Helper >::m_cutMaxLIP, IPProducer< Container, Base, Helper >::m_cutMaxTIP, IPProducer< Container, Base, Helper >::m_cutMinPt, IPProducer< Container, Base, Helper >::m_cutPixelHits, IPProducer< Container, Base, Helper >::m_cutTotalHits, IPProducer< Container, Base, Helper >::m_directionWithGhostTrack, IPProducer< Container, Base, Helper >::m_directionWithTracks, IPProducer< Container, Base, Helper >::m_ghostTrackPriorDeltaR, IPProducer< Container, Base, Helper >::m_useTrackQuality, and IPProducer< Container, Base, Helper >::token_primaryVertex.

188  : m_config(iConfig), m_helper(iConfig, consumesCollector()) {
191 
192  token_primaryVertex = consumes<reco::VertexCollection>(m_config.getParameter<edm::InputTag>("primaryVertex"));
193 
194  m_computeProbabilities = m_config.getParameter<bool>("computeProbabilities");
195  m_computeGhostTrack = m_config.getParameter<bool>("computeGhostTrack");
196  m_ghostTrackPriorDeltaR = m_config.getParameter<double>("ghostTrackPriorDeltaR");
197  m_cutPixelHits = m_config.getParameter<int>("minimumNumberOfPixelHits");
198  m_cutTotalHits = m_config.getParameter<int>("minimumNumberOfHits");
199  m_cutMaxTIP = m_config.getParameter<double>("maximumTransverseImpactParameter");
200  m_cutMinPt = m_config.getParameter<double>("minimumTransverseMomentum");
201  m_cutMaxChiSquared = m_config.getParameter<double>("maximumChiSquared");
202  m_cutMaxLIP = m_config.getParameter<double>("maximumLongitudinalImpactParameter");
203  m_directionWithTracks = m_config.getParameter<bool>("jetDirectionUsingTracks");
204  m_directionWithGhostTrack = m_config.getParameter<bool>("jetDirectionUsingGhostTrack");
205  m_useTrackQuality = m_config.getParameter<bool>("useTrackQuality");
206 
207  if (m_computeGhostTrack)
208  produces<reco::TrackCollection>("ghostTracks");
209  produces<Product>();
210 }
T getParameter(std::string const &) const
double m_cutMaxChiSquared
Definition: IPProducer.h:157
bool m_directionWithGhostTrack
Definition: IPProducer.h:160
unsigned long long m_calibrationCacheId3D
Definition: IPProducer.h:150
double m_cutMaxTIP
Definition: IPProducer.h:155
unsigned long long m_calibrationCacheId2D
Definition: IPProducer.h:149
double m_cutMinPt
Definition: IPProducer.h:156
bool m_useTrackQuality
Definition: IPProducer.h:161
int m_cutTotalHits
Definition: IPProducer.h:154
double m_ghostTrackPriorDeltaR
Definition: IPProducer.h:147
int m_cutPixelHits
Definition: IPProducer.h:153
Helper m_helper
Definition: IPProducer.h:162
edm::EDGetTokenT< reco::VertexCollection > token_primaryVertex
Definition: IPProducer.h:143
bool m_directionWithTracks
Definition: IPProducer.h:159
const edm::ParameterSet & m_config
Definition: IPProducer.h:142
bool m_computeProbabilities
Definition: IPProducer.h:145
bool m_computeGhostTrack
Definition: IPProducer.h:146
double m_cutMaxLIP
Definition: IPProducer.h:158
template<class Container , class Base , class Helper >
IPProducer< Container, Base, Helper >::~IPProducer ( )
override

Definition at line 213 of file IPProducer.h.

213 {}

Member Function Documentation

template<class Container , class Base , class Helper >
void IPProducer< Container, Base, Helper >::checkEventSetup ( const edm::EventSetup iSetup)
private

Definition at line 415 of file IPProducer.h.

References edm::eventsetup::EventSetupRecord::cacheIdentifier(), edm::EventSetup::get(), IPProducer< Container, Base, Helper >::m_calibrationCacheId2D, IPProducer< Container, Base, Helper >::m_calibrationCacheId3D, IPProducer< Container, Base, Helper >::m_probabilityEstimator, and edm::ESHandle< T >::product().

Referenced by IPProducer< Container, Base, Helper >::produce().

415  {
418  unsigned long long cacheId2D = re2D.cacheIdentifier();
419  unsigned long long cacheId3D = re3D.cacheIdentifier();
420 
421  if (cacheId2D != m_calibrationCacheId2D || cacheId3D != m_calibrationCacheId3D) //Calibration changed
422  {
423  //iSetup.get<BTagTrackProbabilityRcd>().get(calib);
425  iSetup.get<BTagTrackProbability2DRcd>().get(calib2DHandle);
427  iSetup.get<BTagTrackProbability3DRcd>().get(calib3DHandle);
428 
429  const TrackProbabilityCalibration* ca2D = calib2DHandle.product();
430  const TrackProbabilityCalibration* ca3D = calib3DHandle.product();
431 
433  }
434  m_calibrationCacheId3D = cacheId3D;
435  m_calibrationCacheId2D = cacheId2D;
436 }
unsigned long long cacheIdentifier() const
unsigned long long m_calibrationCacheId3D
Definition: IPProducer.h:150
unsigned long long m_calibrationCacheId2D
Definition: IPProducer.h:149
std::unique_ptr< HistogramProbabilityEstimator > m_probabilityEstimator
Definition: IPProducer.h:148
T get() const
Definition: EventSetup.h:73
T const * product() const
Definition: ESHandle.h:86
template<class Container , class Base , class Helper >
static void IPProducer< Container, Base, Helper >::fillDescriptions ( edm::ConfigurationDescriptions descriptions)
static

Definition at line 441 of file IPProducer.h.

References edm::ParameterSetDescription::add(), edm::ConfigurationDescriptions::addDefault(), and HLT_2018_cff::InputTag.

442  {
444  desc.add<double>("maximumTransverseImpactParameter", 0.2);
445  desc.add<int>("minimumNumberOfHits", 8);
446  desc.add<double>("minimumTransverseMomentum", 1.0);
447  desc.add<edm::InputTag>("primaryVertex", edm::InputTag("offlinePrimaryVertices"));
448  desc.add<double>("maximumLongitudinalImpactParameter", 17.0);
449  desc.add<bool>("computeGhostTrack", true);
450  desc.add<double>("ghostTrackPriorDeltaR", 0.03);
451  desc.add<edm::InputTag>("jetTracks", edm::InputTag("ak4JetTracksAssociatorAtVertexPF"));
452  desc.add<bool>("jetDirectionUsingGhostTrack", false);
453  desc.add<int>("minimumNumberOfPixelHits", 2);
454  desc.add<bool>("jetDirectionUsingTracks", false);
455  desc.add<bool>("computeProbabilities", true);
456  desc.add<bool>("useTrackQuality", false);
457  desc.add<double>("maximumChiSquared", 5.0);
458  descriptions.addDefault(desc);
459 }
void addDefault(ParameterSetDescription const &psetDescription)
ParameterDescriptionBase * add(U const &iLabel, T const &value)
template<>
void IPProducer< std::vector< reco::CandidatePtr >, reco::JetTagInfo, IPProducerHelpers::FromJetAndCands >::fillDescriptions ( edm::ConfigurationDescriptions descriptions)

Definition at line 462 of file IPProducer.h.

References edm::ParameterSetDescription::add(), edm::ConfigurationDescriptions::addDefault(), edm::ParameterSetDescription::addOptional(), and HLT_2018_cff::InputTag.

463  {
465  desc.add<double>("maximumTransverseImpactParameter", 0.2);
466  desc.add<int>("minimumNumberOfHits", 8);
467  desc.add<double>("minimumTransverseMomentum", 1.0);
468  desc.add<edm::InputTag>("primaryVertex", edm::InputTag("offlinePrimaryVertices"));
469  desc.add<double>("maximumLongitudinalImpactParameter", 17.0);
470  desc.add<bool>("computeGhostTrack", true);
471  desc.add<double>("maxDeltaR", 0.4);
472  desc.add<edm::InputTag>("candidates", edm::InputTag("particleFlow"));
473  desc.add<bool>("jetDirectionUsingGhostTrack", false);
474  desc.add<int>("minimumNumberOfPixelHits", 2);
475  desc.add<bool>("jetDirectionUsingTracks", false);
476  desc.add<bool>("computeProbabilities", true);
477  desc.add<bool>("useTrackQuality", false);
478  desc.add<edm::InputTag>("jets", edm::InputTag("ak4PFJetsCHS"));
479  desc.add<double>("ghostTrackPriorDeltaR", 0.03);
480  desc.add<double>("maximumChiSquared", 5.0);
481  desc.addOptional<bool>("explicitJTA", false);
482  descriptions.addDefault(desc);
483 }
void addDefault(ParameterSetDescription const &psetDescription)
ParameterDescriptionBase * add(U const &iLabel, T const &value)
template<class Container , class Base , class Helper >
void IPProducer< Container, Base, Helper >::produce ( edm::Event iEvent,
const edm::EventSetup iSetup 
)
override

Definition at line 220 of file IPProducer.h.

References funct::abs(), TransientTrackBuilder::build(), IPProducer< Container, Base, Helper >::checkEventSetup(), IPTools::closestApproachToJet(), reco::btag::TrackIPData::closestToGhostTrack, reco::btag::TrackIPData::closestToJetAxis, RecoVertex::convertError(), RecoVertex::convertPos(), reco::GhostTrackPrediction::direction(), VertexDistance3D::distance(), reco::btag::TrackIPData::distanceToGhostTrack, reco::btag::TrackIPData::distanceToJetAxis, reco::TrackBase::dxy(), reco::TrackBase::dz(), MillePedeFileConverter_cfg::e, StorageManager_cfg::e1, relativeConstraints::error, reco::Vertex::error(), reco::TransientTrack::field(), reco::GhostTrackFitter::fit(), edm::EventSetup::get(), edm::Event::getByToken(), edm::Event::getRefBeforePut(), reco::btag::TrackIPData::ghostTrackWeight, TrajectoryStateOnSurface::globalPosition(), reco::TrackBase::hitPattern(), reco::TransientTrack::impactPointState(), reco::btag::TrackIPData::ip2d, reco::btag::TrackIPData::ip3d, TrajectoryStateOnSurface::isValid(), IPTools::jetTrackDistance(), reco::GhostTrackPrediction::lambda(), IPProducer< Container, Base, Helper >::m_computeGhostTrack, IPProducer< Container, Base, Helper >::m_computeProbabilities, IPProducer< Container, Base, Helper >::m_cutMaxChiSquared, IPProducer< Container, Base, Helper >::m_cutMaxLIP, IPProducer< Container, Base, Helper >::m_cutMaxTIP, IPProducer< Container, Base, Helper >::m_cutMinPt, IPProducer< Container, Base, Helper >::m_cutPixelHits, IPProducer< Container, Base, Helper >::m_cutTotalHits, IPProducer< Container, Base, Helper >::m_directionWithGhostTrack, IPProducer< Container, Base, Helper >::m_directionWithTracks, IPProducer< Container, Base, Helper >::m_ghostTrackPriorDeltaR, IPProducer< Container, Base, Helper >::m_helper, IPProducer< Container, Base, Helper >::m_probabilityEstimator, IPProducer< Container, Base, Helper >::m_useTrackQuality, eostools::move(), reco::TrackBase::normalizedChi2(), reco::HitPattern::numberOfValidHits(), reco::TrackBase::numberOfValidHits(), reco::HitPattern::numberOfValidPixelHits(), AlCaHLTBitMon_ParallelJobs::p, p1, p2, reco::GhostTrackPrediction::position(), reco::Vertex::position(), reco::GhostTrackPrediction::positionError(), reco::GhostTrackPrediction::prediction(), BeamMonitor_cff::primaryVertex, reco::TrackBase::pt(), edm::Event::put(), MetAnalyzer::pv(), mps_fire::result, TrackCollections2monitor_cff::selectedTracks, IPTools::signedImpactParameter3D(), IPTools::signedTransverseImpactParameter(), IPProducer< Container, Base, Helper >::token_primaryVertex, reco::btag::toTrack(), reco::GhostTrackState::track(), reco::TransientTrack::track(), HLT_2018_cff::track, PDWG_EXOHSCP_cff::tracks, and HltBtagValidation_cff::Vertex.

220  {
221  // Update probability estimator if event setup is changed
223  checkEventSetup(iSetup);
224 
226  iEvent.getByToken(token_primaryVertex, primaryVertex);
227 
229  iSetup.get<TransientTrackRecord>().get("TransientTrackBuilder", builder);
230  // m_algo.setTransientTrackBuilder(builder.product());
231 
232  // output collections
233  auto result = std::make_unique<Product>();
234 
235  std::unique_ptr<reco::TrackCollection> ghostTracks;
236  reco::TrackRefProd ghostTrackRefProd;
237  if (m_computeGhostTrack) {
238  ghostTracks = std::make_unique<reco::TrackCollection>();
239  ghostTrackRefProd = iEvent.getRefBeforePut<reco::TrackCollection>("ghostTracks");
240  }
241 
242  // use first pv of the collection
244  const reco::Vertex* pv = &dummy;
246  if (!primaryVertex->empty()) {
247  pv = &*primaryVertex->begin();
248  // we always use the first vertex (at the moment)
250  } else { // create a dummy PV
252  e(0, 0) = 0.0015 * 0.0015;
253  e(1, 1) = 0.0015 * 0.0015;
254  e(2, 2) = 15. * 15.;
255  reco::Vertex::Point p(0, 0, 0);
256  dummy = reco::Vertex(p, e, 0, 0, 0);
257  }
258 
259  std::vector<Base> baseTagInfos = m_helper.makeBaseVector(iEvent);
260  for (typename std::vector<Base>::const_iterator it = baseTagInfos.begin(); it != baseTagInfos.end(); it++) {
261  Container tracks = m_helper.tracks(*it);
262  math::XYZVector jetMomentum = it->jet()->momentum();
263 
264  if (m_directionWithTracks) {
265  jetMomentum *= 0.5;
266  for (typename Container::const_iterator itTrack = tracks.begin(); itTrack != tracks.end(); ++itTrack)
267  if (reco::btag::toTrack(*itTrack)->numberOfValidHits() >= m_cutTotalHits) //minimal quality cuts
268  jetMomentum += (*itTrack)->momentum();
269  }
270 
272  std::vector<reco::TransientTrack> transientTracks;
273 
274  for (typename Container::const_iterator itTrack = tracks.begin(); itTrack != tracks.end(); ++itTrack) {
275  reco::TransientTrack transientTrack = builder->build(*itTrack);
276  const reco::Track& track = transientTrack.track(); //**itTrack;
277  /* cout << " pt " << track.pt() <<
278  " d0 " << fabs(track.d0()) <<
279  " #hit " << track.hitPattern().numberOfValidHits()<<
280  " ipZ " << fabs(track.dz()-pv->z())<<
281  " chi2 " << track.normalizedChi2()<<
282  " #pixel " << track.hitPattern().numberOfValidPixelHits()<< endl;
283 */
284  if (track.pt() > m_cutMinPt &&
285  track.hitPattern().numberOfValidHits() >= m_cutTotalHits && // min num tracker hits
287  track.normalizedChi2() < m_cutMaxChiSquared && std::abs(track.dxy(pv->position())) < m_cutMaxTIP &&
288  std::abs(track.dz(pv->position())) < m_cutMaxLIP) {
289  // std::cout << "selected" << std::endl;
290  selectedTracks.push_back(*itTrack);
291  transientTracks.push_back(transientTrack);
292  }
293  }
294  // std::cout <<"SIZE: " << transientTracks.size() << std::endl;
295  GlobalVector direction(jetMomentum.x(), jetMomentum.y(), jetMomentum.z());
296 
297  std::unique_ptr<reco::GhostTrack> ghostTrack;
298  reco::TrackRef ghostTrackRef;
299  if (m_computeGhostTrack) {
300  reco::GhostTrackFitter fitter;
303  ghostTrack.reset(
304  new reco::GhostTrack(fitter.fit(origin, error, direction, m_ghostTrackPriorDeltaR, transientTracks)));
305 
306  /*
307  if (std::sqrt(jetMomentum.Perp2()) > 30) {
308  double offset = ghostTrack->prediction().lambda(origin);
309  std::cout << "------------------ jet pt " << std::sqrt(jetMomentum.Perp2()) << std::endl;
310  const std::vector<GhostTrackState> *states = &ghostTrack->states();
311  for(std::vector<GhostTrackState>::const_iterator state = states->begin();
312  state != states->end(); ++state) {
313  double dist = state->lambda() - offset;
314  double err = state->lambdaError(ghostTrack->prediction(), error);
315  double ipSig = IPTools::signedImpactParameter3D(state->track(), direction, *pv).second.significance();
316  double axisDist = state->axisDistance(ghostTrack->prediction());
317  std::cout << state->track().impactPointState().freeState()->momentum().perp()
318  << ": " << dist << "/" << err << " [" << (dist / err) << "], ipsig = " << ipSig << ", dist = " << axisDist << ", w = " << state->weight() << std::endl;
319  }
320  }
321 */
322  ghostTrackRef = reco::TrackRef(ghostTrackRefProd, ghostTracks->size());
323  ghostTracks->push_back(*ghostTrack);
324 
326  const reco::GhostTrackPrediction& pred = ghostTrack->prediction();
327  double lambda = pred.lambda(origin);
328  dummy = reco::Vertex(RecoVertex::convertPos(pred.position(lambda)),
330  0,
331  0,
332  0);
333  pv = &dummy;
334  direction = pred.direction();
335  }
336  }
337 
338  std::vector<float> prob2D, prob3D;
339  std::vector<reco::btag::TrackIPData> ipData;
340 
341  for (unsigned int ind = 0; ind < transientTracks.size(); ind++) {
342  const reco::TransientTrack& transientTrack = transientTracks[ind];
343  const reco::Track& track = transientTrack.track();
344 
345  reco::btag::TrackIPData trackIP;
346  trackIP.ip3d = IPTools::signedImpactParameter3D(transientTrack, direction, *pv).second;
347  trackIP.ip2d = IPTools::signedTransverseImpactParameter(transientTrack, direction, *pv).second;
348 
349  TrajectoryStateOnSurface closest =
350  IPTools::closestApproachToJet(transientTrack.impactPointState(), *pv, direction, transientTrack.field());
351  if (closest.isValid())
352  trackIP.closestToJetAxis = closest.globalPosition();
353 
354  // TODO: cross check if it is the same using other methods
355  trackIP.distanceToJetAxis = IPTools::jetTrackDistance(transientTrack, direction, *pv).second;
356 
357  if (ghostTrack.get()) {
358  const std::vector<reco::GhostTrackState>& states = ghostTrack->states();
359  std::vector<reco::GhostTrackState>::const_iterator pos = std::find_if(
360  states.begin(),
361  states.end(),
362  bind(std::equal_to<reco::TransientTrack>(), bind(&reco::GhostTrackState::track, _1), transientTrack));
363 
364  if (pos != states.end() && pos->isValid()) {
365  VertexDistance3D dist;
366  const reco::GhostTrackPrediction& pred = ghostTrack->prediction();
367  GlobalPoint p1 = pos->tsos().globalPosition();
368  GlobalError e1 = pos->tsos().cartesianError().position();
369  GlobalPoint p2 = pred.position(pos->lambda());
370  GlobalError e2 = pred.positionError(pos->lambda());
371  trackIP.closestToGhostTrack = p1;
372  trackIP.distanceToGhostTrack = dist.distance(VertexState(p1, e1), VertexState(p2, e2));
373  trackIP.ghostTrackWeight = pos->weight();
374  } else {
375  trackIP.distanceToGhostTrack = Measurement1D(0., -1.);
376  trackIP.ghostTrackWeight = 0.;
377  }
378  } else {
379  trackIP.distanceToGhostTrack = Measurement1D(0., -1.);
380  trackIP.ghostTrackWeight = 1.;
381  }
382 
383  ipData.push_back(trackIP);
384 
386  //probability with 3D ip
387  std::pair<bool, double> probability = m_probabilityEstimator->probability(
388  m_useTrackQuality, 0, ipData.back().ip3d.significance(), track, *(it->jet()), *pv);
389  prob3D.push_back(probability.first ? probability.second : -1.);
390 
391  //probability with 2D ip
392  probability = m_probabilityEstimator->probability(
393  m_useTrackQuality, 1, ipData.back().ip2d.significance(), track, *(it->jet()), *pv);
394  prob2D.push_back(probability.first ? probability.second : -1.);
395  }
396  }
397 
398  result->push_back(
399  typename Product::value_type(ipData, prob2D, prob3D, selectedTracks, *it, pvRef, direction, ghostTrackRef));
400  }
401 
403  iEvent.put(std::move(ghostTracks), "ghostTracks");
404  iEvent.put(std::move(result));
405 }
reco::Vertex::Point convertPos(const GlobalPoint &p)
double m_cutMaxChiSquared
Definition: IPProducer.h:157
OrphanHandle< PROD > put(std::unique_ptr< PROD > product)
Put a new product.
Definition: Event.h:131
bool m_directionWithGhostTrack
Definition: IPProducer.h:160
double lambda(const GlobalPoint &point) const
double normalizedChi2() const
chi-squared divided by n.d.o.f. (or chi-squared * 1e6 if n.d.o.f. is zero)
Definition: TrackBase.h:572
const TransientTrack & track() const
bool getByToken(EDGetToken token, Handle< PROD > &result) const
Definition: Event.h:525
int numberOfValidHits() const
Definition: HitPattern.h:787
Measurement1D ip2d
Definition: IPTagInfo.h:31
double m_cutMaxTIP
Definition: IPProducer.h:155
std::pair< bool, Measurement1D > signedTransverseImpactParameter(const reco::TransientTrack &track, const GlobalVector &direction, const reco::Vertex &vertex)
Definition: IPTools.cc:57
reco::Vertex::Error convertError(const GlobalError &ge)
Definition: ConvertError.h:8
std::vector< Track > TrackCollection
collection of Tracks
Definition: TrackFwd.h:14
reco::TransientTrack build(const reco::Track *p) const
double m_cutMinPt
Definition: IPProducer.h:156
math::Error< dimension >::type Error
covariance error matrix (3x3)
Definition: Vertex.h:43
std::pair< bool, Measurement1D > signedImpactParameter3D(const reco::TransientTrack &track, const GlobalVector &direction, const reco::Vertex &vertex)
Definition: IPTools.cc:81
GlobalPoint globalPosition() const
bool m_useTrackQuality
Definition: IPProducer.h:161
TrajectoryStateOnSurface closestApproachToJet(const TrajectoryStateOnSurface &state, const reco::Vertex &vertex, const GlobalVector &aJetDirection, const MagneticField *field)
Definition: IPTools.cc:182
const MagneticField * field() const
const reco::Track * toTrack(const reco::TrackBaseRef &t)
Definition: IPTagInfo.h:24
const Point & position() const
position
Definition: Vertex.h:113
int m_cutTotalHits
Definition: IPProducer.h:154
std::pair< double, Measurement1D > jetTrackDistance(const reco::TransientTrack &track, const GlobalVector &direction, const reco::Vertex &vertex)
Definition: IPTools.cc:206
double m_ghostTrackPriorDeltaR
Definition: IPProducer.h:147
GhostTrack fit(const GlobalPoint &priorPosition, const GlobalError &priorError, const GlobalVector &direction, double coneRadius, const std::vector< TransientTrack > &tracks) const
void checkEventSetup(const edm::EventSetup &iSetup)
Definition: IPProducer.h:415
std::unique_ptr< HistogramProbabilityEstimator > m_probabilityEstimator
Definition: IPProducer.h:148
Measurement1D distance(const GlobalPoint &vtx1Position, const GlobalError &vtx1PositionError, const GlobalPoint &vtx2Position, const GlobalError &vtx2PositionError) const override
Measurement1D distanceToGhostTrack
Definition: IPTagInfo.h:34
int m_cutPixelHits
Definition: IPProducer.h:153
Helper m_helper
Definition: IPProducer.h:162
double pt() const
track transverse momentum
Definition: TrackBase.h:602
def pv(vc)
Definition: MetAnalyzer.py:7
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
edm::EDGetTokenT< reco::VertexCollection > token_primaryVertex
Definition: IPProducer.h:143
math::XYZPoint Point
point in the space
Definition: Vertex.h:39
unsigned short numberOfValidHits() const
number of valid hits found
Definition: TrackBase.h:740
Measurement1D ip3d
Definition: IPTagInfo.h:32
double p2[4]
Definition: TauolaWrapper.h:90
bool m_directionWithTracks
Definition: IPProducer.h:159
RefProd< PROD > getRefBeforePut()
Definition: Event.h:156
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:596
GlobalPoint closestToJetAxis
Definition: IPTagInfo.h:29
const Track & track() const
const HitPattern & hitPattern() const
Access the hit pattern, indicating in which Tracker layers the track has hits.
Definition: TrackBase.h:483
XYZVectorD XYZVector
spatial vector with cartesian internal representation
Definition: Vector3D.h:31
edm::Ref< TrackCollection > TrackRef
persistent reference to a Track
Definition: TrackFwd.h:20
Error error() const
return SMatrix
Definition: Vertex.h:149
Measurement1D distanceToJetAxis
Definition: IPTagInfo.h:33
const Vector & prediction() const
double p1[4]
Definition: TauolaWrapper.h:89
GlobalPoint position(double lambda=0.) const
T get() const
Definition: EventSetup.h:73
GlobalPoint closestToGhostTrack
Definition: IPTagInfo.h:30
int numberOfValidPixelHits() const
Definition: HitPattern.h:801
TrajectoryStateOnSurface impactPointState() const
bool m_computeProbabilities
Definition: IPProducer.h:145
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:587
primaryVertex
hltOfflineBeamSpot for HLTMON
bool m_computeGhostTrack
Definition: IPProducer.h:146
edm::AssociationVector< reco::JetRefBaseProd, Values > Container
double m_cutMaxLIP
Definition: IPProducer.h:158
def move(src, dest)
Definition: eostools.py:511
GlobalError positionError(double lambda=0.) const
const GlobalVector direction() const

Member Data Documentation

template<class Container , class Base , class Helper >
unsigned long long IPProducer< Container, Base, Helper >::m_calibrationCacheId2D
private
template<class Container , class Base , class Helper >
unsigned long long IPProducer< Container, Base, Helper >::m_calibrationCacheId3D
private
template<class Container , class Base , class Helper >
bool IPProducer< Container, Base, Helper >::m_computeGhostTrack
private
template<class Container , class Base , class Helper >
bool IPProducer< Container, Base, Helper >::m_computeProbabilities
private
template<class Container , class Base , class Helper >
const edm::ParameterSet& IPProducer< Container, Base, Helper >::m_config
private

Definition at line 142 of file IPProducer.h.

Referenced by IPProducer< Container, Base, Helper >::IPProducer().

template<class Container , class Base , class Helper >
double IPProducer< Container, Base, Helper >::m_cutMaxChiSquared
private
template<class Container , class Base , class Helper >
double IPProducer< Container, Base, Helper >::m_cutMaxLIP
private
template<class Container , class Base , class Helper >
double IPProducer< Container, Base, Helper >::m_cutMaxTIP
private
template<class Container , class Base , class Helper >
double IPProducer< Container, Base, Helper >::m_cutMinPt
private
template<class Container , class Base , class Helper >
int IPProducer< Container, Base, Helper >::m_cutPixelHits
private
template<class Container , class Base , class Helper >
int IPProducer< Container, Base, Helper >::m_cutTotalHits
private
template<class Container , class Base , class Helper >
bool IPProducer< Container, Base, Helper >::m_directionWithGhostTrack
private
template<class Container , class Base , class Helper >
bool IPProducer< Container, Base, Helper >::m_directionWithTracks
private
template<class Container , class Base , class Helper >
double IPProducer< Container, Base, Helper >::m_ghostTrackPriorDeltaR
private
template<class Container , class Base , class Helper >
Helper IPProducer< Container, Base, Helper >::m_helper
private

Definition at line 162 of file IPProducer.h.

Referenced by IPProducer< Container, Base, Helper >::produce().

template<class Container , class Base , class Helper >
std::unique_ptr<HistogramProbabilityEstimator> IPProducer< Container, Base, Helper >::m_probabilityEstimator
private
template<class Container , class Base , class Helper >
bool IPProducer< Container, Base, Helper >::m_useDB
private

Definition at line 151 of file IPProducer.h.

template<class Container , class Base , class Helper >
bool IPProducer< Container, Base, Helper >::m_useTrackQuality
private
template<class Container , class Base , class Helper >
edm::EDGetTokenT<reco::VertexCollection> IPProducer< Container, Base, Helper >::token_primaryVertex
private