PandaRoot
KFParticleSIMD Class Reference

#include <KFParticleSIMD.h>

Inheritance diagram for KFParticleSIMD:
KFParticleBaseSIMD

Public Member Functions

 KFParticleSIMD ()
 
 ~KFParticleSIMD ()
 
 KFParticleSIMD (const KFParticleSIMD &d1, const KFParticleSIMD &d2, Bool_t gamma=false)
 
 KFParticleSIMD (const KFParticleSIMD &d1, const KFParticleSIMD &d2, const KFParticleSIMD &d3)
 
 KFParticleSIMD (const KFParticleSIMD &d1, const KFParticleSIMD &d2, const KFParticleSIMD &d3, const KFParticleSIMD &d4)
 
void Create (const fvec Param[], const fvec Cov[], fvec Charge, fvec mass)
 
 KFParticleSIMD (const KFPTrack &track, Int_t PID)
 
 KFParticleSIMD (const KFPTrack *track, Int_t PID)
 
 KFParticleSIMD (KFPTrack *Track[], int NTracks, Int_t *qHypo=nullptr, const Int_t *pdg=nullptr)
 
void Create (KFPTrack *Track[], int NTracks, Int_t *qHypo=nullptr, const Int_t *pdg=nullptr)
 
 KFParticleSIMD (KFPTrack &Track, Int_t *qHypo=nullptr, const Int_t *pdg=nullptr)
 
 KFParticleSIMD (const KFPVertex &vertex)
 
 KFParticleSIMD (KFParticle *part[], const int nPart=0)
 
 KFParticleSIMD (KFParticle &part)
 
void Initialize ()
 
void SetVtxGuess (fvec x, fvec y, fvec z)
 
fvec GetX () const
 
fvec GetY () const
 
fvec GetZ () const
 
fvec GetPx () const
 
fvec GetPy () const
 
fvec GetPz () const
 
fvec GetE () const
 
fvec GetS () const
 
fvec GetQ () const
 
fvec GetChi2 () const
 
fvec GetNDF () const
 
Bool_t GetAtProductionVertex () const
 
const fvecX () const
 
const fvecY () const
 
const fvecZ () const
 
const fvecPx () const
 
const fvecPy () const
 
const fvecPz () const
 
const fvecE () const
 
const fvecS () const
 
const fvecQ () const
 
const fvecChi2 () const
 
const fvecNDF () const
 
fvec GetParameter (int i) const
 
fvec GetCovariance (int i) const
 
fvec GetCovariance (int i, int j) const
 
fvec GetP () const
 
fvec GetPt () const
 
fvec GetEta () const
 
fvec GetPhi () const
 
fvec GetMomentum () const
 
fvec GetMass () const
 
fvec GetDecayLength () const
 
fvec GetDecayLengthXY () const
 
fvec GetLifeTime () const
 
fvec GetR () const
 
fvec GetErrX () const
 
fvec GetErrY () const
 
fvec GetErrZ () const
 
fvec GetErrPx () const
 
fvec GetErrPy () const
 
fvec GetErrPz () const
 
fvec GetErrE () const
 
fvec GetErrS () const
 
fvec GetErrP () const
 
fvec GetErrPt () const
 
fvec GetErrEta () const
 
fvec GetErrPhi () const
 
fvec GetErrMomentum () const
 
fvec GetErrMass () const
 
fvec GetErrDecayLength () const
 
fvec GetErrDecayLengthXY () const
 
fvec GetErrLifeTime () const
 
fvec GetErrR () const
 
fvec GetP (fvec &P, fvec &SigmaP) const
 
fvec GetPt (fvec &Pt, fvec &SigmaPt) const
 
fvec GetEta (fvec &Eta, fvec &SigmaEta) const
 
fvec GetPhi (fvec &Phi, fvec &SigmaPhi) const
 
fvec GetMomentum (fvec &P, fvec &SigmaP) const
 
fvec GetMass (fvec &M, fvec &SigmaM) const
 
fvec GetDecayLength (fvec &L, fvec &SigmaL) const
 
fvec GetDecayLengthXY (fvec &L, fvec &SigmaL) const
 
fvec GetLifeTime (fvec &T, fvec &SigmaT) const
 
fvec GetR (fvec &R, fvec &SigmaR) const
 
fvecX ()
 
fvecY ()
 
fvecZ ()
 
fvecPx ()
 
fvecPy ()
 
fvecPz ()
 
fvecE ()
 
fvecS ()
 
fvecQ ()
 
fvecChi2 ()
 
fvecNDF ()
 
fvecParameter (int i)
 
fvecCovariance (int i)
 
fvecCovariance (int i, int j)
 
fvecParameters ()
 
fvecCovarianceMatrix ()
 
void GetKFParticle (KFParticle &Part, int iPart=0)
 
void GetKFParticle (KFParticle *Part, int nPart=0)
 
void AddDaughter (const KFParticleSIMD &Daughter)
 
void operator+= (const KFParticleSIMD &Daughter)
 
void SetProductionVertex (const KFParticleSIMD &Vtx)
 
void SetMassConstraint (fvec Mass, fvec SigmaMass=0)
 
void SetNoDecayLength ()
 
void Construct (const KFParticleSIMD *vDaughters[], int nDaughters, const KFParticleSIMD *ProdVtx=nullptr, Float_t Mass=-1, Bool_t IsConstrained=0, Bool_t isAtVtxGuess=0)
 
void TransportToDecayVertex ()
 
void TransportToProductionVertex ()
 
void TransportToPoint (const fvec xyz[])
 
void TransportToVertex (const KFPVertex &v)
 
void TransportToParticle (const KFParticleSIMD &p)
 
void TransportToDS (fvec dS)
 
fvec GetDStoPoint (const fvec xyz[]) const
 
void GetDStoParticle (const KFParticleSIMD &p, fvec &DS, fvec &DSp) const
 
void GetDStoParticleXY (const KFParticleBaseSIMD &p, fvec &DS, fvec &DSp) const
 
fvec GetDistanceFromVertex (const fvec vtx[]) const
 
fvec GetDistanceFromVertex (const KFParticleSIMD &Vtx) const
 
fvec GetDistanceFromVertex (const KFPVertex &Vtx) const
 
fvec GetDistanceFromParticle (const KFParticleSIMD &p) const
 
fvec GetDeviationFromVertex (const fvec v[], const fvec Cv[]=0) const
 
fvec GetDeviationFromVertex (const KFParticleSIMD &Vtx) const
 
fvec GetDeviationFromVertex (const KFPVertex &Vtx) const
 
fvec GetDeviationFromParticle (const KFParticleSIMD &p) const
 
fvec GetDistanceFromVertexXY (const fvec vtx[], fvec &val, fvec &err) const
 
fvec GetDistanceFromVertexXY (const fvec vtx[], const fvec Cv[], fvec &val, fvec &err) const
 
fvec GetDistanceFromVertexXY (const KFParticleSIMD &Vtx, fvec &val, fvec &err) const
 
fvec GetDistanceFromVertexXY (const KFPVertex &Vtx, fvec &val, fvec &err) const
 
fvec GetDistanceFromVertexXY (const fvec vtx[]) const
 
fvec GetDistanceFromVertexXY (const KFParticleSIMD &Vtx) const
 
fvec GetDistanceFromVertexXY (const KFPVertex &Vtx) const
 
fvec GetDistanceFromParticleXY (const KFParticleSIMD &p) const
 
fvec GetDeviationFromVertexXY (const fvec v[], const fvec Cv[]=0) const
 
fvec GetDeviationFromVertexXY (const KFParticleSIMD &Vtx) const
 
fvec GetDeviationFromVertexXY (const KFPVertex &Vtx) const
 
fvec GetDeviationFromParticleXY (const KFParticleSIMD &p) const
 
fvec GetAngle (const KFParticleSIMD &p) const
 
fvec GetAngleXY (const KFParticleSIMD &p) const
 
fvec GetAngleRZ (const KFParticleSIMD &p) const
 
