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 51 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 414 of file KFParticleSIMD.h.

415 {
416  KFParticleSIMD mother;
417  mother += d1;
418  mother += d2;
419  mother += d3;
420  *this = mother;
421 }

◆ KFParticleSIMD() [4/11]

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

Definition at line 423 of file KFParticleSIMD.h.

424 {
425  KFParticleSIMD mother;
426  mother += d1;
427  mother += d2;
428  mother += d3;
429  mother += d4;
430  *this = mother;
431 }

◆ 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 848 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::AddDaughter().

Referenced by NDF().

849 {
851 }
void AddDaughter(const KFParticleBaseSIMD &Daughter, Bool_t isAtVtxGuess=0)

◆ Chi2() [1/2]

const fvec& KFParticleSIMD::Chi2 ( ) const
inline

Definition at line 151 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::fChi2.

Referenced by NDF().

151 { return fChi2; }

◆ Chi2() [2/2]

fvec & KFParticleSIMD::Chi2 ( )
inline

Definition at line 808 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::Chi2().

809 {
810  return KFParticleBaseSIMD::Chi2();
811 }
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 868 of file KFParticleSIMD.h.

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

Referenced by NDF().

869 {
870  KFParticleBaseSIMD::Construct((const KFParticleBaseSIMD **)vDaughters, nDaughters, (const KFParticleBaseSIMD *)ProdVtx, Mass, IsConstrained, isAtVtxGuess);
871 
872 #ifdef NonhomogeneousField
873  // calculate a field region for the constructed particle
874  L1FieldValue field[3];
875  fvec zField[3] = {0, fP[2] / 2, fP[2]};
876 
877  for (int iPoint = 0; iPoint < 3; iPoint++) {
878  for (int iD = 0; iD < nDaughters; ++iD) {
879  L1FieldValue b = const_cast<KFParticleSIMD *>(vDaughters[iD])->fField.Get(zField[iPoint]);
880  field[iPoint].x += b.x;
881  field[iPoint].y += b.y;
882  field[iPoint].z += b.z;
883  }
884  field[iPoint].x /= nDaughters;
885  field[iPoint].y /= nDaughters;
886  field[iPoint].z /= nDaughters;
887  }
888 
889  fField.Set(field[2], zField[2], field[1], zField[1], field[0], zField[0]);
890 #endif
891 }
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 1041 of file KFParticleSIMD.h.

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

Referenced by NDF().

1042 {
1043 #ifdef HomogeneousField
1044  KFParticleBaseSIMD::ConstructGammaBz(daughter1, daughter2, GetFieldAlice());
1045 #endif
1046 }
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 823 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::Covariance().

Referenced by NDF().

824 {
826 }
unsigned int i
Definition: P4_F32vec4.h:33
fvec & Covariance(Int_t i)

◆ Covariance() [2/2]

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

Definition at line 828 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::Covariance().

829 {
831 }
unsigned int i
Definition: P4_F32vec4.h:33
fvec & Covariance(Int_t i)

◆ CovarianceMatrix()

fvec * KFParticleSIMD::CovarianceMatrix ( )
inline

Definition at line 838 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::fC.

Referenced by NDF().

839 {
840  return fC;
841 }

◆ 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 148 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::fP.

Referenced by NDF().

148 { return fP[6]; }

◆ E() [2/2]

fvec & KFParticleSIMD::E ( )
inline

Definition at line 793 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::E().

794 {
795  return KFParticleBaseSIMD::E();
796 }
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 140 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::fAtProductionVertex.

140 { return fAtProductionVertex; }

◆ GetChi2()

fvec KFParticleSIMD::GetChi2 ( ) const
inline

Definition at line 488 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetChi2().

Referenced by ~KFParticleSIMD().

489 {
491 }

◆ GetCovariance() [1/2]

fvec KFParticleSIMD::GetCovariance ( int  i) const
inline

Definition at line 503 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetCovariance().

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

504 {
506 }
unsigned int i
Definition: P4_F32vec4.h:33
fvec GetCovariance(Int_t i) const

