CMS 3D CMS Logo

Classes | Functions
mkfit::StdSeq Namespace Reference

Classes

struct  Quality
 

Functions

int clean_cms_seedtracks_iter (TrackVec &seeds, const IterationConfig &itrcfg, const BeamSpot &bspot)
 
void clean_duplicates (TrackVec &tracks, const IterationConfig &itconf)
 
void clean_duplicates_sharedhits (TrackVec &tracks, const IterationConfig &itconf)
 
void clean_duplicates_sharedhits_pixelseed (TrackVec &tracks, const IterationConfig &itconf)
 
void cmssw_LoadHits_Begin (EventOfHits &eoh, const std::vector< const HitVec *> &orig_hitvectors)
 
void cmssw_LoadHits_End (EventOfHits &eoh)
 
void cmssw_Map_TrackHitIndices (const EventOfHits &eoh, TrackVec &seeds)
 
void cmssw_ReMap_TrackHitIndices (const EventOfHits &eoh, TrackVec &out_tracks)
 
void dump_simtracks (Event *event)
 
void handle_duplicates (Event *)
 
void loadDeads (EventOfHits &eoh, const std::vector< DeadVec > &deadvectors)
 
void loadHitsAndBeamSpot (Event &ev, EventOfHits &eoh)
 
void prep_cmsswtracks (Event *event)
 
void prep_recotracks (Event *event)
 
void prep_reftracks (Event *event, TrackVec &tracks, TrackExtraVec &extras, const bool realigntracks)
 
void prep_simtracks (Event *event)
 
void prep_tracks (Event *event, TrackVec &tracks, TrackExtraVec &extras, const bool realigntracks)
 
template<class TRACK >
bool qfilter_n_hits (const TRACK &t, const MkJob &j)
 
template<class TRACK >
bool qfilter_n_hits_pixseed (const TRACK &t, const MkJob &j)
 
template<class TRACK >
bool qfilter_n_layers (const TRACK &t, const MkJob &j)
 
template<class TRACK >
bool qfilter_nan_n_silly (const TRACK &t, const MkJob &)
 
template<class TRACK >
bool qfilter_pixelLessBkwd (const TRACK &t, const MkJob &j)
 quality filter tuned for pixelLess iteration during backward search More...
 
template<class TRACK >
bool qfilter_pixelLessFwd (const TRACK &t, const MkJob &j)
 quality filter tuned for pixelLess iteration during forward search More...
 
void remove_duplicates (TrackVec &tracks)
 
void root_val (Event *event)
 
void root_val_dumb_cmssw (Event *event)
 
void score_tracks (TrackVec &tracks)
 
void track_print (Event *event, const Track &t, const char *pref)
 
float trackScoreDefault (const int nfoundhits, const int ntailholes, const int noverlaphits, const int nmisshits, const float chi2, const float pt, const bool inFindCandidates)
 

Function Documentation

◆ clean_cms_seedtracks_iter()

int mkfit::StdSeq::clean_cms_seedtracks_iter ( TrackVec seeds,
const IterationConfig itrcfg,
const BeamSpot bspot 
)

Definition at line 85 of file MkStdSeqs.cc.

References funct::abs(), mkfit::Track::addHitIdx(), ntupleEnum::Algo, mkfit::binnor< C, A1, A2, NB_first, NB_count >::begin_registration(), mkfit::Config::c_dpt_common, mkfit::Config::c_etamax_brl, mkfit::cdist(), ALCARECOTkAlJpsiMuMu_cff::charge, mkfit::TrackBase::charge(), gather_cfg::cout, d0, mkfit::TrackBase::d0BeamSpot(), PVValHelper::eta, HLT_2024v14_cff::eta1, HLT_2024v14_cff::eta2, f, mkfit::binnor< C, A1, A2, NB_first, NB_count >::finalize_registration(), mkfit::axis_base< R, I, M, N >::from_R_rdr_to_N_bins(), mkfit::axis_pow2_u1< R, I, M, N >::from_R_rdr_to_N_bins(), mkfit::binnor< C, A1, A2, NB_first, NB_count >::get_content(), mkfit::Track::getHitIdx(), mkfit::Track::getHitLyr(), mps_fire::i, testProducerWithPsetDescEmpty_cfi::i1, testProducerWithPsetDescEmpty_cfi::i2, mkfit::TrackBase::invpT(), ALPAKA_ACCELERATOR_NAMESPACE::vertexFinder::it, dqmiolumiharvest::j, mkfit::TrackBase::Status::kMaxSeedHits, LowPtQuadStep_cff::lowPtQuadStep, mkfit::binnor< C, A1, A2, NB_first, NB_count >::m_ranks, mkfit::IterationConfig::m_track_algorithm, mkfit::TrackBase::momEta(), mkfit::TrackBase::momPhi(), mkfit::axis_base< R, I, M, N >::next_N_bin(), mkfit::axis_pow2_u1< R, I, M, N >::next_N_bin(), mkfit::Track::nFoundHits(), nHits, mkfit::Track::nTotalHits(), mkfit::Const::PI, funct::pow(), DiDispStaMuonMonitor_cfi::pt, mkfit::TrackBase::pT(), HLT_2024v14_cff::pt1, HLT_2024v14_cff::pt2, mkfit::binnor< C, A1, A2, NB_first, NB_count >::register_entry_safe(), mkfit::IterationConfig::sc_drmax_bh, mkfit::IterationConfig::sc_drmax_bl, mkfit::IterationConfig::sc_drmax_eh, mkfit::IterationConfig::sc_drmax_el, mkfit::IterationConfig::sc_dzmax_bh, mkfit::IterationConfig::sc_dzmax_bl, mkfit::IterationConfig::sc_dzmax_eh, mkfit::IterationConfig::sc_dzmax_el, mkfit::IterationConfig::sc_ptthr_hpt, HLT_2024v14_cff::seeds, mkfit::Track::sortHitsByLayer(), mathSSE::sqrt(), contentValuesCheck::ss, funct::tan(), mkfit::TrackBase::theta(), mkfit::Config::track1GeVradius, tier0::unique(), mkfit::BeamSpot::x, x, mkfit::TrackBase::x(), mkfit::BeamSpot::y, mkfit::TrackBase::y(), and mkfit::TrackBase::z().