void SubtractFromVertex (KFParticleSIMD &v) const
 
void SubtractFromParticle (KFParticleSIMD &v) const
 
void ConstructGamma (const KFParticleSIMD &daughter1, const KFParticleSIMD &daughter2)
 
fvec GetPseudoProperDecayTime (const KFParticleSIMD &primVertex, const fvec &mass, fvec *timeErr2=0) const
 
void GetFieldValue (const fvec xyz[], fvec B[]) const
 
- Public Member Functions inherited from KFParticleBaseSIMD
 KFParticleBaseSIMD ()
 
virtual ~KFParticleBaseSIMD ()
 
void Initialize (const fvec Param[], const fvec Cov[], fvec Charge, fvec Mass)
 
void Initialize ()
 
void SetVtxGuess (fvec x, fvec y, fvec z)
 
void SetVtxErrGuess (fvec &x, fvec &y, fvec &z)
 
void SetConstructMethod (Int_t m)
 
void SetMassHypo (fvec m)
 
const fvecGetMassHypo () const
 
const fvecGetSumDaughterMass () const
 
fvec GetX () const
 
fvec GetY () const
 
fvec GetZ () const
 
fvec GetPx () const
 
fvec GetPy () const
 
fvec GetPz () const
 
fvec GetE () const
 
fvec GetS () const
 
fvec GetQ () const
 
fvec GetChi2 () const
 
fvec GetNDF () const
 
const fvecX () const
 
const fvecY () const
 
const fvecZ () const
 
const fvecPx () const
 
const fvecPy () const
 
const fvecPz () const
 
const fvecE () const
 
const fvecS () const
 
const fvecQ () const
 
const fvecChi2 () const
 
const fvecNDF () const
 
fvec GetParameter (Int_t i) const
 
fvec GetCovariance (Int_t i) const
 
fvec GetCovariance (Int_t i, Int_t j) const
 
fvec GetMomentum (fvec &P, fvec &SigmaP) const
 
fvec GetPt (fvec &Pt, fvec &SigmaPt) const
 
fvec GetEta (fvec &Eta, fvec &SigmaEta) const
 
fvec GetPhi (fvec &Phi, fvec &SigmaPhi) const
 
fvec GetMass (fvec &M, fvec &SigmaM) const
 
fvec GetDecayLength (fvec &L, fvec &SigmaL) const
 
fvec GetDecayLengthXY (fvec &L, fvec &SigmaL) const
 
fvec GetLifeTime (fvec &T, fvec &SigmaT) const
 
fvec GetR (fvec &R, fvec &SigmaR) const
 
fvecX ()
 
fvecY ()
 
fvecZ ()
 
fvecPx ()
 
fvecPy ()
 
fvecPz ()
 
fvecE ()
 
fvecS ()
 
fvecQ ()
 
fvecChi2 ()
 
fvecNDF ()
 
fvecParameter (Int_t i)
 
fvecCovariance (Int_t i)
 
fvecCovariance (Int_t i, Int_t j)
 
void operator+= (const KFParticleBaseSIMD &Daughter)
 
void AddDaughter (const KFParticleBaseSIMD &Daughter, Bool_t isAtVtxGuess=0)
 
void AddDaughterWithEnergyFit (const KFParticleBaseSIMD &Daughter, Bool_t isAtVtxGuess)
 
void AddDaughterWithEnergyCalc (const KFParticleBaseSIMD &Daughter, Bool_t isAtVtxGuess)
 
void AddDaughterWithEnergyFitMC (const KFParticleBaseSIMD &Daughter, Bool_t isAtVtxGuess)
 
void SetProductionVertex (const KFParticleBaseSIMD &Vtx)
 
void SetNonlinearMassConstraint (fvec Mass)
 
void SetMassConstraint (fvec Mass, fvec SigmaMass=0)
 
void SetNoDecayLength ()
 
void Construct (const KFParticleBaseSIMD *vDaughters[], Int_t nDaughters, const KFParticleBaseSIMD *ProdVtx=nullptr, Float_t Mass=-1, Bool_t IsConstrained=0, Bool_t isAtVtxGuess=0)
 
void TransportToDecayVertex ()
 
void TransportToProductionVertex ()
 
void TransportToDS (fvec dS)
 
fvec GetDStoPointBz (fvec Bz, const fvec xyz[]) const
 
fvec GetDStoPointBy (fvec By, const fvec xyz[]) const
 
void GetDStoParticleBz (fvec Bz, const KFParticleBaseSIMD &p, fvec &dS, fvec &dS1) const
 
void GetDStoParticleBy (fvec B, const KFParticleBaseSIMD &p, fvec &dS, fvec &dS1) const
 
fvec GetDStoPointCBM (const fvec xyz[]) const
 
void GetDStoParticleCBM (const KFParticleBaseSIMD &p, fvec &dS, fvec &dS1) const
 
void TransportBz (fvec Bz, fvec dS, fvec P[], fvec C[]) const
 
void TransportCBM (fvec dS, fvec P[], fvec C[]) const
 
fvec GetDistanceFromVertex (const fvec vtx[]) const
 
fvec GetDistanceFromVertex (const KFParticleBaseSIMD &Vtx) const
 
fvec GetDistanceFromParticle (const KFParticleBaseSIMD &p) const
 
fvec GetDeviationFromVertex (const fvec v[], const fvec Cv[]=0) const
 
fvec GetDeviationFromVertex (const KFParticleBaseSIMD &Vtx) const
 
fvec GetDeviationFromParticle (const KFParticleBaseSIMD &p) const
 
void SubtractFromVertex (KFParticleBaseSIMD &Vtx) const
 
void SubtractFromParticle (KFParticleBaseSIMD &Vtx) const
 
void ConstructGammaBz (const KFParticleBaseSIMD &daughter1, const KFParticleBaseSIMD &daughter2, fvec Bz)
 
void RotateXY (fvec angle, fvec Vtx[3])
 
fvec Id () const
 
int NDaughters () const
 
std::vector< fvec > & DaughterIds ()
 
fvec GetDaughterId (int iD) const
 
void SetId (fvec id)
 
void SetNDaughters (int n)
 
void AddDaughterId (fvec id)
 
void CleanDaughtersId ()
 
void SetPDG (int pdg)
 
const int & GetPDG () const
 
void GetDistanceToVertexLine (const KFParticleBaseSIMD &Vertex, fvec &l, fvec &dl, fvec *isParticleFromVertex=nullptr) const
 

Static Public Member Functions

static void SetField (fvec Bz)
 
- Static Public Member Functions inherited from KFParticleBaseSIMD
static void GetArmenterosPodolanski (KFParticleBaseSIMD &positive, KFParticleBaseSIMD &negative, fvec QtAlfa[2])
 

Protected Member Functions

void GetDStoParticle (const KFParticleBaseSIMD &p, fvec &DS, fvec &DSp) const
 
void Transport (fvec dS, fvec P[], fvec C[]) const
 
- Protected Member Functions inherited from KFParticleBaseSIMD
fvecCij (Int_t i, Int_t j)
 
void Convert (bool ToProduction)
 
void TransportLine (fvec S, fvec P[], fvec C[]) const
 
fvec GetDStoPointLine (const fvec xyz[]) const
 
void GetDStoParticleLine (const KFParticleBaseSIMD &p, fvec &dS, fvec &dS1) const
 
void GetDSIter (const KFParticleBaseSIMD &p, fvec const &dS, fvec x[3], fvec dx[3], fvec ddx[3]) const
 
fvec GetSCorrection (const fvec Part[], const fvec XYZ[]) const
 
void GetMeasurement (const fvec XYZ[], fvec m[], fvec V[], Bool_t isAtVtxGuess=0) const
 
void SetMassConstraint (fvec *mP, fvec *mC, fvec mJ[7][7], fvec mass, fvec mask)
 

Static Protected Member Functions

static fvec GetFieldAlice ()
 