◆ GetCovariance() [2/2]

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

Definition at line 508 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetCovariance().

509 {
511 }
unsigned int i
Definition: P4_F32vec4.h:33
fvec GetCovariance(Int_t i) const

◆ GetDecayLength() [1/2]

fvec KFParticleSIMD::GetDecayLength ( ) const
inline

Definition at line 555 of file KFParticleSIMD.h.

Referenced by GetErrDecayLength(), and NDF().

556 {
557  fvec par, err;
558  fvec mask = KFParticleSIMD::GetDecayLength(par, err);
559  return ((!mask) & par);
560 }
fvec GetDecayLength() const

◆ GetDecayLength() [2/2]

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

Definition at line 743 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetDecayLength().

744 {
745  return KFParticleBaseSIMD::GetDecayLength(L, SigmaL);
746 }
fvec GetDecayLength(fvec &L, fvec &SigmaL) const

◆ GetDecayLengthXY() [1/2]

fvec KFParticleSIMD::GetDecayLengthXY ( ) const
inline

Definition at line 562 of file KFParticleSIMD.h.

Referenced by GetErrDecayLengthXY(), and NDF().

563 {
564  fvec par, err;
565  fvec mask = KFParticleSIMD::GetDecayLengthXY(par, err);
566  return ((!mask) & par);
567 }
fvec GetDecayLengthXY() const

◆ GetDecayLengthXY() [2/2]

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

Definition at line 748 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetDecayLengthXY().

749 {
750  return KFParticleBaseSIMD::GetDecayLengthXY(L, SigmaL);
751 }
fvec GetDecayLengthXY(fvec &L, fvec &SigmaL) const

◆ GetDeviationFromParticle()

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

Definition at line 975 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetDeviationFromParticle().

Referenced by NDF().

976 {
978 }
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 945 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetDeviationFromVertex().

Referenced by GetDeviationFromVertex(), and NDF().

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

◆ GetDeviationFromVertex() [2/3]

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

Definition at line 955 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetDeviationFromVertex().

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

◆ GetDeviationFromVertex() [3/3]

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

Definition at line 965 of file KFParticleSIMD.h.

References GetDeviationFromVertex(), and KFParticleSIMD().

966 {
968 }
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 970 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetDistanceFromParticle().

Referenced by NDF().

971 {
973 }
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 940 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetDistanceFromVertex().

Referenced by GetDistanceFromVertex(), and NDF().

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

◆ GetDistanceFromVertex() [2/3]

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

Definition at line 950 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetDistanceFromVertex().

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

◆ GetDistanceFromVertex() [3/3]

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

Definition at line 960 of file KFParticleSIMD.h.

References GetDistanceFromVertex(), and KFParticleSIMD().

961 {
963 }
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 935 of file KFParticleSIMD.h.

References GetDStoParticleXY().

Referenced by NDF(), and TransportToParticle().

936 {
937  GetDStoParticleXY(p, DS, DSp);
938 }
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 1015 of file KFParticleSIMD.h.

References GetDStoParticleXY().

1016 {
1017  GetDStoParticleXY(p, DS, DSp);
1018 }
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 1020 of file KFParticleSIMD.h.

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

Referenced by GetDStoParticle(), and NDF().

1021 {
1022 #ifdef HomogeneousField
1024 #endif
1025 #ifdef NonhomogeneousField
1027 #endif
1028  // GetDStoParticleALICE( p, DS, DSp ) ;
1029 }
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 925 of file KFParticleSIMD.h.

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

Referenced by NDF(), and TransportToPoint().

926 {
927 #ifdef HomogeneousField
929 #endif
930 #ifdef NonhomogeneousField
932 #endif
933 }
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 473 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetE().

Referenced by ~KFParticleSIMD().

474 {
475  return KFParticleBaseSIMD::GetE();
476 }

◆ GetErrDecayLength()

fvec KFParticleSIMD::GetErrDecayLength ( ) const
inline

Definition at line 677 of file KFParticleSIMD.h.

References GetDecayLength().