85  {
87 
88  const float etamax_brl = Config::c_etamax_brl;
89  const float dpt_common = Config::c_dpt_common;
90 
91  const float dzmax_bh = itrcfg.sc_dzmax_bh;
92  const float drmax_bh = itrcfg.sc_drmax_bh;
93  const float dzmax_eh = itrcfg.sc_dzmax_eh;
94  const float drmax_eh = itrcfg.sc_drmax_eh;
95  const float dzmax_bl = itrcfg.sc_dzmax_bl;
96  const float drmax_bl = itrcfg.sc_drmax_bl;
97  const float dzmax_el = itrcfg.sc_dzmax_el;
98  const float drmax_el = itrcfg.sc_drmax_el;
99 
100  const float ptmin_hpt = itrcfg.sc_ptthr_hpt;
101 
102  const float dzmax2_inv_bh = 1.f / (dzmax_bh * dzmax_bh);
103  const float drmax2_inv_bh = 1.f / (drmax_bh * drmax_bh);
104  const float dzmax2_inv_eh = 1.f / (dzmax_eh * dzmax_eh);
105  const float drmax2_inv_eh = 1.f / (drmax_eh * drmax_eh);
106  const float dzmax2_inv_bl = 1.f / (dzmax_bl * dzmax_bl);
107  const float drmax2_inv_bl = 1.f / (drmax_bl * drmax_bl);
108  const float dzmax2_inv_el = 1.f / (dzmax_el * dzmax_el);
109  const float drmax2_inv_el = 1.f / (drmax_el * drmax_el);
110 
111  // Merge hits from overlapping seeds?
112  // For now always true, we require extra hits after seed,
113  // except for lowPtQuadStep, where we only merge hits for seeds at low pT and large pseudo-rapidity
114  const bool merge_hits = true; // itrcfg.merge_seed_hits_during_cleaning();
115  const float ptmax_merge_lowPtQuad = 0.2;
116  const float etamin_merge_lowPtQuad = 1.5;
117 
118  if (seeds.empty())
119  return 0;
120 
121  const int ns = seeds.size();
122 #ifdef DEBUG
123  std::cout << "before seed cleaning " << seeds.size() << std::endl;
124 #endif
125  TrackVec cleanSeedTracks;
126  cleanSeedTracks.reserve(ns);
127  std::vector<bool> writetrack(ns, true);
128 
129  const float invR1GeV = 1.f / Config::track1GeVradius;
130 
131  std::vector<int> nHits(ns);
132  std::vector<int> charge(ns);
133  std::vector<float> oldPhi(ns);
134  std::vector<float> pos2(ns);
135  std::vector<float> eta(ns);
136  std::vector<float> ctheta(ns);
137  std::vector<float> invptq(ns);
138  std::vector<float> pt(ns);
139  std::vector<float> x(ns);
140  std::vector<float> y(ns);
141  std::vector<float> z(ns);
142  std::vector<float> d0(ns);
143  int i1, i2; //for the sorting
144 
145  axis_pow2_u1<float, unsigned short, 16, 8> ax_phi(-Const::PI, Const::PI);
146  axis<float, unsigned short, 8, 8> ax_eta(-3.0, 3.0, 30u);
147  binnor<unsigned int, decltype(ax_phi), decltype(ax_eta), 24, 8> phi_eta_binnor(ax_phi, ax_eta);
148 
149  phi_eta_binnor.begin_registration(ns);
150 
151  for (int ts = 0; ts < ns; ts++) {
152  const Track &tk = seeds[ts];
153  nHits[ts] = tk.nFoundHits();
154  charge[ts] = tk.charge();
155  oldPhi[ts] = tk.momPhi();
156  pos2[ts] = std::pow(tk.x(), 2) + std::pow(tk.y(), 2);
157  eta[ts] = tk.momEta();
158  ctheta[ts] = 1.f / std::tan(tk.theta());
159  invptq[ts] = tk.charge() * tk.invpT();
160  pt[ts] = tk.pT();
161  x[ts] = tk.x();
162  y[ts] = tk.y();
163  z[ts] = tk.z();
164  d0[ts] = tk.d0BeamSpot(bspot.x, bspot.y);
165 
166  phi_eta_binnor.register_entry_safe(oldPhi[ts], eta[ts]);
167  // If one is sure values are *within* axis ranges: b.register_entry(oldPhi[ts], eta[ts]);
168  }
169 
170  phi_eta_binnor.finalize_registration();
171 
172  for (int sorted_ts = 0; sorted_ts < ns; sorted_ts++) {
173  int ts = phi_eta_binnor.m_ranks[sorted_ts];
174 
175  if (not writetrack[ts])
176  continue; // Note: this speed up prevents transitive masking (possibly marginal gain).
177 
178  const float oldPhi1 = oldPhi[ts];
179  const float pos2_first = pos2[ts];
180  const float eta1 = eta[ts];
181  const float pt1 = pt[ts];
182  const float invptq_first = invptq[ts];
183 
184  // To study some more details -- need EventOfHits for this
185  int n_ovlp_hits_added = 0;
186 
187  auto phi_rng = ax_phi.from_R_rdr_to_N_bins(oldPhi[ts], 0.08f);
188  auto eta_rng = ax_eta.from_R_rdr_to_N_bins(eta[ts], .1f);
189 
190  for (auto i_phi = phi_rng.begin; i_phi != phi_rng.end; i_phi = ax_phi.next_N_bin(i_phi)) {
191  for (auto i_eta = eta_rng.begin; i_eta != eta_rng.end; i_eta = ax_eta.next_N_bin(i_eta)) {
192  const auto cbin = phi_eta_binnor.get_content(i_phi, i_eta);
193  for (auto i = cbin.first; i < cbin.end(); ++i) {
194  int tss = phi_eta_binnor.m_ranks[i];
195 
196  if (not writetrack[ts])
197  continue;
198  if (not writetrack[tss])
199  continue;
200  if (tss == ts)
201  continue;
202 
203  const float pt2 = pt[tss];
204 
205  // Always require charge consistency. If different charge is assigned, do not remove seed-track
206  if (charge[tss] != charge[ts])
207  continue;
208 
209  const float thisDPt = std::abs(pt2 - pt1);
210  // Require pT consistency between seeds. If dpT is large, do not remove seed-track.
211  if (thisDPt > dpt_common * pt1)
212  continue;
213 
214  const float eta2 = eta[tss];
215  const float deta2 = std::pow(eta1 - eta2, 2);
216 
217  const float oldPhi2 = oldPhi[tss];
218 
219  const float pos2_second = pos2[tss];
220  const float thisDXYSign05 = pos2_second > pos2_first ? -0.5f : 0.5f;
221 
222  const float thisDXY = thisDXYSign05 * sqrt(std::pow(x[ts] - x[tss], 2) + std::pow(y[ts] - y[tss], 2));
223 
224  const float invptq_second = invptq[tss];
225 
226  const float newPhi1 = oldPhi1 - thisDXY * invR1GeV * invptq_first;
227  const float newPhi2 = oldPhi2 + thisDXY * invR1GeV * invptq_second;
228 
229  const float dphi = cdist(std::abs(newPhi1 - newPhi2));
230 
231  const float dr2 = deta2 + dphi * dphi;
232 
233  const float thisDZ = z[ts] - z[tss] - thisDXY * (ctheta[ts] + ctheta[tss]);
234  const float dz2 = thisDZ * thisDZ;
235 
236  // Reject tracks within dR-dz elliptical window.
237  // Adaptive thresholds, based on observation that duplicates are more abundant at large pseudo-rapidity and low track pT
238  bool overlapping = false;
239  if (std::abs(eta1) < etamax_brl) {
240  if (pt1 > ptmin_hpt) {
241  if (dz2 * dzmax2_inv_bh + dr2 * drmax2_inv_bh < 1.0f)
242  overlapping = true;
243  } else {
244  if (dz2 * dzmax2_inv_bl + dr2 * drmax2_inv_bl < 1.0f)
245  overlapping = true;
246  }
247  } else {
248  if (pt1 > ptmin_hpt) {
249  if (dz2 * dzmax2_inv_eh + dr2 * drmax2_inv_eh < 1.0f)
250  overlapping = true;
251  } else {
252  if (dz2 * dzmax2_inv_el + dr2 * drmax2_inv_el < 1.0f)
253  overlapping = true;
254  }
255  }
256 
257  if (overlapping) {
258  //Mark tss as a duplicate
259  i1 = ts;
260  i2 = tss;
261  if (d0[tss] > d0[ts])
262  writetrack[tss] = false;
263  else {
264  writetrack[ts] = false;
265  i2 = ts;
266  i1 = tss;
267  }
268  // Add hits from tk2 to the seed we are keeping.
269  // NOTE: We have a limit in Track::Status for the number of seed hits.
270  // There is a check at entry and after adding of a new hit.
271  Track &tk = seeds[i1];
272  if (merge_hits && tk.nTotalHits() < Track::Status::kMaxSeedHits &&
273  (Algo(itrcfg.m_track_algorithm) != Algo::lowPtQuadStep ||
274  (pt1 < ptmax_merge_lowPtQuad && std::abs(eta1) > etamin_merge_lowPtQuad))) {
275  const Track &tk2 = seeds[i2];
276  //We are not actually fitting to the extra hits; use chi2 of 0
277  float fakeChi2 = 0.0;
278 
279  for (int j = 0; j < tk2.nTotalHits(); ++j) {
280  int hitidx = tk2.getHitIdx(j);
281  int hitlyr = tk2.getHitLyr(j);
282  if (hitidx >= 0) {
283  bool unique = true;
284  for (int i = 0; i < tk.nTotalHits(); ++i) {
285  if ((hitidx == tk.getHitIdx(i)) && (hitlyr == tk.getHitLyr(i))) {
286  unique = false;
287  break;
288  }
289  }
290  if (unique) {
291  tk.addHitIdx(tk2.getHitIdx(j), tk2.getHitLyr(j), fakeChi2);
292  ++n_ovlp_hits_added;
293  if (tk.nTotalHits() >= Track::Status::kMaxSeedHits)
294  break;
295  }
296  }
297  }
298  }
299  if (n_ovlp_hits_added > 0)
300  tk.sortHitsByLayer();
301  }
302  } //end of inner loop over tss
303  } //eta bin
304  } //phi bin
305 
306  if (writetrack[ts]) {
307  cleanSeedTracks.emplace_back(seeds[ts]);
308  }
309  }
310 
311  seeds.swap(cleanSeedTracks);
312 
313 #ifdef DEBUG
314  {
315  const int ns2 = seeds.size();
316  printf("Number of CMS seeds before %d --> after %d cleaning\n", ns, ns2);
317 
318  for (int it = 0; it < ns2; it++) {
319  const Track &ss = seeds[it];
320  printf(" %3i q=%+i pT=%7.3f eta=% 7.3f nHits=%i label=% i\n",
321  it,
322  ss.charge(),
323  ss.pT(),
324  ss.momEta(),
325  ss.nFoundHits(),
326  ss.label());
327  }
328  }
329 #endif
330 
331 #ifdef DEBUG
332  std::cout << "AFTER seed cleaning " << seeds.size() << std::endl;
333 #endif
334 
335  return seeds.size();
336  }
constexpr float c_dpt_common
Definition: Config.h:100
constexpr float c_etamax_brl
Definition: Config.h:99
T sqrt(T t)
Definition: SSEVec.h:23
def unique(seq, keepstr=True)
Definition: tier0.py:24
TrackBase::TrackAlgorithm TrackAlgorithm
Tan< T >::type tan(const T &t)
Definition: Tan.h:22
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
double f[11][100]
#define PI
Definition: QcdUeDQM.h:37
float cdist(float a)
Definition: Config.h:33
std::vector< Track > TrackVec
static constexpr float d0
constexpr float track1GeVradius
Definition: Config.h:98
float x
TupleMultiplicity< TrackerTraits > const *__restrict__ uint32_t nHits
Power< A, B >::type pow(const A &a, const B &b)
Definition: Power.h:29
Definition: fakeMenu.h:6

