diff --git a/PWGLF/TableProducer/Nuspex/CMakeLists.txt b/PWGLF/TableProducer/Nuspex/CMakeLists.txt index 7138fe9ded7..66c91c16392 100644 --- a/PWGLF/TableProducer/Nuspex/CMakeLists.txt +++ b/PWGLF/TableProducer/Nuspex/CMakeLists.txt @@ -98,3 +98,8 @@ o2physics_add_dpl_workflow(hyperhelium4sigma-reco-task SOURCES hyperhelium4sigmaRecoTask.cxx PUBLIC_LINK_LIBRARIES O2Physics::AnalysisCore COMPONENT_NAME Analysis) + +o2physics_add_dpl_workflow(he3-lambda-analysis + SOURCES he3LambdaAnalysis.cxx + PUBLIC_LINK_LIBRARIES O2Physics::AnalysisCore O2Physics::EventFilteringUtils + COMPONENT_NAME Analysis) diff --git a/PWGLF/TableProducer/Nuspex/he3LambdaAnalysis.cxx b/PWGLF/TableProducer/Nuspex/he3LambdaAnalysis.cxx new file mode 100644 index 00000000000..aa05bd206f5 --- /dev/null +++ b/PWGLF/TableProducer/Nuspex/he3LambdaAnalysis.cxx @@ -0,0 +1,445 @@ +// Copyright 2019-2020 CERN and copyright holders of ALICE O2. +// See https://alice-o2.web.cern.ch/copyright for details of the copyright holders. +// All rights not expressly granted are reserved. +// +// This software is distributed under the terms of the GNU General Public +// License v3 (GPL Version 3), copied verbatim in the file "COPYING". +// +// In applying this license CERN does not waive the privileges and immunities +// granted to it by virtue of its status as an Intergovernmental Organization +// or submit itself to any jurisdiction. + +#include "Common/Core/trackUtilities.h" +#include "Common/DataModel/Centrality.h" +#include "Common/DataModel/EventSelection.h" +#include "Common/DataModel/PIDResponseITS.h" +#include "Common/DataModel/PIDResponseTPC.h" +#include "EventFiltering/Zorro.h" +#include "EventFiltering/ZorroSummary.h" + +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include + +#include +#include + +#include +#include +#include +#include +#include +#include + +using namespace o2; +using namespace o2::framework; +using namespace o2::framework::expressions; +using namespace o2::constants::physics; + +namespace o2::aod +{ +namespace lfv0he3 +{ +DECLARE_SOA_COLUMN(Z, z, float); +DECLARE_SOA_COLUMN(CentT0C, centT0C, float); +} // namespace lfv0he3 +DECLARE_SOA_TABLE(LFEvents, "AOD", "LFEVENT", o2::soa::Index<>, lfv0he3::Z, lfv0he3::CentT0C); + +namespace lfv0he3 +{ +DECLARE_SOA_INDEX_COLUMN(LFEvent, lfEvent); // Collision ID for the event +DECLARE_SOA_COLUMN(Pt, pt, float); +DECLARE_SOA_COLUMN(Eta, eta, float); +DECLARE_SOA_COLUMN(Phi, phi, float); +DECLARE_SOA_COLUMN(Mass, mass, float); +DECLARE_SOA_COLUMN(CosPA, cosPA, float); +DECLARE_SOA_COLUMN(DCAxy, dcaXY, float); +DECLARE_SOA_COLUMN(DCAz, dcaZ, float); +DECLARE_SOA_COLUMN(TPCnCls, tpcNCls, int); +DECLARE_SOA_COLUMN(ITSClusterSizes, itsClusterSizes, uint32_t); +DECLARE_SOA_COLUMN(NsigmaTPC, nSigmaTPC, float); +DECLARE_SOA_COLUMN(DCAdaughters, dcaDaughters, float); +DECLARE_SOA_COLUMN(DCAPVProton, dcaPVProton, float); +DECLARE_SOA_COLUMN(DCAPVPion, dcaPVPion, float); +DECLARE_SOA_COLUMN(V0Radius, v0Radius, float); +DECLARE_SOA_COLUMN(Sign, sign, int8_t); +} // namespace lfv0he3 +DECLARE_SOA_TABLE(LFHe3, "AOD", "LFHE3V0", lfv0he3::LFEventId, lfv0he3::Pt, lfv0he3::Eta, lfv0he3::Phi, lfv0he3::DCAxy, lfv0he3::DCAz, lfv0he3::TPCnCls, lfv0he3::ITSClusterSizes, lfv0he3::NsigmaTPC, lfv0he3::Sign); +DECLARE_SOA_TABLE(LFLambda, "AOD", "LFLAMBDA", lfv0he3::LFEventId, lfv0he3::Pt, lfv0he3::Eta, lfv0he3::Phi, lfv0he3::Mass, lfv0he3::CosPA, lfv0he3::DCAdaughters, lfv0he3::DCAPVProton, lfv0he3::DCAPVPion, lfv0he3::V0Radius, lfv0he3::Sign); +} // namespace o2::aod + +namespace +{ +constexpr double betheBlochDefault[1][6]{{-1.e32, -1.e32, -1.e32, -1.e32, -1.e32, -1.e32}}; +static const std::vector betheBlochParNames{"p0", "p1", "p2", "p3", "p4", "resolution"}; +static const std::vector particleName{"He3"}; +o2::base::MatLayerCylSet* matLUT = nullptr; + +float alphaAP(std::array const& momA, std::array const& momB, std::array const& momC) +{ + const float lQlPos = (momB[0] * momA[0] + momB[1] * momA[1] + momB[2] * momA[2]); + const float lQlNeg = (momC[0] * momA[0] + momC[1] * momA[1] + momC[2] * momA[2]); + return (lQlPos - lQlNeg) / (lQlPos + lQlNeg); +} + +float qtAP(std::array const& momA, std::array const& momB) +{ + const float dp = momA[0] * momB[0] + momA[1] * momB[1] + momA[2] * momB[2]; + const float p2A = momA[0] * momA[0] + momA[1] * momA[1] + momA[2] * momA[2]; + const float p2B = momB[0] * momB[0] + momB[1] * momB[1] + momB[2] * momB[2]; + return std::sqrt(p2B - dp * dp / p2A); +} + +std::shared_ptr hTPCsignalAll; +std::shared_ptr hTPCsignalHe3; +std::shared_ptr hTPCnSigmaAll; +std::shared_ptr hTPCnSigmaHe3; +std::shared_ptr hArmenterosPodolanskiAll; +std::shared_ptr hArmenterosPodolanskiSelected; + +}; // namespace + +using TracksFull = soa::Join; +using CollisionsFull = soa::Join; + +struct he3Candidate { + ROOT::Math::LorentzVector> momentum; // 4-momentum of the He3 candidate + float nSigmaTPC; // TPC nSigma for He3 + float dcaXY; + float dcaZ; + int tpcNClsFound; // Number of TPC clusters found + int itsNCls; // Number of ITS clusters + uint32_t itsClusterSizes; // ITS cluster sizes + int8_t sign; // Charge sign of the He3 candidate +}; + +struct lambdaCandidate { + ROOT::Math::LorentzVector> momentum; + float mass; // Lambda mass + float cosPA; // Cosine of pointing angle + float dcaV0Daughters; // DCA between V0 daughters + float dcaProtonToPV; // DCA of the proton to primary vertex + float dcaPionToPV; // DCA of the pion to primary vertex + float v0Radius; + float protonNSigmaTPC; // Proton TPC nSigma + float pionNSigmaTPC; + int8_t sign; // Charge sign of the Lambda candidate +}; + +struct he3LambdaAnalysis { + + // Services + Service ccdb; + Zorro zorro; + OutputObj zorroSummary{"zorroSummary"}; + o2::vertexing::DCAFitterN<2> fitter; + + Produces lfHe3V0Collision; + Produces lfHe3; + Produces lfLambda; + + // Configurables for event selection + struct : ConfigurableGroup { + std::string prefix = "cfgEventSelection"; + Configurable zVertexMax{"zVertexMax", 10.0f, "Accepted z-vertex range"}; + Configurable useSel8{"useSel8", true, "Use Sel8 event selection"}; + Configurable skimmedProcessing{"skimmedProcessing", false, "Skimmed dataset processing"}; + } cfgEventSelection; + + // He3 selection criteria + struct : ConfigurableGroup { + std::string prefix = "cfgHe3"; + Configurable ptMin{"ptMin", 1.0f, "Minimum He3 pT"}; + Configurable ptMax{"ptMax", 10.0f, "Maximum He3 pT"}; + Configurable nSigmaTPCMax{"nSigmaTPCMax", 4.0f, "Maximum He3 TPC nSigma"}; + Configurable dcaxyMax{"dcaxyMax", 0.5f, "Maximum He3 DCA xy"}; + Configurable dcazMax{"dcazMax", 0.5f, "Maximum He3 DCA z"}; + Configurable tpcClusMin{"tpcClusMin", 100, "Minimum He3 TPC clusters"}; + Configurable itsClusMin{"itsClusMin", 5, "Minimum He3 ITS clusters"}; + Configurable> betheBlochParams{"betheBlochParams", {betheBlochDefault[0], 1, 6, particleName, betheBlochParNames}, "TPC Bethe-Bloch parameterisation for He3"}; + } cfgHe3; + + // Lambda selection criteria + struct : ConfigurableGroup { + std::string prefix = "cfgLambda"; + Configurable ptMin{"ptMin", 0.5f, "Minimum Lambda pT"}; + Configurable ptMax{"ptMax", 10.0f, "Maximum Lambda pT"}; + Configurable massWindow{"massWindow", 0.015f, "Lambda mass window"}; + Configurable cosPAMin{"cosPAMin", 0.99f, "Minimum Lambda cosPA"}; + Configurable dcaV0DaughtersMax{"dcaV0DaughtersMax", 0.5f, "Maximum Lambda DCA V0 daughters"}; + Configurable v0RadiusMin{"v0RadiusMin", 0.5f, "Minimum Lambda V0 radius"}; + Configurable v0RadiusMax{"v0RadiusMax", 35.0f, "Maximum Lambda V0 radius"}; + Configurable tpcNClsMin{"tpcNClsMin", 70, "Minimum TPC clusters for Lambda daughters"}; + Configurable protonNSigmaTPCMax{"protonNSigmaTPCMax", 4.0f, "Maximum proton TPC nSigma"}; + Configurable pionNSigmaTPCMax{"pionNSigmaTPCMax", 4.0f, "Maximum pion TPC nSigma"}; + } cfgLambda; + + // Pair selection criteria + struct : ConfigurableGroup { + std::string prefix = "cfgPair"; + Configurable ptMin{"PtMin", 1.0f, "Minimum pair pT"}; + Configurable ptMax{"PtMax", 20.0f, "Maximum pair pT"}; + Configurable rapidityMax{"RapidityMax", 0.5f, "Maximum pair rapidity"}; + } cfgPair; + + // CCDB options + struct : ConfigurableGroup { + std::string prefix = "ccdb"; + Configurable url{"url", "http://alice-ccdb.cern.ch", "url of the ccdb repository"}; + Configurable grpPath{"grpPath", "GLO/GRP/GRP", "Path of the grp file"}; + Configurable grpmagPath{"grpmagPath", "GLO/Config/GRPMagField", "CCDB path of the GRPMagField object"}; + } ccdbOptions; + + std::array mBBparamsHe; + float mBz = 0.0f; // Magnetic field in T + HistogramRegistry mRegistry{"He3LambdaAnalysis"}; + int mRunNumber = 0; // Current run number + int mEventIndex = 0; // Current event index + + void init(InitContext const&) + { + // Initialize CCDB + ccdb->setCaching(true); + ccdb->setLocalObjectValidityChecking(); + ccdb->setFatalWhenNull(true); + + for (int i = 0; i < 5; i++) { + mBBparamsHe[i] = cfgHe3.betheBlochParams->get("He3", Form("p%i", i)); + } + mBBparamsHe[5] = cfgHe3.betheBlochParams->get("He3", "resolution"); + matLUT = o2::base::MatLayerCylSet::rectifyPtrFromFile(ccdb->get("GLO/Param/MatLUT")); + + fitter.setPropagateToPCA(true); + fitter.setMaxR(200.); + fitter.setMinParamChange(1e-3); + fitter.setMinRelChi2Change(0.9); + fitter.setMaxDZIni(1e9); + fitter.setMaxChi2(1e9); + fitter.setUseAbsDCA(true); + fitter.setMatCorrType(o2::base::Propagator::MatCorrType::USEMatCorrLUT); + + zorroSummary.setObject(zorro.getZorroSummary()); + + mRegistry.add("hEventSelection", "Event Selection", {HistType::kTH1L, {{6, -.5, 5.5}}}); + std::vector labels{"Total Events", "Sel8 Events", "Z-Vertex OK", "Additional Event Selections", "He3 Candidates Found", "He3 and Lambda Candidates Found"}; + for (size_t i = 1; i <= labels.size(); ++i) { + mRegistry.get(HIST("hEventSelection"))->GetXaxis()->SetBinLabel(i, labels[i - 1].c_str()); + } + + mRegistry.add("hCentralityAll", "Centrality All", {HistType::kTH1L, {{100, 0., 100.}}}); + mRegistry.add("hCentralitySelected", "Centrality Selected", {HistType::kTH1L, {{100, 0., 100.}}}); + + hTPCsignalAll = mRegistry.add("hTPCsignalAll", "TPC Signal All", {HistType::kTH2D, {{400, -10, 10}, {1000, 0, 2000}}}); + hTPCsignalHe3 = mRegistry.add("hTPCsignalHe3", "TPC Signal He3", {HistType::kTH2D, {{400, -10, 10}, {1000, 0, 2000}}}); + + hTPCnSigmaAll = mRegistry.add("hTPCnSigmaAll", "TPC nSigma All", {HistType::kTH2D, {{400, -10, 10}, {100, -5., 5.}}}); + hTPCnSigmaHe3 = mRegistry.add("hTPCnSigmaHe3", "TPC nSigma He3", {HistType::kTH2D, {{400, -10, 10}, {100, -5., 5.}}}); + + hArmenterosPodolanskiAll = mRegistry.add("hArmenterosPodolanskiAll", "Armenteros-Podolanski All", {HistType::kTH2D, {{100, -1., 1.}, {100, 0., 0.5}}}); + hArmenterosPodolanskiSelected = mRegistry.add("hArmenterosPodolanskiSelected", "Armenteros-Podolanski Selected", {HistType::kTH2D, {{100, -1., 1.}, {100, 0., 0.5}}}); + + LOGF(info, "He3-Lambda analysis initialized"); + } + + void initCCDB(const auto& bc) + { + int runNumber = bc.runNumber(); + if (runNumber == mRunNumber) { + return; // Already initialized for this run + } + mRunNumber = runNumber; + if (cfgEventSelection.skimmedProcessing) { + zorro.initCCDB(ccdb.service, bc.runNumber(), bc.timestamp(), "fHe"); + zorro.populateHistRegistry(mRegistry, bc.runNumber()); + } + o2::parameters::GRPMagField* grpmag = ccdb->getForRun("GLO/Config/GRPMagField", runNumber); + o2::base::Propagator::initFieldFromGRP(grpmag); + mBz = static_cast(grpmag->getNominalL3Field()); + fitter.setBz(mBz); + o2::base::Propagator::Instance()->setMatLUT(matLUT); + } + + void processData(CollisionsFull::iterator const& collision, + TracksFull const& tracks, + aod::V0s const& v0s, + aod::BCsWithTimestamps const&) + { + const auto& bc = collision.bc_as(); + initCCDB(bc); + + mRegistry.get(HIST("hEventSelection"))->Fill(0); // Total events + mRegistry.get(HIST("hCentralityAll"))->Fill(collision.centFT0C()); + if (cfgEventSelection.useSel8 && !collision.sel8()) { + return; // Skip events not passing Sel8 selection + } + mRegistry.get(HIST("hEventSelection"))->Fill(1); // Sel8 events + if (std::abs(collision.posZ()) > cfgEventSelection.zVertexMax) { + return; // Skip events with z-vertex outside range + } + mRegistry.get(HIST("hEventSelection"))->Fill(2); // Z-vertex OK + + // Additional event selections not implemented, but can be added here + if (cfgEventSelection.skimmedProcessing) { + if (!zorro.isSelected(bc.globalBC())) { + return; // Skip events not passing Zorro selection + } + } + mRegistry.get(HIST("hEventSelection"))->Fill(3); // Additional event selections + + // Process He3 candidates + std::vector he3Candidates; + o2::track::TrackParCov trackParCov; + trackParCov.setPID(o2::track::PID::Helium3); + const o2::math_utils::Point3D collVtx{collision.posX(), collision.posY(), collision.posZ()}; + + for (auto const& track : tracks) { + if (track.tpcNClsFound() < cfgHe3.tpcClusMin || track.itsNCls() < cfgHe3.itsClusMin) { + continue; // Skip tracks with insufficient clusters + } + hTPCsignalAll->Fill(track.tpcInnerParam() * track.sign(), track.tpcSignal()); + const float pt = track.pt() * 2.0f; + if (pt < cfgHe3.ptMin || pt > cfgHe3.ptMax) { + continue; // Skip tracks outside pT range + } + float expTPCSignal = o2::tpc::BetheBlochAleph(track.tpcInnerParam() * 2.0f / constants::physics::MassHelium3, mBBparamsHe[0], mBBparamsHe[1], mBBparamsHe[2], mBBparamsHe[3], mBBparamsHe[4]); + double nSigmaTPC = (track.tpcSignal() - expTPCSignal) / (expTPCSignal * mBBparamsHe[5]); + hTPCnSigmaAll->Fill(track.tpcInnerParam() * track.sign(), nSigmaTPC); + if (std::abs(nSigmaTPC) > cfgHe3.nSigmaTPCMax) { + continue; // Skip tracks with TPC nSigma outside range + } + setTrackParCov(track, trackParCov); + std::array dcaInfo; + o2::base::Propagator::Instance()->propagateToDCA(collVtx, trackParCov, mBz, 2.f, o2::base::Propagator::MatCorrType::USEMatCorrLUT, &dcaInfo); + if (std::abs(dcaInfo[0]) > cfgHe3.dcaxyMax || std::abs(dcaInfo[1]) > cfgHe3.dcazMax) { + continue; // Skip tracks with DCA outside range + } + hTPCsignalHe3->Fill(track.tpcInnerParam() * track.sign(), track.tpcSignal()); + hTPCnSigmaHe3->Fill(track.tpcInnerParam() * track.sign(), nSigmaTPC); + he3Candidate candidate; + candidate.momentum.SetCoordinates(track.pt() * 2.0f, track.eta(), track.phi(), o2::constants::physics::MassHelium3); + candidate.nSigmaTPC = nSigmaTPC; + candidate.dcaXY = dcaInfo[0]; + candidate.dcaZ = dcaInfo[1]; + candidate.tpcNClsFound = track.tpcNClsFound(); + candidate.itsNCls = track.itsNCls(); + candidate.itsClusterSizes = track.itsClusterSizes(); + candidate.sign = track.sign() > 0 ? 1 : -1; + he3Candidates.push_back(candidate); + } + if (he3Candidates.empty()) { + return; // No valid He3 candidates found + } + mRegistry.get(HIST("hEventSelection"))->Fill(4); // He3 candidates found + + // Process Lambda candidates + std::vector lambdaCandidates; + for (auto const& v0 : v0s) { + if (v0.v0Type() != 1) { + continue; + } + const auto posTrack = v0.posTrack_as(); + const auto negTrack = v0.negTrack_as(); + + if (posTrack.tpcNClsFound() < cfgLambda.tpcNClsMin || negTrack.tpcNClsFound() < cfgLambda.tpcNClsMin) { + continue; // Skip V0s with insufficient TPC clusters + } + auto trackParPos = getTrackParCov(posTrack); + auto trackParNeg = getTrackParCov(negTrack); + int nCand = 0; + try { + nCand = fitter.process(trackParPos, trackParNeg); + } catch (...) { + LOG(error) << "Exception caught in DCA fitter process call!"; + return; + } + if (nCand == 0) { + continue; + } + auto& propParPos = fitter.getTrack(0); + auto& propParNeg = fitter.getTrack(1); + std::array momPos, momNeg; + propParPos.getPxPyPzGlo(momPos); + propParNeg.getPxPyPzGlo(momNeg); + const std::array momV0{momPos[0] + momNeg[0], momPos[1] + momNeg[1], momPos[2] + momNeg[2]}; + float alpha = alphaAP(momV0, momPos, momNeg); + float qt = qtAP(momV0, momPos); + hArmenterosPodolanskiAll->Fill(alpha, qt); + + bool matter = alpha > 0; + const auto& protonTrack = matter ? posTrack : negTrack; + const auto& pionTrack = matter ? negTrack : posTrack; + const auto& protonMom = matter ? momPos : momNeg; + const auto& pionMom = matter ? momNeg : momPos; + + if (std::abs(protonTrack.tpcNSigmaPr()) > cfgLambda.protonNSigmaTPCMax || + std::abs(pionTrack.tpcNSigmaPi()) > cfgLambda.pionNSigmaTPCMax) { + continue; // Skip V0s with TPC nSigma outside range + } + ROOT::Math::LorentzVector> protonMom4D(protonMom[0], protonMom[1], protonMom[2], o2::constants::physics::MassProton); + ROOT::Math::LorentzVector> pionMom4D(pionMom[0], pionMom[1], pionMom[2], o2::constants::physics::MassPionCharged); + auto lambdaMom4D = protonMom4D + pionMom4D; + float massLambda = lambdaMom4D.M(); + + if (std::abs(massLambda - o2::constants::physics::MassLambda0) > cfgLambda.massWindow) { + continue; // Skip V0s outside mass window + } + hArmenterosPodolanskiSelected->Fill(alpha, qt); + + std::array dcaInfoProton, dcaInfoPion; + o2::base::Propagator::Instance()->propagateToDCA(collVtx, matter ? trackParPos : trackParNeg, mBz, 2.f, o2::base::Propagator::MatCorrType::USEMatCorrLUT, &dcaInfoProton); + o2::base::Propagator::Instance()->propagateToDCA(collVtx, matter ? trackParNeg : trackParPos, mBz, 2.f, o2::base::Propagator::MatCorrType::USEMatCorrLUT, &dcaInfoPion); + + const auto sv = fitter.getPCACandidate(0); + + lambdaCandidate candidate; + candidate.momentum.SetCoordinates(lambdaMom4D.Pt(), lambdaMom4D.Eta(), lambdaMom4D.Phi(), o2::constants::physics::MassLambda0); + candidate.mass = massLambda; + candidate.cosPA = (sv[0] - collVtx.x()) * lambdaMom4D.Px() + + (sv[1] - collVtx.y()) * lambdaMom4D.Py() + + (sv[2] - collVtx.z()) * lambdaMom4D.Pz(); + candidate.cosPA /= std::hypot(sv[0] - collVtx.x(), sv[1] - collVtx.y(), sv[2] - collVtx.z()) * lambdaMom4D.P(); + candidate.dcaV0Daughters = std::sqrt(fitter.getChi2AtPCACandidate(0)); + candidate.dcaProtonToPV = std::hypot(dcaInfoProton[0], dcaInfoProton[1]); + candidate.dcaPionToPV = std::hypot(dcaInfoPion[0], dcaInfoPion[1]); + candidate.v0Radius = std::hypot(sv[0], sv[1]); + candidate.protonNSigmaTPC = protonTrack.tpcNSigmaPr(); + candidate.pionNSigmaTPC = pionTrack.tpcNSigmaPi(); + candidate.sign = matter ? 1 : -1; // Positive sign for Lambda, negative for anti-Lambda + lambdaCandidates.push_back(candidate); + } + if (lambdaCandidates.empty()) { + return; // No valid Lambda candidates found + } + mRegistry.get(HIST("hEventSelection"))->Fill(5); // He3 and Lambda candidates found + mRegistry.get(HIST("hCentralitySelected"))->Fill(collision.centFT0C()); + + // Fill output tables + lfHe3V0Collision(collision.posZ(), collision.centFT0C()); + for (const auto& he3 : he3Candidates) { + lfHe3(mEventIndex, he3.momentum.Pt(), he3.momentum.Eta(), he3.momentum.Phi(), + he3.dcaXY, he3.dcaZ, he3.tpcNClsFound, he3.itsClusterSizes, he3.nSigmaTPC, he3.sign); + } + for (const auto& lambda : lambdaCandidates) { + lfLambda(mEventIndex, lambda.momentum.Pt(), lambda.momentum.Eta(), lambda.momentum.Phi(), + lambda.mass, lambda.cosPA, lambda.dcaV0Daughters, lambda.dcaProtonToPV, lambda.dcaPionToPV, lambda.v0Radius, lambda.sign); + } + mEventIndex++; + } + PROCESS_SWITCH(he3LambdaAnalysis, processData, "Process data", true); +}; + +WorkflowSpec defineDataProcessing(ConfigContext const& cfgc) +{ + return WorkflowSpec{ + adaptAnalysisTask(cfgc)}; +}