Referenced by NDF().

678 {
679  fvec par, err;
680  fvec mask = KFParticleSIMD::GetDecayLength(par, err);
681  fvec ret(1.e10);
682  ret = (mask & ret) + ((!mask) & err);
683  return ret;
684 }
fvec GetDecayLength() const

◆ GetErrDecayLengthXY()

fvec KFParticleSIMD::GetErrDecayLengthXY ( ) const
inline

Definition at line 686 of file KFParticleSIMD.h.

References GetDecayLengthXY().

Referenced by NDF().

687 {
688  fvec par, err;
689  fvec mask = KFParticleSIMD::GetDecayLengthXY(par, err);
690  fvec ret(1.e10);
691  ret = (mask & ret) + ((!mask) & err);
692  return ret;
693 }
fvec GetDecayLengthXY() const

◆ GetErrE()

fvec KFParticleSIMD::GetErrE ( ) const
inline

Definition at line 613 of file KFParticleSIMD.h.

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

Referenced by NDF().

614 {
615  return sqrt(fabs(GetCovariance(6, 6)));
616 }
fvec GetCovariance(int i) const
friend F32vec4 sqrt(const F32vec4 &a)
Definition: P4_F32vec4.h:40
friend F32vec4 fabs(const F32vec4 &a)
Definition: P4_F32vec4.h:58

◆ GetErrEta()

fvec KFParticleSIMD::GetErrEta ( ) const
inline

Definition at line 641 of file KFParticleSIMD.h.

References GetEta().

Referenced by NDF().

642 {
643  fvec par, err;
644  fvec mask = KFParticleSIMD::GetEta(par, err);
645  fvec ret(1.e10);
646  ret = (mask & ret) + ((!mask) & err);
647  return ret;
648 }
fvec GetEta() const

◆ GetErrLifeTime()

fvec KFParticleSIMD::GetErrLifeTime ( ) const
inline

Definition at line 695 of file KFParticleSIMD.h.

References GetLifeTime().

Referenced by NDF().

696 {
697  fvec par, err;
698  fvec mask = KFParticleSIMD::GetLifeTime(par, err);
699  fvec ret(1.e10);
700  ret = (mask & ret) + ((!mask) & err);
701  return ret;
702 }
fvec GetLifeTime() const

◆ GetErrMass()

fvec KFParticleSIMD::GetErrMass ( ) const
inline

Definition at line 668 of file KFParticleSIMD.h.

References GetMass().

Referenced by NDF().

669 {
670  fvec par, err;
671  fvec mask = KFParticleSIMD::GetMass(par, err);
672  fvec ret(1.e10);
673  ret = (mask & ret) + ((!mask) & err);
674  return ret;
675 }
fvec GetMass() const

◆ GetErrMomentum()

fvec KFParticleSIMD::GetErrMomentum ( ) const
inline

Definition at line 659 of file KFParticleSIMD.h.

References GetMomentum().

Referenced by NDF().

660 {
661  fvec par, err;
662  fvec mask = KFParticleSIMD::GetMomentum(par, err);
663  fvec ret(1.e10);
664  ret = (mask & ret) + ((!mask) & err);
665  return ret;
666 }
fvec GetMomentum() const

◆ GetErrP()

fvec KFParticleSIMD::GetErrP ( ) const
inline

Definition at line 623 of file KFParticleSIMD.h.

References GetMomentum().

Referenced by NDF().

624 {
625  fvec par, err;
626  fvec mask = KFParticleSIMD::GetMomentum(par, err);
627  fvec ret(1.e10);
628  ret = (mask & ret) + ((!mask) & err);
629  return ret;
630 }
fvec GetMomentum() const

◆ GetErrPhi()

fvec KFParticleSIMD::GetErrPhi ( ) const
inline

Definition at line 650 of file KFParticleSIMD.h.

References GetPhi().

Referenced by NDF().

651 {
652  fvec par, err;
653  fvec mask = KFParticleSIMD::GetPhi(par, err);
654  fvec ret(1.e10);
655  ret = (mask & ret) + ((!mask) & err);
656  return ret;
657 }
fvec GetPhi() const

