30 static bool inited =
false;
33 static GeomSvc* p_geomSvc =
nullptr;
39 static bool COARSE_MODE;
45 static double PT_KICK_FMAG;
46 static double PT_KICK_KMAG;
53 static double INVP_MAX;
54 static double INVP_MIN;
55 static double PROB_LOOSE;
56 static double PROB_TIGHT;
59 static double Z_KMAG_BEND;
60 static double Z_ABSORBER;
61 static double Z_FMAG_BEND;
62 static double Z_KFMAG_BEND;
63 static double ELOSS_KFMAG;
64 static double ELOSS_ABSORBER;
67 void initGlobalVariables()
119 if(
sign > 0) os <<
"L - ";
120 if(
sign < 0) os <<
"R - ";
121 if(
sign == 0) os <<
"U - ";
131 for(
int i = 0; i < 4; ++i)
hits[i].hit.index = -1;
133 initGlobalVariables();
143 for(
int i = 0; i < 4; ++i)
hits[i].hit.index = -1;
153 os <<
"a = " <<
a <<
", b = " <<
b <<
", chisq = " <<
chisq << endl;
154 os <<
"TX_MAX = " << TX_MAX <<
", X0_MAX = " << X0_MAX <<
", chisq max = " << 5 << endl;
157 for(
int i = 0; i < 4; ++i)
159 if(
hits[i].sign > 0) os <<
"L: ";
160 if(
hits[i].sign < 0) os <<
"R: ";
161 if(
hits[i].sign == 0) os <<
"U: ";
170 return (
a*z +
b - pos)/sqrt(
a*
a + 1.);
179 for(
int i = 0; i < 2; ++i)
181 if(
hits[i].hit.index < 0)
continue;
187 return pos_exp/nRefPoints;
193 for(
int i = 0; i < 4; ++i)
195 if(
hits[i].hit.index >= 0) ++nHits;
203 for(
int i = 0; i < 2; ++i)
214 if(
chisq > 5.)
return 0;
217 if(fabs(
a) > TX_MAX)
return 0;
218 if(fabs(
b) > X0_MAX)
return 0;
268 hits[0].
sign = 2*(settings & 1) - 1;
269 hits[1].
sign = 2*((settings & 2) >> 1) - 1;
270 hits[2].
sign = 2*((settings & 4) >> 1) - 1;
271 hits[3].
sign = 2*((settings & 8) >> 1) - 1;
287 while(nHits > 2 &&
chisq > 5.)
291 for(
int i = 0; i < 4; ++i)
293 if(
hits[i].hit.index < 0)
continue;
304 LogInfo(
"Invoking prop segment re-fitting...");
305 LogInfo(
"Removing hit " << index <<
" with residual = " << res_max);
306 LogInfo(
"Before removing a = " <<
a <<
", b = " <<
b <<
", chisq = " <<
chisq);
324 LogInfo(
"After removing a = " <<
a <<
", b = " <<
b <<
", chisq = " <<
chisq);
334 for(
int i = 0; i < 4; ++i)
336 if(
hits[i].hit.index < 0)
continue;
338 z[idx] = p_geomSvc->getPlanePosition(
hits[i].hit.detectorID);
344 a = (pos[1] - pos[0])/(z[1] - z[0]);
389 for(
int i = 0; i < 4; ++i)
391 if(
hits[i].hit.index < 0)
continue;
394 x[i] = p_geomSvc->getPlanePosition(
hits[i].hit.detectorID);
420 double det = sum*sxx - sx*sx;
421 if(fabs(det) < 1E-20)
return;
423 a = (sum*sxy - sx*sy)/det;
424 b = (sy*sxx - sxy*sx)/det;
425 err_a = sqrt(fabs(sum/det));
426 err_b = sqrt(fabs(sxx/det));
429 for(
int i = 0; i < 4; ++i)
431 if(
hits[i].hit.index < 0)
continue;
432 chisq += ((y[i] -
a*x[i] -
b)*(y[i] -
a*x[i] -
b));
442 double x[4], y[4], r[4];
443 for(
int i = 0; i < 4; ++i)
445 if(
hits[i].hit.index < 0)
continue;
448 x[len] = p_geomSvc->getPlanePosition(
hits[i].hit.detectorID);
457 double a_prev = -999.;
459 while(fabs(a_prev -
a) > 1E-4 && ++iter < 100)
464 double C, D, E, F, G, H;
472 for(
int i = 0; i < len; ++i)
474 _x[i] = x[i] - r[i]*
a/sqrt(
a*
a + 1.);
475 _y[i] = y[i] + r[i]/sqrt(
a*
a + 1.);
485 double alpha = H - D*E/C;
486 double beta = F - G -D*D/C + E*E/C;
488 a = (-beta + sqrt(beta*beta + 4*alpha*alpha))/alpha/2.;
492 for(
int i = 0; i < len; ++i)
494 chisq += (
a*_x[i] +
b - _y[i])*(
a*_x[i] +
b - _y[i])/(
a*
a + 1.);
500 Tracklet::Tracklet() : stationID(-1), nXHits(0), nUHits(0), nVHits(0),
chisq(9999.), chisq_vtx(9999.), tx(0.), ty(0.), x0(0.), y0(0.), invP(0.1), err_tx(-1.), err_ty(-1.), err_x0(-1.), err_y0(-1.), err_invP(-1.)
503 initGlobalVariables();
508 if(stationID < 1 || stationID >
nStations)
return 0;
509 if(fabs(
tx) > TX_MAX || fabs(
x0) > X0_MAX)
return 0;
510 if(fabs(
ty) > TY_MAX || fabs(
y0) > Y0_MAX)
return 0;
521 if(nHits < 4)
return 0;
522 if(
chisq > 40.)
return 0;
527 int nRealHits[3][3] = {{0, 0, 0}, {0, 0, 0}, {0, 0, 0}};
529 for(std::list<SignedHit>::const_iterator iter =
hits.begin(); iter !=
hits.end(); ++iter)
531 if(iter->hit.index < 0)
continue;
533 int idx1 = iter->hit.detectorID <= 12 ? 0 : (iter->hit.detectorID <= 18 ? 1 : 2);
534 int idx2 = p_geomSvc->getPlaneType(iter->hit.detectorID) - 1;
536 ++nRealHits[idx1][idx2];
546 for(
int i = 1; i < 3; ++i)
548 if(nRealHits[i][0] < 1 || nRealHits[i][1] < 1 || nRealHits[i][2] < 1)
return 0;
549 if(nRealHits[i][0] + nRealHits[i][1] + nRealHits[i][2] < 4)
return 0;
555 if(nRealHits[0][0] < 1 || nRealHits[0][1] < 1 || nRealHits[0][2] < 1)
return 0;
556 if(nRealHits[0][0] + nRealHits[0][1] + nRealHits[0][2] < 4)
return 0;
558 if(prob < PROB_TIGHT)
return 0;
561 if(invP < INVP_MIN || invP > INVP_MAX)
return 0;
581 return TMath::Prob(
chisq, ndf);
587 double weights[40] = {0, 0, 3.1292e-05, 0.00203877, 0.0147764, 0.0417885, 0.08536, 0.152212, 0.250242, 0.322011, 0.327125, 0.275443, 0.220316, 0.189932, 0.162112, 0.131674, 0.100102, 0.0736696, 0.0510353, 0.0364215, 0.0233914, 0.0152907, 0.00992716, 0.00601322, 0.00382757, 0.00239005, 0.00137169, 0.000768309, 0.000413311, 0.00019659, 8.31216e-05, 2.77721e-05, 7.93826e-06, 7.45884e-07, 2.57648e-08, 0, 6.00088e-09, 0, 0, 0};
588 int index = int(1./
invP/2.5);
590 return (index >= 0 && index < 40) ? (weights[index] < 1.E-5 ? 1.E-5 : weights[index]) : 1.E-5;
603 double x0_st1 =
tx*Z_KMAG_BEND +
x0 - tx_st1*Z_KMAG_BEND;
605 return x0_st1 + tx_st1*z;
618 double err_kick = fabs(
err_invP*PT_KICK_KMAG);
619 double err_tx_st1 =
err_tx + err_kick;
620 double err_x0_st1 =
err_x0 + err_kick*Z_KMAG_BEND;
622 err_x = err_x0_st1 + fabs(err_tx_st1*z);
629 if(z > Z_ABSORBER) err_x += 1.;
641 if(z > Z_ABSORBER) err_y += 1.;
648 double z = p_geomSvc->getPlanePosition(detectorID);
653 if(!p_geomSvc->isInPlane(detectorID, x_exp, y_exp))
return 999999.;
654 return p_geomSvc->getCostheta(detectorID)*x_exp + p_geomSvc->getSintheta(detectorID)*y_exp;
659 return p_geomSvc->getExpElementID(detectorID,
getExpPositionW(detectorID));
678 std::list<SignedHit>::const_iterator first =
hits.begin();
679 std::list<SignedHit>::const_iterator second = elem.
hits.begin();
681 while(first !=
hits.end() && second != elem.
hits.end())
683 if((*first) < (*second))
687 else if((*second) < (*first))
693 if((*first) == (*second)) nCommonHits++;
699 if(nCommonHits/
double(elem.
getNHits()) > 0.33333)
return true;
711 double c1 = Z_FMAG_BEND*PT_KICK_FMAG*charge;
712 double c2 = Z_KMAG_BEND*PT_KICK_KMAG*charge;
714 double c4 = ELOSS_KFMAG/2.;
715 double c5 = ELOSS_KFMAG;
717 double b = c1/c3 + c2/c3 - c4 - c5;
718 double c = c4*c5 - c1*c5/c3 - c2*c4/c3;
720 double disc = b*b - 4*c;
723 p = (-b + sqrt(disc))/2. - ELOSS_KFMAG;
726 if(p < 10. || p > 120. || disc < 0)
729 p = 1./(0.00832161 + 0.184186*k - 0.104132*k*k) + ELOSS_ABSORBER;
747 return -3e-3 * copysign(1.0,
FMAGSTR) *
x0 <
tx ? +1 : -1;
755 x0_st1 =
tx*Z_KMAG_BEND +
x0 - tx_st1*Z_KMAG_BEND;
768 double err_kick = fabs(
err_invP*PT_KICK_KMAG);
769 err_tx_st1 =
err_tx + err_kick;
770 err_x0_st1 =
err_x0 + err_kick*Z_KMAG_BEND;
791 tracklet.
hits.insert(tracklet.
hits.end(), elem.
hits.begin(), elem.
hits.end());
795 tracklet.
hits.insert(tracklet.
hits.begin(), elem.
hits.begin(), elem.
hits.end());
827 tracklet.
hits.insert(tracklet.
hits.end(), elem.
hits.begin(), elem.
hits.end());
831 tracklet.
hits.insert(tracklet.
hits.begin(), elem.
hits.begin(), elem.
hits.end());
836 tracklet.
tx = elem.
tx;
837 tracklet.
ty = elem.
ty;
838 tracklet.
x0 = elem.
x0;
839 tracklet.
y0 = elem.
y0;
889 std::list<SignedHit>::iterator elemend = elem.
hits.begin();
890 for(
int i = 0; i < 6; ++i) ++elemend;
892 tracklet.
hits.insert(tracklet.
hits.begin(), elem.
hits.begin(), elemend);
893 tracklet.
hits.sort();
902 std::vector<int> detectorIDs_all;
905 std::vector<int> detectorIDs_now;
906 for(std::list<SignedHit>::const_iterator iter =
hits.begin(); iter !=
hits.end(); ++iter)
908 detectorIDs_now.push_back(iter->hit.detectorID);
911 std::vector<int> detectorIDs_miss(6);
912 std::vector<int>::iterator iter = std::set_difference(detectorIDs_all.begin(), detectorIDs_all.end(), detectorIDs_now.begin(), detectorIDs_now.end(), detectorIDs_miss.begin());
913 detectorIDs_miss.resize(iter - detectorIDs_miss.begin());
915 for(std::vector<int>::iterator iter = detectorIDs_miss.begin(); iter != detectorIDs_miss.end(); ++iter)
920 hits.push_back(dummy);
933 double tx_st1, x0_st1;
939 for(std::list<SignedHit>::const_iterator iter =
hits.begin(); iter !=
hits.end(); ++iter)
941 if(iter->hit.index < 0)
continue;
943 int detectorID = iter->hit.detectorID;
944 int index = detectorID - 1;
947 if(iter->sign == 0 || COARSE_MODE)
948 sigma = p_geomSvc->getPlaneSpacing(detectorID)/sqrt(12.);
951 sigma = p_geomSvc->getPlaneResolution(detectorID);
957 residual[index] = iter->sign*fabs(iter->hit.driftDistance) - p_geomSvc->getDCA(detectorID, iter->hit.elementID, tx_st1,
ty, x0_st1,
y0);
962 residual[index] = iter->sign*fabs(iter->hit.driftDistance) - p_geomSvc->getDCA(detectorID, iter->hit.elementID,
tx,
ty,
x0,
y0);
976 for(std::list<SignedHit>::const_iterator iter =
hits.begin(); iter !=
hits.end(); ++iter)
978 if(
id == index)
return *iter;
992 if(KMAG_ON)
invP = par[4];
1013 for(std::list<SignedHit>::iterator iter =
hits.begin(); iter !=
hits.end(); ++iter)
1015 if(iter->hit.index < 0)
continue;
1017 double z = p_geomSvc->getPlanePosition(iter->hit.detectorID);
1018 double tx_val, tx_err, x0_val, x0_err;
1019 if(iter->hit.detectorID <= 12)
1032 TMatrixD state(5, 1), covar(5, 5);
1033 state[0][0] =
getCharge()*
invP*sqrt((1. + tx_val*tx_val)/(1. + tx_val*tx_val +
ty*
ty));
1034 state[1][0] = tx_val;
1041 covar[1][1] = tx_err*tx_err;
1068 double tx_st1, x0_st1;
1071 double pz = 1./
invP/sqrt(1. + tx_st1*tx_st1);
1072 return TVector3(pz*tx_st1, pz*
ty, pz);
1077 double pz = 1./
invP/sqrt(1. +
tx*
tx);
1078 return TVector3(pz*
tx, pz*
ty, pz);
1083 using namespace std;
1089 os <<
"Tracklet in station " <<
stationID << endl;
1091 os <<
"Momentum in z @st1: " << mom1.Pz() <<
" +/- " << mom1.Pz()*
err_invP/
invP << endl;
1092 os <<
"Momentum in z @st3: " << mom3.Pz() <<
" +/- " << mom3.Pz()*
err_invP/
invP << endl;
1093 os <<
"Charge: " <<
getCharge() << endl;
1094 for(std::list<SignedHit>::iterator iter =
hits.begin(); iter !=
hits.end(); ++iter)
1096 if(iter->sign > 0) os <<
"L: ";
1097 if(iter->sign < 0) os <<
"R: ";
1098 if(iter->sign == 0) os <<
"U: ";
1100 os << iter->hit.index <<
" " << p_geomSvc->getDetectorName(iter->hit.detectorID) <<
"(" << iter->hit.detectorID <<
") " << iter->hit.elementID <<
" " <<
residual[iter->hit.detectorID-1] <<
" = ";
1104 os <<
"X-Z: (" <<
tx <<
" +/- " <<
err_tx <<
")*z + (" <<
x0 <<
" +/- " <<
err_x0 <<
")" << endl;
1105 os <<
"Y-Z: (" <<
ty <<
" +/- " <<
err_ty <<
")*z + (" <<
y0 <<
" +/- " <<
err_y0 <<
")" << endl;
1109 os <<
"KMAGSTR = " <<
KMAGSTR << endl;
1122 os <<
"TrackletVector with " <<
size() <<
" entries" << std::endl;
1127 for(
auto iter = trackletVec.begin(); iter != trackletVec.end(); ++iter)
delete (*iter);
1128 trackletVec.clear();
1133 if(index >=
size())
return nullptr;
1134 return trackletVec[index];
1139 if(index >=
size())
return nullptr;
1140 return trackletVec[index];
1145 trackletVec.push_back(tracklet->
Clone());
1152 delete trackletVec[index];
1153 trackletVec.erase(trackletVec.begin() + index);
1154 return trackletVec.size();
ClassImp(SignedHit) ClassImp(PropSegment) ClassImp(Tracklet) ClassImp(TrackletVector) namespace
User interface class about the geometry of detector planes.
double ELOSS_KFMAG() const
double Z_KMAG_BEND() const
Getter/setters for a set of fixed parameters - should not be changed unless absolutely necessary.
double ELOSS_ABSORBER() const
static GeomSvc * instance()
singlton instance
double Z_FMAG_BEND() const
double Z_ABSORBER() const
double Z_KFMAG_BEND() const
Definition of hit structure.
virtual double get_DoubleFlag(const std::string &name) const
virtual bool get_BoolFlag(const std::string &name) const
void linearFit_iterative()
double getClosestApproach(double z, double pos)
void print(std::ostream &os=std::cout) const
int isValid() const
isValid returns non zero if object contains vailid data
double getPosRef(double default_val=-9999.)
void setNHitsInPT(Int_t nHitsX, Int_t nHitsY)
void setChisq(Double_t chisq)
Sets.
void insertCovariance(TMatrixD covar)
void setPTSlope(Double_t slopeX, Double_t slopeY)
Prop. tube muon ID info.
void setTriggerRoad(Int_t roadID)
Trigger road info.
void swimToVertex(TVector3 *pos=nullptr, TVector3 *mom=nullptr, bool hyptest=true)
Simple swim to vertex.
void insertHitIndex(Int_t index)
void insertStateVector(TMatrixD state)
void identify(std::ostream &os=std::cout) const
void identify(std::ostream &os=std::cout) const
const Tracklet * at(const size_t index) const
virtual ~TrackletVector()
size_t erase(const size_t index)
void push_back(const Tracklet *tracklet)
double getExpPositionY(double z) const
std::list< SignedHit > hits
bool operator<(const Tracklet &elem) const
TVector3 getMomentumSt1() const
int isValid() const
isValid returns non zero if object contains vailid data
double Eval(const double *par)
double getExpPosErrorY(double z) const
double Eval4(const double *par)
void getXZErrorInSt1(double &err_tx_st1, double &err_x0_st1) const
Tracklet operator*(const Tracklet &elem) const
TVector3 getMomentumSt3() const
double getExpPosErrorX(double z) const
int getExpElementID(int detectorID) const
TVector3 getExpMomentum(double z) const
double getMomProb() const
bool similarity(const Tracklet &elem) const
double residual[nChamberPlanes]
double getExpPositionX(double z) const
SRecTrack getSRecTrack(bool hyptest=true)
SignedHit getSignedHit(int index)
double getExpPositionW(int detectorID) const
double getMomentum() const
Tracklet operator+(const Tracklet &elem) const
void print(std::ostream &os=std::cout)
Tracklet merge(Tracklet &elem)
int getCharge() const
Return the charge (+1 or -1) of this tracklet.
void getXZInfoInSt1(double &tx_st1, double &x0_st1) const
static recoConsts * instance()