◆ clean_duplicates()

void mkfit::StdSeq::clean_duplicates ( TrackVec tracks,
const IterationConfig itconf 
)

Definition at line 355 of file MkStdSeqs.cc.

References funct::abs(), HLT_2024v14_cff::eta1, f, ALPAKA_ACCELERATOR_NAMESPACE::vertexFinder::it, mkfit::Config::maxdEta, mkfit::Config::maxdPhi, mkfit::Config::maxdPt, mkfit::Config::maxdR, SiStripPI::min, mkfit::Config::minFracHitsShared, vertices_cff::ntracks, HLT_2024v14_cff::pt1, remove_duplicates(), mkfit::squashPhiMinimal(), HLT_2024v14_cff::track, DiMuonV_cfg::tracks, mitigatedMETSequence_cff::U, and mkfit::Config::useHitsForDuplicates.

355  {
356  const auto ntracks = tracks.size();
357  float eta1, phi1, pt1, deta, dphi, dr2;
358 
359  if (ntracks == 0) {
360  return;
361  }
362  for (auto itrack = 0U; itrack < ntracks - 1; itrack++) {
363  auto &track = tracks[itrack];
364  eta1 = track.momEta();
365  phi1 = track.momPhi();
366  pt1 = track.pT();
367  for (auto jtrack = itrack + 1; jtrack < ntracks; jtrack++) {
368  auto &track2 = tracks[jtrack];
369  if (track.label() == track2.label())
370  continue;
371  if (track.algoint() != track2.algoint())
372  continue;
373 
374  deta = std::abs(track2.momEta() - eta1);
375  if (deta > Config::maxdEta)
376  continue;
377 
378  dphi = std::abs(squashPhiMinimal(phi1 - track2.momPhi()));
379  if (dphi > Config::maxdPhi)
380  continue;
381 
382  float maxdR = Config::maxdR;
383  float maxdRSquared = maxdR * maxdR;
384  if (std::abs(eta1) > 2.5f)
385  maxdRSquared *= 16.0f;
386  else if (std::abs(eta1) > 1.44f)
387  maxdRSquared *= 9.0f;
388  dr2 = dphi * dphi + deta * deta;
389  if (dr2 < maxdRSquared) {
390  //Keep track with best score
391  if (track.score() > track2.score())
392  track2.setDuplicateValue(true);
393  else
394  track.setDuplicateValue(true);
395  continue;
396  } else {
397  if (pt1 == 0)
398  continue;
399  if (track2.pT() == 0)
400  continue;
401 
402  if (std::abs((1 / track2.pT()) - (1 / pt1)) < Config::maxdPt) {
404  float numHitsShared = 0;
405  for (int ihit2 = 0; ihit2 < track2.nTotalHits(); ihit2++) {
406  const int hitidx2 = track2.getHitIdx(ihit2);
407  const int hitlyr2 = track2.getHitLyr(ihit2);
408  if (hitidx2 >= 0) {
409  auto const it = std::find_if(track.beginHitsOnTrack(),
410  track.endHitsOnTrack(),
411  [&hitidx2, &hitlyr2](const HitOnTrack &element) {
412  return (element.index == hitidx2 && element.layer == hitlyr2);
413  });
414  if (it != track.endHitsOnTrack())
415  numHitsShared++;
416  }
417  }
418 
419  float fracHitsShared = numHitsShared / std::min(track.nFoundHits(), track2.nFoundHits());
420  //Only remove one of the tracks if they share at least X% of the hits (denominator is the shorter track)
421  if (fracHitsShared < Config::minFracHitsShared)
422  continue;
423  }
424  //Keep track with best score
425  if (track.score() > track2.score())
426  track2.setDuplicateValue(true);
427  else
428  track.setDuplicateValue(true);
429  } //end of if dPt
430  } //end of else
431  } //end of loop over track2
432  } //end of loop over track1
433 
435  }
float squashPhiMinimal(float phi)
Definition: Hit.h:26
const float maxdPt
Definition: Config.cc:21
const float maxdR
Definition: Config.cc:24
void remove_duplicates(TrackVec &tracks)
Definition: MkStdSeqs.cc:350
const float maxdEta
Definition: Config.cc:23
const float maxdPhi
Definition: Config.cc:22
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
double f[11][100]
const bool useHitsForDuplicates
Definition: Config.h:114
const float minFracHitsShared
Definition: Config.cc:25

◆ clean_duplicates_sharedhits()

void mkfit::StdSeq::clean_duplicates_sharedhits ( TrackVec tracks,
const IterationConfig itconf 
)

Definition at line 441 of file MkStdSeqs.cc.

