StRoot  1
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Groups Pages
StFwdClosureMaker.cxx
1 #include "StFwdTrackMaker/StFwdClosureMaker.h"
2 #include "St_base/StMessMgr.h"
3 #include "StBFChain/StBFChain.h"
4 #include "StFwdTrackMaker/StFwdTrackMaker.h"
5 
6 #include "StFwdTrackMaker/include/Tracker/FwdTracker.h"
7 #include "StFwdTrackMaker/include/Tracker/ObjExporter.h"
8 // StEvent includes
9 #include "StEvent/StBTofCollection.h"
10 #include "StEvent/StBTofHeader.h"
11 #include "StEvent/StEvent.h"
12 #include "StEvent/StFttCluster.h"
13 #include "StEvent/StFttCollection.h"
14 #include "StEvent/StFcsCluster.h"
15 #include "StEvent/StFcsCollection.h"
16 #include "StFcsDbMaker/StFcsDb.h"
17 #include "StRoot/StEpdUtil/StEpdGeom.h"
18 #include "StEvent/StFwdTrackCollection.h"
19 #include "StEvent/StFwdTrack.h"
20 #include "TPad.h"
21 
22 #include "StMuDSTMaker/COMMON/StMuDstMaker.h"
23 #include "StMuDSTMaker/COMMON/StMuDst.h"
24 #include "StMuDSTMaker/COMMON/StMuEvent.h"
25 #include "StMuDSTMaker/COMMON/StMuFstCollection.h"
26 #include "StMuDSTMaker/COMMON/StMuFstHit.h"
27 #include "StMuDSTMaker/COMMON/StMuPrimaryVertex.h"
28 #include "StMuDSTMaker/COMMON/StMuFwdTrack.h"
29 #include "StMuDSTMaker/COMMON/StMuFwdTrackCollection.h"
30 #include "StMuDSTMaker/COMMON/StMuFcsCollection.h"
31 #include "StMuDSTMaker/COMMON/StMuFcsCluster.h"
32 #include "StMuDSTMaker/COMMON/StMuFcsHit.h"
33 #include "StMuDSTMaker/COMMON/StMuFttCluster.h"
34 #include "StMuDSTMaker/COMMON/StMuFttPoint.h"
35 #include "StMuDSTMaker/COMMON/StMuMcTrack.h"
36 #include "StMuDSTMaker/COMMON/StMuFstHit.h"
37 
38 #include "tables/St_g2t_fts_hit_Table.h"
39 #include "tables/St_g2t_track_Table.h"
40 #include "tables/St_g2t_vertex_Table.h"
41 #include "tables/St_g2t_event_Table.h"
42 
43 /* StFwdClosureMaker.cxx
44  * This maker is a simple example of how to use the genfit package to fit tracks in the FWD
45  * It is a simple maker that uses the GEANT information to fit tracks in the FWD detectors
46  * The goal is to provide closure tests tracking
47  */
48 
49 TVector3 StFwdClosureMaker::raster(TVector3 p0) {
50 
51  TVector3 p = p0;
52  double r = p.Perp();
53  double phi = p.Phi();
54  const double minR = 5.0;
55  // 5.0 is the r minimum of the Si
56  p.SetPerp(minR + (std::floor((r - minR) / mRasterR) * mRasterR + mRasterR / 2.0));
57  p.SetPhi(-TMath::Pi() + (std::floor((phi + TMath::Pi()) / mRasterPhi) * mRasterPhi + mRasterPhi / 2.0));
58  return p;
59 }
60 
61 TMatrixDSym StFwdClosureMaker::makeSiCovMat(TVector3 hit) {
62  // we can calculate the CovMat since we know the det info, but in future we should probably keep this info in the hit itself
63  // measurements on a plane only need 2x2
64  // for Si geom we need to convert from cylindrical to cartesian coords
65  TMatrixDSym cm(2);
66  TMatrixD T(2, 2);
67  TMatrixD J(2, 2);
68  const float x = hit.X();
69  const float y = hit.Y();
70  const float R = sqrt(x * x + y * y);
71  const float cosphi = x / R;
72  const float sinphi = y / R;
73  const float sqrt12 = sqrt(12.);
74 
75  const float dr = mRasterR / sqrt12;
76  const float dphi = (mRasterPhi) / sqrt12;
77 
78  // Setup the Transposed and normal Jacobian transform matrix;
79  // note, the si fast sim did this wrong
80  // row col
81  T(0, 0) = cosphi;
82  T(0, 1) = -R * sinphi;
83  T(1, 0) = sinphi;
84  T(1, 1) = R * cosphi;
85 
86  J(0, 0) = cosphi;
87  J(0, 1) = sinphi;
88  J(1, 0) = -R * sinphi;
89  J(1, 1) = R * cosphi;
90 
91  TMatrixD cmcyl(2, 2);
92  cmcyl(0, 0) = dr * dr;
93  cmcyl(1, 1) = dphi * dphi;
94 
95  TMatrixD r = T * cmcyl * J;
96 
97  // note: float sigmaX = sqrt(r(0, 0));
98  // note: float sigmaY = sqrt(r(1, 1));
99 
100  cm(0, 0) = r(0, 0);
101  cm(1, 1) = r(1, 1);
102  cm(0, 1) = r(0, 1);
103  cm(1, 0) = r(1, 0);
104 
105  TMatrixDSym tamvoc(3);
106  tamvoc( 0, 0 ) = cm(0, 0); tamvoc( 0, 1 ) = cm(0, 1); tamvoc( 0, 2 ) = 0.0;
107  tamvoc( 1, 0 ) = cm(1, 0); tamvoc( 1, 1 ) = cm(1, 1); tamvoc( 1, 2 ) = 0.0;
108  tamvoc( 2, 0 ) = 0.0; tamvoc( 2, 1 ) = 0.0; tamvoc( 2, 2 ) = 0.01*0.01;
109 
110 
111  return tamvoc;
112 }
113 
114 StFwdClosureMaker::StFwdClosureMaker() : StMaker("fwdClosureMaker") {}
115 
116 TGeoManager * gMan = nullptr;
117 std::unique_ptr<genfit::AbsKalmanFitter> mFitter = nullptr;
118 std::unique_ptr<genfit::AbsBField> mBField;
119 std::map< string, TH1* > mHistograms;
120 
121 TH1 * addHistogram1D( string name, string title, int nbins, double min, double max ){
122  TH1 * h = new TH1F( name.c_str(), title.c_str(), nbins, min, max );
123  mHistograms[name] = h;
124  return h;
125 }
126 
127 TH2 * addHistogram2D( string name, string title, int nbinsX, double minX, double maxX, int nbinsY, double minY, double maxY ){
128  TH2 * h = new TH2F( name.c_str(), title.c_str(), nbinsX, minX, maxX, nbinsY, minY, maxY );
129  mHistograms[name] = h;
130  return h;
131 }
132 
133 TH1 * getHistogram1D( string name ){
134  if ( mHistograms.count(name) )
135  return mHistograms[name];
136  assert( false && "Histogram not found" );
137  return nullptr;
138 }
139 TH2 * getHistogram2D( string name ){
140  return dynamic_cast<TH2*>( getHistogram1D(name) );
141 }
142 
143 struct Point {
144  double x, y;
145 };
146 
147 // Function to calculate the determinant of a 2x2 matrix
148 double determinant(double a, double b, double c, double d) {
149  return a * d - b * c;
150 }
151 
152 // Function to compute the curvature of a circle given 3 points
153 double computeCurvature(const Point& p1, const Point& p2, const Point& p3) {
154  // Calculate the lengths of the sides of the triangle
155  double A = std::sqrt(std::pow(p2.x - p1.x, 2) + std::pow(p2.y - p1.y, 2));
156  double B = std::sqrt(std::pow(p3.x - p2.x, 2) + std::pow(p3.y - p2.y, 2));
157  double C = std::sqrt(std::pow(p1.x - p3.x, 2) + std::pow(p1.y - p3.y, 2));
158 
159  // Calculate the determinant of the matrix formed by the points
160  double det = determinant(p2.x - p1.x, p2.y - p1.y, p3.x - p1.x, p3.y - p1.y);
161  // LOG_INFO << "Det: " << det << endm;
162  double charge = det > 0 ? -1 : 1;
163  // Area of the triangle formed by the three points
164  double area = std::abs(det) / 2.0;
165 
166  if (area == 0) {
167  std::cerr << "The points are collinear, curvature is undefined." << std::endl;
168  return -1; // Curvature is undefined for collinear points
169  }
170 
171  // Calculate the radius of the circumcircle using the formula:
172  // R = (A * B * C) / (4 * area)
173  double radius = (A * B * C) / (4 * area);
174  // LOG_INFO << "Radius: " << radius << endm;
175  // Curvature is the inverse of the radius
176  return charge / radius;
177 }
178 
179 int StFwdClosureMaker::Init() {
180 
181  /******************************************************
182  * Setup GenFit
183  */
184  // Setup the Geometry used by GENFIT
185  TGeoManager::Import("fGeom.root");
186  gMan = gGeoManager;
187  // Set up the material interface and set material effects on/off from the config
188  genfit::MaterialEffects::getInstance()->init(new genfit::TGeoMaterialInterface());
189  genfit::MaterialEffects::getInstance()->setNoEffects( true );
190  // Setup the BField to use
191  // mBField = std::unique_ptr<genfit::AbsBField>(new genfit::ConstField(0., 0., 5)); // 0.5 T Bz
192  mBField = std::unique_ptr<genfit::AbsBField>(new StarFieldAdaptor());
193  genfit::FieldManager::getInstance()->init(mBField.get());
194 
195  // initialize the main mFitter using a KalmanFitter with reference tracks
196  mFitter = std::unique_ptr<genfit::AbsKalmanFitter>(new genfit::KalmanFitterRefTrack(
197  /*maxIterations = */ mMaxIt,
198  /*deltaPval = */ mPVal,
199  /*blowUpFactor = */ mBlowUp
200  ));
201 
202  mFitter->setRelChi2Change( mRelChi2 );
203 
204  // Setup the histograms
205  addHistogram2D( "PtCorrelation", "PtCorrelation; MC; RC;", 100, 0, 1, 100, 0, 1 );
206  addHistogram1D( "PtResolution", "PtResolution; (p_{T}^{MC} - p_{T}^{RC}) / p_{T}^{MC};", 100, -5, 5 );
207  addHistogram1D( "CurveResolution", "CurveResolution; (1/p_{T}^{MC} - 1/p_{T}^{RC}) / 1/p_{T}^{MC};", 100, -5, 5 );
208  addHistogram2D( "CurveResolutionVsPt", "CurveResolution; Pt (GeV/c); (1/p_{T}^{MC} - 1/p_{T}^{RC}) / 1/p_{T}^{MC};", 100, 0, 2.0, 100, -5, 5 );
209  addHistogram2D( "PtResolutionVsPt", "PtResolution; Pt (GeV/c); (p_{T}^{MC} - p_{T}^{RC}) / p_{T}^{MC};", 100, 0, 2.0, 100, -5, 5 );
210  addHistogram1D( "PointCurvePtResolution", "PointCurve PtResolution; (p_{T}^{MC} - p_{T}^{RC}) / p_{T}^{MC};", 100, -5, 5 );
211  addHistogram1D( "PointCurveCurveResolution", "PointCurve CurveResolution; (1/p_{T}^{MC} - 1/p_{T}^{RC}) / 1/p_{T}^{MC};", 100, -5, 5 );
212 
213  addHistogram1D( "QCurve", "QCurve; q/Pt;", 100, -5, 5 );
214  addHistogram2D( "QMatrix", "QMatrix; MC; RC;", 4, -2, 2, 4, -2, 2 );
215  addHistogram2D( "QidVsPt", "QMatrix; Pt; Qid;", 100, 0, 2.0, 2, -0.5, 1.5 );
216  return kStOk;
217 }
218 
219 
220 
222 
223  getHistogram1D("PtResolution")->Draw();
224  gPad->Print( "ClosurePtResolution.pdf" );
225 
226  getHistogram1D("CurveResolution")->Draw();
227  gPad->Print( "ClosureCurveResolution.pdf" );
228 
229  getHistogram1D("PointCurvePtResolution")->Draw();
230  gPad->Print( "ClosurePointCurvePtResolution.pdf" );
231 
232  getHistogram1D("PointCurveCurveResolution")->Draw();
233  gPad->Print( "ClosurePointCurveCurveResolution.pdf" );
234 
235  TFile * fOut = new TFile(mOutFile, "RECREATE");
236  fOut->cd();
237  for ( auto h : mHistograms ){
238  h.second->Write();
239  }
240 
241  return kStOk;
242 }
243 
244 
246  LOG_INFO << "Make (StFwdClosureMaker)" << endm;
247 
248  /*****************************************************
249  * Load the MC Vertex
250  */
251  St_g2t_vertex *g2t_vertex = (St_g2t_vertex *)GetDataSet("geant/g2t_vertex");
252  if (!g2t_vertex)
253  return 0;
254 
255  /*****************************************************
256  * Load the MC Tracks
257  */
258  // Store the McMomentum for the first track (assuming single particle gun)
259  TVector3 mcMom(0,0,0);
260  int mcQ = 0;
261  // Get geant tracks
262  St_g2t_track *g2t_track = (St_g2t_track *)GetDataSet("geant/g2t_track");
263  if (!g2t_track)
264  return 0;
265 
266  LOG_DEBUG << g2t_track->GetNRows() << " mc tracks in geant/g2t_track " << endm;
267  // Load the MC track info
268  for (int irow = 0; irow < g2t_track->GetNRows(); irow++) {
269  g2t_track_st *track = (g2t_track_st *)g2t_track->At(irow);
270 
271  if (0 == track)
272  continue;
273 
274  int track_id = track->id;
275  float pt2 = track->p[0] * track->p[0] + track->p[1] * track->p[1];
276  float pt = std::sqrt(pt2);
277  float eta = track->eta;
278  TVector3 pp( track->p[0], track->p[1], track->p[2] );
279  if ( track_id == 1 ){
280  mcMom.SetXYZ( track->p[0], track->p[1], track->p[2] );
281  mcQ = track->charge;
282  }
283  float phi = std::atan2(track->p[1], track->p[0]); //track->phi;
284  int q = track->charge;
285  LOG_INFO << "McTrack: " << track_id << ", pt = " << pt << ", eta = " << eta << ", phi = " << phi << ", q = " << q << endm;
286  }
287 
288 
289 
290  vector<genfit::SpacepointMeasurement*> spoints;
291 
292  /*****************************************************
293  * Load the FST hits
294  */
295  St_g2t_fts_hit *g2t_fsi_hits = (St_g2t_fts_hit *)GetDataSet("geant/g2t_fsi_hit");
296  if ( !g2t_fsi_hits ){
297  LOG_DEBUG << "No g2t_fts_hits, cannot load FST hits from GEANT" << endm;
298  return 0;
299  }
300 
301  // reuse this to store cov mat
302  TMatrixDSym hitCov3(3);
303  const double sigXY = 0.01;
304  hitCov3(0, 0) = sigXY * sigXY;
305  hitCov3(1, 1) = sigXY * sigXY;
306  hitCov3(2, 2) = 0.1;
307 
308  TMatrixDSym vStripCov3(3);
309  vStripCov3(0, 0) = sigXY * sigXY;
310  vStripCov3(1, 1) = 50;
311  vStripCov3(2, 2) = 0.1;
312 
313  TMatrixDSym hStripCov3(3);
314  hStripCov3(0, 0) = 50;
315  hStripCov3(1, 1) = sigXY * sigXY;
316  hStripCov3(2, 2) = 0.1;
317 
318  /*****************************************************
319  * Add Primary Vertex to the track
320  */
321  if ( g2t_vertex != nullptr ) {
322  // Set the MC Vertex for track fitting
323  g2t_vertex_st *vert = (g2t_vertex_st*)g2t_vertex->At(0);
324  TMatrixDSym cov;
325  cov.ResizeTo(3, 3);
326  cov(0, 0) = pow(mPrimaryVertexSigXY,2);
327  cov(1, 1) = pow(mPrimaryVertexSigXY,2);
328  cov(2, 2) = pow(mPrimaryVertexSigZ, 2);
329  auto rhc = TVectorD( 3 );
330  rhc[0] = vert->ge_x[0];
331  rhc[1] = vert->ge_x[1];
332  rhc[2] = vert->ge_x[2];
333  auto spoint = new genfit::SpacepointMeasurement(rhc, cov, 0, 0, nullptr);
334  spoints.push_back(spoint);
335  // mForwardTracker->setEventVertex( TVector3( vert->ge_x[0], vert->ge_x[1], vert->ge_x[2] ), cov );
336  }
337 
338  /*****************************************************
339  * Add FST hits to the track
340  */
341  for (int i = 0; i < g2t_fsi_hits->GetNRows(); i++) {
342 
343  g2t_fts_hit_st *git = (g2t_fts_hit_st *)g2t_fsi_hits->At(i);
344  if (0 == git)
345  continue; // geant hit
346 
347  // int track_id = git->track_p;
348  int volume_id = git->volume_id; // 4, 5, 6
349  int d = volume_id / 1000; // disk id
350 
351  // int plane_id = d - 4;
352  float x = git->x[0];
353  float y = git->x[1];
354  float z = git->x[2];
355 
356  auto rhc = TVectorD( 3 );
357  TVector3 rastered = raster( TVector3( x, y, z ) );
358  rhc[0] = rastered.X();
359  rhc[1] = rastered.Y();
360  rhc[2] = rastered.Z();
361  auto spoint = new genfit::SpacepointMeasurement(rhc, makeSiCovMat(TVector3( x, y, z )), 0, i+1, nullptr);
362  spoints.push_back(spoint);
363  LOG_INFO << "FST HIT: d = " << d << ", x=" << x << ", y=" << y << ", z=" << z << endm;
364  }
365 
366  St_g2t_fts_hit *g2t_stg_hits = (St_g2t_fts_hit *)GetDataSet("geant/g2t_stg_hit");
367  if (!g2t_stg_hits){
368  LOG_WARN << "geant/g2t_stg_hit is empty" << endm;
369  return kStOk;
370  }
371  int nstg = g2t_stg_hits->GetNRows();
372 
373  LOG_DEBUG << "This event has " << nstg << " stg hits in geant/g2t_stg_hit " << endm;
374  int nFttHits = 0;
375  for (int i = 0; i < nstg; i++) {
376 
377  g2t_fts_hit_st *git = (g2t_fts_hit_st *)g2t_stg_hits->At(i);
378  if (0 == git)
379  continue; // geant hit
380  // int track_id = git->track_p;
381  int volume_id = git->volume_id;
382  int plane_id = (volume_id - 1) / 100; // from 1 - 16. four chambers per station
383 
384  // only use the hits on the front modules
385  if ( mFttMode == kPoint && volume_id % 2 ==0 )
386  continue;
387 
388  float x = git->x[0];
389  float y = git->x[1];
390  float z = git->x[2];
391 
392  if (plane_id < 0 || plane_id >= 4) {
393  continue;
394  }
395 
396  auto rhc = TVectorD( 3 );
397  rhc[0] = x;
398  rhc[1] = y;
399  rhc[2] = z;
400  LOG_INFO << "FTT HIT: plane_id = " << plane_id << ", volume_d = " << volume_id << " x=" << x << ", y=" << y << ", z=" << z << endm;
401 
402  if ( kPoint == mFttMode ){
403  auto spoint = new genfit::SpacepointMeasurement(rhc, hitCov3, 0, i+4, nullptr);
404  if ( nFttHits < mNumFttToUse )
405  spoints.push_back(spoint);
406  } else {
407  if ( volume_id % 2 == 0 ){
408  auto spoint = new genfit::SpacepointMeasurement(rhc, vStripCov3, 0, i+4, nullptr);
409  if ( nFttHits < mNumFttToUse )
410  spoints.push_back(spoint);
411  } else {
412  auto spoint = new genfit::SpacepointMeasurement(rhc, hStripCov3, 0, i+4, nullptr);
413  if ( nFttHits < mNumFttToUse )
414  spoints.push_back(spoint);
415  }
416  }
417 
418  nFttHits++;
419  }
420 
421  float ptCurve = 9999.0;
422  float qCurve = 1.0;
423  if ( spoints.size() >= 3 ){
424  double curve = computeCurvature( {spoints[0]->getRawHitCoords()[0], spoints[0]->getRawHitCoords()[1]},
425  {spoints[1]->getRawHitCoords()[0], spoints[1]->getRawHitCoords()[1]},
426  {spoints[2]->getRawHitCoords()[0], spoints[2]->getRawHitCoords()[1]} );
427  const double K = 0.00029979; //K depends on the units used for Bfield
428  const double BStrength = 5; // 0.5 T
429  double pt = fabs((K*BStrength)/curve); // pT from average measured curv
430  qCurve = curve > 0 ? 1 : -1;
431  ptCurve = pt;
432  LOG_INFO << "Curve: " << curve << ", Pt: " << pt << endm;
433  }
434 
435 
436  /*****************************************************
437  * Setup the Genfit Fit Track
438  */
439  auto theTrackRep = new genfit::RKTrackRep(-13 * qCurve);
440  auto seedPos = TVector3(0, 0, 0);
441  auto seedMom = TVector3(0, 0, 10);
442  // seedMom.SetPtEtaPhi( ptCurve, 3.0, 0 );
443  auto mFitTrack = std::make_shared<genfit::Track>(theTrackRep, seedPos, seedMom);
444 
445  LOG_INFO << "Track fit with " << spoints.size() << " space points" << endm;
446  try {
447  for ( size_t i = 0; i < spoints.size(); i++ ){
448  mFitTrack->insertPoint(new genfit::TrackPoint(spoints[i], mFitTrack.get()));
449  }
450 
451  LOG_INFO << "Track prep = " << mFitter->isTrackPrepared( mFitTrack.get(), theTrackRep ) << endm;
452 
453  // mFitter->checkConsistency();
454  mFitTrack->checkConsistency();
455  // mFitter->processTrack(mFitTrack.get());
456  mFitter->processTrack(mFitTrack.get());
457 
458  mFitTrack->checkConsistency();
459  mFitTrack->determineCardinalRep();
460 
461  // mFitter->processTrack(mFitTrack.get());
462 
463 
464  auto status = mFitTrack->getFitStatus();
465  LOG_INFO << "Fit status: " << status->isFitConverged() << endm;
466  LOG_INFO << "-Fit pvalue: " << status->getPVal() << endm;
467  LOG_INFO << "-Fit Chi2: " << status->getChi2() << endm;
468 
469 
470 
471  auto cr = mFitTrack->getCardinalRep();
472  auto p = cr->getMom( mFitTrack->getFittedState( 0, cr ));
473  int rcQ = status->getCharge();
474  LOG_INFO << "Fit momentum: " << p.X() << ", " << p.Y() << ", " << p.Z() << endm;
475  LOG_INFO << "\tFit Pt: " << p.Pt() << ", eta: " << p.Eta() << ", phi: " << p.Phi() << endm;
476  LOG_INFO << "\tMc Pt: " << mcMom.Pt() << ", eta: " << mcMom.Eta() << ", phi: " << mcMom.Phi() << endm;
477 
478 
479  if (status->isFitConvergedPartially()){
480  getHistogram1D("PtResolution")->Fill( (p.Pt() - mcMom.Pt()) / mcMom.Pt() );
481  getHistogram1D("CurveResolution")->Fill( (1/p.Pt() - 1/mcMom.Pt()) / (1/mcMom.Pt()) );
482  getHistogram1D("PtCorrelation")->Fill( mcMom.Pt(), p.Pt() );
483  getHistogram1D("QCurve")->Fill( rcQ / p.Pt() );
484 
485  getHistogram1D("PointCurvePtResolution")->Fill( (ptCurve - mcMom.Pt()) / mcMom.Pt() );
486  getHistogram1D("PointCurveCurveResolution")->Fill( (1/ptCurve - 1/mcMom.Pt()) / (1/mcMom.Pt()) );
487 
488  getHistogram2D("PtResolutionVsPt")->Fill( mcMom.Pt(), (p.Pt() - mcMom.Pt()) / mcMom.Pt() );
489  getHistogram2D("CurveResolutionVsPt")->Fill( mcMom.Pt(), (1/p.Pt() - 1/mcMom.Pt()) / (1/mcMom.Pt()) );
490 
491  getHistogram2D("QMatrix")->Fill( mcQ, rcQ );
492  getHistogram2D("QidVsPt")->Fill( mcMom.Pt(), mcQ == rcQ ? 1 : 0 );
493  }
494  else {
495  LOG_INFO << "Fit did not converge" << endm;
496  }
497 
498 
499  } catch (genfit::Exception &e) {
500  LOG_ERROR << "GenFit failed to fit track with: " << e.what() << endm;
501  }
502 
503  // load the space points from fst geant hits
504 
505 
506  // for (size_t i = 0; i < trackSeed.size(); i++) {
507  // auto seed = trackSeed[i];
508  // TMatrixDSym cm(3);
509  // cm(0, 0) = 0.01;
510  // cm(1, 1) = 0.01;
511  // cm(2, 2) = 0.01;
512  // auto rhc = TVectorD( 3 );
513  // rhc[0] = seed->getX();
514  // rhc[1] = seed->getY();
515  // rhc[2] = seed->getZ();
516  // auto spoint = new genfit::SpacepointMeasurement(rhc, cm, 0, i, nullptr);
517  // spoints.push_back(spoint);
518  // }
519 
520  return kStOk;
521 }
522 void StFwdClosureMaker::Clear(const Option_t *opts) {
523  return;
524 }
const Double_t cm
If an event generator measures distances in cm, then multiply by cm.
Definition: StarGenerator.h:45
Definition: Stypes.h:41