static void GetExternalTrackParam (const KFParticleBaseSIMD &p, Double_t X[fvecLen], Double_t Alpha[fvecLen], Double_t P[5][fvecLen])
 
- Static Protected Member Functions inherited from KFParticleBaseSIMD
static Int_t IJ (Int_t i, Int_t j)
 
static fvec InvertSym3 (const fvec A[], fvec Ainv[])
 
static void InvertCholetsky3 (fvec a[6])
 
static void MultQSQt (const fvec Q[], const fvec S[], fvec SOut[])
 
static void multQSQt1 (const fvec J[11], fvec S[])
 

Additional Inherited Members

- Protected Attributes inherited from KFParticleBaseSIMD
fvec fP [8]
 
fvec fC [36]
 
fvec fQ
 
fvec fNDF
 
fvec fChi2
 
fvec fSFromDecay
 
Bool_t fAtProductionVertex
 
Bool_t fIsVtxGuess
 
Bool_t fIsVtxErrGuess
 
fvec fVtxGuess [3]
 
fvec fVtxErrGuess [3]
 
Bool_t fIsLinearized
 
Int_t fConstructMethod
 
fvec SumDaughterMass
 
fvec fMassHypo
 
fvec fId
 
std::vector< fvecfDaughterIds
 
int fPDG
 

Detailed Description

Definition at line 39 of file KFParticleSIMD.h.

Constructor & Destructor Documentation

◆ KFParticleSIMD() [1/11]

KFParticleSIMD::KFParticleSIMD ( )
inline

◆ ~KFParticleSIMD()

KFParticleSIMD::~KFParticleSIMD ( )
inline

◆ KFParticleSIMD() [2/11]

KFParticleSIMD::KFParticleSIMD ( const KFParticleSIMD d1,
const KFParticleSIMD d2,
Bool_t  gamma = false 
)

◆ KFParticleSIMD() [3/11]

KFParticleSIMD::KFParticleSIMD ( const KFParticleSIMD d1,
const KFParticleSIMD d2,
const KFParticleSIMD d3 
)
inline

Definition at line 402 of file KFParticleSIMD.h.

403 {
404  KFParticleSIMD mother;
405  mother += d1;
406  mother += d2;
407  mother += d3;
408  *this = mother;
409 }

◆ KFParticleSIMD() [4/11]

KFParticleSIMD::KFParticleSIMD ( const KFParticleSIMD d1,
const KFParticleSIMD d2,
const KFParticleSIMD d3,
const KFParticleSIMD d4 
)
inline

Definition at line 411 of file KFParticleSIMD.h.

412 {
413  KFParticleSIMD mother;
414  mother += d1;
415  mother += d2;
416  mother += d3;
417  mother += d4;
418  *this = mother;
419 }

◆ KFParticleSIMD() [5/11]

KFParticleSIMD::KFParticleSIMD ( const KFPTrack track,
Int_t  PID 
)

◆ KFParticleSIMD() [6/11]

KFParticleSIMD::KFParticleSIMD ( const KFPTrack track,
Int_t  PID 
)

◆ KFParticleSIMD() [7/11]

KFParticleSIMD::KFParticleSIMD ( KFPTrack Track[],
int  NTracks,
Int_t *  qHypo = nullptr,
const Int_t *  pdg = nullptr 
)

◆ KFParticleSIMD() [8/11]

KFParticleSIMD::KFParticleSIMD ( KFPTrack Track,
Int_t *  qHypo = nullptr,
const Int_t *  pdg = nullptr 
)

◆ KFParticleSIMD() [9/11]

KFParticleSIMD::KFParticleSIMD ( const KFPVertex vertex)

◆ KFParticleSIMD() [10/11]

KFParticleSIMD::KFParticleSIMD ( KFParticle part[],
const int  nPart = 0 
)

◆ KFParticleSIMD() [11/11]

KFParticleSIMD::KFParticleSIMD ( KFParticle part)

Member Function Documentation

◆ AddDaughter()

void KFParticleSIMD::AddDaughter ( const KFParticleSIMD Daughter)
inline

Definition at line 836 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::AddDaughter().

Referenced by NDF().

837 {
839 }
void AddDaughter(const KFParticleBaseSIMD &Daughter, Bool_t isAtVtxGuess=0)

◆ Chi2() [1/2]

const fvec& KFParticleSIMD::Chi2 ( ) const
inline

Definition at line 139 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::fChi2.

Referenced by NDF().

139 { return fChi2; }

◆ Chi2() [2/2]

fvec & KFParticleSIMD::Chi2 ( )
inline

Definition at line 796 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::Chi2().

797 {
798  return KFParticleBaseSIMD::Chi2();
799 }
const fvec & Chi2() const

◆ Construct()

void KFParticleSIMD::Construct ( const KFParticleSIMD vDaughters[],
int  nDaughters,
const KFParticleSIMD ProdVtx = nullptr,
Float_t  Mass = -1,
Bool_t  IsConstrained = 0,
Bool_t  isAtVtxGuess = 0 
)
inline

Definition at line 856 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::Construct(), and KFParticleBaseSIMD::fP.

Referenced by NDF().

857 {
858  KFParticleBaseSIMD::Construct((const KFParticleBaseSIMD **)vDaughters, nDaughters, (const KFParticleBaseSIMD *)ProdVtx, Mass, IsConstrained, isAtVtxGuess);
859 
860 #ifdef NonhomogeneousField
861  // calculate a field region for the constructed particle
862  L1FieldValue field[3];
863  fvec zField[3] = {0, fP[2] / 2, fP[2]};
864 
865  for (int iPoint = 0; iPoint < 3; iPoint++) {
866  for (int iD = 0; iD < nDaughters; ++iD) {
867  L1FieldValue b = const_cast<KFParticleSIMD *>(vDaughters[iD])->fField.Get(zField[iPoint]);
868  field[iPoint].x += b.x;
869  field[iPoint].y += b.y;
870  field[iPoint].z += b.z;
871  }
872  field[iPoint].x /= nDaughters;
873  field[iPoint].y /= nDaughters;
874  field[iPoint].z /= nDaughters;
875  }
876 
877  fField.Set(field[2], zField[2], field[1], zField[1], field[0], zField[0]);
878 #endif
879 }
void Construct(const KFParticleBaseSIMD *vDaughters[], Int_t nDaughters, const KFParticleBaseSIMD *ProdVtx=nullptr, Float_t Mass=-1, Bool_t IsConstrained=0, Bool_t isAtVtxGuess=0)

◆ ConstructGamma()

void KFParticleSIMD::ConstructGamma ( const KFParticleSIMD daughter1,
const KFParticleSIMD daughter2 
)
inline

Definition at line 1029 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::ConstructGammaBz(), and GetFieldAlice().

Referenced by NDF().

1030 {
1031 #ifdef HomogeneousField
1032  KFParticleBaseSIMD::ConstructGammaBz(daughter1, daughter2, GetFieldAlice());
1033 #endif
1034 }
void ConstructGammaBz(const KFParticleBaseSIMD &daughter1, const KFParticleBaseSIMD &daughter2, fvec Bz)
static fvec GetFieldAlice()

◆ Covariance() [1/2]

fvec & KFParticleSIMD::Covariance ( int  i)
inline

Definition at line 811 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::Covariance().

Referenced by NDF().

812 {
814 }
unsigned int i
Definition: P4_F32vec4.h:21
fvec & Covariance(Int_t i)

◆ Covariance() [2/2]

fvec & KFParticleSIMD::Covariance ( int  i,
int  j 
)
inline

Definition at line 816 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::Covariance().

817 {
819 }
unsigned int i
Definition: P4_F32vec4.h:21
fvec & Covariance(Int_t i)

◆ CovarianceMatrix()

fvec * KFParticleSIMD::CovarianceMatrix ( )
inline

Definition at line 826 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::fC.

Referenced by NDF().

827 {
828  return fC;
829 }

◆ Create() [1/2]

void KFParticleSIMD::Create ( const fvec  Param[],
const fvec  Cov[],
fvec  Charge,
fvec  mass 
)