References a, funct::abs(), b, mkfit::IterationConfig::dc_fracSharedHits, HLT_2024v14_cff::fraction, mps_fire::i, ALPAKA_ACCELERATOR_NAMESPACE::vertexFinder::it, SiStripPI::min, vertices_cff::ntracks, isotrackApplyRegressor::range, remove_duplicates(), mkfit::squashPhiMinimal(), funct::tan(), DiMuonV_cfg::tracks, trk, and mitigatedMETSequence_cff::U.

441  {
442  const float fraction = itconf.dc_fracSharedHits;
443  const auto ntracks = tracks.size();
444 
445  std::vector<float> ctheta(ntracks);
446  std::multimap<int, int> hitMap;
447 
448  for (auto itrack = 0U; itrack < ntracks; itrack++) {
449  auto &trk = tracks[itrack];
450  ctheta[itrack] = 1.f / std::tan(trk.theta());
451  for (int i = 0; i < trk.nTotalHits(); ++i) {
452  if (trk.getHitIdx(i) < 0)
453  continue;
454  int a = trk.getHitLyr(i);
455  int b = trk.getHitIdx(i);
456  hitMap.insert(std::make_pair(b * 1000 + a, i > 0 ? itrack : -itrack)); //negative for first hit in trk
457  }
458  }
459 
460  for (auto itrack = 0U; itrack < ntracks; itrack++) {
461  auto &trk = tracks[itrack];
462  auto phi1 = trk.momPhi();
463  auto ctheta1 = ctheta[itrack];
464 
465  std::map<int, int> sharingMap;
466  for (int i = 0; i < trk.nTotalHits(); ++i) {
467  if (trk.getHitIdx(i) < 0)
468  continue;
469  int a = trk.getHitLyr(i);
470  int b = trk.getHitIdx(i);
471  auto range = hitMap.equal_range(b * 1000 + a);
472  for (auto it = range.first; it != range.second; ++it) {
473  if (std::abs(it->second) >= (int)itrack)
474  continue; // don't check your own hits (==) nor sym. checks (>)
475  if (i == 0 && it->second < 0)
476  continue; // shared first - first is not counted
477  sharingMap[std::abs(it->second)]++;
478  }
479  }
480 
481  for (const auto &elem : sharingMap) {
482  auto &track2 = tracks[elem.first];
483 
484  // broad dctheta-dphi compatibility checks; keep mostly to preserve consistency with old results
485  auto dctheta = std::abs(ctheta[elem.first] - ctheta1);
486  if (dctheta > 1.)
487  continue;
488 
489  auto dphi = std::abs(squashPhiMinimal(phi1 - track2.momPhi()));
490  if (dphi > 1.)
491  continue;
492 
493  if (elem.second >= std::min(trk.nFoundHits(), track2.nFoundHits()) * fraction) {
494  if (trk.score() > track2.score())
495  track2.setDuplicateValue(true);
496  else
497  trk.setDuplicateValue(true);
498  }
499  } // end sharing hits loop
500  } // end trk loop
501 
503  }
float squashPhiMinimal(float phi)
Definition: Hit.h:26
Trktree trk
Definition: Trktree.cc:2
void remove_duplicates(TrackVec &tracks)
Definition: MkStdSeqs.cc:350
Tan< T >::type tan(const T &t)
Definition: Tan.h:22
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
double b
Definition: hdecay.h:120
double a
Definition: hdecay.h:121

◆ clean_duplicates_sharedhits_pixelseed()

void mkfit::StdSeq::clean_duplicates_sharedhits_pixelseed ( TrackVec tracks,
const IterationConfig itconf 
)

Definition at line 505 of file MkStdSeqs.cc.

References a, funct::abs(), b, DummyCfis::c, ztail::d, mkfit::IterationConfig::dc_drth_central, mkfit::IterationConfig::dc_drth_forward, mkfit::IterationConfig::dc_drth_obarrel, mkfit::IterationConfig::dc_fracSharedHits, HLT_2024v14_cff::fraction, mps_fire::i, dqmiolumiharvest::j, mkfit::Config::maxcth_fw, mkfit::Config::maxcth_ob, mkfit::Config::maxd1pt, mkfit::Config::maxdcth, mkfit::Config::maxdphi, SiStripPI::min, vertices_cff::ntracks, remove_duplicates(), mkfit::squashPhiMinimal(), funct::tan(), DiMuonV_cfg::tracks, trk, and mitigatedMETSequence_cff::U.

505  {
506  const float fraction = itconf.dc_fracSharedHits;
507  const float drth_central = itconf.dc_drth_central;
508  const float drth_obarrel = itconf.dc_drth_obarrel;
509  const float drth_forward = itconf.dc_drth_forward;
510  const auto ntracks = tracks.size();
511 
512  std::vector<float> ctheta(ntracks);
513  for (auto itrack = 0U; itrack < ntracks; itrack++) {
514  auto &trk = tracks[itrack];
515  ctheta[itrack] = 1.f / std::tan(trk.theta());
516  }
517 
518  float phi1, invpt1, dctheta, ctheta1, dphi, dr2;
519  for (auto itrack = 0U; itrack < ntracks; itrack++) {
520  auto &trk = tracks[itrack];
521  phi1 = trk.momPhi();
522  invpt1 = trk.invpT();
523  ctheta1 = ctheta[itrack];
524  for (auto jtrack = itrack + 1; jtrack < ntracks; jtrack++) {
525  auto &track2 = tracks[jtrack];
526  if (trk.label() == track2.label())
527  continue;
528 
529  dctheta = std::abs(ctheta[jtrack] - ctheta1);
530 
531  if (dctheta > Config::maxdcth)
532  continue;
533 
534  dphi = std::abs(squashPhiMinimal(phi1 - track2.momPhi()));
535 
536  if (dphi > Config::maxdphi)
537  continue;
538 
539  float maxdRSquared = drth_central * drth_central;
540  if (std::abs(ctheta1) > Config::maxcth_fw)
541  maxdRSquared = drth_forward * drth_forward;
542  else if (std::abs(ctheta1) > Config::maxcth_ob)
543  maxdRSquared = drth_obarrel * drth_obarrel;
544  dr2 = dphi * dphi + dctheta * dctheta;
545  if (dr2 < maxdRSquared) {
546  //Keep track with best score
547  if (trk.score() > track2.score())
548  track2.setDuplicateValue(true);
549  else
550  trk.setDuplicateValue(true);
551  continue;
552  }
553 
554  if (std::abs(track2.invpT() - invpt1) > Config::maxd1pt)
555  continue;
556 
557  auto sharedCount = 0;
558  auto sharedFirst = 0;
559  const auto minFoundHits = std::min(trk.nFoundHits(), track2.nFoundHits());
560 
561  for (int i = 0; i < trk.nTotalHits(); ++i) {
562  if (trk.getHitIdx(i) < 0)
563  continue;
564  const int a = trk.getHitLyr(i);
565  const int b = trk.getHitIdx(i);
566  for (int j = 0; j < track2.nTotalHits(); ++j) {
567  if (track2.getHitIdx(j) < 0)
568  continue;
569  const int c = track2.getHitLyr(j);
570  const int d = track2.getHitIdx(j);
571 
572  //this is to count once shared matched hits (may be done more properly...)
573  if (a == c && b == d)
574  sharedCount += 1;
575  if (j == 0 && i == 0 && a == c && b == d)
576  sharedFirst += 1;
577 
578  if ((sharedCount - sharedFirst) >= ((minFoundHits - sharedFirst) * fraction))
579  continue;
580  }
581  if ((sharedCount - sharedFirst) >= ((minFoundHits - sharedFirst) * fraction))
582  continue;
583  }
584 
585  //selection here - 11percent fraction of shared hits to label a duplicate
586  if ((sharedCount - sharedFirst) >= ((minFoundHits - sharedFirst) * fraction)) {
587  if (trk.score() > track2.score())
588  track2.setDuplicateValue(true);
589  else
590  trk.setDuplicateValue(true);
591  }
592  }
593  } //end loop one over tracks
594 
596  }
float squashPhiMinimal(float phi)
Definition: Hit.h:26
const float maxdphi
Definition: Config.cc:28
const float maxd1pt
Definition: Config.cc:27
const float maxdcth
Definition: Config.cc:29
Trktree trk
Definition: Trktree.cc:2
const float maxcth_fw
Definition: Config.cc:31
void remove_duplicates(TrackVec &tracks)
Definition: MkStdSeqs.cc:350
const float maxcth_ob
Definition: Config.cc:30
Tan< T >::type tan(const T &t)
Definition: Tan.h:22
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
d
Definition: ztail.py:151
double b
Definition: hdecay.h:120
double a
Definition: hdecay.h:121

