Project
Loading...
Searching...
No Matches
TrackingStudy.cxx
Go to the documentation of this file.
1// Copyright 2019-2020 CERN and copyright holders of ALICE O2.
2// See https://alice-o2.web.cern.ch/copyright for details of the copyright holders.
3// All rights not expressly granted are reserved.
4//
5// This software is distributed under the terms of the GNU General Public
6// License v3 (GPL Version 3), copied verbatim in the file "COPYING".
7//
8// In applying this license CERN does not waive the privileges and immunities
9// granted to it by virtue of its status as an Intergovernmental Organization
10// or submit itself to any jurisdiction.
11
12#include <vector>
13#include <TStopwatch.h>
46#include "GPUO2InterfaceRefit.h"
47#include "GPUO2Interface.h" // Needed for propper settings in GPUParam.h
48#include "GPUParam.h"
49#include "GPUParam.inc"
50#include "GPUTPCGeometry.h"
52#include "MathUtils/fit.h"
53#include <TF1.h>
54
55namespace o2::trackstudy
56{
57
58using namespace o2::framework;
61
67
69
70class TrackingStudySpec : public Task
71{
72 public:
73 TrackingStudySpec(std::shared_ptr<DataRequest> dr, std::shared_ptr<o2::base::GRPGeomRequest> gr, GTrackID::mask_t src, bool useMC, const o2::tpc::CorrectionMapsLoaderGloOpts& sclOpts)
74 : mDataRequest(dr), mGGCCDBRequest(gr), mTracksSrc(src), mUseMC(useMC)
75 {
76 mTPCCorrMapsLoader.setLumiScaleType(sclOpts.lumiType);
77 mTPCCorrMapsLoader.setLumiScaleMode(sclOpts.lumiMode);
78 }
79 ~TrackingStudySpec() final = default;
80 void init(InitContext& ic) final;
81 void run(ProcessingContext& pc) final;
82 void endOfStream(EndOfStreamContext& ec) final;
83 void finaliseCCDB(ConcreteDataMatcher& matcher, void* obj) final;
84 void process(o2::globaltracking::RecoContainer& recoData);
85
86 private:
87 void updateTimeDependentParams(ProcessingContext& pc);
88 float getDCAYCut(float pt) const;
89 float getDCAZCut(float pt) const;
90 std::shared_ptr<DataRequest> mDataRequest;
91 std::shared_ptr<o2::base::GRPGeomRequest> mGGCCDBRequest;
92 o2::tpc::VDriftHelper mTPCVDriftHelper{};
93 o2::tpc::CorrectionMapsLoader mTPCCorrMapsLoader{};
94 bool mUseMC{false};
95 std::unique_ptr<o2::utils::TreeStreamRedirector> mDBGOut;
96 std::unique_ptr<o2::utils::TreeStreamRedirector> mDBGOutVtx;
97 std::unique_ptr<o2::gpu::GPUO2InterfaceRefit> mTPCRefitter;
98 std::vector<float> mTBinClOccAft, mTBinClOccBef, mTBinClOccWgh;
99 std::unique_ptr<TF1> mOccWghFun;
100 float mITSROFrameLengthMUS = 0.f;
101 float mTPCTBinMUS = 0.f; // TPC bin in microseconds
102 float mTPCTBinMUSInv = 0.f;
103 int mMaxNeighbours = 3;
104 float mMaxVTTimeDiff = 80.; // \mus
105 float mTPCDCAYCut = 2.;
106 float mTPCDCAZCut = 2.;
107 float mMinX = 46.;
108 float mMaxEta = 0.8;
109 float mMinPt = 0.1;
110 int mMinTPCClusters = 60;
111 int mNTPCOccBinLength = 0;
112 int mNHBPerTF = 0;
113 float mNTPCOccBinLengthInv;
114 bool mStoreWithITSOnly = false;
115 bool mDoPairsCorr = false;
116 std::string mDCAYFormula = "0.0105 + 0.0350 / pow(x, 1.1)";
117 std::string mDCAZFormula = "0.0105 + 0.0350 / pow(x, 1.1)";
118 GTrackID::mask_t mTracksSrc{};
120 o2::steer::MCKinematicsReader mcReader; // reader of MC information
121};
122
124{
126 mTPCCorrMapsLoader.init(ic);
127 int lane = ic.services().get<const o2::framework::DeviceSpec>().inputTimesliceId;
128 int maxLanes = ic.services().get<const o2::framework::DeviceSpec>().maxInputTimeslices;
129 std::string dbgnm = maxLanes == 1 ? "trackStudy.root" : fmt::format("trackStudy_{}.root", lane);
130 mDBGOut = std::make_unique<o2::utils::TreeStreamRedirector>(dbgnm.c_str(), "recreate");
131 dbgnm = maxLanes == 1 ? "trackStudyVtx.root" : fmt::format("trackStudyVtx_{}.root", lane);
132 mDBGOutVtx = std::make_unique<o2::utils::TreeStreamRedirector>(dbgnm.c_str(), "recreate");
133 mStoreWithITSOnly = ic.options().get<bool>("with-its-only");
134 mMaxVTTimeDiff = ic.options().get<float>("max-vtx-timediff");
135 mMaxNeighbours = ic.options().get<int>("max-vtx-neighbours");
136 mTPCDCAYCut = ic.options().get<float>("max-tpc-dcay");
137 mTPCDCAZCut = ic.options().get<float>("max-tpc-dcaz");
138 mMinX = ic.options().get<float>("min-x-prop");
139 mMaxEta = ic.options().get<float>("max-eta");
140 mMinPt = ic.options().get<float>("min-pt");
141 mMinTPCClusters = ic.options().get<int>("min-tpc-clusters");
142 mDCAYFormula = ic.options().get<std::string>("dcay-vs-pt");
143 mDCAZFormula = ic.options().get<std::string>("dcaz-vs-pt");
144 mDoPairsCorr = ic.options().get<bool>("pair-correlations");
145 auto str = ic.options().get<std::string>("occ-weight-fun");
146 if (!str.empty()) {
147 mOccWghFun = std::make_unique<TF1>("occFun", str.c_str(), -100., 100.);
148 }
149}
150
152{
154 recoData.collectData(pc, *mDataRequest.get()); // select tracks of needed type, with minimal cuts, the real selected will be done in the vertexer
155 updateTimeDependentParams(pc); // Make sure this is called after recoData.collectData, which may load some conditions
156 if (recoData.inputsTPCclusters) {
157 mTPCRefitter = std::make_unique<o2::gpu::GPUO2InterfaceRefit>(&recoData.inputsTPCclusters->clusterIndex, &mTPCCorrMapsLoader, o2::base::Propagator::Instance()->getNominalBz(),
158 recoData.getTPCTracksClusterRefs().data(), 0, recoData.clusterShMapTPC.data(), recoData.occupancyMapTPC.data(),
159 recoData.occupancyMapTPC.size(), nullptr, o2::base::Propagator::Instance());
160 mTPCRefitter->setTrackReferenceX(900); // disable propagation after refit by setting reference to value > 500
161 mNTPCOccBinLength = mTPCRefitter->getParam()->rec.tpc.occupancyMapTimeBins;
162 mTBinClOccBef.clear();
163 mTBinClOccAft.clear();
164 mTBinClOccWgh.clear();
165 }
166
167 // prepare TPC occupancy data
168 if (mNTPCOccBinLength > 1 && recoData.occupancyMapTPC.size()) {
169 mNTPCOccBinLengthInv = 1. / mNTPCOccBinLength;
170 int nTPCBins = mNHBPerTF * o2::constants::lhc::LHCMaxBunches / 8, ninteg = 0;
171 int nTPCOccBins = nTPCBins * mNTPCOccBinLengthInv, sumBins = std::max(1, int(o2::constants::lhc::LHCMaxBunches / 8 * mNTPCOccBinLengthInv));
172 mTBinClOccAft.resize(nTPCOccBins);
173 mTBinClOccBef.resize(nTPCOccBins);
174 float sm = 0., tb = 0.5 * mNTPCOccBinLength;
175 /* // at the moment not used
176 if (mOccWghFun) {
177 mTBinClOccWgh.resize(nTPCBins);
178 float occBin2MUS = 8 * o2::constants::lhc::LHCBunchSpacingMUS;
179 int covWghTB = TMath::NInt(100./occBin2MUS); // coverage of weighted occ. in TBins
180 for (int i = 0; i < nTPCBins; i++) {
181 sm = 0.;
182 for (int j=-covWghTB;j<covWghTB;j++) {
183 if (j+i<0 || j+i>=nTPCBins) {
184 continue;
185 }
186 sm += mOccWghFun->Eval(j*occBin2MUS)*mTPCRefitter->getParam()->GetUnscaledMult(j+i);
187 }
188 mTBinClOccWgh[i] = sm;
189 }
190 } else {
191 mTBinClOccWgh.resize(1);
192 }
193 */
194 std::vector<float> mltHistTB(nTPCOccBins);
195 for (int i = 0; i < nTPCOccBins; i++) {
196 mltHistTB[i] = mTPCRefitter->getParam()->GetUnscaledMult(tb);
197 tb += mNTPCOccBinLength;
198 }
199 for (int i = nTPCOccBins; i--;) {
200 sm += mltHistTB[i];
201 if (i + sumBins < nTPCOccBins) {
202 sm -= mltHistTB[i + sumBins];
203 }
204 mTBinClOccAft[i] = sm;
205 }
206 sm = 0;
207 for (int i = 0; i < nTPCOccBins; i++) {
208 sm += mltHistTB[i];
209 if (i - sumBins > 0) {
210 sm -= mltHistTB[i - sumBins];
211 }
212 mTBinClOccBef[i] = sm;
213 }
214 } else {
215 mTBinClOccBef.resize(1);
216 mTBinClOccAft.resize(1);
217 }
218
219 process(recoData);
220}
221
222void TrackingStudySpec::updateTimeDependentParams(ProcessingContext& pc)
223{
225 mTPCVDriftHelper.extractCCDBInputs(pc);
226 mTPCCorrMapsLoader.extractCCDBInputs(pc);
227 static bool initOnceDone = false;
228 if (!initOnceDone) { // this params need to be queried only once
229 initOnceDone = true;
230 // Note: reading of the ITS AlpideParam needed for ITS timing is done by the RecoContainer
233 if (!grp->isDetContinuousReadOut(DetID::ITS)) {
234 mITSROFrameLengthMUS = alpParams.roFrameLengthTrig / 1.e3; // ITS ROFrame duration in \mus
235 } else {
236 mITSROFrameLengthMUS = alpParams.roFrameLengthInBC * o2::constants::lhc::LHCBunchSpacingNS * 1e-3; // ITS ROFrame duration in \mus
237 }
239 mNHBPerTF = o2::base::GRPGeomHelper::instance().getGRPECS()->getNHBFPerTF();
241 mTPCTBinMUS = elParam.ZbinWidth; // TPC bin in microseconds
242 mTPCTBinMUSInv = 1. / mTPCTBinMUS;
243 }
244 bool updateMaps = false;
245 if (mTPCCorrMapsLoader.isUpdated()) {
246 mTPCCorrMapsLoader.acknowledgeUpdate();
247 updateMaps = true;
248 }
249 if (mTPCVDriftHelper.isUpdated()) {
250 LOGP(info, "Updating TPC fast transform map with new VDrift factor of {} wrt reference {} and DriftTimeOffset correction {} wrt {} from source {}",
251 mTPCVDriftHelper.getVDriftObject().corrFact, mTPCVDriftHelper.getVDriftObject().refVDrift,
252 mTPCVDriftHelper.getVDriftObject().timeOffsetCorr, mTPCVDriftHelper.getVDriftObject().refTimeOffset,
253 mTPCVDriftHelper.getSourceName());
254 mTPCVDriftHelper.acknowledgeUpdate();
255 updateMaps = true;
256 }
257 if (updateMaps) {
258 mTPCCorrMapsLoader.updateVDrift(mTPCVDriftHelper.getVDriftObject().corrFact, mTPCVDriftHelper.getVDriftObject().refVDrift, mTPCVDriftHelper.getVDriftObject().getTimeOffset());
259 }
260}
261
263{
264 auto pvvec = recoData.getPrimaryVertices();
265 auto trackIndex = recoData.getPrimaryVertexMatchedTracks(); // Global ID's for associated tracks
266 auto vtxRefs = recoData.getPrimaryVertexMatchedTrackRefs(); // references from vertex to these track IDs
267 auto prop = o2::base::Propagator::Instance();
268 auto FITInfo = recoData.getFT0RecPoints();
269 static int TFCount = 0;
270 int nv = vtxRefs.size();
272 o2::dataformats::PrimaryVertexExt vtxDummy(mMeanVtx.getPos(), {}, {}, 0);
273 std::vector<o2::dataformats::PrimaryVertexExt> pveVec(nv);
274 pveVec.back() = vtxDummy;
276 float tBiasITS = alpParams.roFrameBiasInBC * o2::constants::lhc::LHCBunchSpacingMUS;
278 std::vector<o2::dataformats::TrackInfoExt> trcExtVec;
279 std::vector<o2::trackstudy::TrackPairInfo> trcPairsVec;
280 auto vdrit = mTPCVDriftHelper.getVDriftObject().getVDrift();
281 bool tpcTrackOK = recoData.isTrackSourceLoaded(GTrackID::TPC);
282
283 auto fillTPCClInfo = [&recoData, this](const o2::tpc::TrackTPC& trc, o2::dataformats::TrackInfoExt& trExt, float timestampTB = -1e9) {
284 const auto clRefs = recoData.getTPCTracksClusterRefs();
285 const auto tpcClusAcc = recoData.getTPCClusters();
286 const auto shMap = recoData.clusterShMapTPC;
287 if (recoData.inputsTPCclusters) {
288 uint8_t clSect = 0, clRow = 0, clRowP = -1;
289 uint32_t clIdx = 0;
290 for (int ic = 0; ic < trc.getNClusterReferences(); ic++) {
291 trc.getClusterReference(clRefs, ic, clSect, clRow, clIdx);
292 if (clRow != clRowP) {
293 trExt.rowCountTPC++;
294 clRowP = clRow;
295 }
296 unsigned int absoluteIndex = tpcClusAcc.clusterOffset[clSect][clRow] + clIdx;
297 if (shMap[absoluteIndex] & o2::gpu::GPUTPCGMMergedTrackHit::flagShared) {
298 trExt.nClTPCShared++;
299 }
300 }
301 trc.getClusterReference(clRefs, trc.getNClusterReferences() - 1, clSect, clRow, clIdx);
302 trExt.rowMinTPC = clRow;
303 const auto& clus = tpcClusAcc.clusters[clSect][clRow][clIdx];
304 trExt.padFromEdge = uint8_t(clus.getPad());
305 int npads = o2::gpu::GPUTPCGeometry::NPads(clRow);
306 if (trExt.padFromEdge > npads / 2) {
307 trExt.padFromEdge = npads - 1 - trExt.padFromEdge;
308 }
309 this->mTPCCorrMapsLoader.Transform(clSect, clRow, clus.getPad(), clus.getTime(), trExt.innerTPCPos0[0], trExt.innerTPCPos0[1], trExt.innerTPCPos0[2], trc.getTime0()); // nominal time of the track
310 if (timestampTB > -1e8) {
311 this->mTPCCorrMapsLoader.Transform(clSect, clRow, clus.getPad(), clus.getTime(), trExt.innerTPCPos[0], trExt.innerTPCPos[1], trExt.innerTPCPos[2], timestampTB); // time assigned from the global track track
312 } else {
313 trExt.innerTPCPos = trExt.innerTPCPos0;
314 }
315 trc.getClusterReference(clRefs, 0, clSect, clRow, clIdx);
316 trExt.rowMaxTPC = clRow;
317 }
318 };
319
320 auto getTPCPairSharing = [&recoData, this](const o2::tpc::TrackTPC& trc0, const o2::tpc::TrackTPC& trc1) {
321 const auto clRefs = recoData.getTPCTracksClusterRefs();
322 uint8_t nsh = 0, nshRows = 0, lastSharedRow = -1;
323 if (recoData.inputsTPCclusters) {
324 uint8_t clSect0 = 0, clRow0 = 0, clSect1 = 0, clRow1 = 0;
325 uint32_t clIdx0 = 0, clIdx1 = 0;
326 int ic1Start = 0;
327 for (int ic0 = 0; ic0 < trc0.getNClusterReferences(); ic0++) { // outside -> inside
328 trc0.getClusterReference(clRefs, ic0, clSect0, clRow0, clIdx0);
329 for (int ic1 = ic1Start; ic1 < trc1.getNClusterReferences(); ic1++) { // outside -> inside
330 trc1.getClusterReference(clRefs, ic1, clSect1, clRow1, clIdx1);
331 if (clRow1 > clRow0) {
332 ic1Start = ic1 + 1;
333 continue; // catch up ic0
334 }
335 if (clRow1 == clRow0) {
336 if (clSect0 == clSect1 && clIdx0 == clIdx1) {
337 nsh++;
338 if (lastSharedRow != clRow0) {
339 lastSharedRow = clRow0;
340 nshRows++;
341 }
342 ic1Start = ic1 + 1;
343 break; // check next ic0
344 }
345 }
346 }
347 }
348 }
349 return std::make_pair(nsh, nshRows);
350 };
351
352 auto assignRecTrack = [&recoData, this](const o2::dataformats::TrackInfoExt& src, o2::trackstudy::RecTrack& dst) {
353 dst.track = src.track;
354 dst.gid = src.gid;
355 dst.ts.setTimeStamp(src.ttime);
356 dst.ts.setTimeStampError(src.ttimeE);
357 dst.nClITS = src.nClITS;
358 dst.nClTPC = src.nClTPC;
359 dst.pattITS = src.pattITS;
360 if (src.q2ptITS == 0. && dst.nClITS > 0) {
361 dst.pattITS |= 0x1 << 7;
362 }
363 dst.lowestPadRow = src.rowMinTPC;
364 if (this->mUseMC) {
365 auto gidSet = recoData.getSingleDetectorRefs(src.gid);
366 if (recoData.getTrackMCLabel(src.gid).isFake()) {
367 dst.flags |= RecTrack::FakeGLO;
368 }
369 auto msk = src.gid.getSourceDetectorsMask();
370 if (msk[DetID::ITS]) {
371 if (gidSet[GTrackID::ITS].isSourceSet()) { // has ITS track rather than AB tracklet
372 auto lblITS = recoData.getTrackMCLabel(gidSet[GTrackID::ITS]);
373 if (lblITS.isFake()) {
374 dst.flags |= RecTrack::FakeITS;
375 }
376 } else { // AB ITS tracklet
377 if (recoData.getTrackMCLabel(gidSet[GTrackID::ITSAB]).isFake()) {
378 dst.flags |= RecTrack::FakeITS;
379 }
380 }
381 if (msk[DetID::TPC]) { // has both ITS and TPC contribution
382 if (recoData.getTrackMCLabel(gidSet[GTrackID::ITSTPC]).isFake()) {
383 dst.flags |= RecTrack::FakeITSTPC;
384 }
385 }
386 }
387 if (msk[DetID::TPC]) {
388 if (recoData.getTrackMCLabel(gidSet[GTrackID::TPC]).isFake()) {
389 dst.flags |= RecTrack::FakeTPC;
390 }
391 }
392 }
393 };
394
395 for (int iv = 0; iv < nv; iv++) {
396 LOGP(debug, "processing PV {} of {}", iv, nv);
397 const auto& vtref = vtxRefs[iv];
398 if (iv != nv - 1) {
399 auto& pve = pveVec[iv];
400 static_cast<o2::dataformats::PrimaryVertex&>(pve) = pvvec[iv];
401 // find best matching FT0 signal
402 float bestTimeDiff = 1000, bestTime = -999;
403 int bestFTID = -1;
404 if (mTracksSrc[GTrackID::FT0]) {
405 for (int ift0 = vtref.getFirstEntryOfSource(GTrackID::FT0); ift0 < vtref.getFirstEntryOfSource(GTrackID::FT0) + vtref.getEntriesOfSource(GTrackID::FT0); ift0++) {
406 const auto& ft0 = FITInfo[trackIndex[ift0]];
407 if (ft0Params.isSelected(ft0)) {
408 auto fitTime = ft0.getInteractionRecord().differenceInBCMUS(recoData.startIR);
409 if (std::abs(fitTime - pve.getTimeStamp().getTimeStamp()) < bestTimeDiff) {
410 bestTimeDiff = fitTime - pve.getTimeStamp().getTimeStamp();
411 bestFTID = trackIndex[ift0];
412 }
413 }
414 }
415 } else {
416 LOGP(warn, "FT0 is not requested, cannot set complete vertex info");
417 }
418 if (bestFTID >= 0) {
419 pve.FT0A = FITInfo[bestFTID].getTrigger().getAmplA();
420 pve.FT0C = FITInfo[bestFTID].getTrigger().getAmplC();
421 pve.FT0Time = double(FITInfo[bestFTID].getInteractionRecord().differenceInBCMUS(recoData.startIR)) + FITInfo[bestFTID].getCollisionTimeMean() * 1e-6; // time in \mus
422 }
423 pve.VtxID = iv;
424 }
425 trcExtVec.clear();
426 trcPairsVec.clear();
427 float q2ptITS, q2ptTPC, q2ptITSTPC, q2ptITSTPCTRD;
428 for (int is = 0; is < GTrackID::NSources; is++) {
429 DetID::mask_t dm = GTrackID::getSourceDetectorsMask(is);
430 bool skipTracks = !mTracksSrc[is] || !recoData.isTrackSourceLoaded(is) || !(dm[DetID::ITS] || dm[DetID::TPC]);
431 int idMin = vtref.getFirstEntryOfSource(is), idMax = idMin + vtref.getEntriesOfSource(is);
432 for (int i = idMin; i < idMax; i++) {
433 auto vid = trackIndex[i];
434 bool pvCont = vid.isPVContributor();
435 if (pvCont) {
436 pveVec[iv].nSrc[is]++;
437 }
438 if (skipTracks) {
439 continue;
440 }
441 GTrackID tpcTrID;
442 const o2::tpc::TrackTPC* tpcTr = nullptr;
443 int nclTPC = 0;
444 if (dm[DetID::TPC] && tpcTrackOK) {
445 tpcTrID = recoData.getTPCContributorGID(vid);
446 tpcTr = &recoData.getTPCTrack(tpcTrID);
447 nclTPC = tpcTr->getNClusters();
448 if (nclTPC < mMinTPCClusters) {
449 continue;
450 }
451 }
452 bool ambig = vid.isAmbiguous();
453 auto trc = recoData.getTrackParam(vid);
454 if (abs(trc.getEta()) > mMaxEta) {
455 continue;
456 }
457 if (iv < nv - 1 && is == GTrackID::TPC && tpcTr && !tpcTr->hasBothSidesClusters()) { // for unconstrained TPC tracks correct track Z
458 float corz = vdrit * (tpcTr->getTime0() * mTPCTBinMUS - pvvec[iv].getTimeStamp().getTimeStamp());
459 if (tpcTr->hasASideClustersOnly()) {
460 corz = -corz; // A-side
461 }
462 trc.setZ(trc.getZ() + corz);
463 }
464 float xmin = trc.getX();
466 if (!prop->propagateToDCA(iv == nv - 1 ? vtxDummy : pvvec[iv], trc, prop->getNominalBz(), 2., o2::base::PropagatorF::MatCorrType::USEMatCorrLUT, &dca)) {
467 continue;
468 }
469 bool hasITS = GTrackID::getSourceDetectorsMask(is)[GTrackID::ITS];
470 if (std::abs(dca.getY()) > (hasITS ? getDCAYCut(trc.getPt()) : mTPCDCAYCut) ||
471 std::abs(dca.getZ()) > (hasITS ? getDCAZCut(trc.getPt()) : mTPCDCAZCut)) {
472 continue;
473 }
474 if (trc.getPt() < mMinPt) {
475 continue;
476 }
477 if (iv != nv - 1) {
478 pveVec[iv].nSrcA[is]++;
479 if (ambig) {
480 pveVec[iv].nSrcAU[is]++;
481 }
482 }
483 if (!hasITS && mStoreWithITSOnly) {
484 continue;
485 }
486 {
487 auto& trcExt = trcExtVec.emplace_back();
488 recoData.getTrackTime(vid, trcExt.ttime, trcExt.ttimeE);
489 trcExt.track = trc;
490 trcExt.dca = dca;
491 trcExt.gid = vid;
492 trcExt.xmin = xmin;
493 trcExt.dcaTPC.set(-999.f, -999.f);
494
495 if (tpcTr) {
496 float tsuse = trcExt.ttime / (8 * o2::constants::lhc::LHCBunchSpacingMUS);
497 if (is == GTrackID::TPC) {
498 trcExt.dcaTPC = dca;
499 tsuse = -1e9;
500 } else {
501 o2::track::TrackParCov tmpTPC(*tpcTr);
502 if (iv < nv - 1 && is == GTrackID::TPC && tpcTr && !tpcTr->hasBothSidesClusters()) { // for unconstrained TPC tracks correct track Z
503 float corz = vdrit * (tpcTr->getTime0() * mTPCTBinMUS - pvvec[iv].getTimeStamp().getTimeStamp());
504 if (tpcTr->hasASideClustersOnly()) {
505 corz = -corz; // A-side
506 }
507 tmpTPC.setZ(tmpTPC.getZ() + corz);
508 }
509 if (!prop->propagateToDCA(iv == nv - 1 ? vtxDummy : pvvec[iv], tmpTPC, prop->getNominalBz(), 2., o2::base::PropagatorF::MatCorrType::USEMatCorrLUT, &trcExt.dcaTPC)) {
510 trcExt.dcaTPC.set(-999.f, -999.f);
511 }
512 }
513 fillTPCClInfo(*tpcTr, trcExt, tsuse);
514 }
515 auto gidRefs = recoData.getSingleDetectorRefs(vid);
516 if (gidRefs[GTrackID::ITS].isIndexSet()) {
517 const auto& itsTr = recoData.getITSTrack(gidRefs[GTrackID::ITS]);
518 trcExt.q2ptITS = itsTr.getQ2Pt();
519 trcExt.nClITS = itsTr.getNClusters();
520 for (int il = 0; il < 7; il++) {
521 if (itsTr.hasHitOnLayer(il)) {
522 trcExt.pattITS |= 0x1 << il;
523 }
524 }
525 } else if (gidRefs[GTrackID::ITSAB].isIndexSet()) {
526 const auto& itsTrf = recoData.getITSABRefs()[gidRefs[GTrackID::ITSAB]];
527 trcExt.nClITS = itsTrf.getNClusters();
528 for (int il = 0; il < 7; il++) {
529 if (itsTrf.hasHitOnLayer(il)) {
530 trcExt.pattITS |= 0x1 << il;
531 }
532 }
533 }
534 if (gidRefs[GTrackID::TPC].isIndexSet()) {
535 trcExt.q2ptTPC = recoData.getTrackParam(gidRefs[GTrackID::TPC]).getQ2Pt();
536 trcExt.nClTPC = nclTPC;
537 }
538 if (gidRefs[GTrackID::ITSTPC].isIndexSet()) {
539 const auto& trTPCITS = recoData.getTPCITSTrack(gidRefs[GTrackID::ITSTPC]);
540 trcExt.q2ptITSTPC = trTPCITS.getQ2Pt();
541 trcExt.chi2ITSTPC = trTPCITS.getChi2Match();
542 }
543 if (gidRefs[GTrackID::TRD].isIndexSet()) {
544 trcExt.q2ptITSTPCTRD = recoData.getTrackParam(gidRefs[GTrackID::TRD]).getQ2Pt();
545 }
546 if (gidRefs[GTrackID::TOF].isIndexSet()) {
547 trcExt.infoTOF = recoData.getTOFMatch(vid);
548 }
549 }
550 }
551 }
552 float tpcOccBef = 0., tpcOccAft = 0.;
553 if (iv != nv - 1) {
554 int tb = pveVec[iv].getTimeStamp().getTimeStamp() * mTPCTBinMUSInv * mNTPCOccBinLengthInv;
555 tpcOccBef = tb < 0 ? mTBinClOccBef[0] : (tb >= mTBinClOccBef.size() ? mTBinClOccBef.back() : mTBinClOccBef[tb]);
556 tpcOccAft = tb < 0 ? mTBinClOccAft[0] : (tb >= mTBinClOccAft.size() ? mTBinClOccAft.back() : mTBinClOccAft[tb]);
557 }
558 (*mDBGOut) << "trpv"
559 << "orbit=" << recoData.startIR.orbit << "tfID=" << TFCount
560 << "tpcOccBef=" << tpcOccBef << "tpcOccAft=" << tpcOccAft
561 << "pve=" << pveVec[iv] << "trc=" << trcExtVec << "\n";
562
563 if (mDoPairsCorr) {
564 for (int it0 = 0; it0 < (int)trcExtVec.size(); it0++) {
565 const auto& tr0 = trcExtVec[it0];
566 if (tr0.nClTPC < 1) {
567 continue;
568 }
569 for (int it1 = it0 + 1; it1 < (int)trcExtVec.size(); it1++) {
570 const auto& tr1 = trcExtVec[it1];
571 if (tr1.nClTPC < 1) {
572 continue;
573 }
574
575 if (std::abs(tr0.track.getTgl() - tr1.track.getTgl()) > 0.25) {
576 continue;
577 }
578 auto dphi = tr0.track.getPhi() - tr1.track.getPhi();
579 if (dphi < -o2::constants::math::PI) {
581 } else if (dphi > o2::constants::math::PI) {
583 }
584 if (std::abs(dphi) > 0.25) {
585 continue;
586 }
587 auto& pr = trcPairsVec.emplace_back();
588 assignRecTrack(tr0, pr.tr0);
589 assignRecTrack(tr1, pr.tr1);
590 auto shinfo = getTPCPairSharing(recoData.getTPCTrack(recoData.getTPCContributorGID(tr0.gid)), recoData.getTPCTrack(recoData.getTPCContributorGID(tr1.gid)));
591 pr.nshTPC = shinfo.first;
592 pr.nshTPCRow = shinfo.second;
593 }
594 }
595 (*mDBGOut) << "pairs" << "pr=" << trcPairsVec << "\n";
596 }
597 }
598
599 int nvtot = mMaxNeighbours < 0 ? -1 : (int)pveVec.size();
600
601 auto insSlot = [maxSlots = mMaxNeighbours](std::vector<float>& vc, float v, int slot, std::vector<int>& vid, int id) {
602 for (int i = maxSlots - 1; i > slot; i--) {
603 std::swap(vc[i], vc[i - 1]);
604 std::swap(vid[i], vid[i - 1]);
605 }
606 vc[slot] = v;
607 vid[slot] = id;
608 };
609
610 for (int cnt = 0; cnt < nvtot; cnt++) {
611 const auto& pve = pveVec[cnt];
612 float tv = pve.getTimeStamp().getTimeStamp();
613 std::vector<o2::dataformats::PrimaryVertexExt> pveT(mMaxNeighbours); // neighbours in time
614 std::vector<o2::dataformats::PrimaryVertexExt> pveZ(mMaxNeighbours); // neighbours in Z
615 std::vector<int> idT(mMaxNeighbours), idZ(mMaxNeighbours);
616 std::vector<float> dT(mMaxNeighbours), dZ(mMaxNeighbours);
617 for (int i = 0; i < mMaxNeighbours; i++) {
618 idT[i] = idZ[i] = -1;
619 dT[i] = mMaxVTTimeDiff;
620 dZ[i] = 1e9;
621 }
622 int cntM = cnt - 1, cntP = cnt + 1;
623 for (; cntM >= 0; cntM--) { // backward
624 const auto& vt = pveVec[cntM];
625 auto dtime = std::abs(tv - vt.getTimeStamp().getTimeStamp());
626 if (dtime > mMaxVTTimeDiff) {
627 continue;
628 }
629 for (int i = 0; i < mMaxNeighbours; i++) {
630 if (dT[i] > dtime) {
631 insSlot(dT, dtime, i, idT, cntM);
632 break;
633 }
634 }
635 auto dz = std::abs(pve.getZ() - vt.getZ());
636 for (int i = 0; i < mMaxNeighbours; i++) {
637 if (dZ[i] > dz) {
638 insSlot(dZ, dz, i, idZ, cntM);
639 break;
640 }
641 }
642 }
643 for (; cntP < nvtot; cntP++) { // forward
644 const auto& vt = pveVec[cntP];
645 auto dtime = std::abs(tv - vt.getTimeStamp().getTimeStamp());
646 if (dtime > mMaxVTTimeDiff) {
647 continue;
648 }
649 for (int i = 0; i < mMaxNeighbours; i++) {
650 if (dT[i] > dtime) {
651 insSlot(dT, dtime, i, idT, cntP);
652 break;
653 }
654 }
655 auto dz = std::abs(pve.getZ() - vt.getZ());
656 for (int i = 0; i < mMaxNeighbours; i++) {
657 if (dZ[i] > dz) {
658 insSlot(dZ, dz, i, idZ, cntP);
659 break;
660 }
661 }
662 }
663 for (int i = 0; i < mMaxNeighbours; i++) {
664 if (idT[i] != -1) {
665 pveT[i] = pveVec[idT[i]];
666 } else {
667 break;
668 }
669 }
670 for (int i = 0; i < mMaxNeighbours; i++) {
671 if (idZ[i] != -1) {
672 pveZ[i] = pveVec[idZ[i]];
673 } else {
674 break;
675 }
676 }
677 (*mDBGOutVtx) << "pvExt"
678 << "pve=" << pve
679 << "pveT=" << pveT
680 << "pveZ=" << pveZ
681 << "tfID=" << TFCount
682 << "\n";
683 }
684
685 TFCount++;
686}
687
689{
690 mDBGOut.reset();
691 mDBGOutVtx.reset();
692}
693
695{
697 return;
698 }
699 if (mTPCVDriftHelper.accountCCDBInputs(matcher, obj)) {
700 return;
701 }
702 if (mTPCCorrMapsLoader.accountCCDBInputs(matcher, obj)) {
703 return;
704 }
705 if (matcher == ConcreteDataMatcher("GLO", "MEANVERTEX", 0)) {
706 LOG(info) << "Imposing new MeanVertex: " << ((const o2::dataformats::MeanVertexObject*)obj)->asString();
707 mMeanVtx = *(const o2::dataformats::MeanVertexObject*)obj;
708 return;
709 }
710}
711
712float TrackingStudySpec::getDCAYCut(float pt) const
713{
714 static TF1 fun("dcayvspt", mDCAYFormula.c_str(), 0, 20);
715 return fun.Eval(pt);
716}
717
718float TrackingStudySpec::getDCAZCut(float pt) const
719{
720 static TF1 fun("dcazvspt", mDCAZFormula.c_str(), 0, 20);
721 return fun.Eval(pt);
722}
723
725{
726 std::vector<OutputSpec> outputs;
727 auto dataRequest = std::make_shared<DataRequest>();
728
729 dataRequest->requestTracks(srcTracks, useMC);
730 dataRequest->requestClusters(srcClusters, useMC);
731 dataRequest->requestPrimaryVertices(useMC);
732 dataRequest->inputs.emplace_back("meanvtx", "GLO", "MEANVERTEX", 0, Lifetime::Condition, ccdbParamSpec("GLO/Calib/MeanVertex", {}, 1));
733 auto ggRequest = std::make_shared<o2::base::GRPGeomRequest>(false, // orbitResetTime
734 true, // GRPECS=true
735 true, // GRPLHCIF
736 true, // GRPMagField
737 true, // askMatLUT
739 dataRequest->inputs,
740 true);
741
742 Options opts{
743 {"max-vtx-neighbours", VariantType::Int, 3, {"Max PV neighbours fill, no PV study if < 0"}},
744 {"max-vtx-timediff", VariantType::Float, 90.f, {"Max PV time difference to consider"}},
745 {"dcay-vs-pt", VariantType::String, "0.0105 + 0.0350 / pow(x, 1.1)", {"Formula for global tracks DCAy vs pT cut"}},
746 {"dcaz-vs-pt", VariantType::String, "0.0105 + 0.0350 / pow(x, 1.1)", {"Formula for global tracks DCAy vs pT cut"}},
747 {"min-tpc-clusters", VariantType::Int, 60, {"Cut on TPC clusters"}},
748 {"max-tpc-dcay", VariantType::Float, 5.f, {"Cut on TPC dcaY"}},
749 {"max-tpc-dcaz", VariantType::Float, 5.f, {"Cut on TPC dcaZ"}},
750 {"max-eta", VariantType::Float, 1.0f, {"Cut on track eta"}},
751 {"min-pt", VariantType::Float, 0.1f, {"Cut on track pT"}},
752 {"with-its-only", VariantType::Bool, false, {"Store tracks with ITS only"}},
753 {"pair-correlations", VariantType::Bool, false, {"Do pairs correlation"}},
754 {"occ-weight-fun", VariantType::String, "(x>=-40&&x<-5) ? (1./1225*pow(x+40,2)) : ((x>-5&&x<15) ? 1. : ((x>=15&&x<40) ? (-0.4/25*x+1.24 ) : ( (x>40&&x<100) ? -0.4/60*x+0.6+0.8/3 : 0)))", {"Occupancy weighting f-n vs time in musec"}},
755 {"min-x-prop", VariantType::Float, 100.f, {"track should be propagated to this X at least"}},
756 };
757 o2::tpc::VDriftHelper::requestCCDBInputs(dataRequest->inputs);
758 o2::tpc::CorrectionMapsLoader::requestCCDBInputs(dataRequest->inputs, opts, sclOpts);
759
760 return DataProcessorSpec{
761 "track-study",
762 dataRequest->inputs,
763 outputs,
764 AlgorithmSpec{adaptFromTask<TrackingStudySpec>(dataRequest, ggRequest, srcTracks, useMC, sclOpts)},
765 opts};
766}
767
768} // namespace o2::trackstudy
Helper class to access load maps from CCDB.
Wrapper container for different reconstructed object types.
Definition of the GeometryManager class.
Definition of the FIT RecPoints class.
int32_t i
Helper for geometry and GRP related CCDB requests.
Global index for barrel track: provides provenance (detectors combination), index in respective array...
Utility functions for MC particles.
Definition of the Names Generator class.
Definition of the parameter class for the detector electronics.
Wrapper container for different reconstructed object types.
Result of refitting TPC-ITS matched track.
Reference on ITS/MFT clusters set.
Helper class to extract VDrift from different sources.
std::ostringstream debug
Referenc on track indices contributing to the vertex, with possibility chose tracks from specific sou...
bool isFake() const
Definition MCCompLabel.h:78
void checkUpdates(o2::framework::ProcessingContext &pc)
static GRPGeomHelper & instance()
void setRequest(std::shared_ptr< GRPGeomRequest > req)
GPUd() value_type estimateLTFast(o2 static GPUd() float estimateLTIncrement(const o2 PropagatorImpl * Instance(bool uninitialized=false)
Definition Propagator.h:143
math_utils::Point3D< float > & getPos()
Static class with identifiers, bitmasks and names for ALICE detectors.
Definition DetID.h:58
static constexpr ID ITS
Definition DetID.h:63
static constexpr ID TPC
Definition DetID.h:64
ServiceRegistryRef services()
Definition InitContext.h:34
ConfigParamRegistry const & options()
Definition InitContext.h:33
decltype(auto) get(R binding, int part=0) const
InputRecord & inputs()
The inputs associated with this processing context.
void extractCCDBInputs(o2::framework::ProcessingContext &pc)
void updateVDrift(float vdriftCorr, float vdrifRef, float driftTimeOffset=0)
bool accountCCDBInputs(const o2::framework::ConcreteDataMatcher &matcher, void *obj)
static void requestCCDBInputs(std::vector< o2::framework::InputSpec > &inputs, std::vector< o2::framework::ConfigParamSpec > &options, const CorrectionMapsLoaderGloOpts &gloOpts)
recalculate inverse correction
void init(o2::framework::InitContext &ic)
static void requestCCDBInputs(std::vector< o2::framework::InputSpec > &inputs, bool laser=true, bool itstpcTgl=true)
void extractCCDBInputs(o2::framework::ProcessingContext &pc, bool laser=true, bool itstpcTgl=true)
const VDriftCorrFact & getVDriftObject() const
bool accountCCDBInputs(const o2::framework::ConcreteDataMatcher &matcher, void *obj)
static std::string_view getSourceName(Source s)
bool isUpdated() const
void process(o2::globaltracking::RecoContainer &recoData)
void run(ProcessingContext &pc) final
TrackingStudySpec(std::shared_ptr< DataRequest > dr, std::shared_ptr< o2::base::GRPGeomRequest > gr, GTrackID::mask_t src, bool useMC, const o2::tpc::CorrectionMapsLoaderGloOpts &sclOpts)
void finaliseCCDB(ConcreteDataMatcher &matcher, void *obj) final
void endOfStream(EndOfStreamContext &ec) final
This is invoked whenever we have an EndOfStream event.
void init(InitContext &ic) final
GLenum src
Definition glcorearb.h:1767
const GLdouble * v
Definition glcorearb.h:832
GLenum GLenum dst
Definition glcorearb.h:1767
GLuint id
Definition glcorearb.h:650
constexpr double LHCBunchSpacingMUS
constexpr int LHCMaxBunches
constexpr double LHCBunchSpacingNS
constexpr float TwoPI
constexpr float PI
Defining PrimaryVertex explicitly as messageable.
Definition TFIDInfo.h:20
std::vector< ConfigParamSpec > ccdbParamSpec(std::string const &path, int runDependent, std::vector< CCDBMetadata > metadata={}, int qrate=0)
std::vector< ConfigParamSpec > Options
detail::Bracket< float > Bracketf_t
Definition Primitive2D.h:40
TrackParCovF TrackParCov
Definition Track.h:33
o2::math_utils::Bracketf_t TBracket
o2::framework::DataProcessorSpec getTrackingStudySpec(o2::dataformats::GlobalTrackID::mask_t srcTracks, o2::dataformats::GlobalTrackID::mask_t srcClus, bool useMC, const o2::tpc::CorrectionMapsLoaderGloOpts &sclOpts)
create a processor spec
o2::dataformats::VtxTrackRef V2TRef
o2::dataformats::VtxTrackIndex VTIndex
a couple of static helper functions to create timestamp values for CCDB queries or override obsolete ...
Defining DataPointCompositeObject explicitly as copiable.
uint32_t orbit
LHC orbit.
bool isSelected(const RecPoints &rp) const
GlobalIDSet getSingleDetectorRefs(GTrackID gidx) const
const o2::tpc::TrackTPC & getTPCTrack(GTrackID id) const
const o2::tpc::ClusterNativeAccess & getTPCClusters() const
o2::MCCompLabel getTrackMCLabel(GTrackID id) const
GTrackID getTPCContributorGID(GTrackID source) const
const o2::track::TrackParCov & getTrackParam(GTrackID gidx) const
gsl::span< const unsigned char > clusterShMapTPC
externally set TPC clusters sharing map
const o2::dataformats::TrackTPCITS & getTPCITSTrack(GTrackID gid) const
void collectData(o2::framework::ProcessingContext &pc, const DataRequest &request)
const o2::its::TrackITS & getITSTrack(GTrackID gid) const
std::unique_ptr< o2::tpc::internal::getWorkflowTPCInput_ret > inputsTPCclusters
void getTrackTime(GTrackID gid, float &t, float &tErr) const
gsl::span< const unsigned int > occupancyMapTPC
externally set TPC clusters occupancy map
const o2::dataformats::MatchInfoTOF & getTOFMatch(GTrackID id) const
int lumiType
what estimator to used for corrections scaling: 0: no scaling, 1: CTP, 2: IDC
int lumiMode
what corrections method to use: 0: classical scaling, 1: Using of the derivative map,...
float refTimeOffset
additive time offset reference (\mus)
float refVDrift
reference vdrift for which factor was extracted
float getTimeOffset() const
float timeOffsetCorr
additive time offset correction (\mus)
float corrFact
drift velocity correction factor (multiplicative)
LOG(info)<< "Compressed in "<< sw.CpuTime()<< " s"
const std::string str