◆ GetErrPt()

fvec KFParticleSIMD::GetErrPt ( ) const
inline

Definition at line 632 of file KFParticleSIMD.h.

References GetPt().

Referenced by NDF().

633 {
634  fvec par, err;
635  fvec mask = KFParticleSIMD::GetPt(par, err);
636  fvec ret(1.e10);
637  ret = (mask & ret) + ((!mask) & err);
638  return ret;
639 }
fvec GetPt() const

◆ GetErrPx()

fvec KFParticleSIMD::GetErrPx ( ) const
inline

Definition at line 598 of file KFParticleSIMD.h.

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

Referenced by NDF().

599 {
600  return sqrt(fabs(GetCovariance(3, 3)));
601 }
fvec GetCovariance(int i) const
friend F32vec4 sqrt(const F32vec4 &a)
Definition: P4_F32vec4.h:40
friend F32vec4 fabs(const F32vec4 &a)
Definition: P4_F32vec4.h:58

◆ GetErrPy()

fvec KFParticleSIMD::GetErrPy ( ) const
inline

Definition at line 603 of file KFParticleSIMD.h.

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

Referenced by NDF().

604 {
605  return sqrt(fabs(GetCovariance(4, 4)));
606 }
fvec GetCovariance(int i) const
friend F32vec4 sqrt(const F32vec4 &a)
Definition: P4_F32vec4.h:40
friend F32vec4 fabs(const F32vec4 &a)
Definition: P4_F32vec4.h:58

◆ GetErrPz()

fvec KFParticleSIMD::GetErrPz ( ) const
inline

Definition at line 608 of file KFParticleSIMD.h.

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

Referenced by NDF().

609 {
610  return sqrt(fabs(GetCovariance(5, 5)));
611 }
fvec GetCovariance(int i) const
friend F32vec4 sqrt(const F32vec4 &a)
Definition: P4_F32vec4.h:40
friend F32vec4 fabs(const F32vec4 &a)
Definition: P4_F32vec4.h:58

◆ GetErrR()

fvec KFParticleSIMD::GetErrR ( ) const
inline

Definition at line 704 of file KFParticleSIMD.h.

References GetR().

Referenced by NDF().

705 {
706  fvec par, err;
707  fvec mask = KFParticleSIMD::GetR(par, err);
708  fvec ret(1.e10);
709  ret = (mask & ret) + ((!mask) & err);
710  return ret;
711 }
fvec GetR() const

◆ GetErrS()

fvec KFParticleSIMD::GetErrS ( ) const
inline

Definition at line 618 of file KFParticleSIMD.h.

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

Referenced by NDF().

619 {
620  return sqrt(fabs(GetCovariance(7, 7)));
621 }
fvec GetCovariance(int i) const
friend F32vec4 sqrt(const F32vec4 &a)
Definition: P4_F32vec4.h:40
friend F32vec4 fabs(const F32vec4 &a)
Definition: P4_F32vec4.h:58

◆ GetErrX()

fvec KFParticleSIMD::GetErrX ( ) const
inline

Definition at line 583 of file KFParticleSIMD.h.

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

Referenced by NDF().

584 {
585  return sqrt(fabs(GetCovariance(0, 0)));
586 }
fvec GetCovariance(int i) const
friend F32vec4 sqrt(const F32vec4 &a)
Definition: P4_F32vec4.h:40
friend F32vec4 fabs(const F32vec4 &a)
Definition: P4_F32vec4.h:58

◆ GetErrY()

fvec KFParticleSIMD::GetErrY ( ) const
inline

Definition at line 588 of file KFParticleSIMD.h.

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

Referenced by NDF().

589 {
590  return sqrt(fabs(GetCovariance(1, 1)));
591 }
fvec GetCovariance(int i) const
friend F32vec4 sqrt(const F32vec4 &a)
Definition: P4_F32vec4.h:40
friend F32vec4 fabs(const F32vec4 &a)
Definition: P4_F32vec4.h:58