◆ cmssw_LoadHits_Begin()

void mkfit::StdSeq::cmssw_LoadHits_Begin ( EventOfHits eoh,
const std::vector< const HitVec *> &  orig_hitvectors 
)

Definition at line 29 of file MkStdSeqs.cc.

References mps_fire::i, MainPageGenerator::l, mkfit::EventOfHits::nLayers(), and mkfit::EventOfHits::reset().

Referenced by MkFitEventOfHitsProducer::produce().

29  {
30  eoh.reset();
31  for (int i = 0; i < eoh.nLayers(); ++i) {
32  auto &&l = eoh[i];
33  l.beginRegistrationOfHits(*orig_hitvectors[l.is_pixel() ? 0 : 1]);
34  }
35  }

◆ cmssw_LoadHits_End()

void mkfit::StdSeq::cmssw_LoadHits_End ( EventOfHits eoh)

Definition at line 45 of file MkStdSeqs.cc.

References mps_fire::i, MainPageGenerator::l, and mkfit::EventOfHits::nLayers().

Referenced by MkFitEventOfHitsProducer::produce().

45  {
46  for (int i = 0; i < eoh.nLayers(); ++i) {
47  auto &&l = eoh[i];
48  l.endRegistrationOfHits(false);
49  }
50  }

◆ cmssw_Map_TrackHitIndices()

void mkfit::StdSeq::cmssw_Map_TrackHitIndices ( const EventOfHits eoh,
TrackVec seeds 
)

Definition at line 56 of file MkStdSeqs.cc.

References mps_fire::i, HLT_2024v14_cff::seeds, and HLT_2024v14_cff::track.

56  {
57  for (auto &&track : seeds) {
58  for (int i = 0; i < track.nTotalHits(); ++i) {
59  const int hitidx = track.getHitIdx(i);
60  const int hitlyr = track.getHitLyr(i);
61  if (hitidx >= 0) {
62  const auto &loh = eoh[hitlyr];
63  track.setHitIdx(i, loh.getHitIndexFromOriginal(hitidx));
64  }
65  }
66  }
67  }

◆ cmssw_ReMap_TrackHitIndices()

void mkfit::StdSeq::cmssw_ReMap_TrackHitIndices ( const EventOfHits eoh,
TrackVec out_tracks 
)

Definition at line 69 of file MkStdSeqs.cc.

References mps_fire::i, and HLT_2024v14_cff::track.

69  {
70  for (auto &&track : out_tracks) {
71  for (int i = 0; i < track.nTotalHits(); ++i) {
72  const int hitidx = track.getHitIdx(i);
73  const int hitlyr = track.getHitLyr(i);
74  if (hitidx >= 0) {
75  const auto &loh = eoh[hitlyr];
76  track.setHitIdx(i, loh.getOriginalHitIndex(hitidx));
77  }
78  }
79  }
80  }

◆ dump_simtracks()

void mkfit::StdSeq::dump_simtracks ( Event event)

Definition at line 55 of file MkStandaloneSeqs.cc.

References dprint, createfilelist::int, and HLT_2024v14_cff::track.

55  {
56  // Ripped out of MkBuilder::begin_event, ifdefed under DEBUG
57 
58  std::vector<Track> &simtracks = event->simTracks_;
59 
60  for (int itrack = 0; itrack < (int)simtracks.size(); ++itrack) {
61  // bool debug = true;
62  Track track = simtracks[itrack];
63  // simtracks are initially written with label = index; uncomment in case tracks were edited
64  // if (track.label() != itrack) {
65  // dprintf("Bad label for simtrack %d -- %d\n", itrack, track.label());
66  // }
67 
68  dprint("MX - simtrack with nHits=" << track.nFoundHits() << " chi2=" << track.chi2() << " pT=" << track.pT()
69  << " phi=" << track.momPhi() << " eta=" << track.momEta());
70  }
71 
72  for (int itrack = 0; itrack < (int)simtracks.size(); ++itrack) {
73  for (int ihit = 0; ihit < simtracks[itrack].nFoundHits(); ++ihit) {
74  dprint("track #" << itrack << " hit #" << ihit
75  << " hit pos=" << simtracks[itrack].hitsVector(event->layerHits_)[ihit].position()
76  << " phi=" << simtracks[itrack].hitsVector(event->layerHits_)[ihit].phi());
77  }
78  }
79  }
#define dprint(x)
Definition: Debug.h:95
Definition: event.py:1

◆ handle_duplicates()

void mkfit::StdSeq::handle_duplicates ( Event )

Definition at line 33 of file MkStandaloneSeqs.cc.

33  {
34  /*
35  // Mark tracks as duplicates; if within CMSSW, remove duplicate tracks from fit or candidate track collection
36  if (Config::removeDuplicates) {
37  if (Config::quality_val || Config::sim_val || Config::cmssw_val) {
38  clean_duplicates(event->candidateTracks_);
39  if (Config::backwardFit)
40  clean_duplicates(event->fitTracks_);
41  }
42  // For the MEIF benchmarks and the stress tests, no validation flags are set so we will enter this block
43  else {
44  // Only care about the candidate tracks here; no need to run the duplicate removal on both candidate and fit tracks
45  clean_duplicates(event->candidateTracks_);
46  }
47  }
48  */
49  }

◆ loadDeads()

void mkfit::StdSeq::loadDeads ( EventOfHits eoh,
const std::vector< DeadVec > &  deadvectors 
)

Definition at line 19 of file MkStdSeqs.cc.

References mkfit::internal::deadvectors, and mkfit::EventOfHits::suckInDeads().

Referenced by mkfit::Shell::GoToEvent(), MkFitEventOfHitsProducer::produce(), and test_standard().

19  {
20  for (size_t il = 0; il < deadvectors.size(); il++) {
21  eoh.suckInDeads(int(il), deadvectors[il]);
22  }
23  }
std::vector< DeadVec > deadvectors

◆ loadHitsAndBeamSpot()

void mkfit::StdSeq::loadHitsAndBeamSpot ( Event ev,
EventOfHits eoh 
)

Definition at line 20 of file MkStandaloneSeqs.cc.

References makeMEIFBenchmarkPlots::ev, hgcalTBTopologyTester_cfi::layers, mkfit::EventOfHits::reset(), mkfit::EventOfHits::setBeamSpot(), mkfit::EventOfHits::suckInHits(), and TBB_PARALLEL_FOR.

Referenced by mkfit::Shell::GoToEvent(), and test_standard().

