Skip to content
Merged
Show file tree
Hide file tree
Changes from all commits
Commits
File filter

Filter by extension

Filter by extension

Conversations
Failed to load comments.
Loading
Jump to
Jump to file
Failed to load files.
Loading
Diff view
Diff view
41 changes: 19 additions & 22 deletions PWGHF/ALICE3/TableProducer/candidateCreatorChic.cxx
Original file line number Diff line number Diff line change
@@ -1,4 +1,4 @@
// Copyright 2019-2020 CERN and copyright holders of ALICE O2.

Check failure on line 1 in PWGHF/ALICE3/TableProducer/candidateCreatorChic.cxx

View workflow job for this annotation

GitHub Actions / O2 linter

[o2-workflow-options]

Do not use workflow options to customise workflow topology composition in defineDataProcessing. Use process function switches or metadata instead.
// See https://alice-o2.web.cern.ch/copyright for details of the copyright holders.
// All rights not expressly granted are reserved.
//
Expand All @@ -15,21 +15,21 @@
///
/// \author Alessandro De Falco <alessandro.de.falco@ca.infn.it>, Cagliari University

#include <utility>
#include <vector>
#include "PWGHF/Core/HfHelper.h"
#include "PWGHF/DataModel/CandidateReconstructionTables.h"
#include "PWGHF/DataModel/CandidateSelectionTables.h"

#include "ALICE3/DataModel/ECAL.h"
#include "Common/Core/trackUtilities.h"

#include "CommonConstants/PhysicsConstants.h"
#include "DCAFitter/DCAFitterN.h"
#include "Framework/AnalysisTask.h"
#include "ReconstructionDataFormats/DCA.h"
#include "ReconstructionDataFormats/V0.h"

#include "ALICE3/DataModel/ECAL.h"
#include "Common/Core/trackUtilities.h"

#include "PWGHF/Core/HfHelper.h"
#include "PWGHF/DataModel/CandidateReconstructionTables.h"
#include "PWGHF/DataModel/CandidateSelectionTables.h"
#include <utility>
#include <vector>

using namespace o2;
using namespace o2::analysis;
Expand Down Expand Up @@ -67,7 +67,6 @@
Configurable<double> yCandMax{"yCandMax", -1., "max. cand. rapidity"};

o2::vertexing::DCAFitterN<2> df2; // 2-prong vertex fitter (to rebuild Jpsi vertex)
HfHelper hfHelper;

double massJpsi{0.};
double massJpsiGamma{0.};
Expand Down Expand Up @@ -109,14 +108,14 @@
if (!(jpsiCand.hfflag() & 1 << hf_cand_2prong::DecayType::JpsiToEE) && !(jpsiCand.hfflag() & 1 << hf_cand_2prong::DecayType::JpsiToMuMu)) {
continue;
}
if (yCandMax >= 0. && std::abs(hfHelper.yJpsi(jpsiCand)) > yCandMax) {
if (yCandMax >= 0. && std::abs(HfHelper::yJpsi(jpsiCand)) > yCandMax) {
continue;
}
if (jpsiCand.isSelJpsiToEE() > 0) {
hMassJpsiToEE->Fill(hfHelper.invMassJpsiToEE(jpsiCand));
hMassJpsiToEE->Fill(HfHelper::invMassJpsiToEE(jpsiCand));
}
if (jpsiCand.isSelJpsiToMuMu() > 0) {
hMassJpsiToMuMu->Fill(hfHelper.invMassJpsiToMuMu(jpsiCand));
hMassJpsiToMuMu->Fill(HfHelper::invMassJpsiToMuMu(jpsiCand));
}
hPtJpsi->Fill(jpsiCand.pt());
hCPAJpsi->Fill(jpsiCand.cpa());
Expand Down Expand Up @@ -189,7 +188,7 @@
impactParameter0.getY(), 0.f, // impactParameter1.getY(),
std::sqrt(impactParameter0.getSigmaY2()), 0.f, // std::sqrt(impactParameter1.getSigmaY2()),
jpsiCand.globalIndex(), ecal.globalIndex(),
hfFlag, hfHelper.invMassJpsiToMuMu(jpsiCand));
hfFlag, HfHelper::invMassJpsiToMuMu(jpsiCand));

// calculate invariant mass
auto arrayMomenta = std::array{pvecJpsi, pvecGamma};
Expand All @@ -201,9 +200,9 @@
hMassChicToJpsiToMuMuGamma->Fill(massJpsiGamma);
}
} // ecal loop
} // Jpsi loop
} // process
}; // struct
} // Jpsi loop
} // process
}; // struct