◆ GetErrZ()

fvec KFParticleSIMD::GetErrZ ( ) const
inline

Definition at line 593 of file KFParticleSIMD.h.

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

Referenced by NDF().

594 {
595  return sqrt(fabs(GetCovariance(2, 2)));
596 }
fvec GetCovariance(int i) const
friend F32vec4 sqrt(const F32vec4 &a)
Definition: P4_F32vec4.h:40
friend F32vec4 fabs(const F32vec4 &a)
Definition: P4_F32vec4.h:58

◆ GetEta() [1/2]

fvec KFParticleSIMD::GetEta ( ) const
inline

Definition at line 527 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetEta().

Referenced by GetErrEta(), and NDF().

528 {
529  fvec par, err;
530  fvec mask = KFParticleBaseSIMD::GetEta(par, err);
531  return ((!mask) & par);
532 }
fvec GetEta(fvec &Eta, fvec &SigmaEta) const

◆ GetEta() [2/2]

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

Definition at line 723 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetEta().

724 {
725  return KFParticleBaseSIMD::GetEta(Eta, SigmaEta);
726 }
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 991 of file KFParticleSIMD.h.

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

992 {
993  return fgBz;
994 }

◆ GetFieldValue()

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

Implements KFParticleBaseSIMD.

Definition at line 998 of file KFParticleSIMD.h.

References GetFieldAlice().

Referenced by NDF().

999 {
1000  B[0] = B[1] = 0;
1001  B[2] = GetFieldAlice();
1002 }
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 569 of file KFParticleSIMD.h.

Referenced by GetErrLifeTime(), and NDF().

570 {
571  fvec par, err;
572  fvec mask = KFParticleSIMD::GetLifeTime(par, err);
573  return ((!mask) & par);
574 }
fvec GetLifeTime() const

◆ GetLifeTime() [2/2]

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

Definition at line 753 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetLifeTime().

754 {
755  return KFParticleBaseSIMD::GetLifeTime(T, SigmaT);
756 }
fvec GetLifeTime(fvec &T, fvec &SigmaT) const

◆ GetMass() [1/2]

fvec KFParticleSIMD::GetMass ( ) const
inline

Definition at line 548 of file KFParticleSIMD.h.

Referenced by GetErrMass(), and NDF().

549 {
550  fvec par, err;
551  fvec mask = KFParticleSIMD::GetMass(par, err);
552  return ((!mask) & par);
553 }
fvec GetMass() const

◆ GetMass() [2/2]

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

Definition at line 738 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetMass().

739 {
740  return KFParticleBaseSIMD::GetMass(M, SigmaM);
741 }
fvec GetMass(fvec &M, fvec &SigmaM) const

◆ GetMomentum() [1/2]

fvec KFParticleSIMD::GetMomentum ( ) const
inline

Definition at line 541 of file KFParticleSIMD.h.

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

542 {
543  fvec par, err;
544  fvec mask = KFParticleSIMD::GetMomentum(par, err);
545  return ((!mask) & par);
546 }
fvec GetMomentum() const

◆ GetMomentum() [2/2]

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

Definition at line 733 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetMomentum().

734 {
735  return KFParticleBaseSIMD::GetMomentum(P, SigmaP);
736 }
fvec GetMomentum(fvec &P, fvec &SigmaP) const

◆ GetNDF()

fvec KFParticleSIMD::GetNDF ( ) const
inline

Definition at line 493 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetNDF().

Referenced by ~KFParticleSIMD().

494 {
496 }

◆ GetP() [1/2]

fvec KFParticleSIMD::GetP ( ) const
inline

Definition at line 513 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetMomentum().

Referenced by NDF().

514 {
515  fvec par, err;
516  fvec mask = KFParticleBaseSIMD::GetMomentum(par, err);
517  return ((!mask) & par);
518 }
fvec GetMomentum(fvec &P, fvec &SigmaP) const

◆ GetP() [2/2]

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

Definition at line 713 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetMomentum().