20  {
21  eoh.reset();
22 
23  // fill vector of hits in each layer
24  // XXXXMT: Does it really makes sense to multi-thread this?
25  TBB_PARALLEL_FOR(tbb::blocked_range<int>(0, ev.layerHits_.size()), [&](const tbb::blocked_range<int> &layers) {
26  for (int ilay = layers.begin(); ilay < layers.end(); ++ilay) {
27  eoh.suckInHits(ilay, ev.layerHits_[ilay]);
28  }
29  });
30  eoh.setBeamSpot(ev.beamSpot_);
31  }
#define TBB_PARALLEL_FOR
Definition: Debug.h:143

◆ prep_cmsswtracks()

void mkfit::StdSeq::prep_cmsswtracks ( Event event)

Definition at line 389 of file MkStandaloneSeqs.cc.

References prep_reftracks().

Referenced by root_val().

389 { prep_reftracks(event, event->cmsswTracks_, event->cmsswTracksExtra_, true); }
void prep_reftracks(Event *event, TrackVec &tracks, TrackExtraVec &extras, const bool realigntracks)
Definition: event.py:1

◆ prep_recotracks()

void mkfit::StdSeq::prep_recotracks ( Event event)

Definition at line 296 of file MkStandaloneSeqs.cc.

References mkfit::Config::cmssw_val, prep_tracks(), mkfit::Config::sim_val, and mkfit::Config::sim_val_for_cmssw.

Referenced by root_val(), and root_val_dumb_cmssw().

296  {
297  // seed tracks extras always needed
299  prep_tracks(event, event->seedTracks_, event->seedTracksExtra_, true);
300  } else if (Config::cmssw_val) // seed tracks are not validated, labels used for maps --> do NOT align index and labels!
301  {
302  prep_tracks(event, event->seedTracks_, event->seedTracksExtra_, false);
303  }
304 
305  // make extras + align index == label() for candidate tracks
306  prep_tracks(event, event->candidateTracks_, event->candidateTracksExtra_, true);
307  prep_tracks(event, event->fitTracks_, event->fitTracksExtra_, true);
308  }
void prep_tracks(Event *event, TrackVec &tracks, TrackExtraVec &extras, const bool realigntracks)
Definition: event.py:1

◆ prep_reftracks()

void mkfit::StdSeq::prep_reftracks ( Event event,
TrackVec tracks,
TrackExtraVec extras,
const bool  realigntracks 
)

Definition at line 391 of file MkStandaloneSeqs.cc.

References mkfit::Config::cmsSelMinLayers, prep_tracks(), HLT_2024v14_cff::track, and DiMuonV_cfg::tracks.

Referenced by prep_cmsswtracks(), and prep_simtracks().

391  {
392  prep_tracks(event, tracks, extras, realigntracks);
393 
394  // mark cmsswtracks as unfindable if too short
395  for (auto &track : tracks) {
396  const int nlyr = track.nUniqueLayers();
397  if (nlyr < Config::cmsSelMinLayers)
398  track.setNotFindable();
399  }
400  }
void prep_tracks(Event *event, TrackVec &tracks, TrackExtraVec &extras, const bool realigntracks)
Definition: event.py:1

◆ prep_simtracks()

void mkfit::StdSeq::prep_simtracks ( Event event)

Definition at line 310 of file MkStandaloneSeqs.cc.

References funct::abs(), submitPVResolutionJobs::count, spr::find(), heavyIonCSV_trainingSettings::idx, label, mkfit::Config::mtvLikeValidation, mkfit::Config::mtvRequireSeeds, prep_reftracks(), and mkfit::TrackBase::Signal.

Referenced by root_val_dumb_cmssw(), and mkfit::runBtpCe_MultiIter().

310  {
311  // First prep sim tracks to have hits sorted, then mark unfindable if too short
312  prep_reftracks(event, event->simTracks_, event->simTracksExtra_, false);
313 
314  // Now, make sure sim track shares at least four hits with a single cmssw seed.
315  // This ensures we factor out any weakness from CMSSW
316 
317  // First, make a make a map of [lyr][hit idx].vector(seed trk labels)
318  LayIdxIDVecMapMap seedHitIDMap;
319  std::map<int, int> labelNHitsMap;
320  std::map<int, int> labelAlgoMap;
321  std::map<int, std::vector<int>> labelSeedHitsMap;
322  for (const auto &seedtrack : event->seedTracks_) {
323  for (int ihit = 0; ihit < seedtrack.nTotalHits(); ihit++) {
324  const auto lyr = seedtrack.getHitLyr(ihit);
325  const auto idx = seedtrack.getHitIdx(ihit);
326 
327  if (lyr < 0 || idx < 0)
328  continue; // standard check
329  seedHitIDMap[lyr][idx].push_back(seedtrack.label());
330  labelSeedHitsMap[seedtrack.label()].push_back(lyr);
331  }
332  labelNHitsMap[seedtrack.label()] = seedtrack.nTotalHits();
333  labelAlgoMap[seedtrack.label()] = seedtrack.algoint();
334  }
335 
336  // Then, loop over sim tracks, and add up how many lyrs they possess of a single seed track
337  unsigned int count = 0;
338  for (auto &simtrack : event->simTracks_) {
339  if (simtrack.isNotFindable())
340  continue; // skip ones we already know are bad
341  TrkIDLaySetMap seedIDMap;
342  for (int ihit = 0; ihit < simtrack.nTotalHits(); ihit++) {
343  const auto lyr = simtrack.getHitLyr(ihit);
344  const auto idx = simtrack.getHitIdx(ihit);
345 
346  if (lyr < 0 || idx < 0)
347  continue; // standard check
348 
349  if (!seedHitIDMap.count(lyr))
350  continue; // ensure seed hit map has at least one entry for this layer
351  if (!seedHitIDMap.at(lyr).count(idx))
352  continue; // ensure seed hit map has at least one entry for this idx
353 
354  for (const auto label : seedHitIDMap.at(lyr).at(idx)) {
355  const auto &seedLayers = labelSeedHitsMap[label];
356  if (std::find(seedLayers.begin(), seedLayers.end(), lyr) != seedLayers.end()) //seed check moved here
357  seedIDMap[label].emplace(lyr);
358  }
359  }
360 
361  // now see if one of the seedIDs matched has at least 4 hits!
362  bool isSimSeed = false;
363  for (const auto &seedIDpair : seedIDMap) {
364  if ((int)seedIDpair.second.size() == labelNHitsMap[seedIDpair.first]) {
365  isSimSeed = true;
367  simtrack.setAlgoint(labelAlgoMap[seedIDpair.first]);
369  event->simTracksExtra_[count].addAlgo(labelAlgoMap[seedIDpair.first]);
370  //break;
371  }
372  }
374  // Apply MTV selection criteria and then return
375  if (simtrack.prodType() != Track::ProdType::Signal || simtrack.charge() == 0 || simtrack.posR() > 2.5 ||
376  std::abs(simtrack.z()) > 30 || std::abs(simtrack.momEta()) > 3.0)
377  simtrack.setNotFindable();
378  else if (Config::mtvRequireSeeds && !isSimSeed)
379  simtrack.setNotFindable();
380  } else {
381  // set findability based on bool isSimSeed
382  if (!isSimSeed)
383  simtrack.setNotFindable();
384  }
385  count++;
386  }
387  }
void prep_reftracks(Event *event, TrackVec &tracks, TrackExtraVec &extras, const bool realigntracks)
std::map< int, std::unordered_set< int > > TrkIDLaySetMap
Definition: TrackExtra.h:38
void find(edm::Handle< EcalRecHitCollection > &hits, DetId thisDet, std::vector< EcalRecHitCollection::const_iterator > &hit, bool debug=false)
Definition: FindCaloHit.cc:19
char const * label
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
std::map< int, std::map< int, std::vector< int > > > LayIdxIDVecMapMap
Definition: TrackExtra.h:37
Definition: event.py:1

