5 #include <phfield/PHFieldUtility.h>
6 #include <phfield/PHFieldConfig_v3.h>
7 #include <phfield/PHField.h>
9 #include <GenFit/FieldManager.h>
10 #include <GenFit/MaterialEffects.h>
11 #include <GenFit/TGeoMaterialInterface.h>
12 #include <GenFit/MeasuredStateOnPlane.h>
13 #include <GenFit/SharedPlanePtr.h>
14 #include <GenFit/RKTrackRep.h>
17 #include <TGeoManager.h>
31 static bool inited =
false;
34 static int NSTEPS_TARGET = 100;
35 static int NSTEPS_SHIELDING = 50;
36 static int NSTEPS_FMAG = 100;
38 static double FMAG_LENGTH;
39 static double Z_UPSTREAM;
42 void initGlobalVariables()
50 NSTEPS_SHIELDING = rc->
get_IntFlag(
"NSTEPS_SHIELDING");
59 static const double c_light = 2.99792458e+8 * m/s;
64 pos_i(TVector3()), mom_i(TVector3()), cov_i(TMatrixDSym(5)),
65 pos_f(TVector3()), mom_f(TVector3()), cov_f(TMatrixDSym(5)),
66 jac_sd2sc(TMatrixD(5,5)), jac_sc2sd(TMatrixD(5,5)), propM(TMatrixD(5,5)),
67 jac_genfit2legacy(TMatrixD(5,5)), jac_legacy2genfit(TMatrixD(5,5))
69 initGlobalVariables();
81 genfit::FieldManager::getInstance()->init(fieldMap);
83 _tgeo_manager =
const_cast<TGeoManager*
>(geom);
89 double p[4] = {0, 0, z_test*cm, 0};
90 double B[3] = {0, 0, 0};
92 cout <<
"PHField (CLHEP) at Z = " << z_test << endl;
93 cout << B[0] <<
", " << B[1] <<
", " << B[2] << endl;
96 genfit::AbsBField *f = genfit::FieldManager::getInstance()->getField();
97 TVector3 H = f->get(TVector3(0,0,z_test));
99 cout <<
"genfit::AbsBField (tesla) at Z = " << z_test << endl;
103 H = f->get(TVector3(0,0,z_test));
104 H *= kilogauss/tesla;
105 cout <<
"genfit::AbsBField (tesla) at Z = " << z_test << endl;
110 _tgeo_manager->Export(
"GenFitExtrapolatorGeom.root");
112 genfit::MaterialEffects::getInstance()->init(
new genfit::TGeoMaterialInterface());
123 LogInfo(
"z_in: ") << z_in << endl;
130 if(state_in[0][0] > 0)
171 TMatrixD jac_legacy2genfit_T = jac_legacy2genfit;
172 jac_legacy2genfit_T.T();
173 TMatrixD cov_hold= jac_legacy2genfit*cov_in*jac_legacy2genfit_T;
175 for(
int i = 0; i < 5; i++)
177 for(
int j = 0; j < 5; j++)
179 cov_i[i][j] = cov_hold[i][j];
231 TMatrixD jac_genfit2legacy_T = jac_genfit2legacy;
232 jac_genfit2legacy_T.T();
233 TMatrixD cov_hold= jac_genfit2legacy*cov_f*jac_genfit2legacy_T;
235 for(
int i = 0; i < 5; i++)
237 for(
int j = 0; j < 5; j++)
239 cov_out[i][j] = cov_hold[i][j];
246 if(fabs(pos_i[2] - pos_f[2]) < 1E-3)
274 for(
int i = 0; i < 5; i++)
276 for(
int j = 0; j < 5; j++)
278 prop[i][j] = propM[i][j];
284 prop = jac_legacy2genfit*prop*jac_genfit2legacy;
291 if(pos_i[2] > 2400 || pos_i[2] < -600 || z_out > 2400 || z_out < -600)
297 if(fabs(pos_i[2] - z_out) < 1E-3)
306 int pid = iParType > 0 ? -13 : 13;
309 <<
"extrapolateToPlane: "
310 <<
"From: " << pos_i.Z()
315 auto up_rep = std::unique_ptr<genfit::AbsTrackRep> (
new genfit::RKTrackRep(pid));
316 auto rep = up_rep.get();
318 genfit::SharedPlanePtr destPlane(
new genfit::DetPlane(TVector3(0, 0, z_out), TVector3(0, 0, 1)));
320 std::unique_ptr<genfit::MeasuredStateOnPlane> currentState = std::unique_ptr < genfit::MeasuredStateOnPlane > (
new genfit::MeasuredStateOnPlane(rep));
322 genfit::SharedPlanePtr startplane(
new genfit::DetPlane(TVector3(0, 0, pos_i[2]), TVector3(0, 0, 1)));
323 currentState->setPlane(startplane);
325 currentState->setPosMom(pos_i, mom_i);
326 currentState->setCov(cov_i);
329 travelLength = rep->extrapolateToPlane(*currentState, destPlane);
332 cout <<
"extrapolateToPlane failed!" << endl;
337 currentState->getPosMom(pos_f, mom_f);
338 cov_f = currentState->getCov();
339 propM = rep->getJacobian();
352 TVector3 mom[NSTEPS_FMAG + NSTEPS_TARGET + 1];
353 TVector3 pos[NSTEPS_FMAG + NSTEPS_TARGET + 1];
357 double step_fmag = FMAG_LENGTH/NSTEPS_FMAG;
358 double step_target = fabs(Z_UPSTREAM)/NSTEPS_TARGET;
367 for(; iStep <= NSTEPS_FMAG; ++iStep)
369 pos_i = pos[iStep-1];
370 mom_i = mom[iStep-1];
378 for(; iStep < NSTEPS_FMAG+NSTEPS_TARGET+1; ++iStep)
380 pos_i = pos[iStep-1];
381 mom_i = mom[iStep-1];
390 double dca_min = 1E6;
391 for(
int i = 0; i < NSTEPS_FMAG+NSTEPS_TARGET+1; ++i)
393 double dca = sqrt(pos[i][0]*pos[i][0] + pos[i][1]*pos[i][1]);
401 return pos[iStep][2];
405 double p = fabs(1. / state[0][0]);
406 double pz = p / sqrt(1. + state[1][0] * state[1][0] + state[2][0] * state[2][0]);
407 double px = pz * state[1][0];
408 double py = pz * state[2][0];
410 double x = state[3][0];
411 double y = state[4][0];
414 mom.SetXYZ(px, py, pz);
418 TVector3 mom_gev = mom;
419 TVector3 pos_cm = pos;
421 state[0][0] = double(iParType) / mom_gev.Mag();
422 state[1][0] = mom_gev.x() / mom_gev.z();
423 state[2][0] = mom_gev.y() / mom_gev.z();
425 state[3][0] = pos_cm.x();
426 state[4][0] = pos_cm.y();
432 jac_legacy2genfit.Zero();
433 jac_legacy2genfit[0][0]=1.;
434 jac_legacy2genfit[1][1]=-1.;
435 jac_legacy2genfit[2][2]=-1.;
436 jac_legacy2genfit[3][3]=-1.;
437 jac_legacy2genfit[4][4]=-1.;
444 jac_genfit2legacy.Zero();
445 jac_genfit2legacy[0][0]=1.;
446 jac_genfit2legacy[1][1]=-1.;
447 jac_genfit2legacy[2][2]=-1.;
448 jac_genfit2legacy[3][3]=-1.;
449 jac_genfit2legacy[4][4]=-1.;
456 TVector3 mom(mom_input[0], mom_input[1], mom_input[2]);
457 TVector3 pos(pos_input[0], pos_input[1], pos_input[2]);
460 TVector3 DJ(1., 0., 0.);
461 TVector3 DK(0., 1., 0.);
462 TVector3 DI = DJ.Cross(DK);
465 double p_inv = 1./mom.Mag();
466 double vp = mom.Dot(DJ)/mom.Dot(DI);
467 double wp = mom.Dot(DK)/mom.Dot(DI);
468 double lambda = TMath::Pi()/2. - mom.Theta();
472 TVW.SetX(1./sqrt(1. + vp*vp + wp*wp));
473 TVW.SetY(vp*TVW.X());
474 TVW.SetZ(wp*TVW.X());
477 for(
int i = 0; i < 3; i++)
479 TN[i] = TVW[0]*DI[i] + TVW[1]*DJ[i] + TVW[2]*DK[i];
482 double cosl = cos(lambda);
483 double cosl1 = 1./cosl;
485 TVector3 UN(-TN.Y()*cosl1, TN.X()*cosl1, 0.);
486 TVector3 VN(-TN.Z()*UN.Y(), TN.Z()*UN.X(), cosl);
488 double UJ = UN.Dot(DJ);
489 double UK = UN.Dot(DK);
490 double VJ = VN.Dot(DJ);
491 double VK = VN.Dot(DK);
494 jac_sd2sc[0][0] = 1.;
495 jac_sd2sc[1][1] = TVW[0]*VJ;
496 jac_sd2sc[1][2] = TVW[0]*VK;
497 jac_sd2sc[2][1] = TVW[0]*UJ*cosl1;
498 jac_sd2sc[2][2] = TVW[0]*UK*cosl1;
499 jac_sd2sc[3][3] = UJ;
500 jac_sd2sc[3][4] = UK;
501 jac_sd2sc[4][3] = VJ;
502 jac_sd2sc[4][4] = VK;
505 genfit::AbsBField *field = genfit::FieldManager::getInstance()->getField();
507 if(charge != 0 && field)
509 TVector3 H = field->get(pos);
510 H *= kilogauss/tesla;
517 double HAM = HA*p_inv*tesla*GeV;
528 double Q = -HAM*
c_light/(km/ns);
529 double sinz = -H.Dot(UN)*HM;
530 double cosz = H.Dot(VN)*HM;
532 jac_sd2sc[1][3] = -Q*TVW[1]*sinz;
533 jac_sd2sc[1][4] = -Q*TVW[2]*sinz;
534 jac_sd2sc[2][3] = -Q*TVW[1]*cosz*cosl1;
535 jac_sd2sc[2][4] = -Q*TVW[2]*cosz*cosl1;
542 TVector3 mom(mom_input[0], mom_input[1], mom_input[2]);
543 TVector3 pos(pos_input[0], pos_input[1], pos_input[2]);
546 TVector3 DJ(1., 0., 0.);
547 TVector3 DK(0., 1., 0.);
548 TVector3 DI = DJ.Cross(DK);
551 double p_inv = 1./mom.Mag();
554 double lambda = TMath::Pi()/2. - mom.Theta();
555 double phi = mom.Phi();
557 double cosl = cos(lambda);
558 double sinp = sin(phi);
559 double cosp = cos(phi);
561 TVector3 TN(cosl*cosp, cosl*sinp, sin(lambda));
563 TVW.SetX(TN.Dot(DI));
564 TVW.SetY(TN.Dot(DJ));
565 TVW.SetZ(TN.Dot(DK));
567 double T1R = 1./TVW[0];
568 double T2R = T1R*T1R;
569 TVector3 UN(-sinp, cosp, 0.);
570 TVector3 VN(-TN.Z()*UN.Y(), TN.Z()*UN.X(), cosl);
572 double UJ = UN.Dot(DJ);
573 double UK = UN.Dot(DK);
574 double VJ = VN.Dot(DJ);
575 double VK = VN.Dot(DK);
576 double UI = UN.Dot(DI);
577 double VI = VN.Dot(DI);
580 jac_sc2sd[0][0] = 1.;
581 jac_sc2sd[1][1] = -UK*T2R;
582 jac_sc2sd[1][2] = VK*cosl*T2R;
583 jac_sc2sd[2][1] = UJ*T2R;
584 jac_sc2sd[2][2] = -VJ*cosl*T2R;
585 jac_sc2sd[3][3] = VK*T1R;
586 jac_sc2sd[3][4] = -UK*T1R;
587 jac_sc2sd[4][3] = -VJ*T1R;
588 jac_sc2sd[4][4] = UJ*T1R;
590 genfit::AbsBField *field = genfit::FieldManager::getInstance()->getField();
591 if(charge != 0 && field)
593 TVector3 H = field->get(pos);
594 H *= kilogauss/tesla;
597 double HAM = HA*p_inv;
608 double Q = -HAM*
c_light/(km/ns);
609 double sinz = -H.Dot(UN)*HM;
610 double cosz = H.Dot(VN)*HM;
611 double T3R = Q*T1R*T1R*T1R;
613 jac_sc2sd[1][3] = -UI*(VK*cosz - UK*sinz)*T3R;
614 jac_sc2sd[1][4] = -VI*(VK*cosz - UK*sinz)*T3R;
615 jac_sc2sd[2][3] = UI*(VJ*cosz - UJ*sinz)*T3R;
616 jac_sc2sd[2][4] = VI*(VJ*cosz - UJ*sinz)*T3R;
621 cout <<
"Propagating " << iParType <<
":" << endl;
623 <<
"(" << pos_i.X() <<
", " << pos_i.Y() <<
", "<< pos_i.Z() <<
") "
625 <<
"(" << pos_f.X() <<
", " << pos_f.Y() <<
", "<< pos_f.Z() <<
") "
628 cout <<
"Momentum change: From "
629 <<
"(" << mom_i.X() <<
", " << mom_i.Y() <<
", "<< mom_i.Z() <<
") "
631 <<
"(" << mom_f.X() <<
", " << mom_f.Y() <<
", "<< mom_f.Z() <<
") "
634 cout <<
"Initial error matrix: " << endl;
635 for(
int i = 0; i < 5; i++)
637 for(
int j = 0; j < 5; j++)
639 cout << cov_i[i][j] <<
" ";
644 cout <<
"Final error matrix: " << endl;
645 for(
int i = 0; i < 5; i++)
647 for(
int j = 0; j < 5; j++)
649 cout << cov_f[i][j] <<
" ";
transient DST object for field storage and access
virtual void GetFieldValue(const double Point[4], double *Bfield) const =0
virtual double get_DoubleFlag(const std::string &name) const
virtual int get_IntFlag(const std::string &name) const
static recoConsts * instance()