714 {
715  return KFParticleBaseSIMD::GetMomentum(P, SigmaP);
716 }
fvec GetMomentum(fvec &P, fvec &SigmaP) const

◆ GetParameter()

fvec KFParticleSIMD::GetParameter ( int  i) const
inline

Definition at line 498 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetParameter().

Referenced by NDF().

499 {
501 }
unsigned int i
Definition: P4_F32vec4.h:33
fvec GetParameter(Int_t i) const

◆ GetPhi() [1/2]

fvec KFParticleSIMD::GetPhi ( ) const
inline

Definition at line 534 of file KFParticleSIMD.h.

Referenced by GetErrPhi(), and NDF().

535 {
536  fvec par, err;
537  fvec mask = KFParticleSIMD::GetPhi(par, err);
538  return ((!mask) & par);
539 }
fvec GetPhi() const

◆ GetPhi() [2/2]

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

Definition at line 728 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetPhi().

729 {
730  return KFParticleBaseSIMD::GetPhi(Phi, SigmaPhi);
731 }
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 520 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetPt().

Referenced by GetErrPt(), and NDF().

521 {
522  fvec par, err;
523  fvec mask = KFParticleBaseSIMD::GetPt(par, err);
524  return ((!mask) & par);
525 }
fvec GetPt(fvec &Pt, fvec &SigmaPt) const

◆ GetPt() [2/2]

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

Definition at line 718 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetPt().

719 {
720  return KFParticleBaseSIMD::GetPt(Pt, SigmaPt);
721 }
fvec GetPt(fvec &Pt, fvec &SigmaPt) const

◆ GetPx()

fvec KFParticleSIMD::GetPx ( ) const
inline

Definition at line 458 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetPx().

Referenced by ~KFParticleSIMD().

459 {
460  return KFParticleBaseSIMD::GetPx();
461 }

◆ GetPy()

fvec KFParticleSIMD::GetPy ( ) const
inline

Definition at line 463 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetPy().

Referenced by ~KFParticleSIMD().

464 {
465  return KFParticleBaseSIMD::GetPy();
466 }

◆ GetPz()

fvec KFParticleSIMD::GetPz ( ) const
inline

Definition at line 468 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetPz().

Referenced by ~KFParticleSIMD().

469 {
470  return KFParticleBaseSIMD::GetPz();
471 }

◆ GetQ()

fvec KFParticleSIMD::GetQ ( ) const
inline

Definition at line 483 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetQ().

Referenced by ~KFParticleSIMD().

484 {
485  return KFParticleBaseSIMD::GetQ();
486 }

◆ GetR() [1/2]

fvec KFParticleSIMD::GetR ( ) const
inline

Definition at line 576 of file KFParticleSIMD.h.

Referenced by GetErrR(), and NDF().

577 {
578  fvec par, err;
579  fvec mask = KFParticleSIMD::GetR(par, err);
580  return ((!mask) & par);
581 }
fvec GetR() const

◆ GetR() [2/2]

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

Definition at line 758 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetR().

759 {
760  return KFParticleBaseSIMD::GetR(R, SigmaR);
761 }
fvec GetR(fvec &R, fvec &SigmaR) const

◆ GetS()

fvec KFParticleSIMD::GetS ( ) const
inline

Definition at line 478 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetS().

Referenced by ~KFParticleSIMD().

479 {
480  return KFParticleBaseSIMD::GetS();
481 }

◆ GetX()

fvec KFParticleSIMD::GetX ( ) const
inline

Definition at line 443 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetX().

Referenced by ~KFParticleSIMD().

444 {
445  return KFParticleBaseSIMD::GetX();
446 }

◆ GetY()

fvec KFParticleSIMD::GetY ( ) const
inline

Definition at line 448 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetY().

Referenced by ~KFParticleSIMD().

449 {
450  return KFParticleBaseSIMD::GetY();
451 }

◆ GetZ()

fvec KFParticleSIMD::GetZ ( ) const
inline

Definition at line 453 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::GetZ().

Referenced by ~KFParticleSIMD().