◆ prep_tracks()

void mkfit::StdSeq::prep_tracks ( Event event,
TrackVec tracks,
TrackExtraVec extras,
const bool  realigntracks 
)

Definition at line 402 of file MkStandaloneSeqs.cc.

References mps_fire::i, label, and DiMuonV_cfg::tracks.

Referenced by prep_recotracks(), and prep_reftracks().

402  {
403  for (size_t i = 0; i < tracks.size(); i++) {
404  extras.emplace_back(tracks[i].label());
405  }
406  if (realigntracks)
407  event->validation_.alignTracks(tracks, extras, false);
408  }
char const * label

◆ qfilter_n_hits()

template<class TRACK >
bool mkfit::StdSeq::qfilter_n_hits ( const TRACK &  t,
const MkJob j 
)

Definition at line 617 of file MkStdSeqs.cc.

References dqmiolumiharvest::j, and submitPVValidationJobs::t.

617  {
618  int seedHits = t.getNSeedHits();
619  int seedReduction = (seedHits <= 5) ? 2 : 3;
620  return t.nFoundHits() - seedReduction >= j.params_cur().minHitsQF;
621  }

◆ qfilter_n_hits_pixseed()

template<class TRACK >
bool mkfit::StdSeq::qfilter_n_hits_pixseed ( const TRACK &  t,
const MkJob j 
)

Definition at line 625 of file MkStdSeqs.cc.

References dqmiolumiharvest::j, and submitPVValidationJobs::t.

625  {
626  return t.nFoundHits() >= j.params_cur().minHitsQF;
627  }

◆ qfilter_n_layers()

template<class TRACK >
bool mkfit::StdSeq::qfilter_n_layers ( const TRACK &  t,
const MkJob j 
)

Definition at line 632 of file MkStdSeqs.cc.

References funct::abs(), MuonTCMETValueMapProducer_cff::d0_max, dqmiolumiharvest::j, submitPVValidationJobs::t, mkfit::BeamSpot::x, and mkfit::BeamSpot::y.

632  {
633  const BeamSpot &bspot = j.m_beam_spot;
634  const TrackerInfo &trk_inf = j.m_trk_info;
635  int enhits = t.nHitsByTypeEncoded(trk_inf);
636  int npixhits = t.nPixelDecoded(enhits);
637  int enlyrs = t.nLayersByTypeEncoded(trk_inf);
638  int npixlyrs = t.nPixelDecoded(enlyrs);
639  int nmatlyrs = t.nTotMatchDecoded(enlyrs);
640  int llyr = t.getLastFoundHitLyr();
641  int lplyr = t.getLastFoundPixelHitLyr();
642  float invpt = t.invpT();
643 
644  // based on fr and eff vs pt (convert to native invpt)
645  float invptmin = 1.43; // min 1/pT (=1/0.7) for full filter on (npixhits<=3 .or. npixlyrs<=3)
646  float d0BS = t.d0BeamSpot(bspot.x, bspot.y);
647  float d0_max = 0.1; // 1 mm, max for somewhat prompt
648 
649  // next-to-outermost pixel layers (almost): BPIX3 or FPIX1
650  bool endsInsidePix = (llyr == 2 || llyr == 18 || llyr == 45);
651  // not last pixel layers: BPIX[123] or FPIX[12]
652  bool lastInsidePix = ((0 <= lplyr && lplyr < 3) || (18 <= lplyr && lplyr < 20) || (45 <= lplyr && lplyr < 47));
653  // reject short tracks missing last pixel layer except for prompt-looking
654  return !(((npixhits <= 3 || npixlyrs <= 3) && endsInsidePix &&
655  (invpt < invptmin || (invpt >= invptmin && std::abs(d0BS) > d0_max))) ||
656  ((npixlyrs <= 3 && nmatlyrs <= 6) && lastInsidePix && llyr != lplyr && std::abs(d0BS) > d0_max));
657  }
Abs< T >::type abs(const T &t)
Definition: Abs.h:22

◆ qfilter_nan_n_silly()

template<class TRACK >
bool mkfit::StdSeq::qfilter_nan_n_silly ( const TRACK &  t,
const MkJob  
)

Definition at line 41 of file MkStdSeqs.h.

References submitPVValidationJobs::t.

41  {
42  return !(t.hasNanNSillyValues());
43  }

◆ qfilter_pixelLessBkwd()

template<class TRACK >
bool mkfit::StdSeq::qfilter_pixelLessBkwd ( const TRACK &  t,
const MkJob j 
)

quality filter tuned for pixelLess iteration during backward search

Definition at line 694 of file MkStdSeqs.cc.

References funct::abs(), MuonTCMETValueMapProducer_cff::d0_max, dqmiolumiharvest::j, nHits, mkfit::Const::PIOver2, submitPVValidationJobs::t, mkfit::BeamSpot::x, and mkfit::BeamSpot::y.

694  {
695  const BeamSpot &bspot = j.m_beam_spot;
696  const TrackerInfo &tk_info = j.m_trk_info;
697  float d0BS = t.d0BeamSpot(bspot.x, bspot.y);
698  float d0_max = 0.1; // 1 mm
699 
700  int encoded;
701  encoded = t.nLayersByTypeEncoded(tk_info);
702  int nLyrs = t.nTotMatchDecoded(encoded);
703  encoded = t.nHitsByTypeEncoded(tk_info);
704  int nHits = t.nTotMatchDecoded(encoded);
705 
706  // based on fr and eff vs pt and eta (convert to native invpt and theta)
707  float invpt = t.invpT();
708  float invptmin = 1.11; // =1/0.9
709 
710  float thetasym = std::abs(t.theta() - Const::PIOver2);
711  float thetasymmin_l = 0.80; // -> |eta|=0.9
712  float thetasymmin_h = 1.11; // -> |eta|=1.45
713 
714  // reject too short or too displaced tracks
715  return !(
716  ((nLyrs <= 3 || nHits <= 3)) ||
717  ((nLyrs <= 4 || nHits <= 4) && (invpt < invptmin || (thetasym > thetasymmin_l && std::abs(d0BS) > d0_max))) ||
718  ((nLyrs <= 5 || nHits <= 5) && (invpt > invptmin && thetasym > thetasymmin_h && std::abs(d0BS) > d0_max)));
719  }
constexpr float PIOver2
Definition: Config.h:9
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
TupleMultiplicity< TrackerTraits > const *__restrict__ uint32_t nHits

◆ qfilter_pixelLessFwd()

template<class TRACK >
bool mkfit::StdSeq::qfilter_pixelLessFwd ( const TRACK &  t,
const MkJob j 
)

quality filter tuned for pixelLess iteration during forward search

Definition at line 662 of file MkStdSeqs.cc.

References funct::abs(), MuonTCMETValueMapProducer_cff::d0_max, dqmiolumiharvest::j, nHits, mkfit::Const::PIOver2, submitPVValidationJobs::t, mkfit::BeamSpot::x, and mkfit::BeamSpot::y.

