12 #include <TLorentzVector.h>
15 #include <GenFit/SharedPlanePtr.h>
29 static bool inited =
false;
38 static double PT_KICK_FMAG;
39 static double PT_KICK_KMAG;
42 static double FMAG_LENGTH;
43 static double Z_TARGET;
45 static double Z_UPSTREAM;
46 static double Z_DOWNSTREAM;
47 static double FMAG_HOLE_LENGTH;
48 static double FMAG_HOLE_RADIUS;
53 static double SIGX_BEAM;
54 static double SIGY_BEAM;
57 static int NSTEPS_TARGET;
58 static int NSTEPS_SHIELDING;
59 static int NSTEPS_FMAG;
61 static double DEDX_UNIT_0;
62 static double DEDX_UNIT_1;
63 static double DEDX_UNIT_2;
64 static double DEDX_UNIT_3;
65 static double DEDX_UNIT_4;
66 static double PTKICK_UNIT;
68 static double STEP_TARGET;
69 static double STEP_SHIELDING;
70 static double STEP_FMAG;
73 void initGlobalVariables()
100 NSTEPS_SHIELDING = rc->
get_IntFlag(
"NSTEPS_SHIELDING");
108 PTKICK_UNIT = PT_KICK_FMAG/FMAG_LENGTH;
110 STEP_TARGET = fabs(Z_UPSTREAM)/NSTEPS_TARGET;
112 STEP_FMAG = FMAG_LENGTH/NSTEPS_FMAG/2.;
125 fChisqAtNode.clear();
127 for(Int_t i = 0; i < 3; ++i) fGFDetPlaneVec[i].clear();
133 fVertexPos.SetXYZ(999., 999., 999.);
134 fStateVertex.ResizeTo(5, 1);
135 fCovarVertex.ResizeTo(5, 5);
139 fChisqUpstream = -99.;
141 initGlobalVariables();
151 if(stationID != 1 && stationID != 2 && stationID != 3)
return 0;
153 Double_t z_ref[4] = {0., 700., 1600., 2500.};
155 for(std::vector<Double_t>::iterator iter = fZ.begin(); iter != fZ.end(); ++iter)
157 if(*iter > z_ref[stationID-1] && *iter < z_ref[stationID]) ++nHits;
165 return KMAG_ON == 1 ? TMath::Prob(fChisq,
getNHits() - 5) : TMath::Prob(fChisq,
getNHits() - 4);
171 _node_vertex.
setZ(z);
173 TMatrixD m(2, 1), cov(2, 2), proj(2, 5);
178 cov[0][0] = SIGX_BEAM*SIGX_BEAM;
179 cov[1][1] = SIGY_BEAM*SIGY_BEAM;
196 _trkpar_curr.
_z = fZ[0];
203 fChisqVertex = _node_vertex.
getChisq();
232 fStateVertex[0][0] =
getCharge()/mom.Mag();
233 fStateVertex[1][0] = mom[0]/mom[2];
234 fStateVertex[2][0] = mom[1]/mom[2];
235 fStateVertex[3][0] = pos[0];
236 fStateVertex[4][0] = pos[1];
238 fCovarVertex.UnitMatrix();
243 if(fChisqVertex > 50.)
return false;
244 if(fVertexPos.Z() < Z_UPSTREAM || fVertexPos.Z() > Z_DOWNSTREAM)
return false;
253 Double_t dist_min = 1E6;
254 for(Int_t i = 0; i < nNodes; ++i)
256 Double_t dist = fabs(z - fZ[i]);
269 if(iNode < 0 || iNode >=
getNHits())
278 Double_t z_ref = fZ[iNode];
279 Double_t x_ref = _trkpar.
get_x();
280 Double_t y_ref = _trkpar.
get_y();
284 x = x_ref + axz*(z - z_ref);
285 y = y_ref + ayz*(z - z_ref);
290 if(iNode < 0 || iNode >=
getNHits())
295 Double_t z_ref = fZ[iNode];
296 Double_t dx_ref = sqrt((fCovar[iNode])[3][3]);
297 Double_t dy_ref = sqrt((fCovar[iNode])[4][4]);
298 Double_t daxz = sqrt((fCovar[iNode])[1][1]);
299 Double_t dayz = sqrt((fCovar[iNode])[2][2]);
301 dx = 2.*(dx_ref + fabs(daxz*(z - z_ref)));
302 dy = 2.*(dy_ref + fabs(dayz*(z - z_ref)));
313 if(iNode < 0 || iNode >=
getNHits())
324 Double_t p = 1./fabs(state[0][0]);
325 pz = p/sqrt(1. + state[1][0]*state[1][0] + state[2][0]*state[2][0]);
337 return sqrt(x*x + y*y);
342 Double_t mmu = 0.10566;
343 Double_t px, py, pz, E;
346 E = sqrt(px*px + py*py + pz*pz + mmu*mmu);
348 return TLorentzVector(px, py, pz, E);
353 fGFStateVec.push_back(msop.getState());
354 fGFCov.push_back(msop.getCov());
355 fGFAuxInfo.push_back(msop.getAuxInfo());
357 const genfit::SharedPlanePtr& plane = msop.getPlane();
358 fGFDetPlaneVec[0].push_back(plane->getO());
359 fGFDetPlaneVec[1].push_back(plane->getU());
360 fGFDetPlaneVec[2].push_back(plane->getV());
365 for(std::vector<TMatrixD>::iterator iter = fState.begin(); iter != fState.end(); ++iter)
367 (*iter)[0][0] = (*iter)[0][0]/kmagStr;
378 if(nHits < 14)
return false;
384 if(
getChisq()/(nHits - 5) > 15.)
return false;
394 return (fVertexPos.Z() > -300 && fVertexPos.Z() < 0. && fChisqDump - fChisqTarget > 10.);
399 return (fVertexPos.Z() > 0. && fVertexPos.Z() < 150. && fChisqTarget - fChisqDump > 10.);
405 bool cleanupPos =
false;
406 bool cleanupMom =
false;
409 pos =
new TVector3[NSTEPS_FMAG + NSTEPS_TARGET + 1];
414 mom =
new TVector3[NSTEPS_FMAG + NSTEPS_TARGET + 1];
419 double tx = fState.front()[1][0];
420 double ty = fState.front()[2][0];
421 double x0 = fState.front()[3][0];
422 double y0 = fState.front()[4][0];
423 double z0 = fZ.front();
426 pos[0].SetXYZ(x0 + tx*(FMAG_LENGTH - z0), y0 + ty*(FMAG_LENGTH - z0), FMAG_LENGTH);
434 for(; iStep <= NSTEPS_FMAG; ++iStep)
438 double tx_i = mom[iStep-1].Px()/mom[iStep-1].Pz();
439 double tx_f = tx_i + 2.*charge*PTKICK_UNIT*STEP_FMAG/sqrt(mom[iStep-1].Px()*mom[iStep-1].Px() + mom[iStep-1].Pz()*mom[iStep-1].Pz());
441 TVector3 trajVec1(tx_i*STEP_FMAG, ty*STEP_FMAG, STEP_FMAG);
442 TVector3 pos_b = pos[iStep-1] - trajVec1;
444 double p_tot_i = mom[iStep-1].Mag();
446 if(pos_b[2] > FMAG_HOLE_LENGTH || pos_b.Perp() > FMAG_HOLE_RADIUS)
448 p_tot_b = p_tot_i + (DEDX_UNIT_0 + p_tot_i*DEDX_UNIT_1 + p_tot_i*p_tot_i*DEDX_UNIT_2 + p_tot_i*p_tot_i*p_tot_i*DEDX_UNIT_3 + p_tot_i*p_tot_i*p_tot_i*p_tot_i*DEDX_UNIT_4)*trajVec1.Mag();
455 TVector3 trajVec2(tx_f*STEP_FMAG, ty*STEP_FMAG, STEP_FMAG);
456 pos[iStep] = pos_b - trajVec2;
459 if(pos[iStep][2] > FMAG_HOLE_LENGTH || pos[iStep].Perp() > FMAG_HOLE_RADIUS)
461 p_tot_f = p_tot_b + (DEDX_UNIT_0 + p_tot_b*DEDX_UNIT_1 + p_tot_b*p_tot_b*DEDX_UNIT_2 + p_tot_b*p_tot_b*p_tot_b*DEDX_UNIT_3 + p_tot_b*p_tot_b*p_tot_b*p_tot_b*DEDX_UNIT_4)*trajVec2.Mag();
469 double pz_f = p_tot_f/sqrt(1. + tx_f*tx_f + ty*ty);
470 mom[iStep].SetXYZ(pz_f*tx_f, pz_f*ty, pz_f);
471 pos[iStep] = pos[iStep-1] - trajVec1 - trajVec2;
474 if(fabs(pos_b.Z() - Z_DUMP) < STEP_FMAG)
476 double dz = Z_DUMP - pos_b.Z();
479 setDumpPos(pos_b + TVector3(tx_f*dz, ty*dz, dz));
484 setDumpPos(pos_b + TVector3(tx_i*dz, ty*dz, dz));
489 #ifdef _DEBUG_ON_LEVEL_2
490 std::cout <<
"FMAG: " << iStep <<
": " << pos[iStep-1][2] <<
" ==================>>> " << pos[iStep][2] << std::endl;
491 std::cout << mom[iStep-1][0]/mom[iStep-1][2] <<
" " << mom[iStep-1][1]/mom[iStep-1][2] <<
" " << mom[iStep-1][2] <<
" ";
492 std::cout << pos[iStep-1][0] <<
" " << pos[iStep-1][1] <<
" " << pos[iStep-1][2] << std::endl << std::endl;
493 std::cout << mom[iStep][0]/mom[iStep][2] <<
" " << mom[iStep][1]/mom[iStep][2] <<
" " << mom[iStep][2] <<
" ";
494 std::cout << pos[iStep][0] <<
" " << pos[iStep][1] <<
" " << pos[iStep][2] << std::endl << std::endl;
498 for(; iStep < NSTEPS_FMAG+NSTEPS_TARGET+1; ++iStep)
501 double tx_i = mom[iStep-1].Px()/mom[iStep-1].Pz();
502 TVector3 trajVec(tx_i*STEP_TARGET, ty*STEP_TARGET, STEP_TARGET);
504 mom[iStep] = mom[iStep-1];
505 pos[iStep] = pos[iStep-1] - trajVec;
507 #ifdef _DEBUG_ON_LEVEL_2
508 std::cout <<
"TARGET: " << iStep <<
": " << pos[iStep-1][2] <<
" ==================>>> " << pos[iStep][2] << std::endl;
509 std::cout << mom[iStep-1][0]/mom[iStep-1][2] <<
" " << mom[iStep-1][1]/mom[iStep-1][2] <<
" " << mom[iStep-1][2] <<
" ";
510 std::cout << pos[iStep-1][0] <<
" " << pos[iStep-1][1] <<
" " << pos[iStep-1][2] << std::endl << std::endl;
511 std::cout << mom[iStep][0]/mom[iStep][2] <<
" " << mom[iStep][1]/mom[iStep][2] <<
" " << mom[iStep][2] <<
" ";
512 std::cout << pos[iStep][0] <<
" " << pos[iStep][1] <<
" " << pos[iStep][2] << std::endl << std::endl;
517 double dca_min = 1E9;
518 double dca_xmin = 1E9;
519 double dca_ymin = 1E9;
521 iStep = NSTEPS_FMAG+NSTEPS_TARGET;
524 for(
int i = 0; i < NSTEPS_FMAG+NSTEPS_TARGET+1; ++i)
526 if(
FMAGSTR*charge*mom[i].Px() < 0.)
continue;
528 double dca = (pos[i] - TVector3(X_BEAM, Y_BEAM, pos[i].Z())).Perp();
535 double dca_x = fabs(pos[i].X() - X_BEAM);
542 double dca_y = fabs(pos[i].Y() - Y_BEAM);
553 setTargetPos(fDumpFacePos + TVector3(fDumpFaceMom.Px()/fDumpFaceMom.Pz()*Z_TARGET, fDumpFaceMom.Py()/fDumpFaceMom.Pz()*Z_TARGET, Z_TARGET));
556 double dz_x = -pos[iStep_x].X()/mom[iStep_x].Px()*mom[iStep_x].Pz();
557 setXVertexPos(pos[iStep_x] + TVector3(mom[iStep_x].Px()/mom[iStep_x].Pz()*dz_x, mom[iStep_x].Py()/mom[iStep_x].Pz()*dz_x, dz_x));
560 double dz_y = -pos[iStep_y].Y()/mom[iStep_y].Py()*mom[iStep_y].Pz();
561 setYVertexPos(pos[iStep_y] + TVector3(mom[iStep_y].Px()/mom[iStep_y].Pz()*dz_y, mom[iStep_y].Py()/mom[iStep_y].Pz()*dz_y, dz_y));
564 #ifdef _DEBUG_ON_LEVEL_2
565 std::cout <<
"The one with minimum DCA is: " << iStep <<
": " << std::endl;
566 std::cout << mom[iStep][0]/mom[iStep][2] <<
" " << mom[iStep][1]/mom[iStep][2] <<
" " << mom[iStep][2] <<
" ";
567 std::cout << pos[iStep][0] <<
" " << pos[iStep][1] <<
" " << pos[iStep][2] << std::endl << std::endl;
574 if(cleanupPos)
delete[] pos;
575 if(cleanupMom)
delete[] mom;
580 os <<
"=============== Reconstructed track ==================" << std::endl;
581 os <<
"This candidate has " << fHitIndex.size() <<
" hits!" << std::endl;
582 os <<
"Most upstream momentum is: " << 1./fabs((fState[0])[0][0]) << std::endl;
583 os <<
"Chi square of the track is: " << fChisq << std::endl;
585 os <<
"Current vertex position: " << std::endl;
586 for(Int_t i = 0; i < 3; i++) os << fVertexPos[i] <<
" ";
589 os <<
"Momentum at vertex: " << 1./fabs(fStateVertex[0][0]) << std::endl;
590 os <<
"Chi square at vertex: " << fChisqVertex << std::endl;
595 os <<
"SRecTrack::PrintGF():\n"
597 for (
unsigned int iv = 0; iv < fGFDetPlaneVec[0].size(); iv++) {
598 const TVector3* vec = &fGFDetPlaneVec[0][iv];
599 os <<
" " << iv <<
":(" << vec->X() <<
" " << vec->Y() <<
" " << vec->Z() <<
")" ;
601 os <<
"\n DetPlaneVecU";
602 for (
unsigned int iv = 0; iv < fGFDetPlaneVec[1].size(); iv++) {
603 const TVector3* vec = &fGFDetPlaneVec[1][iv];
604 os <<
" " << iv <<
":(" << vec->X() <<
" " << vec->Y() <<
" " << vec->Z() <<
")" ;
606 os <<
"\n DetPlaneVecV";
607 for (
unsigned int iv = 0; iv < fGFDetPlaneVec[2].size(); iv++) {
608 const TVector3* vec = &fGFDetPlaneVec[2][iv];
609 os <<
" " << iv <<
":(" << vec->X() <<
" " << vec->Y() <<
" " << vec->Z() <<
")" ;
612 for (
unsigned int iv = 0; iv < fGFAuxInfo.size(); iv++) {
613 os <<
" [" << iv <<
"]";
614 for (
int ir = 0; ir < fGFAuxInfo[iv].GetNrows(); ir++) os <<
" " << fGFAuxInfo[iv](ir);
617 for (
unsigned int iv = 0; iv < fGFStateVec.size(); iv++) {
618 os <<
" [" << iv <<
"]";
619 for (
int ir = 0; ir < fGFStateVec[iv].GetNrows(); ir++) os <<
" " << fGFStateVec[iv](ir);
622 for (
unsigned int iv = 0; iv < fGFCov.size(); iv++) {
623 os <<
" [" << iv <<
"]";
624 for (
int ir = 0; ir < fGFCov[iv].GetNrows(); ir++) {
626 for (
int ic = 0; ic < fGFCov[iv].GetNcols(); ic++) os <<
" " << fGFCov[iv][ir][ic];
635 TLorentzVector pos, neg;
653 std::cout <<
"ERROR!!! In SRecDimuon::calcVariables(choice), only three dimuon vertex choice numbers are provided - ";
654 std::cout <<
" 0 (default) = fitted vertex position, 1 = target position, 2 = dump position" << std::endl;
670 Double_t ebeam = 120.;
672 TLorentzVector p_beam(0., 0., sqrt(ebeam*ebeam - mp*mp), ebeam);
673 TLorentzVector p_target(0., 0., 0., mp);
675 TLorentzVector p_cms = p_beam + p_target;
676 TLorentzVector p_sum = pos + neg;
681 x1 = (p_target*p_sum)/(p_target*p_cms);
682 x2 = (p_beam*p_sum)/(p_beam*p_cms);
684 Double_t s = p_cms.M2();
685 TVector3 bv_cms = p_cms.BoostVector();
686 p_sum.Boost(-bv_cms);
687 xF = 2.*p_sum.Pz()/TMath::Sqrt(s)/(1. -
mass*
mass/s);
690 phi = atan2(2.*sqrt(
mass*
mass +
pT*
pT)*(neg.X()*pos.Y() - pos.X()*neg.Y()),
mass*(pos.X()*pos.X() - neg.X()*neg.X() + pos.Y()*pos.Y() - neg.Y()*neg.Y()));
701 if(fabs(
xF) > 1.)
return false;
702 if(x1 < 0. || x1 > 1.)
return false;
703 if(x2 < 0. || x2 > 1.)
return false;
704 if(mass < 0. || mass > 10.)
return false;
705 if(fabs(
vtx.X()) > 2.)
return false;
706 if(fabs(
vtx.Y()) > 2.)
return false;
707 if(fabs(
p_pos.Px() +
p_neg.Px()) > 3.)
return false;
708 if(fabs(
p_pos.Py() +
p_neg.Py()) > 3.)
return false;
709 if(
vtx.Z() > 200. ||
vtx.Z() < -300.)
return false;
726 double pzp =
p_pos.Pz();
729 double pzm =
p_neg.Pz();
738 if(
vtx_pos.Z() > 150.)
return false;
739 if(
vtx_neg.Z() > 150.)
return false;
742 double pzp =
p_pos.Pz();
745 double pzm =
p_neg.Pz();
771 fLocalID.insert(std::map<Int_t, Int_t>::value_type(rawEvent->
getHit(i).
index, i));
787 std::vector<Int_t> trkIDs;
791 for(Int_t i = 0; i < nTracks; i++)
793 if(fAllTracks[i].getCharge() == charge)
ClassImp(SRecTrack) ClassImp(SRecDimuon) ClassImp(SRecEvent) namespace
static KalmanFilter * instance()
singlton instance
void setCurrTrkpar(Node &_node)
set the current track parameter using the current node
bool fit_node(Node &_node)
Fit one node.
void enableDumpCorrection()
Enable the dump mode: stop calc prop matrix, start calc travel length.
TMatrixD & getMeasurement()
TMatrixD & getProjector()
TMatrixD & getMeasurementCov()
virtual double get_DoubleFlag(const std::string &name) const
virtual int get_IntFlag(const std::string &name) const
virtual bool get_BoolFlag(const std::string &name) const
Int_t getTriggerBits()
Set/get the trigger types.
TVector3 vtx
3-vector vertex position
void calcVariables(int choice=0)
Calculate the kinematic vairables, 0 = vertex, 1 = target, 2 = dump.
TLorentzVector p_neg_target
bool isDump()
Dump dimuon.
int isValid() const
isValid returns non zero if object contains vailid data
TLorentzVector p_neg_single
TLorentzVector p_pos_target
Track momentum projections at different location.
TLorentzVector p_pos_single
4-momentum of the muon tracks before vertex fit
Double_t chisq_kf
Vertex fit chisqs.
TLorentzVector p_pos
4-momentum of the muon tracks after vertex fit
Double_t mass
Kinematic variables.
bool isTarget()
Target dimuon.
TVector3 proj_target_pos
Track projections at different location.
TLorentzVector p_pos_dump
TLorentzVector p_neg_dump
std::vector< Int_t > getChargedTrackIDs(Int_t charge)
Get track IDs.
void setRawEvent(SRawEvent *rawEvent)
directly setup everything by raw event
void setEventInfo(SRawEvent *rawEvent)
Set/Get event info.
void clear()
Clear everything.
Int_t getNTracks()
Get tracks.
void clearDimuons()
Clear the dimuon list.
void getExpPosErrorFast(Double_t z, Double_t &dx, Double_t &dy, Int_t iNode=-1)
Double_t getChisq() const
Int_t getCharge() const
Gets.
Double_t getMomentum(const TMatrixD &state, Double_t &px, Double_t &py, Double_t &pz) const
Double_t getPosition(const TMatrixD &state, Double_t &x, Double_t &y) const
bool isVertexValid() const
Vertex stuff.
void setChisqDump(Double_t chisq)
TLorentzVector getMomentumVertex()
Get the vertex info.
void setDumpPos(TVector3 pos)
Set mom/pos at a given location.
void getExpPositionFast(Double_t z, Double_t &x, Double_t &y, Int_t iNode=-1)
bool operator<(const SRecTrack &elem) const
Comparitor.
void setTargetPos(TVector3 pos)
void setZVertex(Double_t z, bool update=true)
void print(std::ostream &os=std::cout) const
Debugging output.
void insertGFState(const genfit::MeasuredStateOnPlane &msop)
void setYVertexPos(TVector3 pos)
void adjustKMag(double kmagStr)
Fast-adjust of kmag.
TVector3 getMomentumVecSt1() const
void setChisqTarget(Double_t chisq)
void setXVertexPos(TVector3 pos)
void setYVertexMom(TVector3 mom)
void printGF(std::ostream &os=std::cout) const
Int_t getNHitsInStation(Int_t stationID)
int isValid() const
isValid returns non zero if object contains vailid data
bool isTarget()
Overall track quality cut.
void setDumpFaceMom(TVector3 mom)
Int_t getNearestNode(Double_t z)
void setXVertexMom(TVector3 mom)
void setTargetMom(TVector3 mom)
void setChisqUpstream(Double_t chisq)
Double_t getExpMomentumFast(Double_t z, Double_t &px, Double_t &py, Double_t &pz, Int_t iNode=-1)
void setDumpMom(TVector3 mom)
void swimToVertex(TVector3 *pos=nullptr, TVector3 *mom=nullptr, bool hyptest=true)
Simple swim to vertex.
void updateVtxHypothesis()
void setDumpFacePos(TVector3 pos)
void setVertexFast(TVector3 mom, TVector3 pos)
Plain setting, no KF-related stuff.
TMatrixD _state_kf
State vectors and its covariance.
static recoConsts * instance()