454 {
455  return KFParticleBaseSIMD::GetZ();
456 }

◆ Initialize()

void KFParticleSIMD::Initialize ( )
inline

Definition at line 433 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::Initialize().

Referenced by ~KFParticleSIMD().

434 {
436 }

◆ NDF() [1/2]

const fvec& KFParticleSIMD::NDF ( ) const
inline

◆ NDF() [2/2]

fvec & KFParticleSIMD::NDF ( )
inline

Definition at line 813 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::NDF().

814 {
815  return KFParticleBaseSIMD::NDF();
816 }
const fvec & NDF() const

◆ operator+=()

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

Definition at line 843 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::operator+=().

Referenced by NDF().

844 {
846 }
void operator+=(const KFParticleBaseSIMD &Daughter)

◆ Parameter()

fvec & KFParticleSIMD::Parameter ( int  i)
inline

Definition at line 818 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::Parameter().

Referenced by NDF().

819 {
821 }
unsigned int i
Definition: P4_F32vec4.h:33
fvec & Parameter(Int_t i)

◆ Parameters()

fvec * KFParticleSIMD::Parameters ( )
inline

Definition at line 833 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::fP.

Referenced by NDF().

834 {
835  return fP;
836 }

◆ Px() [1/2]

const fvec& KFParticleSIMD::Px ( ) const
inline

Definition at line 145 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::fP.

Referenced by NDF().

145 { return fP[3]; }

◆ Px() [2/2]

fvec & KFParticleSIMD::Px ( )
inline

Definition at line 778 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::Px().

779 {
780  return KFParticleBaseSIMD::Px();
781 }
const fvec & Px() const

◆ Py() [1/2]

const fvec& KFParticleSIMD::Py ( ) const
inline

Definition at line 146 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::fP.

Referenced by NDF().

146 { return fP[4]; }

◆ Py() [2/2]

fvec & KFParticleSIMD::Py ( )
inline

Definition at line 783 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::Py().

784 {
785  return KFParticleBaseSIMD::Py();
786 }
const fvec & Py() const

◆ Pz() [1/2]

const fvec& KFParticleSIMD::Pz ( ) const
inline

Definition at line 147 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::fP.

Referenced by NDF().

147 { return fP[5]; }

◆ Pz() [2/2]

fvec & KFParticleSIMD::Pz ( )
inline

Definition at line 788 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::Pz().

789 {
790  return KFParticleBaseSIMD::Pz();
791 }
const fvec & Pz() const

◆ Q() [1/2]

const fvec& KFParticleSIMD::Q ( ) const
inline

Definition at line 150 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::fQ.

Referenced by NDF().

150 { return fQ; }

◆ Q() [2/2]

fvec & KFParticleSIMD::Q ( )
inline

Definition at line 803 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::Q().

804 {
805  return KFParticleBaseSIMD::Q();
806 }
const fvec & Q() const

◆ S() [1/2]

const fvec& KFParticleSIMD::S ( ) const
inline

Definition at line 149 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::fP.

Referenced by NDF().

149 { return fP[7]; }

◆ S() [2/2]

fvec & KFParticleSIMD::S ( )
inline

Definition at line 798 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::S().

799 {
800  return KFParticleBaseSIMD::S();
801 }
const fvec & S() const

◆ SetField()

void KFParticleSIMD::SetField ( fvec  Bz)
inlinestatic

Definition at line 408 of file KFParticleSIMD.h.

409 {
410  fgBz = Bz;
411 }

◆ SetMassConstraint()

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

Definition at line 858 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::SetMassConstraint().

Referenced by NDF().

859 {
860  KFParticleBaseSIMD::SetMassConstraint(Mass, SigmaMass);
861 }
void SetMassConstraint(fvec Mass, fvec SigmaMass=0)

◆ SetNoDecayLength()

void KFParticleSIMD::SetNoDecayLength ( )
inline

Definition at line 863 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::SetNoDecayLength().

Referenced by NDF().

864 {
866 }

◆ SetProductionVertex()

void KFParticleSIMD::SetProductionVertex ( const KFParticleSIMD Vtx)
inline

