Belle II Software development
VXDDedxPIDModule.cc
1/**************************************************************************
2 * basf2 (Belle II Analysis Software Framework) *
3 * Author: The Belle II Collaboration *
4 * *
5 * See git log for contributors and copyright holders. *
6 * This file is licensed under LGPL-3.0, see LICENSE.md. *
7 **************************************************************************/
8
9#include <reconstruction/modules/VXDDedxPID/VXDDedxPIDModule.h>
10#include <reconstruction/modules/VXDDedxPID/HelixHelper.h>
11
12#include <framework/gearbox/Const.h>
13
14#include <vxd/geometry/GeoCache.h>
15
16#include <genfit/MaterialEffects.h>
17
18#include <Math/VectorUtil.h>
19#include <TH2F.h>
20
21#include <memory>
22#include <cassert>
23#include <cmath>
24#include <algorithm>
25
26using namespace Belle2;
27using namespace Dedx;
28
29REG_MODULE(VXDDedxPID);
30
32{
34
35 //Set module properties
36 setDescription("Extract dE/dx and corresponding log-likelihood from fitted tracks and hits in the SVD and PXD.");
37
38 //Parameter definitions
39 addParam("useIndividualHits", m_useIndividualHits,
40 "Include PDF value for each hit in likelihood. If false, the truncated mean of dedx values for the detectors will be used.", false);
41 // no need to define highest and lowest truncated value as we always remove highest two dE/dx value from the 8 dE/dx value
42 addParam("onlyPrimaryParticles", m_onlyPrimaryParticles, "Only save data for primary particles (as determined by MC truth)", false);
43 addParam("usePXD", m_usePXD, "Use PXDClusters for dE/dx calculation", false);
44 addParam("useSVD", m_useSVD, "Use SVDClusters for dE/dx calculation", true);
45 addParam("trackDistanceThreshold", m_trackDistanceThreshhold,
46 "Use a faster helix parametrisation, with corrections as soon as the approximation is more than ... cm off.", double(4.0));
47 addParam("ignoreMissingParticles", m_ignoreMissingParticles, "Ignore particles for which no PDFs are found", false);
48
49 m_eventID = -1;
50 m_trackID = 0;
51}
52
54
56{
57 //load dedx:momentum PDFs
58 if (!m_SVDDedxPDFs) B2FATAL("No SVD Dedx PDFS available");
59 if (!m_PXDDedxPDFs) B2FATAL("No PXD Dedx PDFS available");
60 int nBinsXPXD, nBinsYPXD;
61 double xMinPXD, xMaxPXD, yMinPXD, yMaxPXD;
62 nBinsXPXD = nBinsYPXD = -1;
63 xMinPXD = xMaxPXD = yMinPXD = yMaxPXD = 0.0;
64
65 int nBinsXSVD, nBinsYSVD;
66 double xMinSVD, xMaxSVD, yMinSVD, yMaxSVD;
67 nBinsXSVD = nBinsYSVD = -1;
68 xMinSVD = xMaxSVD = yMinSVD = yMaxSVD = 0.0;
69
70 for (unsigned int iPart = 0; iPart < 6; iPart++) {
71 const int pdgCode = Const::chargedStableSet.at(iPart).getPDGCode();
72 const TH2F* svd_pdf = m_SVDDedxPDFs->getSVDPDF(iPart, !m_useIndividualHits);
73 const TH2F* pxd_pdf = m_PXDDedxPDFs->getPXDPDF(iPart, !m_useIndividualHits);
74
75 if (pxd_pdf->GetEntries() == 0 || svd_pdf->GetEntries() == 0) {
77 continue;
78 B2FATAL("Couldn't find PDF for PDG " << pdgCode);
79 }
80
81 //check that PXD PDFs have the same dimensions and same binning
82 const double epsFactor = 1e-5;
83 if (nBinsXPXD == -1 and nBinsYPXD == -1) {
84 nBinsXPXD = pxd_pdf->GetNbinsX();
85 nBinsYPXD = pxd_pdf->GetNbinsY();
86 xMinPXD = pxd_pdf->GetXaxis()->GetXmin();
87 xMaxPXD = pxd_pdf->GetXaxis()->GetXmax();
88 yMinPXD = pxd_pdf->GetYaxis()->GetXmin();
89 yMaxPXD = pxd_pdf->GetYaxis()->GetXmax();
90 } else if (nBinsXPXD != pxd_pdf->GetNbinsX()
91 or nBinsYPXD != pxd_pdf->GetNbinsY()
92 or fabs(xMinPXD - pxd_pdf->GetXaxis()->GetXmin()) > epsFactor * xMaxPXD
93 or fabs(xMaxPXD - pxd_pdf->GetXaxis()->GetXmax()) > epsFactor * xMaxPXD
94 or fabs(yMinPXD - pxd_pdf->GetYaxis()->GetXmin()) > epsFactor * yMaxPXD
95 or fabs(yMaxPXD - pxd_pdf->GetYaxis()->GetXmax()) > epsFactor * yMaxPXD) {
96 B2FATAL("PDF for PDG " << pdgCode << ", PXD has binning/dimensions differing from previous PDF.");
97 }
98
99 //check that SVD PDFs have the same dimensions and same binning
100 if (nBinsXSVD == -1 and nBinsYSVD == -1) {
101 nBinsXSVD = svd_pdf->GetNbinsX();
102 nBinsYSVD = svd_pdf->GetNbinsY();
103 xMinSVD = svd_pdf->GetXaxis()->GetXmin();
104 xMaxSVD = svd_pdf->GetXaxis()->GetXmax();
105 yMinSVD = svd_pdf->GetYaxis()->GetXmin();
106 yMaxSVD = svd_pdf->GetYaxis()->GetXmax();
107 } else if (nBinsXSVD != svd_pdf->GetNbinsX()
108 or nBinsYSVD != svd_pdf->GetNbinsY()
109 or fabs(xMinSVD - svd_pdf->GetXaxis()->GetXmin()) > epsFactor * xMaxSVD
110 or fabs(xMaxSVD - svd_pdf->GetXaxis()->GetXmax()) > epsFactor * xMaxSVD
111 or fabs(yMinSVD - svd_pdf->GetYaxis()->GetXmin()) > epsFactor * yMaxSVD
112 or fabs(yMaxSVD - svd_pdf->GetYaxis()->GetXmax()) > epsFactor * yMaxSVD) {
113 B2FATAL("PDF for PDG " << pdgCode << ", PXD has binning/dimensions differing from previous PDF.");
114 }
115 }
116}
117
119{
120
121 // required inputs
122 m_tracks.isRequired();
124
125 //optional inputs
127 m_tracks.optionalRelationTo(m_mcparticles);
128
129 if (m_useSVD)
131 else
133 if (m_usePXD)
135 else
137
138 // register dE/dx data points
139 m_dedxTracks.registerInDataStore();
140 m_tracks.registerRelationTo(m_dedxTracks);
141
142 // register likelihoods
143 m_dedxLikelihoods.registerInDataStore();
144 m_tracks.registerRelationTo(m_dedxLikelihoods);
145
146 m_SVDDedxPDFs.addCallback([this]() {checkPDFs();});
147 m_PXDDedxPDFs.addCallback([this]() {checkPDFs();});
148 checkPDFs();
149
150
151 // create instances here to not confuse profiling
153
154 if (!genfit::MaterialEffects::getInstance()->isInitialized()) {
155 B2FATAL("Need to have SetupGenfitExtrapolationModule in path before this one.");
156 }
157}
158
160{
161 // go through Tracks
162 // get fitresult and gftrack and do extrapolations, save corresponding dE/dx and likelihood values
163 // get genfit::TrackCand through genfit::Track::getCand()
164 // get hit indices through genfit::TrackCand::getHit(...)
165 // create one VXDDedxTrack per fitresult/gftrack
166 //create one DedkLikelihood per Track (plus rel)
167 m_eventID++;
168
169 // inputs
170 const int numMCParticles = m_mcparticles.getEntries();
171
172 // **************************************************
173 //
174 // LOOP OVER TRACKS
175 //
176 // **************************************************
177
178 for (const auto& track : m_tracks) {
179 m_trackID++;
180
181 std::shared_ptr<VXDDedxTrack> dedxTrack = std::make_shared<VXDDedxTrack>();
182 dedxTrack->m_eventID = m_eventID;
183 dedxTrack->m_trackID = m_trackID;
184
185 // load the pion fit hypothesis or the hypothesis which is the closest in mass to a pion
186 // the tracking will not always successfully fit with a pion hypothesis
187 const TrackFitResult* fitResult = track.getTrackFitResultWithClosestMass(Const::pion);
188 if (!fitResult) {
189 B2WARNING("No related fit for track ...");
190 continue;
191 }
192
193 if (numMCParticles != 0) {
194 // find MCParticle corresponding to this track
195 const MCParticle* mcpart = track.getRelatedTo<MCParticle>();
196
197 if (mcpart) {
199 continue; //not a primary particle, ignore
200 }
201
202 //add some MC truths to VXDDedxTrack object
203 dedxTrack->m_pdg = mcpart->getPDG();
204 const MCParticle* mother = mcpart->getMother();
205 dedxTrack->m_motherPDG = mother ? mother->getPDG() : 0;
206
207 const ROOT::Math::XYZVector trueMomentum = mcpart->getMomentum();
208 dedxTrack->m_pTrue = trueMomentum.R();
209 }
210 }
211
212 // get momentum (at origin) from fit result
213 const ROOT::Math::XYZVector& trackPos = fitResult->getPosition();
214 const ROOT::Math::XYZVector& trackMom = fitResult->getMomentum();
215 dedxTrack->m_p = trackMom.R();
216 dedxTrack->m_cosTheta = cos(trackMom.Theta());
217 dedxTrack->m_charge = fitResult->getChargeSign();
218
219 // dE/dx values will be calculated using associated RecoTrack
220 const RecoTrack* recoTrack = track.getRelatedTo<RecoTrack>();
221 if (!recoTrack) {
222 B2WARNING("No related track for this fit...");
223 continue;
224 }
225
226 // Check to see if the track is pruned. We use the cardinal representation for this, as we do not expect that one
227 // representation is pruned whereas the other is not.
228 if (recoTrack->getTrackFitStatus()->isTrackPruned()) {
229 B2ERROR("GFTrack is pruned, please run VXDDedxPID only on unpruned tracks! Skipping this track.");
230 continue;
231 }
232
233 //used for PXD/SVD hits
234 const HelixHelper helixAtOrigin(trackPos, trackMom, dedxTrack->m_charge);
235
236 if (m_usePXD) {
237 const std::vector<PXDCluster*>& pxdClusters = recoTrack->getPXDHitList();
238 saveSiHits(dedxTrack.get(), helixAtOrigin, pxdClusters);
239 }
240
241 if (m_useSVD) {
242 const std::vector<SVDCluster*>& svdClusters = recoTrack->getSVDHitList();
243 saveSiHits(dedxTrack.get(), helixAtOrigin, svdClusters);
244 }
245
246 if (dedxTrack->dedx.empty()) {
247 B2DEBUG(50, "Found track with no hits, ignoring.");
248 continue;
249 }
250
251 // calculate likelihoods for truncated mean
252 if (!m_useIndividualHits) {
253 for (int detector = 0; detector <= c_SVD; detector++) {
254 if (!detectorEnabled(static_cast<Detector>(detector)))
255 continue; //unwanted detector
256
257 if (detector == 0) savePXDLogLikelihood(dedxTrack->m_vxdLogl, dedxTrack->m_p, dedxTrack->m_dedxAvgTruncated[detector]);
258 else if (detector == 1) saveSVDLogLikelihood(dedxTrack->m_vxdLogl, dedxTrack->m_p, dedxTrack->m_dedxAvgTruncated[detector]);
259 }
260 }
261
262 // add a few last things to the VXDDedxTrack
263 const int numDedx = dedxTrack->dedx.size();
264 dedxTrack->m_nHits = numDedx;
265 // no need to define lowedgetruncated and highedgetruncated as we always remove the highest 2 dE/dx values from 8 dE/dx value
266 dedxTrack->m_nHitsUsed = numDedx - 2;
267
268 // now book the information for this track
269 VXDDedxTrack* newVXDDedxTrack = m_dedxTracks.appendNew(*dedxTrack);
270 track.addRelationTo(newVXDDedxTrack);
271
272 // save VXDDedxLikelihood
273 VXDDedxLikelihood* likelihoodObj = m_dedxLikelihoods.appendNew(dedxTrack->m_vxdLogl);
274 track.addRelationTo(likelihoodObj);
275
276 } // end of loop over tracks
277}
278
280{
281
282 B2DEBUG(50, "VXDDedxPIDModule exiting after processing " << m_trackID <<
283 " tracks in " << m_eventID + 1 << " events.");
284}
285// calculateMeans need some change as we always remove highest 2 dE/dx values
286void VXDDedxPIDModule::calculateMeans(double* mean, double* truncatedMean, double* truncatedMeanErr,
287 const std::vector<double>& dedx) const
288{
289 // Calculate the truncated average by skipping only highest two value
290 std::vector<double> sortedDedx = dedx;
291 std::sort(sortedDedx.begin(), sortedDedx.end());
292
293 double truncatedMeanTmp = 0.0;
294 double meanTmp = 0.0;
295 double sumOfSquares = 0.0;
296 const int numDedx = sortedDedx.size();
297
298
299 for (int i = 0; i < numDedx; i++) {
300 meanTmp += sortedDedx[i];
301 }
302 if (numDedx != 0) {
303 meanTmp /= numDedx;
304 }
305
306 for (int i = 0; i < numDedx - 2; i++) {
307 truncatedMeanTmp += sortedDedx[i];
308 sumOfSquares += sortedDedx[i] * sortedDedx[i];
309 }
310 if (numDedx - 2 != 0) {
311 truncatedMeanTmp /= numDedx - 2;
312 }
313
314 *mean = meanTmp;
315 *truncatedMean = truncatedMeanTmp;
316
317 if (numDedx - 2 > 1) {
318 *truncatedMeanErr = sqrt(sumOfSquares / double(numDedx - 2) - truncatedMeanTmp * truncatedMeanTmp) / double(
319 (numDedx - 2) - 1);
320 } else {
321 *truncatedMeanErr = 0;
322 }
323}
324
326{
328 const VXD::SensorInfoBase& sensor = geo.getSensorInfo(hit->getSensorID());
329
330 const ROOT::Math::XYZVector localPos(hit->getU(), hit->getV(), 0.0); //z-component is height over the center of the detector plane
331 const ROOT::Math::XYZVector& globalPos = sensor.pointToGlobal(localPos);
332 const ROOT::Math::XYZVector& localMomentum = helix->momentum(helix->pathLengthToPoint(globalPos));
333
334 const ROOT::Math::XYZVector& sensorNormal = sensor.vectorToGlobal(ROOT::Math::XYZVector(0.0, 0.0, 1.0));
335 const double angle = ROOT::Math::VectorUtil::Angle(sensorNormal, localMomentum); //includes theta and phi components
336
337 //I'm assuming there's only one hit per sensor, there are _very_ rare exceptions to that (most likely curlers)
338 return TMath::Min(sensor.getWidth(), sensor.getThickness() / fabs(cos(angle)));
339}
340
341
343{
345 const VXD::SensorInfoBase& sensor = geo.getSensorInfo(hit->getSensorID());
346
347 ROOT::Math::XYZVector a, b;
348 if (hit->isUCluster()) {
349 const float u = hit->getPosition();
350 a = sensor.pointToGlobal(ROOT::Math::XYZVector(sensor.getBackwardWidth() / sensor.getWidth(0) * u, -0.5 * sensor.getLength(), 0.0));
351 b = sensor.pointToGlobal(ROOT::Math::XYZVector(sensor.getForwardWidth() / sensor.getWidth(0) * u, +0.5 * sensor.getLength(), 0.0));
352 } else {
353 const float v = hit->getPosition();
354 a = sensor.pointToGlobal(ROOT::Math::XYZVector(-0.5 * sensor.getWidth(v), v, 0.0));
355 b = sensor.pointToGlobal(ROOT::Math::XYZVector(+0.5 * sensor.getWidth(v), v, 0.0));
356 }
357 const double pathLength = helix->pathLengthToLine(ROOT::Math::XYZVector(a), ROOT::Math::XYZVector(b));
358 const ROOT::Math::XYZVector& localMomentum = helix->momentum(pathLength);
359
360 const ROOT::Math::XYZVector& sensorNormal = sensor.vectorToGlobal(ROOT::Math::XYZVector(0.0, 0.0, 1.0));
361 const double angle = ROOT::Math::VectorUtil::Angle(sensorNormal, localMomentum); //includes theta and phi components
362
363 return TMath::Min(sensor.getWidth(), sensor.getThickness() / fabs(cos(angle)));
364}
365
366
367template <class HitClass> void VXDDedxPIDModule::saveSiHits(VXDDedxTrack* track, const HelixHelper& helix,
368 const std::vector<HitClass*>& hits) const
369{
370 const int numHits = hits.size();
371 if (numHits == 0)
372 return;
373
375
376 //figure out which detector to assign hits to
377 const int currentDetector = geo.getSensorInfo(hits.front()->getSensorID()).getType();
378 assert(currentDetector == VXD::SensorInfoBase::PXD or currentDetector == VXD::SensorInfoBase::SVD);
379 assert(currentDetector <= 1); //used as array index
380
381 std::vector<double> siliconDedx; //used for averages
382 siliconDedx.reserve(numHits);
383
384 VxdID prevSensor;
385 for (int i = 0; i < numHits; i++) {
386 const HitClass* hit = hits[i];
387 if (!hit) {
388 B2ERROR("Added hit is a null pointer!");
389 continue;
390 }
391 const VxdID& currentSensor = hit->getSensorID();
392 int layer = -currentSensor.getLayerNumber();
393 assert(layer >= -6 && layer < 0);
394
395 //active medium traversed, in cm (can traverse one sensor at most)
396 //assumption: Si detectors are close enough to the origin that helix is still accurate
397 const double totalDistance = getTraversedLength(hit, &helix);
398 const float charge = hit->getCharge();
399 const float dedx = charge / totalDistance;
400 if (dedx <= 0) {
401 B2WARNING("dE/dx is " << dedx << " in layer " << layer);
402 } else if (i == 0 or prevSensor != currentSensor) { //only save once per sensor (u and v hits share charge!)
403 prevSensor = currentSensor;
404 //store data
405 siliconDedx.push_back(dedx);
406 track->m_dedxAvg[currentDetector] += dedx;
407 track->addDedx(layer, totalDistance, dedx);
409 if (currentDetector == 0) savePXDLogLikelihood(track->m_vxdLogl, track->m_p, dedx);
410 else if (currentDetector == 1) saveSVDLogLikelihood(track->m_vxdLogl, track->m_p, dedx);
411 }
412 }
413
414 track->addHit(currentSensor, layer, charge, totalDistance, dedx);
415 }
416
417 //save averages
418 calculateMeans(&(track->m_dedxAvg[currentDetector]),
419 &(track->m_dedxAvgTruncated[currentDetector]),
420 &(track->m_dedxAvgTruncatedErr[currentDetector]),
421 siliconDedx);
422}
423
424void VXDDedxPIDModule::savePXDLogLikelihood(double(&logl)[Const::ChargedStable::c_SetSize], double p, float dedx) const
425{
426 //all pdfs have the same dimensions
427 const TH2F* pdf = m_PXDDedxPDFs->getPXDPDF(0, !m_useIndividualHits);
428 const Int_t binX = pdf->GetXaxis()->FindFixBin(p);
429 const Int_t binY = pdf->GetYaxis()->FindFixBin(dedx);
430
431 for (unsigned int iPart = 0; iPart < Const::ChargedStable::c_SetSize; iPart++) {
432 pdf = m_PXDDedxPDFs->getPXDPDF(iPart, !m_useIndividualHits);
433 if (pdf->GetEntries() == 0) //might be NULL if m_ignoreMissingParticles is set
434 continue;
435 double probability = 0.0;
436
437 //check if this is still in the histogram, take overflow bin otherwise
438 if (binX < 1 or binX > pdf->GetNbinsX()
439 or binY < 1 or binY > pdf->GetNbinsY()) {
440 probability = pdf->GetBinContent(binX, binY);
441 } else {
442 //in normal histogram range. Of course ROOT has a bug that Interpolate()
443 //is not declared as const but it does not modify the internal state so
444 //fine, const_cast it is.
445 probability = const_cast<TH2F*>(pdf)->Interpolate(p, dedx);
446 }
447
448 if (probability != probability)
449 B2ERROR("probability NAN for a track with p=" << p << " and dedx=" << dedx);
450
451 //my pdfs aren't perfect...
452 if (probability == 0.0)
453 probability = m_useIndividualHits ? (1e-5) : (1e-3); //likelihoods for truncated mean are much higher
454
455 logl[iPart] += log(probability);
456 }
457}
458
459void VXDDedxPIDModule::saveSVDLogLikelihood(double(&logl)[Const::ChargedStable::c_SetSize], double p, float dedx) const
460{
461 //all pdfs have the same dimensions
462 const TH2F* pdf = m_SVDDedxPDFs->getSVDPDF(0, !m_useIndividualHits);
463 const Int_t binX = pdf->GetXaxis()->FindFixBin(p);
464 const Int_t binY = pdf->GetYaxis()->FindFixBin(dedx);
465
466 for (unsigned int iPart = 0; iPart < Const::ChargedStable::c_SetSize; iPart++) {
467 pdf = m_SVDDedxPDFs->getSVDPDF(iPart, !m_useIndividualHits);
468 if (pdf->GetEntries() == 0) //might be NULL if m_ignoreMissingParticles is set
469 continue;
470 double probability = 0.0;
471
472 //check if this is still in the histogram, take overflow bin otherwise
473 if (binX < 1 or binX > pdf->GetNbinsX()
474 or binY < 1 or binY > pdf->GetNbinsY()) {
475 probability = pdf->GetBinContent(binX, binY);
476 } else {
477 //in normal histogram range. Of course ROOT has a bug that Interpolate()
478 //is not declared as const but it does not modify the internal state so
479 //fine, const_cast it is.
480 probability = const_cast<TH2F*>(pdf)->Interpolate(p, dedx);
481 }
482
483 if (probability != probability)
484 B2ERROR("probability NAN for a track with p=" << p << " and dedx=" << dedx);
485
486 //my pdfs aren't perfect...
487 if (probability == 0.0)
488 probability = m_useIndividualHits ? (1e-5) : (1e-3); //likelihoods for truncated mean are much higher
489
490 logl[iPart] += log(probability);
491 }
492}
static const unsigned int c_SetSize
Number of elements (for use in array bounds etc.)
Definition: Const.h:615
const ParticleType & at(unsigned int index) const
Return particle at given index, or end() if out of range.
Definition: Const.h:549
int getPDGCode() const
PDG code.
Definition: Const.h:473
static const ParticleSet chargedStableSet
set of charged stable particles
Definition: Const.h:618
static const ChargedStable pion
charged pion particle
Definition: Const.h:661
Helper class representing a helical track.
Definition: HelixHelper.h:28
double pathLengthToPoint(const ROOT::Math::XYZVector &p) const
returns the path length (along the helix) to the helix point closest to p.
Definition: HelixHelper.h:68
ROOT::Math::XYZVector momentum(double s=0) const
momentum of the particle, at the helix point corresponding to a flown path length s (from poca).
Definition: HelixHelper.h:109
double pathLengthToLine(const ROOT::Math::XYZVector &a, const ROOT::Math::XYZVector &b) const
returns the path length (along the helix) to the helix point closest to the line going through points...
Definition: HelixHelper.h:87
A Class to store the Monte Carlo particle information.
Definition: MCParticle.h:32
@ c_PrimaryParticle
bit 0: Particle is primary particle.
Definition: MCParticle.h:47
bool hasStatus(unsigned short int bitmask) const
Return if specific status bit is set.
Definition: MCParticle.h:129
int m_pdg
PDG-Code of the particle.
Definition: MCParticle.h:541
int getPDG() const
Return PDG code of particle.
Definition: MCParticle.h:112
ROOT::Math::XYZVector getMomentum() const
Return momentum.
Definition: MCParticle.h:198
Base class for Modules.
Definition: Module.h:72
void setDescription(const std::string &description)
Sets the description of the module.
Definition: Module.cc:214
void setPropertyFlags(unsigned int propertyFlags)
Sets the flags for the module properties.
Definition: Module.cc:208
@ c_ParallelProcessingCertified
This module can be run in parallel processing mode safely (All I/O must be done through the data stor...
Definition: Module.h:80
The PXD Cluster class This class stores all information about reconstructed PXD clusters The position...
Definition: PXDCluster.h:30
This is the Reconstruction Event-Data Model Track.
Definition: RecoTrack.h:79
std::vector< Belle2::RecoTrack::UsedPXDHit * > getPXDHitList() const
Return an unsorted list of pxd hits.
Definition: RecoTrack.h:449
std::vector< Belle2::RecoTrack::UsedSVDHit * > getSVDHitList() const
Return an unsorted list of svd hits.
Definition: RecoTrack.h:452
const genfit::FitStatus * getTrackFitStatus(const genfit::AbsTrackRep *representation=nullptr) const
Return the track fit status for the given representation or for the cardinal one. You are not allowed...
Definition: RecoTrack.h:621
The SVD Cluster class This class stores all information about reconstructed SVD clusters.
Definition: SVDCluster.h:29
bool isRequired(const std::string &name="")
Ensure this array/object has been registered previously.
bool isOptional(const std::string &name="")
Tell the DataStore about an optional input.
int getEntries() const
Get the number of objects in the array.
Definition: StoreArray.h:216
Values of the result of a track fit with a given particle hypothesis.
short getChargeSign() const
Return track charge (1 or -1).
ROOT::Math::XYZVector getMomentum() const
Getter for vector of momentum at closest approach of track in r/phi projection.
ROOT::Math::XYZVector getPosition() const
Getter for vector of position at closest approach of track in r/phi projection.
Container for likelihoods obtained by the VXD dE/dx PID (VXDDedxPIDModule).
void saveSVDLogLikelihood(double(&logl)[Const::ChargedStable::c_SetSize], double p, float dedx) const
for all particles in the SVD, save log-likelihood values into 'logl'.
DBObjPtr< SVDdEdxPDFs > m_SVDDedxPDFs
SVD DB object for dedx:momentum PDFs.
int m_trackID
counter for tracks in this event
virtual void initialize() override
Initialize the module.
StoreArray< SVDCluster > m_svdClusters
Optional array of SVDClusters.
bool m_usePXD
use PXD hits for likelihood
virtual void event() override
This method is called for each event.
StoreArray< MCParticle > m_mcparticles
Optional array of MCParticles.
StoreArray< VXDDedxLikelihood > m_dedxLikelihoods
Output array of VXDDedxLikelihoods.
void checkPDFs()
Check the pdfs for consistency every time they change in the database.
virtual void terminate() override
End of the event processing.
void saveSiHits(VXDDedxTrack *track, const HelixHelper &helix, const std::vector< HitClass * > &hits) const
save energy loss and hit information from SVD/PXDHits to track
DBObjPtr< PXDdEdxPDFs > m_PXDDedxPDFs
PXD DB object for dedx:momentum PDFs.
void calculateMeans(double *mean, double *truncatedMean, double *truncatedMeanErr, const std::vector< double > &dedx) const
Save arithmetic and truncated mean for the 'dedx' values.
StoreArray< VXDDedxTrack > m_dedxTracks
Output array of VXDDedxTracks.
virtual ~VXDDedxPIDModule()
Destructor.
int m_eventID
counter for events
bool m_useSVD
use SVD hits for likelihood
bool detectorEnabled(Dedx::Detector d) const
should info from this detector be included in likelihood?
bool m_ignoreMissingParticles
Ignore particles for which no PDFs are found.
StoreArray< Track > m_tracks
Required array of Tracks.
bool m_onlyPrimaryParticles
Only save data for primary particles (as determined by MC truth)
StoreArray< PXDCluster > m_pxdClusters
Optional array of PXDClusters.
static double getTraversedLength(const PXDCluster *hit, const HelixHelper *helix)
returns traversed length through active medium of given PXDCluster.
StoreArray< RecoTrack > m_recoTracks
Required array of input RecoTracks.
bool m_useIndividualHits
Include PDF value for each hit in likelihood.
VXDDedxPIDModule()
Default constructor.
double m_trackDistanceThreshhold
Use a faster helix parametrisation, with corrections as soon as the approximation is more than ....
void savePXDLogLikelihood(double(&logl)[Const::ChargedStable::c_SetSize], double p, float dedx) const
for all particles in the PXD, save log-likelihood values into 'logl'.
Debug output for VXDDedxPID module.
Definition: VXDDedxTrack.h:27
Class to faciliate easy access to sensor information of the VXD like coordinate transformations or pi...
Definition: GeoCache.h:39
const SensorInfoBase & getSensorInfo(Belle2::VxdID id) const
Return a referecne to the SensorInfo of a given SensorID.
Definition: GeoCache.cc:67
static GeoCache & getInstance()
Return a reference to the singleton instance.
Definition: GeoCache.cc:214
Base class to provide Sensor Information for PXD and SVD.
SensorType getType() const
Return the Type of the Sensor.
Class to uniquely identify a any structure of the PXD and SVD.
Definition: VxdID.h:33
baseType getLayerNumber() const
Get the layer id.
Definition: VxdID.h:96
void addParam(const std::string &name, T &paramVariable, const std::string &description, const T &defaultValue)
Adds a new parameter to the module.
Definition: Module.h:560
#define REG_MODULE(moduleName)
Register the given module (without 'Module' suffix) with the framework.
Definition: Module.h:650
double sqrt(double a)
sqrt for double
Definition: beamHelpers.h:28
MCParticle * getMother() const
Returns a pointer to the mother particle.
Definition: MCParticle.h:600
Abstract base class for different kinds of events.