Skip to content

Commit

Permalink
assure TOF code uses std::abs everywhere
Browse files Browse the repository at this point in the history
  • Loading branch information
noferini committed Oct 10, 2024
1 parent 81baf91 commit 13eb869
Show file tree
Hide file tree
Showing 12 changed files with 84 additions and 84 deletions.
48 changes: 24 additions & 24 deletions Detectors/GlobalTracking/src/MatchTOF.cxx
Original file line number Diff line number Diff line change
Expand Up @@ -192,15 +192,15 @@ void MatchTOF::run(const o2::globaltracking::RecoContainer& inp, unsigned long f
bct0--;
}
float tof = matchingPair.getSignal() - bct0 * Geo::BC_TIME_INPS;
if (abs(tof - matchingPair.getLTIntegralOut().getTOF(2)) < 600) {
} else if (abs(tof - matchingPair.getLTIntegralOut().getTOF(3)) < 600) {
} else if (abs(tof - matchingPair.getLTIntegralOut().getTOF(4)) < 600) {
} else if (abs(tof - matchingPair.getLTIntegralOut().getTOF(0)) < 600) {
} else if (abs(tof - matchingPair.getLTIntegralOut().getTOF(1)) < 600) {
} else if (abs(tof - matchingPair.getLTIntegralOut().getTOF(5)) < 600) {
} else if (abs(tof - matchingPair.getLTIntegralOut().getTOF(6)) < 600) {
} else if (abs(tof - matchingPair.getLTIntegralOut().getTOF(7)) < 600) {
} else if (abs(tof - matchingPair.getLTIntegralOut().getTOF(8)) < 600) {
if (std::abs(tof - matchingPair.getLTIntegralOut().getTOF(2)) < 600) {
} else if (std::abs(tof - matchingPair.getLTIntegralOut().getTOF(3)) < 600) {
} else if (std::abs(tof - matchingPair.getLTIntegralOut().getTOF(4)) < 600) {
} else if (std::abs(tof - matchingPair.getLTIntegralOut().getTOF(0)) < 600) {
} else if (std::abs(tof - matchingPair.getLTIntegralOut().getTOF(1)) < 600) {
} else if (std::abs(tof - matchingPair.getLTIntegralOut().getTOF(5)) < 600) {
} else if (std::abs(tof - matchingPair.getLTIntegralOut().getTOF(6)) < 600) {
} else if (std::abs(tof - matchingPair.getLTIntegralOut().getTOF(7)) < 600) {
} else if (std::abs(tof - matchingPair.getLTIntegralOut().getTOF(8)) < 600) {
} else { // no pion, kaon, proton, electron, muon, deuteron, triton, 3He, 4He
matchingPair.setFakeMatch();
}
Expand Down Expand Up @@ -557,7 +557,7 @@ void MatchTOF::propagateTPCTracks(int sec)
}