/// Extends the base table with expression columns.
struct HfCandidateCreatorChicExpressions {
Expand All @@ -217,8 +216,6 @@
Produces<aod::HfCandChicMcRec> rowMcMatchRec;
Produces<aod::HfCandChicMcGen> rowMcMatchGen;

HfHelper hfHelper;

OutputObj<TH1F> hMassJpsiToMuMuMatched{TH1F("hMassChicToJpsiToMuMuMatched", "2-prong candidates;inv. mass (J/#psi (#rightarrow #mu+ #mu-)) (GeV/#it{c}^{2});entries", 500, 0., 5.)};
OutputObj<TH1F> hMassEMatched{TH1F("hMassEMatched", "2-prong candidates;inv. mass (J/#psi (#rightarrow #mu+ #mu-)) (GeV/#it{c}^{2});entries", 500, 0., 5.)};
OutputObj<TH1F> hEphotonMatched{TH1F("hEphotonMatched", "2-prong candidates;inv. mass (J/#psi (#rightarrow #mu+ #mu-)) (GeV/#it{c}^{2});entries", 500, 0., 5.)};
Expand Down Expand Up @@ -249,7 +246,7 @@
// chi_c → J/ψ gamma
indexRec = RecoDecay::getMatchedMCRec(mcParticles, arrayJpsiDaughters, Pdg::kJPsi, std::array{+kMuonPlus, -kMuonPlus}, true);
if (indexRec > -1) {
hMassJpsiToMuMuMatched->Fill(hfHelper.invMassJpsiToMuMu(candidate.prong0()));
hMassJpsiToMuMuMatched->Fill(HfHelper::invMassJpsiToMuMu(candidate.prong0()));

int indexMother = RecoDecay::getMother(mcParticles, mcParticles.rawIteratorAt(indexRec), Pdg::kChiC1);
int indexMotherGamma = RecoDecay::getMother(mcParticles, mcParticles.rawIteratorAt(candidate.prong1().mcparticleId()), Pdg::kChiC1);
Expand All @@ -260,9 +257,9 @@
if (particleMother.has_daughters()) {
std::vector<int> arrAllDaughtersIndex;
RecoDecay::getDaughters(particleMother, &arrAllDaughtersIndex, std::array{static_cast<int>(kGamma), static_cast<int>(Pdg::kJPsi)}, 1);
if (arrAllDaughtersIndex.size() == 2) {

Check failure on line 260 in PWGHF/ALICE3/TableProducer/candidateCreatorChic.cxx

View workflow job for this annotation

GitHub Actions / O2 linter

[magic-number]

Avoid magic numbers in expressions. Assign the value to a clearly named variable or constant.
flag = 1 << hf_cand_chic::DecayType::ChicToJpsiToMuMuGamma;
hMassChicToJpsiToMuMuGammaMatched->Fill(hfHelper.invMassChicToJpsiGamma(candidate));
hMassChicToJpsiToMuMuGammaMatched->Fill(HfHelper::invMassChicToJpsiGamma(candidate));
}
}
}
Expand Down Expand Up @@ -299,8 +296,8 @@

rowMcMatchGen(flag, origin, channel);
} // candidate loop
} // process
}; // struct
} // process
}; // struct