Referenced by ~KFParticleSIMD().

◆ Create() [2/2]

void KFParticleSIMD::Create ( KFPTrack Track[],
int  NTracks,
Int_t *  qHypo = nullptr,
const Int_t *  pdg = nullptr 
)

◆ E() [1/2]

const fvec& KFParticleSIMD::E ( ) const
inline

Definition at line 136 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::fP.

Referenced by NDF().

136 { return fP[6]; }

◆ E() [2/2]

fvec & KFParticleSIMD::E ( )
inline

Definition at line 781 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::E().

782 {
783  return KFParticleBaseSIMD::E();
784 }
const fvec & E() const

◆ GetAngle()

fvec KFParticleSIMD::GetAngle ( const KFParticleSIMD p) const

Referenced by NDF().

◆ GetAngleRZ()

fvec KFParticleSIMD::GetAngleRZ ( const KFParticleSIMD p) const

Referenced by NDF().

◆ GetAngleXY()

fvec KFParticleSIMD::GetAngleXY ( const KFParticleSIMD p) const

Referenced by NDF().

◆ GetAtProductionVertex()

Bool_t KFParticleSIMD::GetAtProductionVertex ( ) const
inline

Definition at line 128 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::fAtProductionVertex.

128 { return fAtProductionVertex; }

◆ GetChi2()

fvec KFParticleSIMD::GetChi2 ( ) const
inline

Definition at line 476 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetChi2().

Referenced by ~KFParticleSIMD().

477 {
479 }

◆ GetCovariance() [1/2]

fvec KFParticleSIMD::GetCovariance ( int  i) const
inline

Definition at line 491 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetCovariance().

Referenced by GetErrE(), GetErrPx(), GetErrPy(), GetErrPz(), GetErrS(), GetErrX(), GetErrY(), GetErrZ(), and NDF().

492 {
494 }
unsigned int i
Definition: P4_F32vec4.h:21
fvec GetCovariance(Int_t i) const

◆ GetCovariance() [2/2]

fvec KFParticleSIMD::GetCovariance ( int  i,
int  j 
) const
inline

Definition at line 496 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetCovariance().

497 {
499 }
unsigned int i
Definition: P4_F32vec4.h:21
fvec GetCovariance(Int_t i) const

◆ GetDecayLength() [1/2]

fvec KFParticleSIMD::GetDecayLength ( ) const
inline

Definition at line 543 of file KFParticleSIMD.h.

Referenced by GetErrDecayLength(), and NDF().

544 {
545  fvec par, err;
546  fvec mask = KFParticleSIMD::GetDecayLength(par, err);
547  return ((!mask) & par);
548 }
fvec GetDecayLength() const

◆ GetDecayLength() [2/2]

fvec KFParticleSIMD::GetDecayLength ( fvec L,
fvec SigmaL 
) const
inline

Definition at line 731 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetDecayLength().

732 {
733  return KFParticleBaseSIMD::GetDecayLength(L, SigmaL);
734 }
fvec GetDecayLength(fvec &L, fvec &SigmaL) const

◆ GetDecayLengthXY() [1/2]

fvec KFParticleSIMD::GetDecayLengthXY ( ) const
inline

Definition at line 550 of file KFParticleSIMD.h.

Referenced by GetErrDecayLengthXY(), and NDF().

551 {
552  fvec par, err;
553  fvec mask = KFParticleSIMD::GetDecayLengthXY(par, err);
554  return ((!mask) & par);
555 }
fvec GetDecayLengthXY() const

◆ GetDecayLengthXY() [2/2]

fvec KFParticleSIMD::GetDecayLengthXY ( fvec L,
fvec SigmaL 
) const
inline

Definition at line 736 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetDecayLengthXY().

737 {
738  return KFParticleBaseSIMD::GetDecayLengthXY(L, SigmaL);
739 }
fvec GetDecayLengthXY(fvec &L, fvec &SigmaL) const

◆ GetDeviationFromParticle()

fvec KFParticleSIMD::GetDeviationFromParticle ( const KFParticleSIMD p) const
inline

Definition at line 963 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetDeviationFromParticle().

Referenced by NDF().

964 {
966 }
fvec GetDeviationFromParticle(const KFParticleBaseSIMD &p) const

◆ GetDeviationFromParticleXY()

fvec KFParticleSIMD::GetDeviationFromParticleXY ( const KFParticleSIMD p) const

Referenced by NDF().

◆ GetDeviationFromVertex() [1/3]

fvec KFParticleSIMD::GetDeviationFromVertex ( const fvec  v[],
const fvec  Cv[] = 0 
) const
inline

Definition at line 933 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetDeviationFromVertex().

Referenced by GetDeviationFromVertex(), and NDF().

934 {
936 }
fvec GetDeviationFromVertex(const fvec v[], const fvec Cv[]=0) const

◆ GetDeviationFromVertex() [2/3]

fvec KFParticleSIMD::GetDeviationFromVertex ( const KFParticleSIMD Vtx) const
inline

Definition at line 943 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetDeviationFromVertex().

944 {
946 }
fvec GetDeviationFromVertex(const fvec v[], const fvec Cv[]=0) const

◆ GetDeviationFromVertex() [3/3]

fvec KFParticleSIMD::GetDeviationFromVertex ( const KFPVertex Vtx) const
inline

Definition at line 953 of file KFParticleSIMD.h.

References GetDeviationFromVertex(), and KFParticleSIMD().

954 {
956 }
fvec GetDeviationFromVertex(const fvec v[], const fvec Cv[]=0) const

◆ GetDeviationFromVertexXY() [1/3]

fvec KFParticleSIMD::GetDeviationFromVertexXY ( const fvec  v[],
const fvec  Cv[] = 0 
) const

Referenced by NDF().

◆ GetDeviationFromVertexXY() [2/3]

fvec KFParticleSIMD::GetDeviationFromVertexXY ( const KFParticleSIMD Vtx) const

◆ GetDeviationFromVertexXY() [3/3]

fvec KFParticleSIMD::GetDeviationFromVertexXY ( const KFPVertex Vtx) const

◆ GetDistanceFromParticle()

fvec KFParticleSIMD::GetDistanceFromParticle ( const KFParticleSIMD p) const
inline

Definition at line 958 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetDistanceFromParticle().

Referenced by NDF().

959 {
961 }
fvec GetDistanceFromParticle(const KFParticleBaseSIMD &p) const

◆ GetDistanceFromParticleXY()

fvec KFParticleSIMD::GetDistanceFromParticleXY ( const KFParticleSIMD p) const

Referenced by NDF().

◆ GetDistanceFromVertex() [1/3]

fvec KFParticleSIMD::GetDistanceFromVertex ( const fvec  vtx[]) const
inline

Definition at line 928 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetDistanceFromVertex().

Referenced by GetDistanceFromVertex(), and NDF().

929 {
931 }
fvec GetDistanceFromVertex(const fvec vtx[]) const

◆ GetDistanceFromVertex() [2/3]

fvec KFParticleSIMD::GetDistanceFromVertex ( const KFParticleSIMD Vtx) const
inline

Definition at line 938 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetDistanceFromVertex().

939 {
941 }
fvec GetDistanceFromVertex(const fvec vtx[]) const

◆ GetDistanceFromVertex() [3/3]

fvec KFParticleSIMD::GetDistanceFromVertex ( const KFPVertex Vtx) const
inline

Definition at line 948 of file KFParticleSIMD.h.

References GetDistanceFromVertex(), and KFParticleSIMD().

949 {
951 }
fvec GetDistanceFromVertex(const fvec vtx[]) const

◆ GetDistanceFromVertexXY() [1/7]

fvec KFParticleSIMD::GetDistanceFromVertexXY ( const fvec  vtx[],
fvec val,
fvec err 
) const

Referenced by NDF().

◆ GetDistanceFromVertexXY() [2/7]

fvec KFParticleSIMD::GetDistanceFromVertexXY ( const fvec  vtx[],
const fvec  Cv[],
fvec val,
fvec err 
) const

