10 #include <analysis/variables/Variables.h> 
   13 #include <analysis/VariableManager/Manager.h> 
   15 #include <analysis/utility/PCmsLabTransform.h> 
   16 #include <analysis/utility/ReferenceFrame.h> 
   17 #include <analysis/utility/MCMatching.h> 
   18 #include <analysis/ClusterUtility/ClusterUtils.h> 
   21 #include <framework/datastore/StoreArray.h> 
   22 #include <framework/datastore/StoreObjPtr.h> 
   25 #include <analysis/dataobjects/Particle.h> 
   26 #include <analysis/dataobjects/ParticleList.h> 
   27 #include <framework/dataobjects/EventExtraInfo.h> 
   28 #include <analysis/dataobjects/EventShapeContainer.h> 
   30 #include <mdst/dataobjects/MCParticle.h> 
   31 #include <mdst/dataobjects/Track.h> 
   32 #include <mdst/dataobjects/ECLCluster.h> 
   33 #include <mdst/dataobjects/V0.h> 
   35 #include <mdst/dbobjects/BeamSpot.h> 
   38 #include <framework/logging/Logger.h> 
   39 #include <framework/geometry/B2Vector3.h> 
   40 #include <framework/geometry/BFieldManager.h> 
   41 #include <framework/gearbox/Const.h> 
   42 #include <framework/utilities/Conversion.h> 
   44 #include <Math/Vector4D.h> 
   50 #include <boost/algorithm/string.hpp> 
   64     double particleP(
const Particle* part)
 
   66       const auto& frame = ReferenceFrame::GetCurrent();
 
   67       return frame.getMomentum(part).P();
 
   70     double particleE(
const Particle* part)
 
   72       const auto& frame = ReferenceFrame::GetCurrent();
 
   73       return frame.getMomentum(part).E();
 
   76     double particleClusterEUncertainty(
const Particle* part)
 
   78       const ECLCluster* cluster = part->getECLCluster();
 
   80         const auto EPhiThetaCov = cluster->getCovarianceMatrix3x3();
 
   81         return std::sqrt(EPhiThetaCov[0][0]);
 
   83       return std::numeric_limits<double>::quiet_NaN();
 
   86     double particlePx(
const Particle* part)
 
   88       const auto& frame = ReferenceFrame::GetCurrent();
 
   89       return frame.getMomentum(part).Px();
 
   92     double particlePy(
const Particle* part)
 
   94       const auto& frame = ReferenceFrame::GetCurrent();
 
   95       return frame.getMomentum(part).Py();
 
   98     double particlePz(
const Particle* part)
 
  100       const auto& frame = ReferenceFrame::GetCurrent();
 
  101       return frame.getMomentum(part).Pz();
 
  104     double particlePt(
const Particle* part)
 
  106       const auto& frame = ReferenceFrame::GetCurrent();
 
  107       return frame.getMomentum(part).Pt();
 
  110     double covMatrixElement(
const Particle* part, 
const std::vector<double>& element)
 
  112       int elementI = int(std::lround(element[0]));
 
  113       int elementJ = int(std::lround(element[1]));
 
  115       if (elementI < 0 || elementI > 6) {
 
  116         B2WARNING(
"Requested particle's momentumVertex covariance matrix element is out of boundaries [0 - 6]:" << 
LogVar(
"i", elementI));
 
  117         return std::numeric_limits<double>::quiet_NaN();
 
  119       if (elementJ < 0 || elementJ > 6) {
 
  120         B2WARNING(
"Requested particle's momentumVertex covariance matrix element is out of boundaries [0 - 6]:" << 
LogVar(
"j", elementJ));
 
  121         return std::numeric_limits<double>::quiet_NaN();
 
  124       return part->getMomentumVertexErrorMatrix()(elementI, elementJ);
 
  127     double particleEUncertainty(
const Particle* part)
 
  129       const auto& frame = ReferenceFrame::GetCurrent();
 
  131       double errorSquared = frame.getMomentumErrorMatrix(part)(3, 3);
 
  133       if (errorSquared >= 0.0)
 
  134         return sqrt(errorSquared);
 
  136         return std::numeric_limits<double>::quiet_NaN();
 
  139     double particlePErr(
const Particle* part)
 
  141       TMatrixD jacobianRot(3, 3);
 
  144       double cosPhi = cos(particlePhi(part));
 
  145       double sinPhi = sin(particlePhi(part));
 
  146       double cosTheta = particleCosTheta(part);
 
  147       double sinTheta = sin(acos(cosTheta));
 
  148       double p = particleP(part);
 
  150       jacobianRot(0, 0) = sinTheta * cosPhi;
 
  151       jacobianRot(0, 1) = sinTheta * sinPhi;
 
  152       jacobianRot(1, 0) = cosTheta * cosPhi / p;
 
  153       jacobianRot(1, 1) = cosTheta * sinPhi / p;
 
  154       jacobianRot(0, 2) = cosTheta;
 
  155       jacobianRot(2, 0) = -sinPhi / sinTheta / p;
 
  156       jacobianRot(1, 2) = -sinTheta / p;
 
  157       jacobianRot(2, 1) = cosPhi / sinTheta / p;
 
  159       const auto& frame = ReferenceFrame::GetCurrent();
 
  161       double errorSquared = frame.getMomentumErrorMatrix(part).GetSub(0, 2, 0, 2, 
" ").Similarity(jacobianRot)(0, 0);
 
  163       if (errorSquared >= 0.0)
 
  164         return sqrt(errorSquared);
 
  166         return std::numeric_limits<double>::quiet_NaN();
 
  169     double particlePxErr(
const Particle* part)
 
  171       const auto& frame = ReferenceFrame::GetCurrent();
 
  173       double errorSquared = frame.getMomentumErrorMatrix(part)(0, 0);
 
  175       if (errorSquared >= 0.0)
 
  176         return sqrt(errorSquared);
 
  178         return std::numeric_limits<double>::quiet_NaN();
 
  181     double particlePyErr(
const Particle* part)
 
  183       const auto& frame = ReferenceFrame::GetCurrent();
 
  184       double errorSquared = frame.getMomentumErrorMatrix(part)(1, 1);
 
  186       if (errorSquared >= 0.0)
 
  187         return sqrt(errorSquared);
 
  189         return std::numeric_limits<double>::quiet_NaN();
 
  192     double particlePzErr(
const Particle* part)
 
  194       const auto& frame = ReferenceFrame::GetCurrent();
 
  195       double errorSquared = frame.getMomentumErrorMatrix(part)(2, 2);
 
  197       if (errorSquared >= 0.0)
 
  198         return sqrt(errorSquared);
 
  200         return std::numeric_limits<double>::quiet_NaN();
 
  203     double particlePtErr(
const Particle* part)
 
  205       TMatrixD jacobianRot(3, 3);
 
  208       double px = particlePx(part);
 
  209       double py = particlePy(part);
 
  210       double pt = particlePt(part);
 
  212       jacobianRot(0, 0) = px / pt;
 
  213       jacobianRot(0, 1) = py / pt;
 
  214       jacobianRot(1, 0) = -py / (pt * pt);
 
  215       jacobianRot(1, 1) = px / (pt * pt);
 
  216       jacobianRot(2, 2) = 1;
 
  218       const auto& frame = ReferenceFrame::GetCurrent();
 
  219       double errorSquared = frame.getMomentumErrorMatrix(part).GetSub(0, 2, 0, 2, 
" ").Similarity(jacobianRot)(0, 0);
 
  221       if (errorSquared >= 0.0)
 
  222         return sqrt(errorSquared);
 
  224         return std::numeric_limits<double>::quiet_NaN();
 
  227     double momentumDeviationChi2(
const Particle* part)
 
  229       double result = std::numeric_limits<double>::quiet_NaN();
 
  232       if (part->getPValue() < 0.0)
 
  241       result += TMath::Power(part->getPx() - mcp->getMomentum().X(), 2.0) / part->getMomentumVertexErrorMatrix()(0, 0);
 
  242       result += TMath::Power(part->getPy() - mcp->getMomentum().Y(), 2.0) / part->getMomentumVertexErrorMatrix()(1, 1);
 
  243       result += TMath::Power(part->getPz() - mcp->getMomentum().Z(), 2.0) / part->getMomentumVertexErrorMatrix()(2, 2);
 
  248     double particleTheta(
const Particle* part)
 
  250       const auto& frame = ReferenceFrame::GetCurrent();
 
  251       return frame.getMomentum(part).Theta();
 
  254     double particleThetaErr(
const Particle* part)
 
  256       TMatrixD jacobianRot(3, 3);
 
  259       double cosPhi = cos(particlePhi(part));
 
  260       double sinPhi = sin(particlePhi(part));
 
  261       double cosTheta = particleCosTheta(part);
 
  262       double sinTheta = sin(acos(cosTheta));
 
  263       double p = particleP(part);
 
  265       jacobianRot(0, 0) = sinTheta * cosPhi;
 
  266       jacobianRot(0, 1) = sinTheta * sinPhi;
 
  267       jacobianRot(1, 0) = cosTheta * cosPhi / p;
 
  268       jacobianRot(1, 1) = cosTheta * sinPhi / p;
 
  269       jacobianRot(0, 2) = cosTheta;
 
  270       jacobianRot(2, 0) = -sinPhi / sinTheta / p;
 
  271       jacobianRot(1, 2) = -sinTheta / p;
 
  272       jacobianRot(2, 1) = cosPhi / sinTheta / p;
 
  274       const auto& frame = ReferenceFrame::GetCurrent();
 
  275       double errorSquared = frame.getMomentumErrorMatrix(part).GetSub(0, 2, 0, 2, 
" ").Similarity(jacobianRot)(1, 1);
 
  277       if (errorSquared >= 0.0)
 
  278         return sqrt(errorSquared);
 
  280         return std::numeric_limits<double>::quiet_NaN();
 
  283     double particleCosTheta(
const Particle* part)
 
  285       const auto& frame = ReferenceFrame::GetCurrent();
 
  286       return cos(frame.getMomentum(part).Theta());
 
  289     double particleCosThetaErr(
const Particle* part)
 
  291       return fabs(particleThetaErr(part) * sin(particleTheta(part)));
 
  294     double particlePhi(
const Particle* part)
 
  296       const auto& frame = ReferenceFrame::GetCurrent();
 
  297       return frame.getMomentum(part).Phi();
 
  300     double particlePhiErr(
const Particle* part)
 
  302       TMatrixD jacobianRot(3, 3);
 
  305       double px = particlePx(part);
 
  306       double py = particlePy(part);
 
  307       double pt = particlePt(part);
 
  309       jacobianRot(0, 0) = px / pt;
 
  310       jacobianRot(0, 1) = py / pt;
 
  311       jacobianRot(1, 0) = -py / (pt * pt);
 
  312       jacobianRot(1, 1) = px / (pt * pt);
 
  313       jacobianRot(2, 2) = 1;
 
  315       const auto& frame = ReferenceFrame::GetCurrent();
 
  316       double errorSquared = frame.getMomentumErrorMatrix(part).GetSub(0, 2, 0, 2, 
" ").Similarity(jacobianRot)(1, 1);
 
  318       if (errorSquared >= 0.0)
 
  319         return sqrt(errorSquared);
 
  321         return std::numeric_limits<double>::quiet_NaN();
 
  324     double particleXp(
const Particle* part)
 
  327       ROOT::Math::PxPyPzEVector p4 = part -> get4Vector();
 
  328       ROOT::Math::PxPyPzEVector p4CMS = T.rotateLabToCms() * p4;
 
  329       float s = T.getCMSEnergy();
 
  330       float M = part->getMass();
 
  331       return p4CMS.P() / TMath::Sqrt(s * s / 4 - M * M);
 
  334     int particlePDGCode(
const Particle* part)
 
  336       return part->getPDGCode();
 
  339     double cosAngleBetweenMomentumAndVertexVectorInXYPlane(
const Particle* part)
 
  341       static DBObjPtr<BeamSpot> beamSpotDB;
 
  342       double px = part->getPx();
 
  343       double py = part->getPy();
 
  345       double xV = part->getX();
 
  346       double yV = part->getY();
 
  348       double xIP = (beamSpotDB->getIPPosition()).X();
 
  349       double yIP = (beamSpotDB->getIPPosition()).Y();
 
  354       double cosangle = (px * x + py * y) / (sqrt(px * px + py * py) * sqrt(x * x + y * y));
 
  358     double cosAngleBetweenMomentumAndVertexVector(
const Particle* part)
 
  360       static DBObjPtr<BeamSpot> beamSpotDB;
 
  361       return cos((
B2Vector3D(part->getVertex()) - beamSpotDB->getIPPosition()).Angle(
B2Vector3D(part->getMomentum())));
 
  364     double cosThetaBetweenParticleAndNominalB(
const Particle* part)
 
  367       int particlePDG = abs(part->getPDGCode());
 
  368       if (particlePDG != 511 and particlePDG != 521)
 
  369         B2FATAL(
"The Variables cosThetaBetweenParticleAndNominalB is only meant to be used on B mesons!");
 
  372       double e_Beam = T.getCMSEnergy() / 2.0; 
 
  373       double m_B = part->getPDGMass();
 
  375       if (e_Beam * e_Beam - m_B * m_B < 0) {
 
  376         e_Beam = 1.0579400E+1 / 2.0; 
 
  378       double p_B = std::sqrt(e_Beam * e_Beam - m_B * m_B);
 
  380       ROOT::Math::PxPyPzEVector p = T.rotateLabToCms() * part->get4Vector();
 
  385       double theta_BY = (2 * e_Beam * e_d - m_B * m_B - m_d * m_d)
 
  390     double cosToThrustOfEvent(
const Particle* part)
 
  392       StoreObjPtr<EventShapeContainer> evtShape;
 
  394         B2WARNING(
"Cannot find thrust of event information, did you forget to load the event shape calculation?");
 
  395         return std::numeric_limits<float>::quiet_NaN();
 
  399       B2Vector3D particleMomentum = (T.rotateLabToCms() * part -> get4Vector()).Vect();
 
  400       return std::cos(th.Angle(particleMomentum));
 
  403     double ImpactXY(
const Particle* particle)
 
  405       static DBObjPtr<BeamSpot> beamSpotDB;
 
  407       ROOT::Math::XYZVector mom = particle->getMomentum();
 
  409       ROOT::Math::XYZVector r = particle->getVertex() - ROOT::Math::XYZVector(beamSpotDB->getIPPosition());
 
  411       ROOT::Math::XYZVector Bfield = BFieldManager::getInstance().getFieldInTesla(ROOT::Math::XYZVector(beamSpotDB->getIPPosition()));
 
  413       ROOT::Math::XYZVector curvature = - Bfield * Const::speedOfLight * particle->getCharge(); 
 
  414       double T = TMath::Sqrt(mom.Perp2() - 2.0 * curvature.Dot(r.Cross(mom)) + curvature.Mag2() * r.Perp2());
 
  416       return TMath::Abs((-2 * r.Cross(mom).Z() + curvature.R() * r.Perp2()) / (T + mom.Rho()));
 
  419     double ArmenterosLongitudinalMomentumAsymmetry(
const Particle* part)
 
  421       const auto& frame = ReferenceFrame::GetCurrent();
 
  422       int nDaughters = part -> getNDaughters();
 
  424         B2FATAL(
"You are trying to use an Armenteros variable. The mother particle is required to have exactly two daughters");
 
  426       const auto& daughters = part -> getDaughters();
 
  427       B2Vector3D motherMomentum = frame.getMomentum(part).Vect();
 
  428       B2Vector3D daughter1Momentum = frame.getMomentum(daughters[0]).Vect();
 
  429       B2Vector3D daughter2Momentum = frame.getMomentum(daughters[1]).Vect();
 
  431       int daughter1Charge = daughters[0] -> getCharge();
 
  432       int daughter2Charge = daughters[1] -> getCharge();
 
  433       double daughter1Ql = daughter1Momentum.Dot(motherMomentum) / motherMomentum.Mag();
 
  434       double daughter2Ql = daughter2Momentum.Dot(motherMomentum) / motherMomentum.Mag();
 
  437       if (daughter2Charge > daughter1Charge)
 
  438         Arm_alpha = (daughter2Ql - daughter1Ql) / (daughter2Ql + daughter1Ql);
 
  440         Arm_alpha = (daughter1Ql - daughter2Ql) / (daughter1Ql + daughter2Ql);
 
  445     double ArmenterosDaughter1Qt(
const Particle* part)
 
  447       const auto& frame = ReferenceFrame::GetCurrent();
 
  448       int nDaughters = part -> getNDaughters();
 
  450         B2FATAL(
"You are trying to use an Armenteros variable. The mother particle is required to have exactly two daughters.");
 
  452       const auto& daughters = part -> getDaughters();
 
  453       B2Vector3D motherMomentum = frame.getMomentum(part).Vect();
 
  454       B2Vector3D daughter1Momentum = frame.getMomentum(daughters[0]).Vect();
 
  455       double qt = daughter1Momentum.
Perp(motherMomentum);
 
  460     double ArmenterosDaughter2Qt(
const Particle* part)
 
  462       const auto& frame = ReferenceFrame::GetCurrent();
 
  463       int nDaughters = part -> getNDaughters();
 
  465         B2FATAL(
"You are trying to use an Armenteros variable. The mother particle is required to have exactly two daughters.");
 
  467       const auto& daughters = part -> getDaughters();
 
  468       B2Vector3D motherMomentum = frame.getMomentum(part).Vect();
 
  469       B2Vector3D daughter2Momentum = frame.getMomentum(daughters[1]).Vect();
 
  470       double qt = daughter2Momentum.
Perp(motherMomentum);
 
  478     double particleMass(
const Particle* part)
 
  480       return part->getMass();
 
  483     double particleDMass(
const Particle* part)
 
  485       return part->getMass() - part->getPDGMass();
 
  488     double particleInvariantMassFromDaughters(
const Particle* part)
 
  490       const std::vector<Particle*> daughters = part->getDaughters();
 
  491       if (daughters.size() > 0) {
 
  492         ROOT::Math::PxPyPzEVector sum;
 
  493         for (
auto daughter : daughters)
 
  494           sum += daughter->get4Vector();
 
  498         return part->getMass(); 
 
  502     double particleInvariantMassFromDaughtersDisplaced(
const Particle* part)
 
  504       ROOT::Math::XYZVector vertex = part->getVertex();
 
  505       if (part->getParticleSource() != Particle::EParticleSourceObject::c_V0
 
  506           && vertex.Rho() < 0.5) 
return particleInvariantMassFromDaughters(part);
 
  508       const std::vector<Particle*> daughters = part->getDaughters();
 
  509       if (daughters.size() == 0) 
return particleInvariantMassFromDaughters(part);
 
  511       const double bField = BFieldManager::getFieldInTesla(vertex).Z();
 
  512       ROOT::Math::PxPyPzMVector sum;
 
  513       for (
auto daughter : daughters) {
 
  514         const TrackFitResult* tfr = daughter->getTrackFitResult();
 
  516           sum += daughter->get4Vector();
 
  519         Helix helix = tfr->getHelix();
 
  520         helix.passiveMoveBy(vertex);
 
  521         double scalingFactor = daughter->getEffectiveMomentumScale();
 
  522         double momX = scalingFactor * helix.getMomentumX(bField);
 
  523         double momY = scalingFactor * helix.getMomentumY(bField);
 
  524         double momZ = scalingFactor * helix.getMomentumZ(bField);
 
  525         float mPDG = daughter->getPDGMass();
 
  526         sum += ROOT::Math::PxPyPzMVector(momX, momY, momZ, mPDG);
 
  531     double particleInvariantMassLambda(
const Particle* part)
 
  533       const std::vector<Particle*> daughters = part->getDaughters();
 
  534       if (daughters.size() == 2) {
 
  535         ROOT::Math::PxPyPzEVector dt1;
 
  536         ROOT::Math::PxPyPzEVector dt2;
 
  537         ROOT::Math::PxPyPzEVector dtsum;
 
  538         double mpi = Const::pionMass;
 
  539         double mpr = Const::protonMass;
 
  540         dt1 = daughters[0]->get4Vector();
 
  541         dt2 = daughters[1]->get4Vector();
 
  542         double E1 = hypot(mpi, dt1.P());
 
  543         double E2 = hypot(mpr, dt2.P());
 
  545         return sqrt((E1 + E2) * (E1 + E2) - dtsum.P() * dtsum.P());
 
  548         return part->getMass();
 
  552     double particleInvariantMassError(
const Particle* part)
 
  554       float invMass = part->getMass();
 
  555       TMatrixFSym covarianceMatrix = part->getMomentumErrorMatrix();
 
  557       TVectorF jacobian(Particle::c_DimMomentum);
 
  558       jacobian[0] = -1.0 * part->getPx() / invMass;
 
  559       jacobian[1] = -1.0 * part->getPy() / invMass;
 
  560       jacobian[2] = -1.0 * part->getPz() / invMass;
 
  561       jacobian[3] = 1.0 * part->getEnergy() / invMass;
 
  563       double result = jacobian * (covarianceMatrix * jacobian);
 
  566         return std::numeric_limits<double>::quiet_NaN();
 
  568       return TMath::Sqrt(result);
 
  571     double particleInvariantMassSignificance(
const Particle* part)
 
  573       return particleDMass(part) / particleInvariantMassError(part);
 
  576     double particleMassSquared(
const Particle* part)
 
  578       ROOT::Math::PxPyPzEVector p4 = part->get4Vector();
 
  582     double b2bTheta(
const Particle* part)
 
  585       ROOT::Math::PxPyPzEVector pcms = T.rotateLabToCms() * part->get4Vector();
 
  586       ROOT::Math::PxPyPzEVector b2bcms(-pcms.Px(), -pcms.Py(), -pcms.Pz(), pcms.E());
 
  587       ROOT::Math::PxPyPzEVector b2blab = T.rotateCmsToLab() * b2bcms;
 
  588       return b2blab.Theta();
 
  591     double b2bPhi(
const Particle* part)
 
  594       ROOT::Math::PxPyPzEVector pcms = T.rotateLabToCms() * part->get4Vector();
 
  595       ROOT::Math::PxPyPzEVector b2bcms(-pcms.Px(), -pcms.Py(), -pcms.Pz(), pcms.E());
 
  596       ROOT::Math::PxPyPzEVector b2blab = T.rotateCmsToLab() * b2bcms;
 
  600     double b2bClusterTheta(
const Particle* part)
 
  603       const ECLCluster* cluster = part->getECLCluster();
 
  604       if (!cluster) 
return std::numeric_limits<float>::quiet_NaN();
 
  605       const ECLCluster::EHypothesisBit clusterHypothesis = part->getECLClusterEHypothesisBit();
 
  609       ROOT::Math::PxPyPzEVector p4Cluster = clutls.Get4MomentumFromCluster(cluster, clusterHypothesis);
 
  613       ROOT::Math::PxPyPzEVector pcms = T.rotateLabToCms() * p4Cluster;
 
  614       ROOT::Math::PxPyPzEVector b2bcms(-pcms.Px(), -pcms.Py(), -pcms.Pz(), pcms.E());
 
  615       ROOT::Math::PxPyPzEVector b2blab = T.rotateCmsToLab() * b2bcms;
 
  616       return b2blab.Theta();
 
  619     double b2bClusterPhi(
const Particle* part)
 
  622       const ECLCluster* cluster = part->getECLCluster();
 
  623       if (!cluster) 
return std::numeric_limits<float>::quiet_NaN();
 
  624       const ECLCluster::EHypothesisBit clusterHypothesis = part->getECLClusterEHypothesisBit();
 
  628       ROOT::Math::PxPyPzEVector p4Cluster = clutls.Get4MomentumFromCluster(cluster, clusterHypothesis);
 
  632       ROOT::Math::PxPyPzEVector pcms = T.rotateLabToCms() * p4Cluster;
 
  633       ROOT::Math::PxPyPzEVector b2bcms(-pcms.Px(), -pcms.Py(), -pcms.Pz(), pcms.E());
 
  634       ROOT::Math::PxPyPzEVector b2blab = T.rotateCmsToLab() * b2bcms;
 
  641     double particleQ(
const Particle* part)
 
  643       float m = part->getMass();
 
  644       for (
unsigned i = 0; i < part->getNDaughters(); i++) {
 
  645         const Particle* child = part->getDaughter(i);
 
  647           m -= child->getMass();
 
  652     double particleDQ(
const Particle* part)
 
  654       float m = part->getMass() - part->getPDGMass();
 
  655       for (
unsigned i = 0; i < part->getNDaughters(); i++) {
 
  656         const Particle* child = part->getDaughter(i);
 
  658           m -= (child->getMass() - child->getPDGMass());
 
  665     double particleMbc(
const Particle* part)
 
  668       ROOT::Math::PxPyPzEVector vec = T.rotateLabToCms() * part->get4Vector();
 
  669       double E = T.getCMSEnergy() / 2;
 
  670       double m2 = E * E - vec.P2();
 
  671       double mbc = m2 >= 0 ? sqrt(m2) : std::numeric_limits<double>::quiet_NaN();
 
  675     double particleDeltaE(
const Particle* part)
 
  678       ROOT::Math::PxPyPzEVector vec = T.rotateLabToCms() * part->get4Vector();
 
  679       return vec.E() - T.getCMSEnergy() / 2;
 
  685     void printParticleInternal(
const Particle* p, 
int depth)
 
  688       for (
int i = 0; i < depth; i++) {
 
  691       s << p->getPDGCode();
 
  692       const MCParticle* mcp = p->getMCParticle();
 
  694         unsigned int flags = MCMatching::getMCErrors(p, mcp);
 
  695         s << 
" -> MC: " << mcp->getPDG() << 
", mcErrors: " << flags << 
" (" 
  696           << MCMatching::explainFlags(flags) << 
")";
 
  697         s << 
", mc-index " << mcp->getIndex();
 
  699         s << 
" (no MC match)";
 
  701       s << 
", mdst-source " << p->getMdstSource();
 
  703       for (
const auto* daughter : p->getDaughters()) {
 
  704         printParticleInternal(daughter, depth + 1);
 
  708     bool printParticle(
const Particle* p)
 
  710       printParticleInternal(p, 0);
 
  715     double particleMCMomentumTransfer2(
const Particle* part)
 
  721         return std::numeric_limits<double>::quiet_NaN();
 
  723       ROOT::Math::PxPyPzEVector pB = mcB->get4Vector();
 
  725       std::vector<MCParticle*> mcDaug = mcB->getDaughters();
 
  728         return std::numeric_limits<double>::quiet_NaN();
 
  732       ROOT::Math::PxPyPzEVector pX;
 
  734       for (
auto mcTemp : mcDaug) {
 
  735         if (abs(mcTemp->getPDG()) <= 16)
 
  738         pX += mcTemp->get4Vector();
 
  741       ROOT::Math::PxPyPzEVector q = pB - pX;
 
  747     double recoilPx(
const Particle* particle)
 
  752       ROOT::Math::PxPyPzEVector pIN = T.getBeamFourMomentum();
 
  755       const auto& frame = ReferenceFrame::GetCurrent();
 
  756       return frame.getMomentum(pIN - particle->get4Vector()).Px();
 
  759     double recoilPy(
const Particle* particle)
 
  764       ROOT::Math::PxPyPzEVector pIN = T.getBeamFourMomentum();
 
  767       const auto& frame = ReferenceFrame::GetCurrent();
 
  768       return frame.getMomentum(pIN - particle->get4Vector()).Py();
 
  771     double recoilPz(
const Particle* particle)
 
  776       ROOT::Math::PxPyPzEVector pIN = T.getBeamFourMomentum();
 
  779       const auto& frame = ReferenceFrame::GetCurrent();
 
  780       return frame.getMomentum(pIN - particle->get4Vector()).Pz();
 
  783     double recoilMomentum(
const Particle* particle)
 
  788       ROOT::Math::PxPyPzEVector pIN = T.getBeamFourMomentum();
 
  791       const auto& frame = ReferenceFrame::GetCurrent();
 
  792       return frame.getMomentum(pIN - particle->get4Vector()).P();
 
  795     double recoilMomentumTheta(
const Particle* particle)
 
  800       ROOT::Math::PxPyPzEVector pIN = T.getBeamFourMomentum();
 
  803       const auto& frame = ReferenceFrame::GetCurrent();
 
  804       return frame.getMomentum(pIN - particle->get4Vector()).Theta();
 
  807     double recoilMomentumPhi(
const Particle* particle)
 
  812       ROOT::Math::PxPyPzEVector pIN = T.getBeamFourMomentum();
 
  815       const auto& frame = ReferenceFrame::GetCurrent();
 
  816       return frame.getMomentum(pIN - particle->get4Vector()).Phi();
 
  819     double recoilEnergy(
const Particle* particle)
 
  824       ROOT::Math::PxPyPzEVector pIN = T.getBeamFourMomentum();
 
  827       const auto& frame = ReferenceFrame::GetCurrent();
 
  828       return frame.getMomentum(pIN - particle->get4Vector()).E();
 
  831     double recoilMass(
const Particle* particle)
 
  836       ROOT::Math::PxPyPzEVector pIN = T.getBeamFourMomentum();
 
  839       const auto& frame = ReferenceFrame::GetCurrent();
 
  840       return frame.getMomentum(pIN - particle->get4Vector()).M();
 
  843     double recoilMassSquared(
const Particle* particle)
 
  848       ROOT::Math::PxPyPzEVector pIN = T.getBeamFourMomentum();
 
  851       const auto& frame = ReferenceFrame::GetCurrent();
 
  852       return frame.getMomentum(pIN - particle->get4Vector()).M2();
 
  855     double m2RecoilSignalSide(
const Particle* part)
 
  858       double beamEnergy = T.getCMSEnergy() / 2.;
 
  859       if (part->getNDaughters() != 2) 
return std::numeric_limits<double>::quiet_NaN();
 
  860       ROOT::Math::PxPyPzEVector tagVec = T.rotateLabToCms() * part->getDaughter(0)->get4Vector();
 
  861       ROOT::Math::PxPyPzEVector sigVec = T.rotateLabToCms() * part->getDaughter(1)->get4Vector();
 
  862       tagVec.SetE(-beamEnergy);
 
  863       return (-tagVec - sigVec).M2();
 
  866     double recoilMCDecayType(
const Particle* particle)
 
  868       auto* mcp = particle->getMCParticle();
 
  871         return std::numeric_limits<double>::quiet_NaN();
 
  873       MCParticle* mcMother = mcp->getMother();
 
  876         return std::numeric_limits<double>::quiet_NaN();
 
  878       std::vector<MCParticle*> daughters = mcMother->getDaughters();
 
  880       if (daughters.size() != 2)
 
  881         return std::numeric_limits<double>::quiet_NaN();
 
  883       MCParticle* recoilMC = 
nullptr;
 
  884       if (daughters[0]->getArrayIndex() == mcp->getArrayIndex())
 
  885         recoilMC = daughters[1];
 
  887         recoilMC = daughters[0];
 
  889       if (!recoilMC->hasStatus(MCParticle::c_PrimaryParticle))
 
  890         return std::numeric_limits<double>::quiet_NaN();
 
  893       checkMCParticleDecay(recoilMC, decayType, 
false);
 
  896         checkMCParticleDecay(recoilMC, decayType, 
true);
 
  901     void checkMCParticleDecay(MCParticle* mcp, 
int& decayType, 
bool recursive)
 
  903       int nHadronicParticles = 0;
 
  904       int nPrimaryParticleDaughters = 0;
 
  905       std::vector<MCParticle*> daughters = mcp->getDaughters();
 
  908       for (
auto& daughter : daughters) {
 
  909         if (!daughter->hasStatus(MCParticle::c_PrimaryParticle))
 
  912         nPrimaryParticleDaughters++;
 
  913         if (abs(daughter->getPDG()) > Const::photon.getPDGCode())
 
  914           nHadronicParticles++;
 
  917       if (nPrimaryParticleDaughters > 1) {
 
  918         for (
auto& daughter : daughters) {
 
  919           if (!daughter->hasStatus(MCParticle::c_PrimaryParticle))
 
  922           if (abs(daughter->getPDG()) == 12 or abs(daughter->getPDG()) == 14 or abs(daughter->getPDG()) == 16) {
 
  924               if (nHadronicParticles == 0) {
 
  938             checkMCParticleDecay(daughter, decayType, recursive);
 
  943     int nRemainingTracksInEvent(
const Particle* particle)
 
  946       StoreArray<Track> tracks;
 
  947       int event_tracks = tracks.getEntries();
 
  950       const auto& daughters = particle->getFinalStateDaughters();
 
  951       for (
const auto& daughter : daughters) {
 
  952         int pdg = abs(daughter->getPDGCode());
 
  953         if (pdg == Const::electron.getPDGCode() or pdg == Const::muon.getPDGCode() or pdg == Const::pion.getPDGCode()
 
  954             or pdg == Const::kaon.getPDGCode() or pdg == Const::proton.getPDGCode())
 
  957       return event_tracks - par_tracks;
 
  960     double trackMatchType(
const Particle* particle)
 
  963       double result = std::numeric_limits<double>::quiet_NaN();
 
  965       const ECLCluster* cluster = particle->getECLCluster();
 
  969         if (cluster->isTrack()) {
 
  978     bool False(
const Particle*)
 
  983     bool True(
const Particle*)
 
  988     double infinity(
const Particle*)
 
  990       double inf = std::numeric_limits<double>::infinity();
 
  994     double random(
const Particle*)
 
  996       return gRandom->Uniform(0, 1);
 
  999     double eventRandom(
const Particle*)
 
 1001       std::string key = 
"__eventRandom";
 
 1002       StoreObjPtr<EventExtraInfo> eventExtraInfo;
 
 1003       if (not eventExtraInfo.isValid())
 
 1004         eventExtraInfo.create();
 
 1005       if (eventExtraInfo->hasExtraInfo(key)) {
 
 1006         return eventExtraInfo->getExtraInfo(key);
 
 1008         double value = gRandom->Uniform(0, 1);
 
 1009         eventExtraInfo->addExtraInfo(key, value);
 
 1014     Manager::FunctionPtr particleDistToClosestExtTrk(
const std::vector<std::string>& arguments)
 
 1016       if (arguments.size() != 3 && arguments.size() != 4) {
 
 1017         B2ERROR(
"Wrong number of arguments (3 or 4 required) for meta variable minET2ETDist");
 
 1020       bool useHighestProbMassForExt(
true);
 
 1021       if (arguments.size() == 4) {
 
 1023           useHighestProbMassForExt = 
static_cast<bool>(Belle2::convertString<int>(arguments[3]));
 
 1024         } 
catch (std::invalid_argument& e) {
 
 1025           B2ERROR(
"Fourth (optional) argument of minET2ETDist must be an integer flag.");
 
 1030       std::string detName = arguments[0];
 
 1031       std::string detLayer = arguments[1];
 
 1032       std::string referenceListName = arguments[2];
 
 1033       std::string extraSuffix = (useHighestProbMassForExt) ? 
"__useHighestProbMassForExt" : 
"";
 
 1035       std::string extraInfo = 
"distToClosestTrkAt" + detName + detLayer + 
"_VS_" + referenceListName + extraSuffix;
 
 1037       auto func = [ = ](
const Particle * part) -> 
double {
 
 1038         auto dist = (part->hasExtraInfo(extraInfo)) ? part->getExtraInfo(extraInfo) : std::numeric_limits<float>::quiet_NaN();
 
 1047     Manager::FunctionPtr particleDistToClosestExtTrkVar(
const std::vector<std::string>& arguments)
 
 1049       if (arguments.size() != 4) {
 
 1050         B2ERROR(
"Wrong number of arguments (4 required) for meta variable minET2ETDistVar");
 
 1054       std::string detName = arguments[0];
 
 1055       std::string detLayer = arguments[1];
 
 1056       std::string referenceListName = arguments[2];
 
 1057       std::string variableName = arguments[3];
 
 1059       std::string extraInfo = 
"idxOfClosestPartAt" + detName + detLayer + 
"In_" + referenceListName;
 
 1061       auto func = [ = ](
const Particle * part) -> 
double {
 
 1063         StoreObjPtr<ParticleList> refPartList(referenceListName);
 
 1064         if (!refPartList.isValid())
 
 1066           B2FATAL(
"Invalid Listname " << referenceListName << 
" given to minET2ETDistVar!");
 
 1069         if (!part->hasExtraInfo(extraInfo))
 
 1071           return std::numeric_limits<float>::quiet_NaN();
 
 1074         const Variable::Manager::Var* var = Manager::Instance().getVariable(variableName);
 
 1075         auto refPart = refPartList->getParticleWithMdstIdx(part->getExtraInfo(extraInfo));
 
 1077         return std::get<double>(var->function(refPart));
 
 1084     Manager::FunctionPtr particleExtTrkIsoScoreVar(
const std::vector<std::string>& arguments)
 
 1087       if (arguments.size() < 3) {
 
 1088         B2ERROR(
"Wrong number of arguments (at least 3 required) for meta variable minET2ETIsoScore");
 
 1092       std::string referenceListName = arguments[0];
 
 1093       bool useHighestProbMassForExt;
 
 1095         useHighestProbMassForExt = 
static_cast<bool>(Belle2::convertString<int>(arguments[1]));
 
 1096       } 
catch (std::invalid_argument& e) {
 
 1097         B2ERROR(
"Second argument must be an integer flag.");
 
 1100       std::string extraSuffix = (useHighestProbMassForExt) ? 
"__useHighestProbMassForExt" : 
"";
 
 1102       std::vector<std::string> detectorNames(arguments.begin() + 2, arguments.end());
 
 1104       std::string detNamesConcat(
"");
 
 1105       for (
auto& detName : detectorNames) {
 
 1106         boost::to_upper(detName);
 
 1107         detNamesConcat += 
"_" + detName;
 
 1110       std::string extraInfo = 
"trkIsoScore" + detNamesConcat + 
"_VS_" + referenceListName + extraSuffix;
 
 1112       auto func = [ = ](
const Particle * part) -> 
double {
 
 1114         StoreObjPtr<ParticleList> refPartList(referenceListName);
 
 1115         if (!refPartList.isValid())
 
 1117           B2FATAL(
"Invalid Listname " << referenceListName << 
" given to minET2ETIsoScore!");
 
 1120         if (!part->hasExtraInfo(extraInfo))
 
 1122           return std::numeric_limits<float>::quiet_NaN();
 
 1124         auto scoreDet = part->getExtraInfo(extraInfo);
 
 1125         if (std::isnan(scoreDet))
 
 1127           return std::numeric_limits<float>::quiet_NaN();
 
 1138     Manager::FunctionPtr particleExtTrkIsoScoreVarAsWeightedAvg(
const std::vector<std::string>& arguments)
 
 1141       if (arguments.size() < 3) {
 
 1142         B2ERROR(
"Wrong number of arguments (at least 3 required) for meta variable minET2ETIsoScoreAsWeightedAvg");
 
 1146       std::string referenceListName = arguments[0];
 
 1147       bool useHighestProbMassForExt;
 
 1149         useHighestProbMassForExt = 
static_cast<bool>(Belle2::convertString<int>(arguments[1]));
 
 1150       } 
catch (std::invalid_argument& e) {
 
 1151         B2ERROR(
"Second argument must be an integer flag.");
 
 1154       std::string extraSuffix = (useHighestProbMassForExt) ? 
"__useHighestProbMassForExt" : 
"";
 
 1156       std::vector<std::string> detectorNames(arguments.begin() + 2, arguments.end());
 
 1158       std::string detNamesConcat(
"");
 
 1159       for (
auto& detName : detectorNames) {
 
 1160         boost::to_upper(detName);
 
 1161         detNamesConcat += 
"_" + detName;
 
 1164       std::string extraInfo = 
"trkIsoScoreAsWeightedAvg" + detNamesConcat + 
"_VS_" + referenceListName + extraSuffix;
 
 1166       auto func = [ = ](
const Particle * part) -> 
double {
 
 1168         StoreObjPtr<ParticleList> refPartList(referenceListName);
 
 1169         if (!refPartList.isValid())
 
 1171           B2FATAL(
"Invalid Listname " << referenceListName << 
" given to minET2ETIsoScoreAsWeightedAvg!");
 
 1174         if (!part->hasExtraInfo(extraInfo))
 
 1176           return std::numeric_limits<float>::quiet_NaN();
 
 1178         auto scoreDet = part->getExtraInfo(extraInfo);
 
 1179         if (std::isnan(scoreDet))
 
 1181           return std::numeric_limits<float>::quiet_NaN();
 
 1191     VARIABLE_GROUP(
"Kinematics");
 
 1192     REGISTER_VARIABLE(
"p", particleP, 
"momentum magnitude\n\n", 
"GeV/c");
 
 1193     REGISTER_VARIABLE(
"E", particleE, 
"energy\n\n", 
"GeV");
 
 1195     REGISTER_VARIABLE(
"E_uncertainty", particleEUncertainty, R
"DOC( 
 1196                       energy uncertainty (:math:`\sqrt{\sigma^2}`) 
 1199     REGISTER_VARIABLE(
"ECLClusterE_uncertainty", particleClusterEUncertainty,
 
 1200                       "energy uncertainty as given by the underlying ECL cluster\n\n", 
"GeV");
 
 1201     REGISTER_VARIABLE(
"px", particlePx, 
"momentum component x\n\n", 
"GeV/c");
 
 1202     REGISTER_VARIABLE(
"py", particlePy, 
"momentum component y\n\n", 
"GeV/c");
 
 1203     REGISTER_VARIABLE(
"pz", particlePz, 
"momentum component z\n\n", 
"GeV/c");
 
 1204     REGISTER_VARIABLE(
"pt", particlePt, 
"transverse momentum\n\n", 
"GeV/c");
 
 1205     REGISTER_VARIABLE(
"xp", particleXp,
 
 1206                       "scaled momentum: the momentum of the particle in the CMS as a fraction of its maximum available momentum in the collision");
 
 1207     REGISTER_VARIABLE(
"pErr", particlePErr, 
"error of momentum magnitude\n\n", 
"GeV/c");
 
 1208     REGISTER_VARIABLE(
"pxErr", particlePxErr, 
"error of momentum component x\n\n", 
"GeV/c");
 
 1209     REGISTER_VARIABLE(
"pyErr", particlePyErr, 
"error of momentum component y\n\n", 
"GeV/c");
 
 1210     REGISTER_VARIABLE(
"pzErr", particlePzErr, 
"error of momentum component z\n\n", 
"GeV/c");
 
 1211     REGISTER_VARIABLE(
"ptErr", particlePtErr, 
"error of transverse momentum\n\n", 
"GeV/c");
 
 1212     REGISTER_VARIABLE(
"momVertCovM(i,j)", covMatrixElement,
 
 1213                       "returns the (i,j)-th element of the MomentumVertex Covariance Matrix (7x7).\n" 
 1214                       "Order of elements in the covariance matrix is: px, py, pz, E, x, y, z.\n\n", 
"GeV/c, GeV/c, GeV/c, GeV, cm, cm, cm");
 
 1215     REGISTER_VARIABLE(
"momDevChi2", momentumDeviationChi2, R
"DOC( 
 1216 momentum deviation :math:`\chi^2` value calculated as :math:`\chi^2 = \sum_i (p_i - mc(p_i))^2/\sigma(p_i)^2`, 
 1217 where :math:`\sum` runs over i = px, py, pz and :math:`mc(p_i)` is the mc truth value and :math:`\sigma(p_i)` is the estimated error of i-th component of momentum vector 
 1219     REGISTER_VARIABLE("theta", particleTheta, 
"polar angle\n\n", 
"rad");
 
 1220     REGISTER_VARIABLE(
"thetaErr", particleThetaErr, 
"error of polar angle\n\n", 
"rad");
 
 1221     REGISTER_VARIABLE(
"cosTheta", particleCosTheta, 
"momentum cosine of polar angle");
 
 1222     REGISTER_VARIABLE(
"cosThetaErr", particleCosThetaErr, 
"error of momentum cosine of polar angle");
 
 1223     REGISTER_VARIABLE(
"phi", particlePhi, 
"momentum azimuthal angle\n\n", 
"rad");
 
 1224     REGISTER_VARIABLE(
"phiErr", particlePhiErr, 
"error of momentum azimuthal angle\n\n", 
"rad");
 
 1225     REGISTER_VARIABLE(
"PDG", particlePDGCode, 
"PDG code");
 
 1226     REGISTER_VARIABLE(
"cosAngleBetweenMomentumAndVertexVectorInXYPlane",
 
 1227                       cosAngleBetweenMomentumAndVertexVectorInXYPlane,
 
 1228                       "cosine of the angle between momentum and vertex vector (vector connecting ip and fitted vertex) of this particle in xy-plane");
 
 1229     REGISTER_VARIABLE(
"cosAngleBetweenMomentumAndVertexVector",
 
 1230                       cosAngleBetweenMomentumAndVertexVector,
 
 1231                       "cosine of the angle between momentum and vertex vector (vector connecting ip and fitted vertex) of this particle");
 
 1232     REGISTER_VARIABLE(
"cosThetaBetweenParticleAndNominalB",
 
 1233                       cosThetaBetweenParticleAndNominalB,
 
 1234                       "cosine of the angle in CMS between momentum the particle and a nominal B particle. It is somewhere between -1 and 1 if only a massless particle like a neutrino is missing in the reconstruction.");
 
 1235     REGISTER_VARIABLE(
"cosToThrustOfEvent", cosToThrustOfEvent,
 
 1236                       "Returns the cosine of the angle between the particle and the thrust axis of the event, as calculate by the EventShapeCalculator module. buildEventShape() must be run before calling this variable");
 
 1238     REGISTER_VARIABLE(
"ImpactXY"  , ImpactXY , 
"The impact parameter of the given particle in the xy plane\n\n", 
"cm");
 
 1240     REGISTER_VARIABLE(
"M", particleMass, R
"DOC( 
 1241 The particle's mass. 
 1243 Note that this is context-dependent variable and can take different values depending on the situation. This should be the "best" 
 1244 value possible with the information provided. 
 1246 - If this particle is track- or cluster- based, then this is the value of the mass hypothesis. 
 1247 - If this particle is an MC particle then this is the mass of that particle. 
 1248 - If this particle is composite, then *initially* this takes the value of the invariant mass of the daughters. 
 1249 - If this particle is composite and a *mass or vertex fit* has been performed then this may be updated by the fit. 
 1251 * You will see a difference between this mass and the :b2:var:`InvM`. 
 1253 )DOC", "GeV/:math:`\\text{c}^2`");
 
 1254     REGISTER_VARIABLE(
"dM", particleDMass, 
"mass minus nominal mass\n\n", 
"GeV/:math:`\\text{c}^2`");
 
 1255     REGISTER_VARIABLE(
"Q", particleQ, 
"energy released in decay\n\n", 
"GeV");
 
 1256     REGISTER_VARIABLE(
"dQ", particleDQ, 
":b2:var:`Q` minus nominal energy released in decay\n\n", 
"GeV");
 
 1257     REGISTER_VARIABLE(
"Mbc", particleMbc, 
"beam constrained mass\n\n", 
"GeV/:math:`\\text{c}^2`");
 
 1258     REGISTER_VARIABLE(
"deltaE", particleDeltaE, 
"difference between :b2:var:`E` and half the center of mass energy\n\n", 
"GeV");
 
 1259     REGISTER_VARIABLE(
"M2", particleMassSquared, 
"The particle's mass squared.\n\n", 
":math:`[\\text{GeV}/\\text{c}^2]^2`");
 
 1261     REGISTER_VARIABLE(
"InvM", particleInvariantMassFromDaughtersDisplaced,
 
 1262                       "invariant mass (determined from particle's daughter 4-momentum vectors). If this particle is V0 or decays at rho > 5 mm, its daughter 4-momentum vectors at fitted vertex are taken.\n" 
 1263                       "If this particle has no daughters, defaults to :b2:var:`M`.\n\n", 
"GeV/:math:`\\text{c}^2`");
 
 1264     REGISTER_VARIABLE(
"InvMLambda", particleInvariantMassLambda,
 
 1265                       "Invariant mass (determined from particle's daughter 4-momentum vectors), assuming the first daughter is a pion and the second daughter is a proton.\n" 
 1266                       "If the particle has not 2 daughters, it returns just the mass value.\n\n", 
"GeV/:math:`\\text{c}^2`");
 
 1268     REGISTER_VARIABLE(
"ErrM", particleInvariantMassError,
 
 1269                       "uncertainty of invariant mass\n\n", 
"GeV/:math:`\\text{c}^2`");
 
 1270     REGISTER_VARIABLE(
"SigM", particleInvariantMassSignificance,
 
 1271                       "signed deviation of particle's invariant mass from its nominal mass in units of the uncertainty on the invariant mass (:b2:var:`dM`/:b2:var:`ErrM`)");
 
 1273     REGISTER_VARIABLE(
"pxRecoil", recoilPx,
 
 1274                       "component x of 3-momentum recoiling against given Particle\n\n", 
"GeV/c");
 
 1275     REGISTER_VARIABLE(
"pyRecoil", recoilPy,
 
 1276                       "component y of 3-momentum recoiling against given Particle\n\n", 
"GeV/c");
 
 1277     REGISTER_VARIABLE(
"pzRecoil", recoilPz,
 
 1278                       "component z of 3-momentum recoiling against given Particle\n\n", 
"GeV/c");
 
 1280     REGISTER_VARIABLE(
"pRecoil", recoilMomentum,
 
 1281                       "magnitude of 3 - momentum recoiling against given Particle\n\n", 
"GeV/c");
 
 1282     REGISTER_VARIABLE(
"pRecoilTheta", recoilMomentumTheta,
 
 1283                       "Polar angle of a particle's missing momentum\n\n", 
"rad");
 
 1284     REGISTER_VARIABLE(
"pRecoilPhi", recoilMomentumPhi,
 
 1285                       "Azimuthal angle of a particle's missing momentum\n\n", 
"rad");
 
 1286     REGISTER_VARIABLE(
"eRecoil", recoilEnergy,
 
 1287                       "energy recoiling against given Particle\n\n", 
"GeV");
 
 1288     REGISTER_VARIABLE(
"mRecoil", recoilMass,
 
 1289                       "Invariant mass of the system recoiling against given Particle\n\n", 
"GeV/:math:`\\text{c}^2`");
 
 1290     REGISTER_VARIABLE(
"m2Recoil", recoilMassSquared,
 
 1291                       "invariant mass squared of the system recoiling against given Particle\n\n", 
":math:`[\\text{GeV}/\\text{c}^2]^2`");
 
 1292     REGISTER_VARIABLE(
"m2RecoilSignalSide", m2RecoilSignalSide, R
"DOC( 
 1293                        Squared recoil mass of the signal side which is calculated in the CMS frame under the assumption that the 
 1294                        signal and tag side are produced back to back and the tag side energy equals the beam energy. The variable 
 1295                        must be applied to the Upsilon and the tag side must be the first, the signal side the second daughter 
 1297                        )DOC", ":math:`[\\text{GeV}/\\text{c}^2]^2`");
 
 1299     REGISTER_VARIABLE(
"b2bTheta", b2bTheta,
 
 1300                       "Polar angle in the lab system that is back-to-back to the particle in the CMS. Useful for low multiplicity studies.\n\n", 
"rad");
 
 1301     REGISTER_VARIABLE(
"b2bPhi", b2bPhi,
 
 1302                       "Azimuthal angle in the lab system that is back-to-back to the particle in the CMS. Useful for low multiplicity studies.\n\n",
 
 1304     REGISTER_VARIABLE(
"b2bClusterTheta", b2bClusterTheta,
 
 1305                       "Polar angle in the lab system that is back-to-back to the particle's associated ECLCluster in the CMS. Returns NAN if no cluster is found. Useful for low multiplicity studies.\n\n",
 
 1307     REGISTER_VARIABLE(
"b2bClusterPhi", b2bClusterPhi,
 
 1308                       "Azimuthal angle in the lab system that is back-to-back to the particle's associated ECLCluster in the CMS. Returns NAN if no cluster is found. Useful for low multiplicity studies.\n\n",
 
 1310     REGISTER_VARIABLE(
"ArmenterosLongitudinalMomentumAsymmetry", ArmenterosLongitudinalMomentumAsymmetry,
 
 1311                       "Longitudinal momentum asymmetry of V0's daughters.\n" 
 1312                       "The mother (V0) is required to have exactly two daughters");
 
 1313     REGISTER_VARIABLE(
"ArmenterosDaughter1Qt", ArmenterosDaughter1Qt, R
"DOC( 
 1314                        Transverse momentum of the first daughter with respect to the V0 mother. 
 1315                        The mother is required to have exactly two daughters 
 1318     REGISTER_VARIABLE(
"ArmenterosDaughter2Qt", ArmenterosDaughter2Qt, R
"DOC( 
 1319                        Transverse momentum of the second daughter with respect to the V0 mother. 
 1320                        The mother is required to have exactly two daughters 
 1324     VARIABLE_GROUP(
"Miscellaneous");
 
 1325     REGISTER_VARIABLE(
"nRemainingTracksInEvent",  nRemainingTracksInEvent,
 
 1326                       "Number of tracks in the event - Number of tracks( = charged FSPs) of particle.");
 
 1327     REGISTER_VARIABLE(
"trackMatchType", trackMatchType, R
"DOC( 
 1329 * -1 particle has no ECL cluster 
 1330 *  0 particle has no associated track 
 1331 *  1 there is a matched track called connected - region(CR) track match 
 1335                      Use better variables like `trackNECLClusters`, `clusterTrackMatch`, and `nECLClusterTrackMatches`.)DOC"); 
 1337     REGISTER_VARIABLE("decayTypeRecoil", recoilMCDecayType,
 
 1338                       "type of the particle decay(no related mcparticle = -1, hadronic = 0, direct leptonic = 1, direct semileptonic = 2," 
 1339                       "lower level leptonic = 3.");
 
 1341     REGISTER_VARIABLE(
"printParticle", printParticle,
 
 1342                       "For debugging, print Particle and daughter PDG codes, plus MC match. Returns 0.");
 
 1343     REGISTER_VARIABLE(
"mcMomTransfer2", particleMCMomentumTransfer2,
 
 1344                       "Return the true momentum transfer to lepton pair in a B(semi -) leptonic B meson decay.\n\n", 
"GeV/c");
 
 1345     REGISTER_VARIABLE(
"False", False,
 
 1346                       "returns always 0, used for testing and debugging.");
 
 1347     REGISTER_VARIABLE(
"True", True,
 
 1348                       "returns always 1, used for testing and debugging.");
 
 1349     REGISTER_VARIABLE(
"infinity", infinity,
 
 1350                       "returns std::numeric_limits<double>::infinity()");
 
 1351     REGISTER_VARIABLE(
"random", random,
 
 1352                       "return a random number between 0 and 1 for each candidate. Can be used, e.g. for picking a random" 
 1353                       "candidate in the best candidate selection.");
 
 1354     REGISTER_VARIABLE(
"eventRandom", eventRandom,
 
 1355                       "[Eventbased] Returns a random number between 0 and 1 for this event. Can be used, e.g. for applying an event prescale.");
 
 1356     REGISTER_METAVARIABLE(
"minET2ETDist(detName, detLayer, referenceListName, useHighestProbMassForExt=1)", particleDistToClosestExtTrk,
 
 1357                           R
"DOC(Returns the distance :math:`d_{\mathrm{i}}` in [cm] between the particle and the nearest particle in the reference list at the given detector :math:`i`-th layer surface. 
 1358 The definition is based on the track helices extrapolation. 
 1360 * The first argument is the name of the detector to consider. 
 1361 * The second argument is the detector layer on whose surface we search for the nearest neighbour. 
 1362 * The third argument is the reference particle list name used to search for the nearest neighbour. 
 1363 * The fourth (optional) argument is an integer ("boolean") flag: if 1 (the default, if nothing is set), it is assumed the extrapolation was done with the most probable mass hypothesis for the track fit; 
 1364   if 0, it is assumed the mass hypothesis matching the particle lists' PDG was used. 
 1367     This variable requires to run the ``TrackIsoCalculator`` module first. 
 1368     Note that the choice of input parameters of this metafunction must correspond to the settings used to configure the module! 
 1370         Manager::VariableDataType::c_double); 
 1372     REGISTER_METAVARIABLE("minET2ETDistVar(detName, detLayer, referenceListName, variableName)", particleDistToClosestExtTrkVar,
 
 1373         R
"DOC(Returns the value of the variable for the nearest neighbour to this particle as taken from the reference list at the given detector :math:`i`-th layer surface 
 1374 , according to the distance definition of `minET2ETDist`. 
 1376 * The first argument is the name of the detector to consider. 
 1377 * The second argument is the detector layer on whose surface we search for the nearest neighbour. 
 1378 * The third argument is the reference particle list name used to search for the nearest neighbour. 
 1379 * The fourth argument is a variable name, e.g. `nCDCHits`. 
 1382     This variable requires to run the ``TrackIsoCalculator`` module first. 
 1383     Note that the choice of input parameters of this metafunction must correspond to the settings used to configure the module! 
 1385         Manager::VariableDataType::c_double); 
 1387     REGISTER_METAVARIABLE("minET2ETIsoScore(referenceListName, useHighestProbMassForExt, detectorList)", particleExtTrkIsoScoreVar,
 
 1388         R
"DOC(Returns a particle's isolation score :math:`s` defined as: 
 1395      s &= \sum_{\mathrm{det}} 1 - \left(-w_{\mathrm{det}} \cdot \frac{\sum_{i}^{N_{\mathrm{det}}^{\mathrm{layers}}} H(i)}{N_{\mathrm{det}}^{\mathrm{layers}}}\right), \\ 
 1399          0 & d_{\mathrm{i}} > D_{\mathrm{det}}^{\mathrm{thresh}} \\ 
 1400          1 & d_{\mathrm{i}} <= D_{\mathrm{det}}^{\mathrm{thresh}}, \\ 
 1405 where :math:`d_{\mathrm{i}}` is the distance to the closest neighbour at the :math:`i`-th layer of the given detector (c.f., `minET2ETDist`), :math:`N_{\mathrm{det}}^{\mathrm{layers}}` is the 
 1406 number of layers of the detector, :math:`D_{\mathrm{det}}^{\mathrm{thresh}}` is a threshold length related to the detector's granularity defined in the ``TrackIsoCalculator`` module, 
 1407 and :math:`w_{\mathrm{det}}` are (negative) weights associated to the detector's impact on PID for this particle type, read from a CDB payload. 
 1409 The score is normalised in [0, 1], where values closer to 1 indicates a well-isolated particle. 
 1411 * The first argument is the reference particle list name used to search for the nearest neighbour. 
 1412 * The second argument is an integer ("boolean") flag: if 1, it is assumed the extrapolation was done with the most probable mass hypothesis for the track fit; 
 1413   if 0, it is assumed the mass hypothesis matching the particle lists' PDG was used. 
 1414 * The remaining arguments are a comma-separated list of detector names, which must correspond to the one given to the `TrackIsoCalculator` module. 
 1417     The PID detector weights :math:`w_{\mathrm{det}}` are non-trivial only if ``excludePIDDetWeights=false`` in the ``TrackIsoCalculator`` module configuration. 
 1418     Otherwise :math:`w_{\mathrm{det}} = -1`. 
 1421     This variable requires to run the `TrackIsoCalculator` module first. 
 1422     Note that the choice of input parameters of this metafunction must correspond to the settings used to configure the module! 
 1425         Manager::VariableDataType::c_double); 
 1427     REGISTER_METAVARIABLE("minET2ETIsoScoreAsWeightedAvg(referenceListName, useHighestProbMassForExt, detectorList)", particleExtTrkIsoScoreVarAsWeightedAvg,
 
 1428         R
"DOC(Returns a particle's isolation score :math:`s` based on the weighted average: 
 1432    s = 1 - \frac{\sum_{\mathrm{det}} \sum_{i}^{N_{\mathrm{det}}^{\mathrm{layers}}} w_{\mathrm{det}} \cdot \frac{D_{\mathrm{det}}^{\mathrm{thresh}}}{d_{\mathrm{i}}} }{ \sum_{\mathrm{det}} w_{\mathrm{det}}}, 
 1434 where :math:`d_{\mathrm{i}}` is the distance to the closest neighbour at the :math:`i`-th layer of the given detector (c.f., `minET2ETDist`), :math:`N_{\mathrm{det}}^{\mathrm{layers}}` is the 
 1435 number of layers of the detector, :math:`D_{\mathrm{det}}^{\mathrm{thresh}}` is a threshold length related to the detector's granularity defined in the ``TrackIsoCalculator`` module, 
 1436 and :math:`w_{\mathrm{det}}` are (negative) weights associated to the detector's impact on PID for this particle type, read from a CDB payload. 
 1438 The score is normalised in [0, 1], where values closer to 1 indicates a well-isolated particle. 
 1440 * The first argument is the reference particle list name used to search for the nearest neighbour. 
 1441 * The second argument is an integer ("boolean") flag: if 1, it is assumed the extrapolation was done with the most probable mass hypothesis for the track fit; 
 1442   if 0, it is assumed the mass hypothesis matching the particle lists' PDG was used. 
 1443 * The remaining arguments are a comma-separated list of detector names, which must correspond to the one given to the `TrackIsoCalculator` module. 
 1446     The PID detector weights :math:`w_{\mathrm{det}}` are non-trivial only if ``excludePIDDetWeights=false`` in the ``TrackIsoCalculator`` module configuration. 
 1447     Otherwise :math:`\lvert w_{\mathrm{det}} \rvert = 1`. 
 1450     This variable requires to run the `TrackIsoCalculator` module first. 
 1451     Note that the choice of input parameters of this metafunction must correspond to the settings used to configure the module! 
 1454         Manager::VariableDataType::c_double); 
DataType Perp() const
The transverse component (R in cylindrical coordinate system).
const MCParticle * getMCParticle() const
Returns the pointer to the MCParticle object that was used to create this Particle (ParticleType == c...
Class to store variables with their name which were sent to the logging service.
#define MAKE_DEPRECATED(name, make_fatal, version, description)
Registers a variable as deprecated.
B2Vector3< double > B2Vector3D
typedef for common usage with double
Abstract base class for different kinds of events.