WorkflowSpec defineDataProcessing(ConfigContext const& cfgc)
{
Expand Down
37 changes: 18 additions & 19 deletions PWGHF/ALICE3/TableProducer/candidateCreatorX.cxx
Original file line number Diff line number Diff line change
@@ -1,4 +1,4 @@
// Copyright 2019-2020 CERN and copyright holders of ALICE O2.

Check failure on line 1 in PWGHF/ALICE3/TableProducer/candidateCreatorX.cxx

View workflow job for this annotation

GitHub Actions / O2 linter

[o2-workflow-options]

Do not use workflow options to customise workflow topology composition in defineDataProcessing. Use process function switches or metadata instead.
// See https://alice-o2.web.cern.ch/copyright for details of the copyright holders.
// All rights not expressly granted are reserved.
//
Expand All @@ -16,20 +16,20 @@
/// \author Rik Spijkers <r.spijkers@students.uu.nl>, Utrecht University
/// \author Luca Micheletti <luca.micheletti@to.infn.it>, INFN

#include <utility>
#include <vector>
#include "PWGHF/Core/HfHelper.h"
#include "PWGHF/DataModel/CandidateReconstructionTables.h"
#include "PWGHF/DataModel/CandidateSelectionTables.h"

#include "Common/Core/trackUtilities.h"

#include "CommonConstants/PhysicsConstants.h"
#include "DCAFitter/DCAFitterN.h"
#include "Framework/AnalysisTask.h"
#include "ReconstructionDataFormats/DCA.h"
#include "ReconstructionDataFormats/V0.h"

#include "Common/Core/trackUtilities.h"

#include "PWGHF/Core/HfHelper.h"
#include "PWGHF/DataModel/CandidateReconstructionTables.h"
#include "PWGHF/DataModel/CandidateSelectionTables.h"
#include <utility>
#include <vector>

using namespace o2;
using namespace o2::analysis;
Expand Down Expand Up @@ -67,7 +67,6 @@

o2::vertexing::DCAFitterN<2> df2; // 2-prong vertex fitter (to rebuild Jpsi vertex)
o2::vertexing::DCAFitterN<3> df3; // 3-prong vertex fitter
HfHelper hfHelper;

double massPi{0.};
double massJpsi{0.};
Expand Down Expand Up @@ -119,20 +118,20 @@
if (!(jpsiCand.hfflag() & 1 << hf_cand_2prong::DecayType::JpsiToEE) && !(jpsiCand.hfflag() & 1 << hf_cand_2prong::DecayType::JpsiToMuMu)) {
continue;
}
if (yCandMax >= 0. && std::abs(hfHelper.yJpsi(jpsiCand)) > yCandMax) {
if (yCandMax >= 0. && std::abs(HfHelper::yJpsi(jpsiCand)) > yCandMax) {
continue;
}
if (jpsiCand.isSelJpsiToEE() > 0) {
if (std::abs(hfHelper.invMassJpsiToEE(jpsiCand) - massJpsi) > diffMassJpsiMax) {
if (std::abs(HfHelper::invMassJpsiToEE(jpsiCand) - massJpsi) > diffMassJpsiMax) {
continue;
}
hMassJpsiToEE->Fill(hfHelper.invMassJpsiToEE(jpsiCand));
hMassJpsiToEE->Fill(HfHelper::invMassJpsiToEE(jpsiCand));
}
if (jpsiCand.isSelJpsiToMuMu() > 0) {
if (std::abs(hfHelper.invMassJpsiToMuMu(jpsiCand) - massJpsi) > diffMassJpsiMax) {
if (std::abs(HfHelper::invMassJpsiToMuMu(jpsiCand) - massJpsi) > diffMassJpsiMax) {
continue;
}
hMassJpsiToMuMu->Fill(hfHelper.invMassJpsiToMuMu(jpsiCand));
hMassJpsiToMuMu->Fill(HfHelper::invMassJpsiToMuMu(jpsiCand));
}

hPtJpsi->Fill(jpsiCand.pt());
Expand Down Expand Up @@ -255,10 +254,10 @@
hMassXToJpsiToMuMuPiPi->Fill(massJpsiPiPi);
}
} // pi- loop
} // pi+ loop
} // Jpsi loop
} // process
}; // struct
} // pi+ loop
} // Jpsi loop
} // process
}; // struct

/// Extends the base table with expression columns.
struct HfCandidateCreatorXExpressions {
Expand Down Expand Up @@ -363,8 +362,8 @@

rowMcMatchGen(flag, origin, channel);
} // candidate loop
} // process
}; // struct
} // process
}; // struct