◆ GetDistanceFromVertexXY() [3/7]

fvec KFParticleSIMD::GetDistanceFromVertexXY ( const KFParticleSIMD Vtx,
fvec val,
fvec err 
) const

◆ GetDistanceFromVertexXY() [4/7]

fvec KFParticleSIMD::GetDistanceFromVertexXY ( const KFPVertex Vtx,
fvec val,
fvec err 
) const

◆ GetDistanceFromVertexXY() [5/7]

fvec KFParticleSIMD::GetDistanceFromVertexXY ( const fvec  vtx[]) const

◆ GetDistanceFromVertexXY() [6/7]

fvec KFParticleSIMD::GetDistanceFromVertexXY ( const KFParticleSIMD Vtx) const

◆ GetDistanceFromVertexXY() [7/7]

fvec KFParticleSIMD::GetDistanceFromVertexXY ( const KFPVertex Vtx) const

◆ GetDStoParticle() [1/2]

void KFParticleSIMD::GetDStoParticle ( const KFParticleSIMD p,
fvec DS,
fvec DSp 
) const
inline

Definition at line 923 of file KFParticleSIMD.h.

References GetDStoParticleXY().

Referenced by NDF(), and TransportToParticle().

924 {
925  GetDStoParticleXY(p, DS, DSp);
926 }
void GetDStoParticleXY(const KFParticleBaseSIMD &p, fvec &DS, fvec &DSp) const

◆ GetDStoParticle() [2/2]

void KFParticleSIMD::GetDStoParticle ( const KFParticleBaseSIMD p,
fvec DS,
fvec DSp 
) const
inlineprotectedvirtual

Implements KFParticleBaseSIMD.

Definition at line 1003 of file KFParticleSIMD.h.

References GetDStoParticleXY().

1004 {
1005  GetDStoParticleXY(p, DS, DSp);
1006 }
void GetDStoParticleXY(const KFParticleBaseSIMD &p, fvec &DS, fvec &DSp) const

◆ GetDStoParticleXY()

void KFParticleSIMD::GetDStoParticleXY ( const KFParticleBaseSIMD p,
fvec DS,
fvec DSp 
) const
inline

Definition at line 1008 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetDStoParticleBz(), KFParticleBaseSIMD::GetDStoParticleCBM(), and GetFieldAlice().

Referenced by GetDStoParticle(), and NDF().

1009 {
1010 #ifdef HomogeneousField
1012 #endif
1013 #ifdef NonhomogeneousField
1015 #endif
1016  // GetDStoParticleALICE( p, DS, DSp ) ;
1017 }
void GetDStoParticleBz(fvec Bz, const KFParticleBaseSIMD &p, fvec &dS, fvec &dS1) const
static fvec GetFieldAlice()
void GetDStoParticleCBM(const KFParticleBaseSIMD &p, fvec &dS, fvec &dS1) const

◆ GetDStoPoint()

fvec KFParticleSIMD::GetDStoPoint ( const fvec  xyz[]) const
inlinevirtual

Implements KFParticleBaseSIMD.

Definition at line 913 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetDStoPointBz(), KFParticleBaseSIMD::GetDStoPointCBM(), and GetFieldAlice().

Referenced by NDF(), and TransportToPoint().

914 {
915 #ifdef HomogeneousField
917 #endif
918 #ifdef NonhomogeneousField
920 #endif
921 }
static fvec GetFieldAlice()
fvec GetDStoPointCBM(const fvec xyz[]) const
fvec GetDStoPointBz(fvec Bz, const fvec xyz[]) const

◆ GetE()

fvec KFParticleSIMD::GetE ( ) const
inline

Definition at line 461 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetE().

Referenced by ~KFParticleSIMD().

462 {
463  return KFParticleBaseSIMD::GetE();
464 }

◆ GetErrDecayLength()

fvec KFParticleSIMD::GetErrDecayLength ( ) const
inline

Definition at line 665 of file KFParticleSIMD.h.

References GetDecayLength().

Referenced by NDF().

666 {
667  fvec par, err;
668  fvec mask = KFParticleSIMD::GetDecayLength(par, err);
669  fvec ret(1.e10);
670  ret = (mask & ret) + ((!mask) & err);
671  return ret;
672 }
fvec GetDecayLength() const

◆ GetErrDecayLengthXY()

fvec KFParticleSIMD::GetErrDecayLengthXY ( ) const
inline

Definition at line 674 of file KFParticleSIMD.h.

References GetDecayLengthXY().

Referenced by NDF().

675 {
676  fvec par, err;
677  fvec mask = KFParticleSIMD::GetDecayLengthXY(par, err);
678  fvec ret(1.e10);
679  ret = (mask & ret) + ((!mask) & err);
680  return ret;
681 }
fvec GetDecayLengthXY() const

◆ GetErrE()

fvec KFParticleSIMD::GetErrE ( ) const
inline

Definition at line 601 of file KFParticleSIMD.h.

References fabs(), GetCovariance(), and sqrt().

Referenced by NDF().

602 {
603  return sqrt(fabs(GetCovariance(6, 6)));
604 }
fvec GetCovariance(int i) const
friend F32vec4 sqrt(const F32vec4 &a)
Definition: P4_F32vec4.h:28
friend F32vec4 fabs(const F32vec4 &a)
Definition: P4_F32vec4.h:46

◆ GetErrEta()

fvec KFParticleSIMD::GetErrEta ( ) const
inline

Definition at line 629 of file KFParticleSIMD.h.

References GetEta().

Referenced by NDF().

630 {
631  fvec par, err;
632  fvec mask = KFParticleSIMD::GetEta(par, err);
633  fvec ret(1.e10);
634  ret = (mask & ret) + ((!mask) & err);
635  return ret;
636 }
fvec GetEta() const

◆ GetErrLifeTime()

fvec KFParticleSIMD::GetErrLifeTime ( ) const
inline

Definition at line 683 of file KFParticleSIMD.h.

References GetLifeTime().

Referenced by NDF().

684 {
685  fvec par, err;
686  fvec mask = KFParticleSIMD::GetLifeTime(par, err);
687  fvec ret(1.e10);
688  ret = (mask & ret) + ((!mask) & err);
689  return ret;
690 }
fvec GetLifeTime() const

◆ GetErrMass()

fvec KFParticleSIMD::GetErrMass ( ) const
inline

Definition at line 656 of file KFParticleSIMD.h.

References GetMass().

Referenced by NDF().

657 {
658  fvec par, err;
659  fvec mask = KFParticleSIMD::GetMass(par, err);
660  fvec ret(1.e10);
661  ret = (mask & ret) + ((!mask) & err);
662  return ret;
663 }
fvec GetMass() const

◆ GetErrMomentum()

fvec KFParticleSIMD::GetErrMomentum ( ) const
inline

Definition at line 647 of file KFParticleSIMD.h.

References GetMomentum().

Referenced by NDF().

648 {
649  fvec par, err;
650  fvec mask = KFParticleSIMD::GetMomentum(par, err);
651  fvec ret(1.e10);
652  ret = (mask & ret) + ((!mask) & err);
653  return ret;
654 }
fvec GetMomentum() const

◆ GetErrP()

fvec KFParticleSIMD::GetErrP ( ) const
inline

Definition at line 611 of file KFParticleSIMD.h.

References GetMomentum().

Referenced by NDF().

612 {
613  fvec par, err;
614  fvec mask = KFParticleSIMD::GetMomentum(par, err);
615  fvec ret(1.e10);
616  ret = (mask & ret) + ((!mask) & err);
617  return ret;
618 }
fvec GetMomentum() const

◆ GetErrPhi()

fvec KFParticleSIMD::GetErrPhi ( ) const
inline

Definition at line 638 of file KFParticleSIMD.h.

References GetPhi().

Referenced by NDF().

639 {
640  fvec par, err;
641  fvec mask = KFParticleSIMD::GetPhi(par, err);
642  fvec ret(1.e10);
643  ret = (mask & ret) + ((!mask) & err);
644  return ret;
645 }
fvec GetPhi() const