if (trc.getX() < o2::constants::geom::XTPCOuterRef - 1.) {
if (!propagateToRefXWithoutCov(trc, o2::constants::geom::XTPCOuterRef, 10, mBz) || TMath::Abs(trc.getZ()) > Geo::MAXHZTOF) { // we check that the propagat>
if (!propagateToRefXWithoutCov(trc, o2::constants::geom::XTPCOuterRef, 10, mBz) || std::abs(trc.getZ()) > Geo::MAXHZTOF) { // we check that the propagat>
mNotPropagatedToTOF[trkType::UNCONS]++;
continue;
}
Expand All @@ -566,7 +566,7 @@ void MatchTOF::propagateTPCTracks(int sec)
o2::base::Propagator::Instance()->estimateLTFast(intLT0, trc);

// the "rough" propagation worked; now we can propagate considering also the cov matrix
if (!propagateToRefX(trc, mXRef, 2, intLT0)) { // || TMath::Abs(trc.getZ()) > Geo::MAXHZTOF) { // we check that the propagation with the cov matrix w>
if (!propagateToRefX(trc, mXRef, 2, intLT0)) { // || std::abs(trc.getZ()) > Geo::MAXHZTOF) { // we check that the propagation with the cov matrix w>
mNotPropagatedToTOF[trkType::UNCONS]++;
continue;
}
Expand Down Expand Up @@ -603,7 +603,7 @@ void MatchTOF::propagateConstrTracks(int sec)
}

// the "rough" propagation worked; now we can propagate considering also the cov matrix
if (!propagateToRefX(trc, mXRef, 2, intLT0) || TMath::Abs(trc.getZ()) > Geo::MAXHZTOF) { // we check that the propagation with the cov matrix worked;>
if (!propagateToRefX(trc, mXRef, 2, intLT0) || std::abs(trc.getZ()) > Geo::MAXHZTOF) { // we check that the propagation with the cov matrix worked;>
mNotPropagatedToTOF[trkType::CONSTR]++;
continue;
}
Expand Down Expand Up @@ -706,7 +706,7 @@ void MatchTOF::addTPCSeed(const o2::tpc::TrackTPC& _tr, o2::dataformats::GlobalT
// compute track length up to now
mLTinfos[sector][trkType::UNCONS].emplace_back(intLT0);
float vz0 = _tr.getZAt(0, mBz);
if (abs(vz0) > 9000) {
if (std::abs(vz0) > 9000) {
vz0 = _tr.getZ() - _tr.getX() * _tr.getTgl();
}
mVZtpcOnly[sector].push_back(vz0);
Expand All @@ -727,14 +727,14 @@ void MatchTOF::addTPCSeed(const o2::tpc::TrackTPC& _tr, o2::dataformats::GlobalT
}
if (trc.getX() < o2::constants::geom::XTPCOuterRef - 1.) {
if (!propagateToRefX(trc, o2::constants::geom::XTPCOuterRef, 10, intLT0) || TMath::Abs(trc.getZ()) > Geo::MAXHZTOF) { // we check that the propagation with the cov matrix worked; CHECK: can it happ
if (!propagateToRefX(trc, o2::constants::geom::XTPCOuterRef, 10, intLT0) || std::abs(trc.getZ()) > Geo::MAXHZTOF) { // we check that the propagation with the cov matrix worked; CHECK: can it happ
mNotPropagatedToTOF[trkType::UNCONS]++;
return;
}
}
// the "rough" propagation worked; now we can propagate considering also the cov matrix
if (!propagateToRefX(trc, mXRef, 2, intLT0)) { // || TMath::Abs(trc.getZ()) > Geo::MAXHZTOF) { // we check that the propagation with the cov matrix worked; CHECK: can it happen that it does not if the prop>
if (!propagateToRefX(trc, mXRef, 2, intLT0)) { // || std::abs(trc.getZ()) > Geo::MAXHZTOF) { // we check that the propagation with the cov matrix worked; CHECK: can it happen that it does not if the prop>
mNotPropagatedToTOF[trkType::UNCONS]++;
return;
}
Expand Down Expand Up @@ -1411,9 +1411,9 @@ void MatchTOF::doMatchingForTPC(int sec)
}

if (mMatchParams->applyPIDcutTPConly) { // for TPC only tracks allowing possibility to apply a PID cut
if (abs(tof - trkLTInt[ibc][iPropagation].getTOF(2)) < 2000) { // pion hypotesis
} else if (abs(tof - trkLTInt[ibc][iPropagation].getTOF(3)) < 2000) { // kaon hypoteis
} else if (abs(tof - trkLTInt[ibc][iPropagation].getTOF(4)) < 2000) { // proton hypotesis
if (std::abs(tof - trkLTInt[ibc][iPropagation].getTOF(2)) < 2000) { // pion hypotesis
} else if (std::abs(tof - trkLTInt[ibc][iPropagation].getTOF(3)) < 2000) { // kaon hypoteis
} else if (std::abs(tof - trkLTInt[ibc][iPropagation].getTOF(4)) < 2000) { // proton hypotesis
} else { // reject matching
continue;
}
Expand Down Expand Up @@ -1518,7 +1518,7 @@ int MatchTOF::findFITIndex(int bc, const gsl::span<const o2::ft0::RecPoints>& FI
if (mHasFillScheme && !mFillScheme[ir.bc]) {
continue;
}
bool quality = (fabs(FITRecPoints[i].getCollisionTime(0)) < 1000 && fabs(FITRecPoints[i].getVertex()) < 1000);
bool quality = (std::abs(FITRecPoints[i].getCollisionTime(0)) < 1000 && std::abs(FITRecPoints[i].getVertex()) < 1000);
if (bestQuality && !quality) { // if current has no good quality and the one previoulsy selected has -> discard the current one
continue;
}
Expand Down Expand Up @@ -1596,7 +1596,7 @@ void MatchTOF::BestMatches(std::vector<o2::dataformats::MatchInfoTOFReco>& match
float timeNew = TOFClusWork[matchingPair.getTOFClIndex()].getTime() - deltaT;
float timeOld = TOFClusWork[prevMatching.getTOFClIndex()].getTime();

if (fabs(timeNew - timeOld) < 200) {
if (std::abs(timeNew - timeOld) < 200) {
// update time information averaging the two (the second one corrected for the difference in the track length)
prevMatching.setSignal((timeNew + timeOld) * 0.5);
prevMatching.setChi2(0); // flag such cases with chi2 equal to zero
Expand Down Expand Up @@ -1820,7 +1820,7 @@ bool MatchTOF::propagateToRefX(o2::track::TrackParCov& trc, float xRef, float st
refReached = true; // we reached the 371cm reference
}
istep++;
if (fabs(trc.getY()) > trc.getX() * tanHalfSector) { // we are still in the same sector
if (std::abs(trc.getY()) > trc.getX() * tanHalfSector) { // we are still in the same sector
// we need to rotate the track to go to the new sector
//Printf("propagateToRefX: changing sector");
auto alphaNew = o2::math_utils::angle2Alpha(trc.getPhiPos());
Expand Down Expand Up @@ -1860,7 +1860,7 @@ bool MatchTOF::propagateToRefXWithoutCov(const o2::track::TrackParCov& trc, floa
refReached = true; // we reached the 371cm reference
}
istep++;
if (fabs(trcNoCov.getY()) > trcNoCov.getX() * tanHalfSector) { // we are still in the same sector
if (std::abs(trcNoCov.getY()) > trcNoCov.getX() * tanHalfSector) { // we are still in the same sector
// we need to rotate the track to go to the new sector
//Printf("propagateToRefX: changing sector");
auto alphaNew = o2::math_utils::angle2Alpha(trcNoCov.getPhiPos());
Expand All @@ -1877,7 +1877,7 @@ bool MatchTOF::propagateToRefXWithoutCov(const o2::track::TrackParCov& trc, floa
// if (std::abs(trc.getSnp()) > MAXSNP) Printf("propagateToRefX: condition on snp not ok, returning false");
//Printf("propagateToRefX: snp of teh track is %f (--> %f grad)", trcNoCov.getSnp(), TMath::ASin(trcNoCov.getSnp())*TMath::RadToDeg());

return refReached && std::abs(trcNoCov.getSnp()) < 0.95 && TMath::Abs(trcNoCov.getZ()) < Geo::MAXHZTOF; // Here we need to put MAXSNP
return refReached && std::abs(trcNoCov.getSnp()) < 0.95 && std::abs(trcNoCov.getZ()) < Geo::MAXHZTOF; // Here we need to put MAXSNP
}

//______________________________________________
Expand All @@ -1900,7 +1900,7 @@ void MatchTOF::updateTimeDependentParams()
mTPCBin2Z = mTPCTBinMUS * mTPCVDrift;

mBz = o2::base::Propagator::Instance()->getNominalBz();
mMaxInvPt = abs(mBz) > 0.1 ? 1. / (abs(mBz) * 0.05) : 999.;
mMaxInvPt = std::abs(mBz) > 0.1 ? 1. / (std::abs(mBz) * 0.05) : 999.;

const auto& trackTune = TrackTuneParams::Instance();
float scale = mTPCCorrMapsHelper->getInstLumiCTP();
Expand Down
8 changes: 4 additions & 4 deletions Detectors/GlobalTrackingWorkflow/src/TOFEventTimeChecker.cxx
Original file line number Diff line number Diff line change
Expand Up @@ -266,10 +266,10 @@ void TOFEventTimeChecker::processEvent(std::vector<MyTrack>& tracks)
float betaexpPr = mL / mExpPr * cinv;

//Mass
float mass = mP / beta * TMath::Sqrt(TMath::Abs(1 - beta * beta));
float massexpPi = mP / betaexpPi * TMath::Sqrt(TMath::Abs(1 - betaexpPi * betaexpPi));
float massexpKa = mP / betaexpKa * TMath::Sqrt(TMath::Abs(1 - betaexpKa * betaexpKa));
float massexpPr = mP / betaexpPr * TMath::Sqrt(TMath::Abs(1 - betaexpPr * betaexpPr));
float mass = mP / beta * TMath::Sqrt(std::abs(1 - beta * beta));
float massexpPi = mP / betaexpPi * TMath::Sqrt(std::abs(1 - betaexpPi * betaexpPi));
float massexpKa = mP / betaexpKa * TMath::Sqrt(std::abs(1 - betaexpKa * betaexpKa));
float massexpPr = mP / betaexpPr * TMath::Sqrt(std::abs(1 - betaexpPr * betaexpPr));

if (massexpPi < 0.13) { // remove wrong track lengths
continue;
Expand Down
8 changes: 4 additions & 4 deletions Detectors/TOF/base/src/EventTimeMaker.cxx
Original file line number Diff line number Diff line change
Expand Up @@ -152,7 +152,7 @@ void computeEvTime(const std::vector<eventTimeTrack>& tracks, const std::vector<
}
float err = evtime.mTrackTimes[i] - averageBest;
err *= sqrt(evtime.mWeights[i]);
err = fabs(err);
err = std::abs(err);
if (err > errworse) {
errworse = err;
worse = i;
Expand Down Expand Up @@ -293,7 +293,7 @@ int getStartTimeInSet(const std::vector<eventTimeTrack>& tracks, std::vector<int
const eventTimeTrack& ctrack = tracks[trackInSet[itrk]];
starttime[itrk] = ctrack.mSignal - ctrack.expTimes[hypo[itrk]];

if (fabs(starttime[itrk] - refT0) < 2000) { // otherwise time inconsistent with the int BC
if (std::abs(starttime[itrk] - refT0) < 2000) { // otherwise time inconsistent with the int BC
weighttime[itrk] = 1. / (ctrack.expSigma[hypo[itrk]] * ctrack.expSigma[hypo[itrk]]);
average += starttime[itrk] * weighttime[itrk];
sumweights += weighttime[itrk];
Expand Down Expand Up @@ -329,7 +329,7 @@ int getStartTimeInSet(const std::vector<eventTimeTrack>& tracks, std::vector<int
const eventTimeTrack& ctrack = tracks[trackInSet[itrk]];
float err = ctrack.mSignal - ctrack.expTimes[hypo[itrk]] - averageBest;
err /= ctrack.expSigma[hypo[itrk]];
err = fabs(err);
err = std::abs(err);
if (err > errworse) {
errworse = err;
worse = itrk;
Expand Down Expand Up @@ -404,7 +404,7 @@ int getStartTimeInSetFast(const std::vector<eventTimeTrack>& tracks, std::vector
const eventTimeTrack& ctrack = tracks[trackInSet[itrk]];
float err = ctrack.mSignal - ctrack.expTimes[hypo[itrk]] - averageBest;
err /= ctrack.expSigma[hypo[itrk]];
err = fabs(err);
err = std::abs(err);
if (err > errworse) {
errworse = err;
worse = itrk;
Expand Down
14 changes: 7 additions & 7 deletions Detectors/TOF/base/src/Geo.cxx
Original file line number Diff line number Diff line change
Expand Up @@ -773,10 +773,10 @@ Int_t Geo::fromPlateToStrip(Float_t* pos, Int_t iplate, Int_t isector)
step[2] = -getGeoDistances(isector, iplate, istrip);
translate(posLoc2[0], posLoc2[1], posLoc2[2], step);

if (fabs(posLoc2[1]) > 10) {
if (std::abs(posLoc2[1]) > 10) {
continue;
}
if (fabs(posLoc2[2]) > 10) {
if (std::abs(posLoc2[2]) > 10) {
continue;
}

Expand All @@ -788,8 +788,8 @@ Int_t Geo::fromPlateToStrip(Float_t* pos, Int_t iplate, Int_t isector)

rotateToStrip(posLoc2, iplate, istrip, isector);

if ((TMath::Abs(posLoc2[0]) <= STRIPLENGTH * 0.5) && (TMath::Abs(posLoc2[1]) <= HSTRIPY * 0.5) &&
(TMath::Abs(posLoc2[2]) <= WCPCBZ * 0.5)) {
if ((std::abs(posLoc2[0]) <= STRIPLENGTH * 0.5) && (std::abs(posLoc2[1]) <= HSTRIPY * 0.5) &&
(std::abs(posLoc2[2]) <= WCPCBZ * 0.5)) {
step[0] = -0.5 * NPADX * XPAD;
step[1] = 0.;
step[2] = -0.5 * NPADZ * ZPAD;
Expand Down Expand Up @@ -891,11 +891,11 @@ Int_t Geo::getPlate(const Float_t* pos)
Float_t zLocal = pos[2];

Float_t deltaRhoLoc = (RMAX - RMIN) * 0.5 - MODULEWALLTHICKNESS + yLocal;
Float_t deltaZetaLoc = TMath::Abs(zLocal);
Float_t deltaZetaLoc = std::abs(zLocal);

Float_t deltaRHOmax = 0.;

if (TMath::Abs(zLocal) >= EXTERINTERMODBORDER1 && TMath::Abs(zLocal) <= EXTERINTERMODBORDER2) {
if (std::abs(zLocal) >= EXTERINTERMODBORDER1 && std::abs(zLocal) <= EXTERINTERMODBORDER2) {
deltaRhoLoc -= LENGTHEXINMODBORDER;
deltaZetaLoc = EXTERINTERMODBORDER2 - deltaZetaLoc;
deltaRHOmax = (RMAX - RMIN) * 0.5 - MODULEWALLTHICKNESS - 2. * LENGTHEXINMODBORDER; // old 5.35, new 4.8
Expand All @@ -913,7 +913,7 @@ Int_t Geo::getPlate(const Float_t* pos)
iPlate = 3;
}
}
} else if (TMath::Abs(zLocal) >= INTERCENTRMODBORDER1 && TMath::Abs(zLocal) <= INTERCENTRMODBORDER2) {
} else if (std::abs(zLocal) >= INTERCENTRMODBORDER1 && std::abs(zLocal) <= INTERCENTRMODBORDER2) {
deltaRhoLoc -= LENGTHINCEMODBORDERD;
deltaZetaLoc = deltaZetaLoc - INTERCENTRMODBORDER1;
deltaRHOmax = (RMAX - RMIN) * 0.5 - MODULEWALLTHICKNESS - 2. * LENGTHINCEMODBORDERD; // old 0.39, new 0.2
Expand Down
24 changes: 12 additions & 12 deletions Detectors/TOF/base/src/Utils.cxx
Original file line number Diff line number Diff line change
Expand Up @@ -143,20 +143,20 @@ double Utils::subtractInteractionBC(double time, int& mask, bool subLatency)
if (deltaCBC >= -8 && deltaCBC < 8) {
mask += (1 << (deltaCBC + 8)); // fill bc candidates
}
if (abs(deltaCBC) < dbc) {
if (std::abs(deltaCBC) < dbc) {
bcc = bc - deltaCBC;
dbcSigned = deltaCBC;
dbc = abs(dbcSigned);
dbc = std::abs(dbcSigned);
}
if (abs(deltaCBC + o2::constants::lhc::LHCMaxBunches) < dbc) { // in case k is close to the right border (last BC of the orbit)
if (std::abs(deltaCBC + o2::constants::lhc::LHCMaxBunches) < dbc) { // in case k is close to the right border (last BC of the orbit)
bcc = bc - deltaCBC - o2::constants::lhc::LHCMaxBunches;
dbcSigned = deltaCBC + o2::constants::lhc::LHCMaxBunches;
dbc = abs(dbcSigned);
dbc = std::abs(dbcSigned);
}
if (abs(deltaCBC - o2::constants::lhc::LHCMaxBunches) < dbc) { // in case k is close to the left border (BC=0)
if (std::abs(deltaCBC - o2::constants::lhc::LHCMaxBunches) < dbc) { // in case k is close to the left border (BC=0)
bcc = bc - deltaCBC + o2::constants::lhc::LHCMaxBunches;
dbcSigned = deltaCBC - o2::constants::lhc::LHCMaxBunches;
dbc = abs(dbcSigned);
dbc = std::abs(dbcSigned);
}
}
if (dbcSigned >= -8 && dbcSigned < 8) {
Expand Down Expand Up @@ -192,20 +192,20 @@ float Utils::subtractInteractionBC(float time, int& mask, bool subLatency)
if (deltaCBC >= -8 && deltaCBC < 8) {
mask += (1 << (deltaCBC + 8)); // fill bc candidates
}
if (abs(deltaCBC) < dbc) {
if (std::abs(deltaCBC) < dbc) {
bcc = bc - deltaCBC;
dbcSigned = deltaCBC;
dbc = abs(dbcSigned);
dbc = std::abs(dbcSigned);
}
if (abs(deltaCBC + o2::constants::lhc::LHCMaxBunches) < dbc) { // in case k is close to the right border (last BC of the orbit)
if (std::abs(deltaCBC + o2::constants::lhc::LHCMaxBunches) < dbc) { // in case k is close to the right border (last BC of the orbit)
bcc = bc - deltaCBC - o2::constants::lhc::LHCMaxBunches;
dbcSigned = deltaCBC + o2::constants::lhc::LHCMaxBunches;
dbc = abs(dbcSigned);
dbc = std::abs(dbcSigned);
}
if (abs(deltaCBC - o2::constants::lhc::LHCMaxBunches) < dbc) { // in case k is close to the left border (BC=0)
if (std::abs(deltaCBC - o2::constants::lhc::LHCMaxBunches) < dbc) { // in case k is close to the left border (BC=0)
bcc = bc - deltaCBC + o2::constants::lhc::LHCMaxBunches;
dbcSigned = deltaCBC - o2::constants::lhc::LHCMaxBunches;
dbc = abs(dbcSigned);
dbc = std::abs(dbcSigned);
}
}
if (dbcSigned >= -8 && dbcSigned < 8) {
Expand Down
12 changes: 6 additions & 6 deletions Detectors/TOF/calibration/src/CalibTOF.cxx
Original file line number Diff line number Diff line change
Expand Up @@ -212,7 +212,7 @@ void CalibTOF::run(int flag, int sector)
int channelInSector = (ipad + ich) % o2::tof::Geo::NPADSXSECTOR;

mTimeSlewingObj->setFractionUnderPeak(sector, channelInSector, fractionUnderPeak);
mTimeSlewingObj->setSigmaPeak(sector, channelInSector, abs(funcChOffset->GetParameter(2)));
mTimeSlewingObj->setSigmaPeak(sector, channelInSector, std::abs(funcChOffset->GetParameter(2)));

// now fill 2D histo for time-slewing using current channel offset

Expand Down Expand Up @@ -603,8 +603,8 @@ Int_t CalibTOF::FitPeak(TF1* fitFunc, TH1* h, Float_t startSigma, Float_t nSigma
/* refit with better range */
for (Int_t i = 0; i < 3; i++) {
fitCent = fitFunc->GetParameter(1);
fitMin = fitCent - nSigmaMin * abs(fitFunc->GetParameter(2));
fitMax = fitCent + nSigmaMax * abs(fitFunc->GetParameter(2));
fitMin = fitCent - nSigmaMin * std::abs(fitFunc->GetParameter(2));
fitMax = fitCent + nSigmaMax * std::abs(fitFunc->GetParameter(2));
if (fitMin < -12500) {
fitMin = -12500;
}
Expand Down Expand Up @@ -735,9 +735,9 @@ void CalibTOF::flagProblematics()
hsigmapeak->Fit(fFuncSigma, "WWq0");
hfractionpeak->Fit(fFuncFraction, "WWq0");

sigmaMin = fFuncSigma->GetParameter(1) - mNsigmaSigmaProblematicCut * abs(fFuncSigma->GetParameter(2));
sigmaMax = fFuncSigma->GetParameter(1) + mNsigmaSigmaProblematicCut * abs(fFuncSigma->GetParameter(3));
fractionMin = fFuncFraction->GetParameter(1) - mNsigmaFractionProblematicCut * abs(fFuncFraction->GetParameter(2));
sigmaMin = fFuncSigma->GetParameter(1) - mNsigmaSigmaProblematicCut * std::abs(fFuncSigma->GetParameter(2));
sigmaMax = fFuncSigma->GetParameter(1) + mNsigmaSigmaProblematicCut * std::abs(fFuncSigma->GetParameter(3));
fractionMin = fFuncFraction->GetParameter(1) - mNsigmaFractionProblematicCut * std::abs(fFuncFraction->GetParameter(2));

for (int k = 0; k < o2::tof::Geo::NPADX; k++) {
ipad = 48 * iz + k;
Expand Down
Loading

0 comments on commit 13eb869

Please sign in to comment.