WorkflowSpec defineDataProcessing(ConfigContext const& cfgc)
{
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -15,16 +15,16 @@
///
/// \author Alessandro De Falco <alessandro.de.falco@ca.infn.it>, Università/INFN Cagliari

#include <vector>
#include "PWGHF/Core/HfHelper.h"
#include "PWGHF/Core/SelectorCuts.h"
#include "PWGHF/DataModel/CandidateReconstructionTables.h"
#include "PWGHF/DataModel/CandidateSelectionTables.h"

#include "CommonConstants/PhysicsConstants.h"
#include "Framework/AnalysisTask.h"
#include "Framework/runDataProcessing.h"

#include "PWGHF/Core/HfHelper.h"
#include "PWGHF/Core/SelectorCuts.h"
#include "PWGHF/DataModel/CandidateReconstructionTables.h"
#include "PWGHF/DataModel/CandidateSelectionTables.h"
#include <vector>

using namespace o2;
using namespace o2::aod;
Expand All @@ -50,8 +50,6 @@
Configurable<std::vector<double>> binsPt{"binsPt", std::vector<double>{hf_cuts_chic_to_jpsi_gamma::vecBinsPt}, "pT bin limits"};
Configurable<LabeledArray<double>> cuts{"cuts", {hf_cuts_chic_to_jpsi_gamma::Cuts[0], hf_cuts_chic_to_jpsi_gamma::NBinsPt, hf_cuts_chic_to_jpsi_gamma::NCutVars, hf_cuts_chic_to_jpsi_gamma::labelsPt, hf_cuts_chic_to_jpsi_gamma::labelsCutVar}, "Jpsi candidate selection per pT bin"};

HfHelper hfHelper;

/// Selection on goodness of daughter tracks
/// \note should be applied at candidate selection
/// \param track is daughter track
Expand Down Expand Up @@ -80,7 +78,7 @@
}

