7 #include <TMatrixDSym.h>
9 #include <GenFit/MeasuredStateOnPlane.h>
10 #include <GenFit/MeasurementOnPlane.h>
11 #include <GenFit/WireMeasurement.h>
12 #include <GenFit/PlanarMeasurement.h>
13 #include <GenFit/RKTrackRep.h>
14 #include <GenFit/AbsFitterInfo.h>
15 #include <GenFit/KalmanFitterInfo.h>
16 #include <GenFit/StateOnPlane.h>
25 static bool inited =
false;
27 static double Z_TARGET;
29 static double Z_UPSTREAM;
33 static double SIGX_BEAM;
34 static double SIGY_BEAM;
37 void initGlobalVariables()
59 GFTrack::GFTrack(): _track(nullptr), _trkrep(nullptr), _propState(nullptr), _virtMeas(nullptr), _trkcand(nullptr), _pdg(0)
61 initGlobalVariables();
64 GFTrack::GFTrack(
SRecTrack& recTrack): _track(nullptr), _trkrep(nullptr), _propState(nullptr), _virtMeas(nullptr), _trkcand(nullptr), _pdg(0)
66 initGlobalVariables();
68 _pdg = recTrack.
getCharge() > 0 ? -13 : 13;
69 _trkrep =
new genfit::RKTrackRep(_pdg);
74 TVectorD seed_state(6);
75 seed_state[0] = seed_pos.X();
76 seed_state[1] = seed_pos.Y();
77 seed_state[2] = seed_pos.Z();
78 seed_state[3] = seed_mom.Px();
79 seed_state[4] = seed_mom.Py();
80 seed_state[5] = seed_mom.Pz();
82 TMatrixDSym seed_cov(6);
83 double uncertainty[6] = {10., 10., 10., 3., 3., 10.};
84 for(
int i = 0; i < 6; i++)
86 for(
int j = 0; j < 6; j++)
88 seed_cov[i][j] = uncertainty[i]*uncertainty[j];
91 _track =
new genfit::Track(_trkrep, seed_state, seed_cov);
95 for(
int i = 0; i < nHits; ++i)
103 GFTrack::GFTrack(
Tracklet& tracklet): _track(nullptr), _trkrep(nullptr), _propState(nullptr), _virtMeas(nullptr), _trkcand(nullptr), _pdg(0)
105 initGlobalVariables();
111 if(_track !=
nullptr)
delete _track;
116 if(_trkrep !=
nullptr) _trkrep->setDebugLvl(v);
121 for(
auto iter = measurements.begin(); iter != measurements.end(); ++iter)
123 if(!(*iter)->isEnabled())
continue;
132 genfit::TrackPoint* tp =
new genfit::TrackPoint(measurement, _track);
133 tp->setSortingParameter(measurement->
getZ());
134 _track->insertPoint(tp);
139 genfit::AbsTrackRep* rep = _track->getCardinalRep();
142 genfit::FitStatus* fs = _track->getFitStatus(rep);
143 if(fs)
return fs->getChi2();
151 genfit::AbsTrackRep* rep = _track->getCardinalRep();
154 genfit::FitStatus* fs = _track->getFitStatus(rep);
155 if(fs)
return fs->getNdf();
163 double z = meas->
getZ();
164 if(z < _measurements.front()->getZ())
168 else if(z > _measurements.back()->getZ())
170 return _measurements.size() - 1;
174 auto iter = std::lower_bound(_measurements.begin(), _measurements.end(), meas, [](
GFMeasurement* a,
GFMeasurement* b) { return (a->getZ() < b->getZ()); });
175 int idx = std::distance(_measurements.begin(), iter);
176 return fabs(z - _measurements[idx]->getZ()) < fabs(z - _measurements[idx-1]->getZ()) ? idx : idx-1;
182 TVector3 linePoint = (endPoint2 + endPoint1);
183 TVector3 lineDir = endPoint2 - endPoint1;
185 if(!setInitialStateForExtrap(startPtID))
return -9999.;
187 genfit::AbsTrackRep* rep = _track->getCardinalRep();
188 double len = rep->extrapolateToLine(*_propState, linePoint, lineDir);
190 TVectorD hitcoord(7);
191 hitcoord[0] = endPoint1.X();
192 hitcoord[1] = endPoint1.Y();
193 hitcoord[2] = endPoint1.Z();
194 hitcoord[3] = endPoint2.X();
195 hitcoord[4] = endPoint2.Y();
196 hitcoord[5] = endPoint2.Z();
198 TMatrixDSym tempcov(7);
200 _virtMeas.reset(
new genfit::WireMeasurement(hitcoord, tempcov, 999, 999,
nullptr));
207 genfit::SharedPlanePtr destPlane(
new genfit::DetPlane(pO, pU, pV));
209 if(!setInitialStateForExtrap(startPtID))
return -9999.;
211 genfit::AbsTrackRep* rep = _track->getCardinalRep();
212 double len = rep->extrapolateToPlane(*_propState, destPlane);
214 TVectorD hitcoord(2);
215 hitcoord[0] = pO.X();
216 hitcoord[1] = pO.Y();
217 TMatrixDSym tempcov(2);
218 tempcov.UnitMatrix();
220 genfit::PlanarMeasurement* pMeas =
new genfit::PlanarMeasurement(hitcoord, tempcov, 998, 998,
nullptr);
221 pMeas->setPlane(destPlane);
222 _virtMeas.reset(pMeas);
229 if(!setInitialStateForExtrap(startPtID))
return -9999.;
231 genfit::AbsTrackRep* rep = _track->getCardinalRep();
232 double len = rep->extrapolateToPoint(*_propState, point);
242 std::unique_ptr<const genfit::AbsHMatrix> H(_virtMeas->constructHMatrix(_propState->getRep()));
245 TVectorD stateVec(_propState->getState());
246 TMatrixDSym cov(_propState->getCov());
248 double ndf = meas.GetNrows();
250 TVectorD res(meas - H->Hv(stateVec));
251 TMatrixDSym covSumInv(cov);
254 genfit::tools::invertMatrix(covSumInv);
256 TMatrixD CHt(H->MHt(cov));
257 TVectorD update(TMatrixD(CHt, TMatrixD::kMult, covSumInv)*res);
260 covSumInv.Similarity(CHt);
262 _propState->setStateCov(stateVec, cov);
265 TVectorD resNew(meas - H->Hv(stateVec));
266 TMatrixDSym HCHt(cov);
270 genfit::tools::invertMatrix(HCHt);
271 chi2 = HCHt.Similarity(resNew);
276 bool GFTrack::setInitialStateForExtrap(
const int startPtID)
278 genfit::AbsTrackRep* rep = _track->getCardinalRep();
279 if(_track->getNumPoints() > 0)
281 genfit::TrackPoint* tp = _track->getPointWithMeasurementAndFitterInfo(startPtID, rep);
282 if(tp ==
nullptr)
return false;
284 genfit::KalmanFitterInfo* info =
static_cast<genfit::KalmanFitterInfo*
>(tp->getFitterInfo(rep));
285 _propState.reset(
new genfit::MeasuredStateOnPlane(info->getFittedState()));
289 _propState.reset(
new genfit::MeasuredStateOnPlane(_fitstates[startPtID]));
298 TVector3 pU(1., 0., 0.);
299 TVector3 pV(0., 1., 0.);
300 TVector3 pO(0., 0., z );
302 TVectorD beamCenter(2);
303 beamCenter[0] = X_BEAM; beamCenter[1] = Y_BEAM;
304 TMatrixDSym beamCov(2);
306 beamCov(0, 0) = SIGX_BEAM*SIGX_BEAM; beamCov(1, 1) = SIGY_BEAM*SIGY_BEAM;
312 if(fabs(len) > 6000.)
throw len;
319 else if(mom !=
nullptr)
324 catch(genfit::Exception& e)
326 std::cerr << __FILE__ <<
" " << __LINE__ <<
": hypo test failed vertex @Z=" << z <<
": " << e.what() << std::endl;
331 std::cerr << __FILE__ <<
" " << __LINE__ <<
": hypo test failed vertex @Z=" << z <<
": " << len << std::endl;
340 _trkcand = &tracklet;
341 _pdg = tracklet.
getCharge() > 0 ? -13 : 13;
342 _trkrep =
new genfit::RKTrackRep(_pdg);
344 TVectorD seed_state(6);
348 seed_state[0] = seed_pos.X();
349 seed_state[1] = seed_pos.Y();
350 seed_state[2] = seed_pos.Z();
351 seed_state[3] = seed_mom.Px();
352 seed_state[4] = seed_mom.Py();
353 seed_state[5] = seed_mom.Pz();
355 TMatrixDSym seed_cov(6);
356 double uncertainty[6] = {10., 10., 10., 3., 3., 10.};
357 for(
int i = 0; i < 6; i++)
359 for(
int j = 0; j < 6; j++)
361 seed_cov[i][j] = uncertainty[i]*uncertainty[j];
369 _track =
new genfit::Track(_trkrep, seed_state, seed_cov);
371 _measurements.clear();
372 for(
auto iter = tracklet.
hits.begin(); iter != tracklet.
hits.end(); ++iter)
374 if(iter->hit.index < 0)
continue;
377 _measurements.push_back(meas);
379 std::sort(_measurements.begin(), _measurements.end(), [](
GFMeasurement* a,
GFMeasurement* b) { return (a->getZ() < b->getZ()); });
387 if(!updateMeasurements)
return;
388 for(
auto iter = _measurements.begin(); iter != _measurements.end(); ++iter)
390 (*iter)->postFitUpdate();
400 for(
auto iter = _measurements.begin(); iter != _measurements.end(); ++iter)
404 const genfit::MeasuredStateOnPlane& fitstate = (*iter)->getTrackPoint()->getKalmanFitterInfo()->getFittedState(
true);
408 fitstate.getPosMom(pos, mom);
409 TMatrixD stateVec(5, 1);
411 stateVec[1][0] = mom.Px()/mom.Pz();
412 stateVec[2][0] = mom.Py()/mom.Pz();
413 stateVec[3][0] = pos.X();
414 stateVec[4][0] = pos.Y();
418 TMatrixD cov(fitstate.getCov());
421 strack.
insertChisq((*iter)->getTrackPoint()->getKalmanFitterInfo()->getSmoothedChi2());
469 std::cout <<
"=============== SGTrack ===============" << std::endl;
470 std::cout <<
"------------ Track candidate ----------" << std::endl;
473 std::cout <<
"------------ Fit status ---------------" << std::endl;
474 _track->getFitStatus(_trkrep)->Print();
476 std::cout <<
"------------ Fit Result ---------------" << std::endl;
477 _track->getFittedState().Print();
479 if(debugLvl < 1)
return;
480 for(
auto iter = _measurements.begin(); iter != _measurements.end(); ++iter)
482 (*iter)->print(debugLvl-1);
485 if(debugLvl < 20)
return;
486 std::cout <<
"------------ GenFit Track ---------------" << std::endl;
virtual double get_DoubleFlag(const std::string &name) const
void setTrackPtr(GFTrack *trackPtr)
void print(unsigned int debugLvl=0)
double extrapolateToPlane(TVector3 &pO, TVector3 &pU, TVector3 &pV, const int startPtID=0)
void getExtrapPosMomCov(TVector3 &pos, TVector3 &mom, TMatrixDSym &cov)
void addMeasurements(std::vector< GFMeasurement * > &measurements)
void setVerbosity(unsigned int v)
void postFitUpdate(bool updateMeasurements=true)
int getNearestMeasurementID(GFMeasurement *meas)
double swimToVertex(double z, TVector3 *pos=nullptr, TVector3 *mom=nullptr, TMatrixDSym *cov=nullptr)
void addMeasurement(GFMeasurement *measurement)
double extrapolateToLine(TVector3 &endPoint1, TVector3 &endPoint2, const int startPtID=0)
void getExtrapPosMom(TVector3 &pos, TVector3 &mom)
void setTracklet(Tracklet &tracklet, double z_reference=590., bool wildseedcov=false)
double extrapolateToPoint(TVector3 &point, bool update=false, const int startPtID=0)
double updatePropState(const TVectorD &meas, const TMatrixDSym &V)
Int_t getCharge() const
Gets.
void setVertexPos(TVector3 pos)
void setChisqDump(Double_t chisq)
TVectorD getGFAuxInfo(Int_t i)
void insertChisq(Double_t chisq)
void setChisq(Double_t chisq)
Sets.
void insertCovariance(TMatrixD covar)
void insertGFState(const genfit::MeasuredStateOnPlane &msop)
TVector3 getMomentumVecSt1() const
void setChisqTarget(Double_t chisq)
TVector3 getPositionVecSt1() const
TVectorD getGFState(Int_t i)
TVector3 getGFPlaneU(Int_t i)
void setVertexMom(TVector3 mom)
TVector3 getGFPlaneO(Int_t i)
void setChisqUpstream(Double_t chisq)
TMatrixDSym getGFCov(Int_t i)
void swimToVertex(TVector3 *pos=nullptr, TVector3 *mom=nullptr, bool hyptest=true)
Simple swim to vertex.
void insertHitIndex(Int_t index)
void setKalmanStatus(Int_t status)
TVector3 getGFPlaneV(Int_t i)
void insertStateVector(TMatrixD state)
void setChisqVertex(Double_t chisq)
double getExpPositionY(double z) const
std::list< SignedHit > hits
TVector3 getExpMomentum(double z) const
double getExpPositionX(double z) const
void print(std::ostream &os=std::cout)
int getCharge() const
Return the charge (+1 or -1) of this tracklet.
static recoConsts * instance()