◆ GetErrPt()

fvec KFParticleSIMD::GetErrPt ( ) const
inline

Definition at line 620 of file KFParticleSIMD.h.

References GetPt().

Referenced by NDF().

621 {
622  fvec par, err;
623  fvec mask = KFParticleSIMD::GetPt(par, err);
624  fvec ret(1.e10);
625  ret = (mask & ret) + ((!mask) & err);
626  return ret;
627 }
fvec GetPt() const

◆ GetErrPx()

fvec KFParticleSIMD::GetErrPx ( ) const
inline

Definition at line 586 of file KFParticleSIMD.h.

References fabs(), GetCovariance(), and sqrt().

Referenced by NDF().

587 {
588  return sqrt(fabs(GetCovariance(3, 3)));
589 }
fvec GetCovariance(int i) const
friend F32vec4 sqrt(const F32vec4 &a)
Definition: P4_F32vec4.h:28
friend F32vec4 fabs(const F32vec4 &a)
Definition: P4_F32vec4.h:46

◆ GetErrPy()

fvec KFParticleSIMD::GetErrPy ( ) const
inline

Definition at line 591 of file KFParticleSIMD.h.

References fabs(), GetCovariance(), and sqrt().

Referenced by NDF().

592 {
593  return sqrt(fabs(GetCovariance(4, 4)));
594 }
fvec GetCovariance(int i) const
friend F32vec4 sqrt(const F32vec4 &a)
Definition: P4_F32vec4.h:28
friend F32vec4 fabs(const F32vec4 &a)
Definition: P4_F32vec4.h:46

◆ GetErrPz()

fvec KFParticleSIMD::GetErrPz ( ) const
inline

Definition at line 596 of file KFParticleSIMD.h.

References fabs(), GetCovariance(), and sqrt().

Referenced by NDF().

597 {
598  return sqrt(fabs(GetCovariance(5, 5)));
599 }
fvec GetCovariance(int i) const
friend F32vec4 sqrt(const F32vec4 &a)
Definition: P4_F32vec4.h:28
friend F32vec4 fabs(const F32vec4 &a)
Definition: P4_F32vec4.h:46

◆ GetErrR()

fvec KFParticleSIMD::GetErrR ( ) const
inline

Definition at line 692 of file KFParticleSIMD.h.

References GetR().

Referenced by NDF().

693 {
694  fvec par, err;
695  fvec mask = KFParticleSIMD::GetR(par, err);
696  fvec ret(1.e10);
697  ret = (mask & ret) + ((!mask) & err);
698  return ret;
699 }
fvec GetR() const

◆ GetErrS()

fvec KFParticleSIMD::GetErrS ( ) const
inline

Definition at line 606 of file KFParticleSIMD.h.

References fabs(), GetCovariance(), and sqrt().

Referenced by NDF().

607 {
608  return sqrt(fabs(GetCovariance(7, 7)));
609 }
fvec GetCovariance(int i) const
friend F32vec4 sqrt(const F32vec4 &a)
Definition: P4_F32vec4.h:28
friend F32vec4 fabs(const F32vec4 &a)
Definition: P4_F32vec4.h:46

◆ GetErrX()

fvec KFParticleSIMD::GetErrX ( ) const
inline

Definition at line 571 of file KFParticleSIMD.h.

References fabs(), GetCovariance(), and sqrt().

Referenced by NDF().

572 {
573  return sqrt(fabs(GetCovariance(0, 0)));
574 }
fvec GetCovariance(int i) const
friend F32vec4 sqrt(const F32vec4 &a)
Definition: P4_F32vec4.h:28
friend F32vec4 fabs(const F32vec4 &a)
Definition: P4_F32vec4.h:46

◆ GetErrY()

fvec KFParticleSIMD::GetErrY ( ) const
inline

Definition at line 576 of file KFParticleSIMD.h.

References fabs(), GetCovariance(), and sqrt().

Referenced by NDF().

577 {
578  return sqrt(fabs(GetCovariance(1, 1)));
579 }
fvec GetCovariance(int i) const
friend F32vec4 sqrt(const F32vec4 &a)
Definition: P4_F32vec4.h:28
friend F32vec4 fabs(const F32vec4 &a)
Definition: P4_F32vec4.h:46

◆ GetErrZ()

fvec KFParticleSIMD::GetErrZ ( ) const
inline

Definition at line 581 of file KFParticleSIMD.h.

References fabs(), GetCovariance(), and sqrt().

Referenced by NDF().

582 {
583  return sqrt(fabs(GetCovariance(2, 2)));
584 }
fvec GetCovariance(int i) const
friend F32vec4 sqrt(const F32vec4 &a)
Definition: P4_F32vec4.h:28
friend F32vec4 fabs(const F32vec4 &a)
Definition: P4_F32vec4.h:46

◆ GetEta() [1/2]

fvec KFParticleSIMD::GetEta ( ) const
inline

Definition at line 515 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetEta().

Referenced by GetErrEta(), and NDF().

516 {
517  fvec par, err;
518  fvec mask = KFParticleBaseSIMD::GetEta(par, err);
519  return ((!mask) & par);
520 }
fvec GetEta(fvec &Eta, fvec &SigmaEta) const

◆ GetEta() [2/2]

fvec KFParticleSIMD::GetEta ( fvec Eta,
fvec SigmaEta 
) const
inline

Definition at line 711 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetEta().

712 {
713  return KFParticleBaseSIMD::GetEta(Eta, SigmaEta);
714 }
fvec GetEta(fvec &Eta, fvec &SigmaEta) const

◆ GetExternalTrackParam()

static void KFParticleSIMD::GetExternalTrackParam ( const KFParticleBaseSIMD p,
Double_t  X[fvecLen],
Double_t  Alpha[fvecLen],
Double_t  P[5][fvecLen] 
)
staticprotected

Referenced by NDF().

◆ GetFieldAlice()

fvec KFParticleSIMD::GetFieldAlice ( )
inlinestaticprotected

Definition at line 979 of file KFParticleSIMD.h.

Referenced by ConstructGamma(), GetDStoParticleXY(), GetDStoPoint(), GetFieldValue(), NDF(), and Transport().

980 {
981  return fgBz;
982 }

◆ GetFieldValue()

void KFParticleSIMD::GetFieldValue ( const fvec  xyz[],
fvec  B[] 
) const
inlinevirtual

Implements KFParticleBaseSIMD.

Definition at line 986 of file KFParticleSIMD.h.

References GetFieldAlice().

Referenced by NDF().

987 {
988  B[0] = B[1] = 0;
989  B[2] = GetFieldAlice();
990 }
static fvec GetFieldAlice()

◆ GetKFParticle() [1/2]

void KFParticleSIMD::GetKFParticle ( KFParticle Part,
int  iPart = 0 
)

Referenced by NDF().

◆ GetKFParticle() [2/2]

void KFParticleSIMD::GetKFParticle ( KFParticle Part,
int  nPart = 0 
)

◆ GetLifeTime() [1/2]

fvec KFParticleSIMD::GetLifeTime ( ) const
inline

Definition at line 557 of file KFParticleSIMD.h.

Referenced by GetErrLifeTime(), and NDF().

558 {
559  fvec par, err;
560  fvec mask = KFParticleSIMD::GetLifeTime(par, err);
561  return ((!mask) & par);
562 }
fvec GetLifeTime() const

◆ GetLifeTime() [2/2]

fvec KFParticleSIMD::GetLifeTime ( fvec T,
fvec SigmaT 
) const
inline

Definition at line 741 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetLifeTime().

742 {
743  return KFParticleBaseSIMD::GetLifeTime(T, SigmaT);
744 }
fvec GetLifeTime(fvec &T, fvec &SigmaT) const

◆ GetMass() [1/2]

fvec KFParticleSIMD::GetMass ( ) const
inline

Definition at line 536 of file KFParticleSIMD.h.

Referenced by GetErrMass(), and NDF().