auto mchic = o2::constants::physics::MassChiC1; // chi_c1(1p)
if (std::abs(hfHelper.invMassChicToJpsiGamma(hfCandChic) - mchic) > cuts->get(pTBin, "m")) {
if (std::abs(HfHelper::invMassChicToJpsiGamma(hfCandChic) - mchic) > cuts->get(pTBin, "m")) {
// LOGF(debug, "Chic topol selection failed at mass diff check");
return false; // check that mass difference is within bounds
}
Expand Down Expand Up @@ -141,7 +139,7 @@
template <typename T>
bool selectionPIDTPC(const T& /*track*/, int nSigmaCut)
{
if (nSigmaCut > 999.) {

Check failure on line 142 in PWGHF/ALICE3/TableProducer/candidateSelectorChicToJpsiGamma.cxx

View workflow job for this annotation

GitHub Actions / O2 linter

[magic-number]

Avoid magic numbers in expressions. Assign the value to a clearly named variable or constant.
return true;
}
// return track.tpcNSigmaPi() < nSigmaCut;
Expand All @@ -155,7 +153,7 @@
template <typename T>
bool selectionPIDTOF(const T& /*track*/, double nSigmaCut)
{
if (nSigmaCut > 999.) {

Check failure on line 156 in PWGHF/ALICE3/TableProducer/candidateSelectorChicToJpsiGamma.cxx

View workflow job for this annotation

GitHub Actions / O2 linter

[magic-number]

Avoid magic numbers in expressions. Assign the value to a clearly named variable or constant.
return true;
}
// return track.tofNSigmaPi() < nSigmaCut;
Expand Down
24 changes: 11 additions & 13 deletions PWGHF/ALICE3/TableProducer/candidateSelectorD0Alice3Barrel.cxx
Original file line number Diff line number Diff line change
Expand Up @@ -15,18 +15,18 @@
/// \author Nima Zardoshti <nima.zardoshti@cern.ch>, CERN
/// \author Vít Kučera <vit.kucera@cern.ch>, CERN

#include <vector>
#include <algorithm>
#include "PWGHF/Core/HfHelper.h"
#include "PWGHF/DataModel/CandidateReconstructionTables.h"
#include "PWGHF/DataModel/CandidateSelectionTables.h"

#include "ALICE3/DataModel/RICH.h"

#include "CommonConstants/PhysicsConstants.h"
#include "Framework/AnalysisTask.h"
#include "Framework/runDataProcessing.h"

#include "ALICE3/DataModel/RICH.h"

#include "PWGHF/Core/HfHelper.h"
#include "PWGHF/DataModel/CandidateReconstructionTables.h"
#include "PWGHF/DataModel/CandidateSelectionTables.h"
#include <algorithm>
#include <vector>

using namespace o2;
using namespace o2::analysis;
Expand Down Expand Up @@ -70,8 +70,6 @@
Configurable<std::vector<double>> binsPt{"binsPt", std::vector<double>{hf_cuts_d0_to_pi_k::vecBinsPt}, "pT bin limits"};
Configurable<LabeledArray<double>> cuts{"cuts", {hf_cuts_d0_to_pi_k::Cuts[0], hf_cuts_d0_to_pi_k::NBinsPt, hf_cuts_d0_to_pi_k::NCutVars, hf_cuts_d0_to_pi_k::labelsPt, hf_cuts_d0_to_pi_k::labelsCutVar}, "D0 candidate selection per pT bin"};

HfHelper hfHelper;

using TracksSel = soa::Join<aod::TracksWDcaExtra, aod::pidTOFFullPi, aod::pidTOFFullKa, aod::RICHTracksIndex, aod::McTrackLabels>;

/// Conjugate-independent topological cuts
Expand Down Expand Up @@ -111,7 +109,7 @@

// decay exponentail law, with tau = beta*gamma*ctau
// decay length > ctau retains (1-1/e)
if (std::abs(candidate.impactParameterNormalised0()) < 0.5 || std::abs(candidate.impactParameterNormalised1()) < 0.5) {

Check failure on line 112 in PWGHF/ALICE3/TableProducer/candidateSelectorD0Alice3Barrel.cxx

View workflow job for this annotation

GitHub Actions / O2 linter

[magic-number]

Avoid magic numbers in expressions. Assign the value to a clearly named variable or constant.
return false;
}
double decayLengthCut = std::min((candidate.p() * 0.0066) + 0.01, cuts->get(pTBin, "minimum decay length"));
Expand Down Expand Up @@ -147,11 +145,11 @@

// invariant-mass cut
if (trackPion.sign() > 0) {
if (std::abs(hfHelper.invMassD0ToPiK(candidate) - o2::constants::physics::MassD0) > cuts->get(pTBin, "m")) {
if (std::abs(HfHelper::invMassD0ToPiK(candidate) - o2::constants::physics::MassD0) > cuts->get(pTBin, "m")) {
return false;
}
} else {
if (std::abs(hfHelper.invMassD0barToKPi(candidate) - o2::constants::physics::MassD0) > cuts->get(pTBin, "m")) {
if (std::abs(HfHelper::invMassD0barToKPi(candidate) - o2::constants::physics::MassD0) > cuts->get(pTBin, "m")) {
return false;
}
}
Expand All @@ -168,11 +166,11 @@

// cut on cos(theta*)
if (trackPion.sign() > 0) {
if (std::abs(hfHelper.cosThetaStarD0(candidate)) > cuts->get(pTBin, "cos theta*")) {
if (std::abs(HfHelper::cosThetaStarD0(candidate)) > cuts->get(pTBin, "cos theta*")) {
return false;
}
} else {
if (std::abs(hfHelper.cosThetaStarD0bar(candidate)) > cuts->get(pTBin, "cos theta*")) {
if (std::abs(HfHelper::cosThetaStarD0bar(candidate)) > cuts->get(pTBin, "cos theta*")) {
return false;
}
}
Expand Down Expand Up @@ -263,11 +261,11 @@
bool selectNegPionTOFplusRICH = false;
bool selectPosKaonTOFplusRICH = false;

if ((momentumPosTrack < 0.6 && std::abs(nsigmaTOFPosPion) < 3.0))

Check failure on line 264 in PWGHF/ALICE3/TableProducer/candidateSelectorD0Alice3Barrel.cxx

View workflow job for this annotation

GitHub Actions / O2 linter

[magic-number]

Avoid magic numbers in expressions. Assign the value to a clearly named variable or constant.
selectPosPionTOFplusRICH = true;
if ((momentumPosTrack > 0.6 && trackPos.has_rich() && std::sqrt(nsigmaRICHPosPion * nsigmaRICHPosPion + nsigmaTOFPosPion * nsigmaTOFPosPion) < 3.0))

Check failure on line 266 in PWGHF/ALICE3/TableProducer/candidateSelectorD0Alice3Barrel.cxx

View workflow job for this annotation

GitHub Actions / O2 linter

[magic-number]

Avoid magic numbers in expressions. Assign the value to a clearly named variable or constant.
selectPosPionTOFplusRICH = true;
if ((momentumNegTrack < 2.0 && std::abs(nsigmaTOFNegKaon) < 3.0))

Check failure on line 268 in PWGHF/ALICE3/TableProducer/candidateSelectorD0Alice3Barrel.cxx

View workflow job for this annotation

GitHub Actions / O2 linter

[magic-number]

Avoid magic numbers in expressions. Assign the value to a clearly named variable or constant.
selectNegKaonTOFplusRICH = true;
if ((momentumNegTrack > 2.0 && trackNeg.has_rich() && std::sqrt(nsigmaRICHNegKaon * nsigmaRICHNegKaon + nsigmaTOFNegKaon * nsigmaTOFNegKaon) < 3.0))
selectNegKaonTOFplusRICH = true;
Expand All @@ -283,7 +281,7 @@

if (topolD0) {
statusD0NoPid = 1;
if (pdgPositive == 211 && pdgNegative == -321)

Check failure on line 284 in PWGHF/ALICE3/TableProducer/candidateSelectorD0Alice3Barrel.cxx

View workflow job for this annotation

GitHub Actions / O2 linter

[pdg/explicit-code]

Avoid hard-coded PDG codes. Use named values from PDG_t or o2::constants::physics::Pdg instead.
statusD0PerfectPid = 1;
if ((std::abs(nsigmaTOFPosPion) < 3.0 && std::abs(nsigmaTOFNegKaon) < 3.0))
statusD0TofPid = 1;
Expand Down
24 changes: 11 additions & 13 deletions PWGHF/ALICE3/TableProducer/candidateSelectorD0Alice3Forward.cxx
Original file line number Diff line number Diff line change
Expand Up @@ -15,18 +15,18 @@
/// \author Nima Zardoshti <nima.zardoshti@cern.ch>, CERN
/// \author Vít Kučera <vit.kucera@cern.ch>, CERN

#include <vector>
#include <algorithm>
#include "PWGHF/Core/HfHelper.h"
#include "PWGHF/DataModel/CandidateReconstructionTables.h"
#include "PWGHF/DataModel/CandidateSelectionTables.h"

#include "ALICE3/DataModel/RICH.h"

#include "CommonConstants/PhysicsConstants.h"
#include "Framework/AnalysisTask.h"
#include "Framework/runDataProcessing.h"

#include "ALICE3/DataModel/RICH.h"

#include "PWGHF/Core/HfHelper.h"
#include "PWGHF/DataModel/CandidateReconstructionTables.h"
#include "PWGHF/DataModel/CandidateSelectionTables.h"
#include <algorithm>
#include <vector>

using namespace o2;
using namespace o2::analysis;
Expand Down Expand Up @@ -70,8 +70,6 @@ struct HfCandidateSelectorD0Alice3Forward {
Configurable<std::vector<double>> binsPt{"binsPt", std::vector<double>{hf_cuts_d0_to_pi_k::vecBinsPt}, "pT bin limits"};
Configurable<LabeledArray<double>> cuts{"cuts", {hf_cuts_d0_to_pi_k::Cuts[0], hf_cuts_d0_to_pi_k::NBinsPt, hf_cuts_d0_to_pi_k::NCutVars, hf_cuts_d0_to_pi_k::labelsPt, hf_cuts_d0_to_pi_k::labelsCutVar}, "D0 candidate selection per pT bin"};

HfHelper hfHelper;

using TracksSel = soa::Join<aod::TracksWDca, aod::FRICHTracksIndex>;

/// Conjugate-independent topological cuts
Expand Down Expand Up @@ -147,11 +145,11 @@ struct HfCandidateSelectorD0Alice3Forward {

// invariant-mass cut
if (trackPion.sign() > 0) {
if (std::abs(hfHelper.invMassD0ToPiK(candidate) - o2::constants::physics::MassD0) > cuts->get(pTBin, "m")) {
if (std::abs(HfHelper::invMassD0ToPiK(candidate) - o2::constants::physics::MassD0) > cuts->get(pTBin, "m")) {
return false;
}
} else {
if (std::abs(hfHelper.invMassD0barToKPi(candidate) - o2::constants::physics::MassD0) > cuts->get(pTBin, "m")) {
if (std::abs(HfHelper::invMassD0barToKPi(candidate) - o2::constants::physics::MassD0) > cuts->get(pTBin, "m")) {
return false;
}
}
Expand All @@ -168,11 +166,11 @@ struct HfCandidateSelectorD0Alice3Forward {

// cut on cos(theta*)
if (trackPion.sign() > 0) {
if (std::abs(hfHelper.cosThetaStarD0(candidate)) > cuts->get(pTBin, "cos theta*")) {
if (std::abs(HfHelper::cosThetaStarD0(candidate)) > cuts->get(pTBin, "cos theta*")) {
return false;
}
} else {
if (std::abs(hfHelper.cosThetaStarD0bar(candidate)) > cuts->get(pTBin, "cos theta*")) {
if (std::abs(HfHelper::cosThetaStarD0bar(candidate)) > cuts->get(pTBin, "cos theta*")) {
return false;
}
}
Expand Down
Loading
Loading