662  {
663  const BeamSpot &bspot = j.m_beam_spot;
664  const TrackerInfo &tk_info = j.m_trk_info;
665  float d0BS = t.d0BeamSpot(bspot.x, bspot.y);
666  float d0_max = 0.05; // 0.5 mm, max for somewhat prompt
667 
668  int encoded;
669  encoded = t.nLayersByTypeEncoded(tk_info);
670  int nLyrs = t.nTotMatchDecoded(encoded);
671  encoded = t.nHitsByTypeEncoded(tk_info);
672  int nHits = t.nTotMatchDecoded(encoded);
673 
674  // to subtract stereo seed layers to count just r-phi seed layers (better pt err)
675  int seedReduction = (t.getNSeedHits() <= 5) ? 2 : 3;
676 
677  // based on fr and eff vs pt and eta (convert to native invpt and theta)
678  float invpt = t.invpT();
679  float invptmin = 1.11; // =1/0.9
680 
681  float thetasym = std::abs(t.theta() - Const::PIOver2);
682  float thetasymmin = 1.11; // -> |eta|=1.45
683 
684  // accept longer tracks, reject too short and displaced
685  return (((t.nFoundHits() - seedReduction >= 4 && invpt < invptmin) ||
686  (t.nFoundHits() - seedReduction >= 3 && invpt > invptmin && thetasym <= thetasymmin) ||
687  (t.nFoundHits() - seedReduction >= 4 && invpt > invptmin && thetasym > thetasymmin)) &&
688  !((nLyrs <= 4 || nHits <= 4) && std::abs(d0BS) > d0_max && invpt < invptmin));
689  }
constexpr float PIOver2
Definition: Config.h:9
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
TupleMultiplicity< TrackerTraits > const *__restrict__ uint32_t nHits

◆ remove_duplicates()

void mkfit::StdSeq::remove_duplicates ( TrackVec tracks)

Definition at line 350 of file MkStdSeqs.cc.

References HLT_2024v14_cff::track, and DiMuonV_cfg::tracks.

Referenced by clean_duplicates(), clean_duplicates_sharedhits(), and clean_duplicates_sharedhits_pixelseed().

350  {
351  tracks.erase(std::remove_if(tracks.begin(), tracks.end(), [](auto track) { return track.getDuplicateValue(); }),
352  tracks.end());
353  }

◆ root_val()

void mkfit::StdSeq::root_val ( Event event)

Definition at line 276 of file MkStandaloneSeqs.cc.

References mkfit::Config::backwardFit, mkfit::Config::cmssw_val, prep_cmsswtracks(), prep_recotracks(), and score_tracks().

Referenced by mkfit::runBtpCe_MultiIter(), mkfit::runBuildingTestPlexBestHit(), mkfit::runBuildingTestPlexCloneEngine(), and mkfit::runBuildingTestPlexStandard().

276  {
277  // score the tracks
278  score_tracks(event->seedTracks_);
279  score_tracks(event->candidateTracks_);
280 
281  // deal with fit tracks
282  if (Config::backwardFit) {
283  score_tracks(event->fitTracks_);
284  } else
285  event->fitTracks_ = event->candidateTracks_;
286 
287  // sort hits + make extras, align if needed
289  if (Config::cmssw_val)
291 
292  // validate
293  event->validate();
294  }
void score_tracks(TrackVec &tracks)
void prep_recotracks(Event *event)
Definition: event.py:1
void prep_cmsswtracks(Event *event)

◆ root_val_dumb_cmssw()

void mkfit::StdSeq::root_val_dumb_cmssw ( Event event)

Definition at line 255 of file MkStandaloneSeqs.cc.

References mkfit::Config::nItersCMSSW, prep_recotracks(), and prep_simtracks().

Referenced by mkfit::runBuildingTestPlexDumbCMSSW().

255  {
256  // get labels correct first
257  event->relabel_bad_seedtracks();
258  event->relabel_cmsswtracks_from_seeds();
259 
260  //collection cleaning
261  if (Config::nItersCMSSW > 0)
262  event->select_tracks_iter(Config::nItersCMSSW);
263 
264  // set the track collections to each other
265  event->candidateTracks_ = event->cmsswTracks_;
266  event->fitTracks_ = event->candidateTracks_;
267 
268  // prep the tracks + extras
271 
272  // validate
273  event->validate();
274  }
void prep_simtracks(Event *event)
void prep_recotracks(Event *event)
Definition: event.py:1

◆ score_tracks()

void mkfit::StdSeq::score_tracks ( TrackVec tracks)

Definition at line 410 of file MkStandaloneSeqs.cc.

References mkfit::IterationConfig::get_track_scorer(), mkfit::getScoreCand(), HLT_2024v14_cff::track, and DiMuonV_cfg::tracks.

Referenced by root_val().

410  {
411  auto score_func = IterationConfig::get_track_scorer("default");
412  for (auto &track : tracks) {
413  track.setScore(getScoreCand(score_func, track));
414  }
415  }
float getScoreCand(const track_score_func &score_func, const Track &cand1, bool penalizeTailMissHits=false, bool inFindCandidates=false)
Definition: Track.h:601

◆ track_print()

void mkfit::StdSeq::track_print ( Event event,
const Track t,
const char *  pref 
)

Definition at line 81 of file MkStandaloneSeqs.cc.

References heavyIonCSV_trainingSettings::idx, mkfit::print(), submitPVValidationJobs::t, and hit::z.

81  {
82  printf("%s with q=%+i pT=%7.3f eta=% 7.3f nHits=%2d label=%4d\nState:\n",
83  pref,
84  t.charge(),
85  t.pT(),
86  t.momEta(),
87  t.nFoundHits(),
88  t.label());
89 
90  print(t.state());
91 
92  printf("Hits:\n");
93  for (int ih = 0; ih < t.nTotalHits(); ++ih) {
94  int lyr = t.getHitLyr(ih);
95  int idx = t.getHitIdx(ih);
96  if (idx >= 0) {
97  const Hit &hit = event->layerHits_[lyr][idx];
98  printf(" hit %2d lyr=%2d idx=%4d pos r=%7.3f z=% 8.3f mc_hit=%4d mc_trk=%4d\n",
99  ih,
100  lyr,
101  idx,
102  hit.r(),
103  hit.z(),
104  hit.mcHitID(),
105  hit.mcTrackID(event->simHitsInfo_));
106  } else
107  printf(" hit %2d idx=%i\n", ih, t.getHitIdx(ih));
108  }
109  }
void print(TMatrixD &m, const char *label=nullptr, bool mathematicaFormat=false)
Definition: Utilities.cc:47
Definition: event.py:1

◆ trackScoreDefault()

float mkfit::StdSeq::trackScoreDefault ( const int  nfoundhits,
const int  ntailholes,
const int  noverlaphits,
const int  nmisshits,
const float  chi2,
const float  pt,
const bool  inFindCandidates 
)

Definition at line 738 of file MkStdSeqs.cc.

References isoTrack_cff::chi2, f, SiStripPI::min, mkfit::Config::missingHitPenalty_, mkfit::Config::overlapHitBonus_, DiDispStaMuonMonitor_cfi::pt, offlineSlimmedPrimaryVertices_cfi::score, mkfit::Config::tailMissingHitPenalty_, mkfit::Config::validHitBonus_, and mkfit::Config::validHitSlope_.

744  {
745  float maxBonus = 8.0;
746  float bonus = Config::validHitSlope_ * nfoundhits + Config::validHitBonus_;
747  float penalty = Config::missingHitPenalty_;
748  float tailPenalty = Config::tailMissingHitPenalty_;
749  float overlapBonus = Config::overlapHitBonus_;
750  if (pt < 0.9) {
751  penalty *= inFindCandidates ? 1.7f : 1.5f;
752  bonus = std::min(bonus * (inFindCandidates ? 0.9f : 1.0f), maxBonus);
753  }
754  float score =
755  bonus * nfoundhits + overlapBonus * noverlaphits - penalty * nmisshits - tailPenalty * ntailholes - chi2;
756  return score;
757  }
constexpr float validHitSlope_
Definition: Config.h:81
constexpr float tailMissingHitPenalty_
Definition: Config.h:84
double f[11][100]
constexpr float overlapHitBonus_
Definition: Config.h:82
constexpr float validHitBonus_
Definition: Config.h:80
constexpr float missingHitPenalty_
Definition: Config.h:83