537 {
538  fvec par, err;
539  fvec mask = KFParticleSIMD::GetMass(par, err);
540  return ((!mask) & par);
541 }
fvec GetMass() const

◆ GetMass() [2/2]

fvec KFParticleSIMD::GetMass ( fvec M,
fvec SigmaM 
) const
inline

Definition at line 726 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetMass().

727 {
728  return KFParticleBaseSIMD::GetMass(M, SigmaM);
729 }
fvec GetMass(fvec &M, fvec &SigmaM) const

◆ GetMomentum() [1/2]

fvec KFParticleSIMD::GetMomentum ( ) const
inline

Definition at line 529 of file KFParticleSIMD.h.

Referenced by GetErrMomentum(), GetErrP(), and NDF().

530 {
531  fvec par, err;
532  fvec mask = KFParticleSIMD::GetMomentum(par, err);
533  return ((!mask) & par);
534 }
fvec GetMomentum() const

◆ GetMomentum() [2/2]

fvec KFParticleSIMD::GetMomentum ( fvec P,
fvec SigmaP 
) const
inline

Definition at line 721 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetMomentum().

722 {
723  return KFParticleBaseSIMD::GetMomentum(P, SigmaP);
724 }
fvec GetMomentum(fvec &P, fvec &SigmaP) const

◆ GetNDF()

fvec KFParticleSIMD::GetNDF ( ) const
inline

Definition at line 481 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetNDF().

Referenced by ~KFParticleSIMD().

482 {
484 }

◆ GetP() [1/2]

fvec KFParticleSIMD::GetP ( ) const
inline

Definition at line 501 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetMomentum().

Referenced by NDF().

502 {
503  fvec par, err;
504  fvec mask = KFParticleBaseSIMD::GetMomentum(par, err);
505  return ((!mask) & par);
506 }
fvec GetMomentum(fvec &P, fvec &SigmaP) const

◆ GetP() [2/2]

fvec KFParticleSIMD::GetP ( fvec P,
fvec SigmaP 
) const
inline

Definition at line 701 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetMomentum().

702 {
703  return KFParticleBaseSIMD::GetMomentum(P, SigmaP);
704 }
fvec GetMomentum(fvec &P, fvec &SigmaP) const

◆ GetParameter()

fvec KFParticleSIMD::GetParameter ( int  i) const
inline

Definition at line 486 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetParameter().

Referenced by NDF().

487 {
489 }
unsigned int i
Definition: P4_F32vec4.h:21
fvec GetParameter(Int_t i) const

◆ GetPhi() [1/2]

fvec KFParticleSIMD::GetPhi ( ) const
inline

Definition at line 522 of file KFParticleSIMD.h.

Referenced by GetErrPhi(), and NDF().

523 {
524  fvec par, err;
525  fvec mask = KFParticleSIMD::GetPhi(par, err);
526  return ((!mask) & par);
527 }
fvec GetPhi() const

◆ GetPhi() [2/2]

fvec KFParticleSIMD::GetPhi ( fvec Phi,
fvec SigmaPhi 
) const
inline

Definition at line 716 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetPhi().

717 {
718  return KFParticleBaseSIMD::GetPhi(Phi, SigmaPhi);
719 }
fvec GetPhi(fvec &Phi, fvec &SigmaPhi) const

◆ GetPseudoProperDecayTime()

fvec KFParticleSIMD::GetPseudoProperDecayTime ( const KFParticleSIMD primVertex,
const fvec mass,
fvec timeErr2 = 0 
) const

Referenced by NDF().

◆ GetPt() [1/2]

fvec KFParticleSIMD::GetPt ( ) const
inline

Definition at line 508 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetPt().

Referenced by GetErrPt(), and NDF().

509 {
510  fvec par, err;
511  fvec mask = KFParticleBaseSIMD::GetPt(par, err);
512  return ((!mask) & par);
513 }
fvec GetPt(fvec &Pt, fvec &SigmaPt) const

◆ GetPt() [2/2]

fvec KFParticleSIMD::GetPt ( fvec Pt,
fvec SigmaPt 
) const
inline

Definition at line 706 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetPt().

707 {
708  return KFParticleBaseSIMD::GetPt(Pt, SigmaPt);
709 }
fvec GetPt(fvec &Pt, fvec &SigmaPt) const

◆ GetPx()

fvec KFParticleSIMD::GetPx ( ) const
inline

Definition at line 446 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetPx().

Referenced by ~KFParticleSIMD().

447 {
448  return KFParticleBaseSIMD::GetPx();
449 }

◆ GetPy()

fvec KFParticleSIMD::GetPy ( ) const
inline

Definition at line 451 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetPy().

Referenced by ~KFParticleSIMD().

452 {
453  return KFParticleBaseSIMD::GetPy();
454 }

◆ GetPz()

fvec KFParticleSIMD::GetPz ( ) const
inline

Definition at line 456 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetPz().

Referenced by ~KFParticleSIMD().

457 {
458  return KFParticleBaseSIMD::GetPz();
459 }

◆ GetQ()

fvec KFParticleSIMD::GetQ ( ) const
inline

Definition at line 471 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetQ().

Referenced by ~KFParticleSIMD().

472 {
473  return KFParticleBaseSIMD::GetQ();
474 }

◆ GetR() [1/2]

fvec KFParticleSIMD::GetR ( ) const
inline

Definition at line 564 of file KFParticleSIMD.h.

Referenced by GetErrR(), and NDF().

565 {
566  fvec par, err;
567  fvec mask = KFParticleSIMD::GetR(par, err);
568  return ((!mask) & par);
569 }
fvec GetR() const

◆ GetR() [2/2]

fvec KFParticleSIMD::GetR ( fvec R,
fvec SigmaR 
) const
inline

Definition at line 746 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetR().

747 {
748  return KFParticleBaseSIMD::GetR(R, SigmaR);
749 }
fvec GetR(fvec &R, fvec &SigmaR) const

◆ GetS()

fvec KFParticleSIMD::GetS ( ) const
inline

Definition at line 466 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetS().

Referenced by ~KFParticleSIMD().

467 {
468  return KFParticleBaseSIMD::GetS();
469 }

◆ GetX()

fvec KFParticleSIMD::GetX ( ) const
inline

Definition at line 431 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetX().

Referenced by ~KFParticleSIMD().

432 {
433  return KFParticleBaseSIMD::GetX();
434 }

◆ GetY()

fvec KFParticleSIMD::GetY ( ) const
inline

Definition at line 436 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetY().

Referenced by ~KFParticleSIMD().

437 {
438  return KFParticleBaseSIMD::GetY();
439 }

◆ GetZ()

fvec KFParticleSIMD::GetZ ( ) const
inline

Definition at line 441 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetZ().

Referenced by ~KFParticleSIMD().

442 {
443  return KFParticleBaseSIMD::GetZ();
444 }

◆ Initialize()

void KFParticleSIMD::Initialize ( )
inline

Definition at line 421 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::Initialize().

Referenced by ~KFParticleSIMD().

422 {
424 }

◆ NDF() [1/2]

const fvec& KFParticleSIMD::NDF ( ) const
inline

◆ NDF() [2/2]

fvec & KFParticleSIMD::NDF ( )
inline

Definition at line 801 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::NDF().

802 {
803  return KFParticleBaseSIMD::NDF();
804 }
const fvec & NDF() const

◆ operator+=()

void KFParticleSIMD::operator+= ( const KFParticleSIMD Daughter)
inline

Definition at line 831 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::operator+=().

Referenced by NDF().

832 {
834 }
void operator+=(const KFParticleBaseSIMD &Daughter)

◆ Parameter()

fvec & KFParticleSIMD::Parameter ( int  i)
inline

Definition at line 806 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::Parameter().

Referenced by NDF().

807 {
809 }
unsigned int i
Definition: P4_F32vec4.h:21
fvec & Parameter(Int_t i)

◆ Parameters()

fvec * KFParticleSIMD::Parameters ( )
inline