Definition at line 853 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::SetProductionVertex().

Referenced by NDF().

854 {
856 }
void SetProductionVertex(const KFParticleBaseSIMD &Vtx)

◆ SetVtxGuess()

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

Definition at line 438 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::SetVtxGuess().

Referenced by ~KFParticleSIMD().

439 {
441 }
void SetVtxGuess(fvec x, fvec y, fvec z)

◆ SubtractFromParticle()

void KFParticleSIMD::SubtractFromParticle ( KFParticleSIMD v) const
inline

Definition at line 985 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::SubtractFromParticle().

Referenced by NDF().

986 {
988 }
void SubtractFromParticle(KFParticleBaseSIMD &Vtx) const

◆ SubtractFromVertex()

void KFParticleSIMD::SubtractFromVertex ( KFParticleSIMD v) const
inline

Definition at line 980 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::SubtractFromVertex().

Referenced by NDF().

981 {
983 }
void SubtractFromVertex(KFParticleBaseSIMD &Vtx) const

◆ Transport()

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

Implements KFParticleBaseSIMD.

Definition at line 1031 of file KFParticleSIMD.h.

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

Referenced by NDF().

1032 {
1033 #ifdef HomogeneousField
1035 #endif
1036 #ifdef NonhomogeneousField
1038 #endif
1039 }
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 893 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::TransportToDecayVertex().

Referenced by NDF().

◆ TransportToDS()

void KFParticleSIMD::TransportToDS ( fvec  dS)
inline

Definition at line 920 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::TransportToDS().

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

921 {
923 }
void TransportToDS(fvec dS)

◆ TransportToParticle()

void KFParticleSIMD::TransportToParticle ( const KFParticleSIMD p)
inline

Definition at line 913 of file KFParticleSIMD.h.

References GetDStoParticle(), and TransportToDS().

Referenced by NDF().

914 {
915  fvec dS, dSp;
916  GetDStoParticle(p, dS, dSp);
917  TransportToDS(dS);
918 }
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 903 of file KFParticleSIMD.h.

References GetDStoPoint(), and TransportToDS().

Referenced by NDF(), and TransportToVertex().

904 {
906 }
void TransportToDS(fvec dS)
fvec GetDStoPoint(const fvec xyz[]) const

◆ TransportToProductionVertex()

void KFParticleSIMD::TransportToProductionVertex ( )
inline

Definition at line 898 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::TransportToProductionVertex().

Referenced by NDF().

◆ TransportToVertex()

void KFParticleSIMD::TransportToVertex ( const KFPVertex v)
inline

Definition at line 908 of file KFParticleSIMD.h.

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

Referenced by NDF().

909 {
911 }
void TransportToPoint(const fvec xyz[])

◆ X() [1/2]

const fvec& KFParticleSIMD::X ( ) const
inline

Definition at line 142 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::fP.

Referenced by NDF().

142 { return fP[0]; }

◆ X() [2/2]

fvec & KFParticleSIMD::X ( )
inline

Definition at line 763 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::X().

764 {
765  return KFParticleBaseSIMD::X();
766 }
const fvec & X() const

◆ Y() [1/2]

const fvec& KFParticleSIMD::Y ( ) const
inline

Definition at line 143 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::fP.

Referenced by NDF().

143 { return fP[1]; }

◆ Y() [2/2]

fvec & KFParticleSIMD::Y ( )
inline

Definition at line 768 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::Y().

769 {
770  return KFParticleBaseSIMD::Y();
771 }
const fvec & Y() const

◆ Z() [1/2]

const fvec& KFParticleSIMD::Z ( ) const
inline

Definition at line 144 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::fP.

Referenced by NDF().

144 { return fP[2]; }

◆ Z() [2/2]

fvec & KFParticleSIMD::Z ( )
inline

Definition at line 773 of file KFParticleSIMD.h.

References KFParticleBaseSIMD::Z().

774 {
775  return KFParticleBaseSIMD::Z();
776 }
const fvec & Z() const

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