Definition at line 821 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::fP.

Referenced by NDF().

822 {
823  return fP;
824 }

◆ Px() [1/2]

const fvec& KFParticleSIMD::Px ( ) const
inline

Definition at line 133 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::fP.

Referenced by NDF().

133 { return fP[3]; }

◆ Px() [2/2]

fvec & KFParticleSIMD::Px ( )
inline

Definition at line 766 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::Px().

767 {
768  return KFParticleBaseSIMD::Px();
769 }
const fvec & Px() const

◆ Py() [1/2]

const fvec& KFParticleSIMD::Py ( ) const
inline

Definition at line 134 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::fP.

Referenced by NDF().

134 { return fP[4]; }

◆ Py() [2/2]

fvec & KFParticleSIMD::Py ( )
inline

Definition at line 771 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::Py().

772 {
773  return KFParticleBaseSIMD::Py();
774 }
const fvec & Py() const

◆ Pz() [1/2]

const fvec& KFParticleSIMD::Pz ( ) const
inline

Definition at line 135 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::fP.

Referenced by NDF().

135 { return fP[5]; }

◆ Pz() [2/2]

fvec & KFParticleSIMD::Pz ( )
inline

Definition at line 776 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::Pz().

777 {
778  return KFParticleBaseSIMD::Pz();
779 }
const fvec & Pz() const

◆ Q() [1/2]

const fvec& KFParticleSIMD::Q ( ) const
inline

Definition at line 138 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::fQ.

Referenced by NDF().

138 { return fQ; }

◆ Q() [2/2]

fvec & KFParticleSIMD::Q ( )
inline

Definition at line 791 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::Q().

792 {
793  return KFParticleBaseSIMD::Q();
794 }
const fvec & Q() const

◆ S() [1/2]

const fvec& KFParticleSIMD::S ( ) const
inline

Definition at line 137 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::fP.

Referenced by NDF().

137 { return fP[7]; }

◆ S() [2/2]

fvec & KFParticleSIMD::S ( )
inline

Definition at line 786 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::S().

787 {
788  return KFParticleBaseSIMD::S();
789 }
const fvec & S() const

◆ SetField()

void KFParticleSIMD::SetField ( fvec  Bz)
inlinestatic

Definition at line 396 of file KFParticleSIMD.h.

397 {
398  fgBz = Bz;
399 }

◆ SetMassConstraint()

void KFParticleSIMD::SetMassConstraint ( fvec  Mass,
fvec  SigmaMass = 0 
)
inline

Definition at line 846 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::SetMassConstraint().

Referenced by NDF().

847 {
848  KFParticleBaseSIMD::SetMassConstraint(Mass, SigmaMass);
849 }
void SetMassConstraint(fvec Mass, fvec SigmaMass=0)

◆ SetNoDecayLength()

void KFParticleSIMD::SetNoDecayLength ( )
inline

Definition at line 851 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::SetNoDecayLength().

Referenced by NDF().

852 {
854 }

◆ SetProductionVertex()

void KFParticleSIMD::SetProductionVertex ( const KFParticleSIMD Vtx)
inline

Definition at line 841 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::SetProductionVertex().

Referenced by NDF().

842 {
844 }
void SetProductionVertex(const KFParticleBaseSIMD &Vtx)

◆ SetVtxGuess()

void KFParticleSIMD::SetVtxGuess ( fvec  x,
fvec  y,
fvec  z 
)
inline

Definition at line 426 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::SetVtxGuess().

Referenced by ~KFParticleSIMD().

427 {
429 }
void SetVtxGuess(fvec x, fvec y, fvec z)

◆ SubtractFromParticle()

void KFParticleSIMD::SubtractFromParticle ( KFParticleSIMD v) const
inline

Definition at line 973 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::SubtractFromParticle().

Referenced by NDF().

974 {
976 }
void SubtractFromParticle(KFParticleBaseSIMD &Vtx) const

◆ SubtractFromVertex()

void KFParticleSIMD::SubtractFromVertex ( KFParticleSIMD v) const
inline

Definition at line 968 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::SubtractFromVertex().

Referenced by NDF().

969 {
971 }
void SubtractFromVertex(KFParticleBaseSIMD &Vtx) const

◆ Transport()

void KFParticleSIMD::Transport ( fvec  dS,
fvec  P[],
fvec  C[] 
) const
inlineprotectedvirtual

Implements KFParticleBaseSIMD.

Definition at line 1019 of file KFParticleSIMD.h.

References GetFieldAlice(), KFParticleBaseSIMD::TransportBz(), and KFParticleBaseSIMD::TransportCBM().

Referenced by NDF().

1020 {
1021 #ifdef HomogeneousField
1023 #endif
1024 #ifdef NonhomogeneousField
1026 #endif
1027 }
void TransportCBM(fvec dS, fvec P[], fvec C[]) const
void TransportBz(fvec Bz, fvec dS, fvec P[], fvec C[]) const
static fvec GetFieldAlice()

◆ TransportToDecayVertex()

void KFParticleSIMD::TransportToDecayVertex ( )
inline

Definition at line 881 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::TransportToDecayVertex().

Referenced by NDF().

◆ TransportToDS()

void KFParticleSIMD::TransportToDS ( fvec  dS)
inline

Definition at line 908 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::TransportToDS().

Referenced by NDF(), TransportToParticle(), and TransportToPoint().

909 {
911 }
void TransportToDS(fvec dS)

◆ TransportToParticle()

void KFParticleSIMD::TransportToParticle ( const KFParticleSIMD p)
inline

Definition at line 901 of file KFParticleSIMD.h.

References GetDStoParticle(), and TransportToDS().

Referenced by NDF().

902 {
903  fvec dS, dSp;
904  GetDStoParticle(p, dS, dSp);
905  TransportToDS(dS);
906 }
void TransportToDS(fvec dS)
void GetDStoParticle(const KFParticleSIMD &p, fvec &DS, fvec &DSp) const

◆ TransportToPoint()

void KFParticleSIMD::TransportToPoint ( const fvec  xyz[])
inline

Definition at line 891 of file KFParticleSIMD.h.

References GetDStoPoint(), and TransportToDS().

Referenced by NDF(), and TransportToVertex().

892 {
894 }
void TransportToDS(fvec dS)
fvec GetDStoPoint(const fvec xyz[]) const

◆ TransportToProductionVertex()

void KFParticleSIMD::TransportToProductionVertex ( )
inline

Definition at line 886 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::TransportToProductionVertex().

Referenced by NDF().

◆ TransportToVertex()

void KFParticleSIMD::TransportToVertex ( const KFPVertex v)
inline

Definition at line 896 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::fP, KFParticleSIMD(), and TransportToPoint().

Referenced by NDF().

897 {
899 }
void TransportToPoint(const fvec xyz[])

◆ X() [1/2]

const fvec& KFParticleSIMD::X ( ) const
inline

Definition at line 130 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::fP.

Referenced by NDF().

130 { return fP[0]; }

◆ X() [2/2]

fvec & KFParticleSIMD::X ( )
inline

Definition at line 751 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::X().

752 {
753  return KFParticleBaseSIMD::X();
754 }
const fvec & X() const

◆ Y() [1/2]

const fvec& KFParticleSIMD::Y ( ) const
inline

Definition at line 131 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::fP.

Referenced by NDF().

131 { return fP[1]; }

◆ Y() [2/2]

fvec & KFParticleSIMD::Y ( )
inline

Definition at line 756 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::Y().

757 {
758  return KFParticleBaseSIMD::Y();
759 }
const fvec & Y() const

◆ Z() [1/2]

const fvec& KFParticleSIMD::Z ( ) const
inline

Definition at line 132 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::fP.

Referenced by NDF().

132 { return fP[2]; }

◆ Z() [2/2]

fvec & KFParticleSIMD::Z ( )
inline

Definition at line 761 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::Z().

762 {
763  return KFParticleBaseSIMD::Z();
764 }
const fvec & Z() const

The documentation for this class was generated from the following file: