Main Page | Namespace List | Class Hierarchy | Alphabetical List | Class List | Directories | File List | Namespace Members | Class Members | File Members | Related Pages

TofPID Class Reference

#include <TofPID.h>

Inheritance diagram for TofPID:

ParticleIDBase ParticleIDBase List of all members.

Public Member Functions

int all () const
int all () const
void calculate ()
void calculate ()
double charge ()
double charge ()
double chi (int n) const
double chi (int n) const
double chilayer1 (int n) const
double chilayer1 (int n) const
double chilayer2 (int n) const
double chilayer2 (int n) const
double chiMinCut () const
double chiMinCut () const
int dedxValid () const
int dedxValid () const
int emcValid () const
int emcValid () const
double getRunNo () const
double getRunNo () const
double getweight1 () const
double getweight1 () const
double getweight2 () const
double getweight2 () const
void init ()
void init ()
double interpolation (double *x, double *y, double x1)
double interpolation (double *x, double *y, double x1)
bool IsPidInfoValid () const
bool IsPidInfoValid () const
int methodLikelihood () const
int methodLikelihood () const
int methodNeuronNetwork () const
int methodNeuronNetwork () const
int methodProbability () const
int methodProbability () const
int mucValid () const
int mucValid () const
int ndof () const
int ndof () const
double offset (int n) const
double offset (int n) const
int onlyElectron () const
int onlyElectron () const
int onlyKaon () const
int onlyKaon () const
int onlyMuon () const
int onlyMuon () const
int onlyPion () const
int onlyPion () const
int onlyPionKaon () const
int onlyPionKaon () const
int onlyPionKaonElectron () const
int onlyPionKaonElectron () const
int onlyPionKaonProton () const
int onlyPionKaonProton () const
int onlyProton () const
int onlyProton () const
double p ()
double p ()
double pdfCalculate (double offset, double sigma)
double pdfCalculate (double offset, double sigma)
double pdfMinSigmaCut () const
double pdfMinSigmaCut () const
EvtRecTrackPidTrk () const
EvtRecTrackPidTrk () const
double pol2 (double x, double *par)
double pol2 (double x, double *par)
double pol3 (double x, double *par)
double pol3 (double x, double *par)
double pol4 (double x, double *par)
double pol4 (double x, double *par)
double prob (int n) const
double prob (int n) const
double probCalculate (double chi2, int n)
double probCalculate (double chi2, int n)
double pt ()
double pt ()
void setChiMinCut (const double chi=4)
void setChiMinCut (const double chi=4)
void setPdfMinSigmaCut (const double pdf=4)
void setPdfMinSigmaCut (const double pdf=4)
void setRecTrack (EvtRecTrack *trk)
void setRecTrack (EvtRecTrack *trk)
void setRunNo (const double runh=8093)
void setRunNo (const double runh=8093)
double sigma (int n) const
double sigma (int n) const
int tofcValid () const
int tofcValid () const
int tofeValid () const
int tofeValid () const
int tofqValid () const
int tofqValid () const
int tofValid () const
int tofValid () const
int useDedx () const
int useDedx () const
int useEmc () const
int useEmc () const
int useMuc () const
int useMuc () const
int useTof () const
int useTof () const
int useTof1 () const
int useTof1 () const
int useTof2 () const
int useTof2 () const
int useTofC () const
int useTofC () const
int useTofE () const
int useTofE () const
int useTofQ () const
int useTofQ () const
double velc ()
double velc ()
double xmass (int n)
double xmass (int n)
 ~TofPID ()
 ~TofPID ()

Static Public Member Functions

TofPIDinstance ()
TofPIDinstance ()

Protected Member Functions

int LikelihoodCalculation ()
int LikelihoodCalculation ()
int neuronPIDCalculation ()
int neuronPIDCalculation ()
int particleIDCalculation ()
int particleIDCalculation ()

Private Member Functions

 TofPID ()
 TofPID ()

Private Attributes

double m_chi [5]
double m_chimin
int m_ndof
double m_offset [5]
double m_pdfmin
double m_prob [5]
double m_sigma [5]
Tof1PIDm_tof1pid
Tof1PIDm_tof1pid
Tof2PIDm_tof2pid
Tof2PIDm_tof2pid
bool val_tof1
bool val_tof2
double weight1
double weight2

Static Private Attributes

TofPIDm_pointer
TofPIDm_pointer = 0

Constructor & Destructor Documentation

TofPID::~TofPID  )  [inline]
 

00022 {;} 

TofPID::TofPID  )  [private]
 

00015 :ParticleIDBase() {;}

TofPID::~TofPID  )  [inline]
 

00022 {;} 

TofPID::TofPID  )  [private]
 


Member Function Documentation

int ParticleIDBase::all  )  const [inline, inherited]
 

00091 {return (IDENTIFY_ELECTRON | IDENTIFY_PION | IDENTIFY_KAON | IDENTIFY_PROTON);}

int ParticleIDBase::all  )  const [inline, inherited]
 

00091 {return (IDENTIFY_ELECTRON | IDENTIFY_PION | IDENTIFY_KAON | IDENTIFY_PROTON);}

void TofPID::calculate  )  [virtual]
 

Implements ParticleIDBase.

void TofPID::calculate  )  [virtual]
 

Implements ParticleIDBase.

00041                        {
00042   if(particleIDCalculation() == 0) m_ndof=1;
00043 }

double ParticleIDBase::charge  )  [inherited]
 

double ParticleIDBase::charge  )  [inherited]
 

00077                               {
00078   double val = 999;
00079   if(!m_trk) return val;
00080   if(!m_trk->isMdcTrackValid()) return val;
00081   RecMdcTrack *mdcTrk = m_trk->mdcTrack();
00082   val = mdcTrk->charge() + 0.0;
00083 }

double TofPID::chi int  n  )  const [inline, virtual]
 

Implements ParticleIDBase.

00027 {return m_chi[n];}

double TofPID::chi int  n  )  const [inline, virtual]
 

Implements ParticleIDBase.

00027 {return m_chi[n];}

double TofPID::chilayer1 int  n  )  const
 

double TofPID::chilayer1 int  n  )  const
 

00029                                       {
00030   double chi = 99;
00031   if(val_tof1) chi = m_tof1pid->chi(n);
00032   return chi;
00033 }       

double TofPID::chilayer2 int  n  )  const
 

double TofPID::chilayer2 int  n  )  const
 

00035                                       {
00036   double chi = 99;
00037   if(val_tof2) chi = m_tof2pid->chi(n);
00038   return chi;
00039 }

double ParticleIDBase::chiMinCut  )  const [inline, inherited]
 

00052 {return m_chimin_cut;}

double ParticleIDBase::chiMinCut  )  const [inline, inherited]
 

00052 {return m_chimin_cut;}

int ParticleIDBase::dedxValid  )  const [inline, inherited]
 

00103 {return DEDX_VALID;}

int ParticleIDBase::dedxValid  )  const [inline, inherited]
 

00103 {return DEDX_VALID;}

int ParticleIDBase::emcValid  )  const [inline, inherited]
 

00108 {return EMC_VALID;}

int ParticleIDBase::emcValid  )  const [inline, inherited]
 

00108 {return EMC_VALID;}

double ParticleIDBase::getRunNo  )  const [inline, inherited]
 

00056 {return m_runno;}

double ParticleIDBase::getRunNo  )  const [inline, inherited]
 

00056 {return m_runno;}

double TofPID::getweight1  )  const [inline]
 

00032 { return weight1;}

double TofPID::getweight1  )  const [inline]
 

00032 { return weight1;}

double TofPID::getweight2  )  const [inline]
 

00033 { return weight2;}

double TofPID::getweight2  )  const [inline]
 

00033 { return weight2;}

void TofPID::init  )  [virtual]
 

Implements ParticleIDBase.

void TofPID::init  )  [virtual]
 

Implements ParticleIDBase.

00017                   {
00018   for(int i = 0; i < 5; i++) {
00019     m_chi[i] = 99.0;
00020     m_prob[i] = -1.0;
00021     m_sigma[i] = 1;
00022     m_offset[i] = 99.0;
00023   }
00024   m_chimin = 99.;
00025   m_pdfmin = 99.;
00026   m_ndof = 0;
00027 }

TofPID* TofPID::instance  )  [static]
 

TofPID * TofPID::instance  )  [static]
 

00010                           {
00011   if(!m_pointer) m_pointer = new TofPID();
00012   return m_pointer;
00013 }

double ParticleIDBase::interpolation double *  x,
double *  y,
double  x1
[inherited]
 

double ParticleIDBase::interpolation double *  x,
double *  y,
double  x1
[inherited]
 

00085                                                                   {
00086   double c1 = (y[0]-y[1])*(x[1]-x[2])-(x[0]-x[1])*(y[1]-y[2]);
00087   double c2 = (x[0]*x[0]-x[1]*x[1])*(x[1]-x[2])-(x[1]*x[1]-x[2]*x[2])*(x[0]-x[1]);
00088   double c = c1/c2;
00089   double b1 = (y[0]-y[1])*(x[1]*x[1]-x[2]*x[2])-(x[0]*x[0]-x[1]*x[1])*(y[1]-y[2]);
00090   double b2 = (x[0]-x[1])*(x[1]*x[1]-x[2]*x[2])-(x[1]-x[2])*(x[0]*x[0]-x[1]*x[1]);
00091   double b = b1/b2;
00092   double a = y[0] - b*x[0]-c*x[0]*x[0];
00093   double y1 = a + b*x1 +c*x1*x1;
00094   return y1;
00095 }

bool TofPID::IsPidInfoValid  )  const [inline, virtual]
 

Implements ParticleIDBase.

00026 {return (m_ndof > 0); }

bool TofPID::IsPidInfoValid  )  const [inline, virtual]
 

Implements ParticleIDBase.

00026 {return (m_ndof > 0); }

int TofPID::LikelihoodCalculation  )  [inline, protected, virtual]
 

Implements ParticleIDBase.

00041 {return -1;}

int TofPID::LikelihoodCalculation  )  [inline, protected, virtual]
 

Implements ParticleIDBase.

00041 {return -1;}

int ParticleIDBase::methodLikelihood  )  const [inline, inherited]
 

00099 {return LIKELIHOOD_PID;}

int ParticleIDBase::methodLikelihood  )  const [inline, inherited]
 

00099 {return LIKELIHOOD_PID;}

int ParticleIDBase::methodNeuronNetwork  )  const [inline, inherited]
 

00101 {return NEURONNETWORK_PID;}

int ParticleIDBase::methodNeuronNetwork  )  const [inline, inherited]
 

00101 {return NEURONNETWORK_PID;}

int ParticleIDBase::methodProbability  )  const [inline, inherited]
 

00100 {return PROBABILITY_PID;}

int ParticleIDBase::methodProbability  )  const [inline, inherited]
 

00100 {return PROBABILITY_PID;}

int ParticleIDBase::mucValid  )  const [inline, inherited]
 

00109 {return MUC_VALID;}

int ParticleIDBase::mucValid  )  const [inline, inherited]
 

00109 {return MUC_VALID;}

int TofPID::ndof  )  const [inline, virtual]
 

Implements ParticleIDBase.

00031 {return m_ndof;}

int TofPID::ndof  )  const [inline, virtual]
 

Implements ParticleIDBase.

00031 {return m_ndof;}

int TofPID::neuronPIDCalculation  )  [inline, protected]
 

00040 { return -1;}

int TofPID::neuronPIDCalculation  )  [inline, protected]
 

00040 { return -1;}

double TofPID::offset int  n  )  const [inline]
 

00029 {return m_offset[n];}

double TofPID::offset int  n  )  const [inline]
 

00029 {return m_offset[n];}

int ParticleIDBase::onlyElectron  )  const [inline, inherited]
 

00092 {return IDENTIFY_ELECTRON;}

int ParticleIDBase::onlyElectron  )  const [inline, inherited]
 

00092 {return IDENTIFY_ELECTRON;}

int ParticleIDBase::onlyKaon  )  const [inline, inherited]
 

00095 {return IDENTIFY_KAON;}

int ParticleIDBase::onlyKaon  )  const [inline, inherited]
 

00095 {return IDENTIFY_KAON;}

int ParticleIDBase::onlyMuon  )  const [inline, inherited]
 

00093 {return IDENTIFY_MUON;}

int ParticleIDBase::onlyMuon  )  const [inline, inherited]
 

00093 {return IDENTIFY_MUON;}

int ParticleIDBase::onlyPion  )  const [inline, inherited]
 

00094 {return IDENTIFY_PION;}

int ParticleIDBase::onlyPion  )  const [inline, inherited]
 

00094 {return IDENTIFY_PION;}

int ParticleIDBase::onlyPionKaon  )  const [inline, inherited]
 

00088 {return (IDENTIFY_PION | IDENTIFY_KAON);}

int ParticleIDBase::onlyPionKaon  )  const [inline, inherited]
 

00088 {return (IDENTIFY_PION | IDENTIFY_KAON);}

int ParticleIDBase::onlyPionKaonElectron  )  const [inline, inherited]
 

00090 {return (IDENTIFY_PION | IDENTIFY_KAON | IDENTIFY_ELECTRON);}

int ParticleIDBase::onlyPionKaonElectron  )  const [inline, inherited]
 

00090 {return (IDENTIFY_PION | IDENTIFY_KAON | IDENTIFY_ELECTRON);}

int ParticleIDBase::onlyPionKaonProton  )  const [inline, inherited]
 

00089 {return (IDENTIFY_PION | IDENTIFY_KAON | IDENTIFY_PROTON);}

int ParticleIDBase::onlyPionKaonProton  )  const [inline, inherited]
 

00089 {return (IDENTIFY_PION | IDENTIFY_KAON | IDENTIFY_PROTON);}

int ParticleIDBase::onlyProton  )  const [inline, inherited]
 

00096 {return IDENTIFY_PROTON;}

int ParticleIDBase::onlyProton  )  const [inline, inherited]
 

00096 {return IDENTIFY_PROTON;}

double ParticleIDBase::p  )  [inherited]
 

double ParticleIDBase::p  )  [inherited]
 

00063                          {
00064   double val = 999;
00065   if(!m_trk) return val;
00066   if(!m_trk->isMdcTrackValid()) return val;
00067   RecMdcTrack *mdcTrk = m_trk->mdcTrack();
00068   val = mdcTrk->p();
00069 }

int TofPID::particleIDCalculation  )  [protected, virtual]
 

Implements ParticleIDBase.

int TofPID::particleIDCalculation  )  [protected, virtual]
 

Implements ParticleIDBase.

00047                                   {
00048    int irc=-1;
00049    EvtRecTrack* recTrk = PidTrk();
00050    m_tof1pid = Tof1PID::instance();
00051    m_tof1pid->init();
00052    m_tof1pid->setRecTrack(recTrk); 
00053    m_tof1pid->setChiMinCut(chiMinCut());
00054    m_tof1pid->setPdfMinSigmaCut(pdfMinSigmaCut());
00055    m_tof1pid->calculate();
00056 val_tof1 = m_tof1pid->IsPidInfoValid();
00057    m_tof2pid = Tof2PID::instance(); 
00058    m_tof2pid->init();
00059    m_tof2pid->setRecTrack(recTrk);
00060    m_tof2pid->setChiMinCut(chiMinCut());
00061    m_tof2pid->setPdfMinSigmaCut(pdfMinSigmaCut());
00062    m_tof2pid->calculate();
00063     val_tof2 = m_tof2pid->IsPidInfoValid();
00064    double chitemp = 99.;
00065    double pdftemp = 0;
00066    for(int i=0;i<5;i++){
00067      double t_tof1 = m_tof1pid->offset(i);
00068      double t_tof2 = m_tof2pid->offset(i);
00069      double m_sigma1 = m_tof1pid->sigma(i);
00070      double m_sigma2 = m_tof2pid->sigma(i);
00071    //  double weight1,weight2;
00072        if(val_tof1==1&&val_tof2==1){
00073    weight1 =  (m_sigma2*m_sigma2-0.041*0.041)/(m_sigma1*m_sigma1+m_sigma2*m_sigma2-2*0.041*0.041);
00074    weight2 = (m_sigma1*m_sigma1-0.041*0.041)/(m_sigma1*m_sigma1+m_sigma2*m_sigma2-2*0.041*0.041);
00075       m_sigma[i] = sqrt((m_sigma1*m_sigma1*m_sigma2*m_sigma2 - 0.041*0.041*0.041*0.041)/(m_sigma1*m_sigma1+m_sigma2*m_sigma2-2*0.041*0.041));
00076       m_offset[i] = weight1*t_tof1+weight2*t_tof2;
00077       m_chi[i] = m_offset[i]/m_sigma[i];
00078        }
00079     if(val_tof1==1&&val_tof2==0){
00080       weight1=1;
00081       weight2=0;
00082        m_sigma[i] =  m_tof1pid->sigma(i);
00083        m_offset[i] = t_tof1;
00084        m_chi[i] = m_tof1pid->chi(i);
00085     }
00086 
00087     if(val_tof1==0&&val_tof2==1){
00088       weight1=0;
00089       weight2=1;
00090      m_sigma[i] =  m_tof2pid->sigma(i);
00091      m_offset[i] = t_tof2;
00092      m_chi[i] = m_tof2pid->chi(i);
00093       }
00094 
00095      if(val_tof1==0&&val_tof2==0) return irc;
00096      if(fabs(m_chi[i]) < chitemp) chitemp = fabs(m_chi[i]);
00097      double ppp = pdfCalculate(m_chi[i],1); 
00098      if(fabs(ppp) > pdftemp) pdftemp = fabs(ppp);
00099     } 
00100    
00101      m_chimin = chitemp;
00102       m_pdfmin = pdftemp;
00103       if(pdftemp < pdfCalculate(pdfMinSigmaCut(),1)) return irc;
00104    if(m_chimin > chiMinCut()) return irc;
00105   for(int i = 0; i < 5; i++)
00106     m_prob[i] = probCalculate(m_chi[i]*m_chi[i], 1);
00107   irc = 0;
00108   return irc;
00109 }

double ParticleIDBase::pdfCalculate double  offset,
double  sigma
[inherited]
 

double ParticleIDBase::pdfCalculate double  offset,
double  sigma
[inherited]
 

00055                                                               {
00056  const double pi =  3.141592653589793238;
00057  const double twoPi = 2*pi;
00058  double chi2 = -0.5*offset*offset/(sigma*sigma);
00059  double pdf = exp(chi2)/(sigma*sqrt(twoPi));
00060   return pdf;
00061 }

double ParticleIDBase::pdfMinSigmaCut  )  const [inline, inherited]
 

00054 {return m_pdfsigmamin_cut;} 

double ParticleIDBase::pdfMinSigmaCut  )  const [inline, inherited]
 

00054 {return m_pdfsigmamin_cut;} 

EvtRecTrack* ParticleIDBase::PidTrk  )  const [inline, inherited]
 

00050 {return m_trk;}

EvtRecTrack* ParticleIDBase::PidTrk  )  const [inline, inherited]
 

00050 {return m_trk;}

double ParticleIDBase::pol2 double  x,
double *  par
[inherited]
 

double ParticleIDBase::pol2 double  x,
double *  par
[inherited]
 

00097                                                 {
00098    double y=x;
00099    return par[0] + (par[1] * y) +(par[2] * y * y);
00100 }

double ParticleIDBase::pol3 double  x,
double *  par
[inherited]
 

double ParticleIDBase::pol3 double  x,
double *  par
[inherited]
 

00102                                                 {
00103    double y=x;
00104    return par[0] + (par[1] * y) +(par[2] * y * y)+(par[3] * y * y*y);
00105 }

double ParticleIDBase::pol4 double  x,
double *  par
[inherited]
 

double ParticleIDBase::pol4 double  x,
double *  par
[inherited]
 

00107                                                 {
00108    double y=x;
00109    return par[0] + (par[1] * y) +(par[2] * y * y)+(par[3] * y * y*y) + (par[4] * y * y*y*y);
00110 }

double TofPID::prob int  n  )  const [inline, virtual]
 

Implements ParticleIDBase.

00028 {return m_prob[n];}

double TofPID::prob int  n  )  const [inline, virtual]
 

Implements ParticleIDBase.

00028 {return m_prob[n];}

double ParticleIDBase::probCalculate double  chi2,
int  n
[inherited]
 

double ParticleIDBase::probCalculate double  chi2,
int  n
[inherited]
 

00047                                                           {
00048   double p = -1.0;
00049   if(chi2 < 0) return p;
00050   p = TMath::Prob(chi2, ndof);
00051   return p;
00052 }

double ParticleIDBase::pt  )  [inherited]
 

double ParticleIDBase::pt  )  [inherited]
 

00070                           {
00071   double val = 999;
00072   if(!m_trk) return val;
00073   if(!m_trk->isMdcTrackValid()) return val;
00074   RecMdcTrack *mdcTrk = m_trk->mdcTrack();
00075   val = mdcTrk->pxy();
00076 }

void ParticleIDBase::setChiMinCut const double  chi = 4  )  [inline, inherited]
 

00053 {m_chimin_cut = chi;}

void ParticleIDBase::setChiMinCut const double  chi = 4  )  [inline, inherited]
 

00053 {m_chimin_cut = chi;}

void ParticleIDBase::setPdfMinSigmaCut const double  pdf = 4  )  [inline, inherited]
 

00055 {m_pdfsigmamin_cut= pdf;}  

void ParticleIDBase::setPdfMinSigmaCut const double  pdf = 4  )  [inline, inherited]
 

00055 {m_pdfsigmamin_cut= pdf;}  

void ParticleIDBase::setRecTrack EvtRecTrack trk  )  [inline, inherited]
 

00051 {m_trk = trk;} 

void ParticleIDBase::setRecTrack EvtRecTrack trk  )  [inline, inherited]
 

00051 {m_trk = trk;} 

void ParticleIDBase::setRunNo const double  runh = 8093  )  [inline, inherited]
 

00057 {m_runno = runh;}

void ParticleIDBase::setRunNo const double  runh = 8093  )  [inline, inherited]
 

00057 {m_runno = runh;}

double TofPID::sigma int  n  )  const [inline]
 

00030 {return m_sigma[n];}

double TofPID::sigma int  n  )  const [inline]
 

00030 {return m_sigma[n];}

int ParticleIDBase::tofcValid  )  const [inline, inherited]
 

00107 {return TOFC_VALID;}

int ParticleIDBase::tofcValid  )  const [inline, inherited]
 

00107 {return TOFC_VALID;}

int ParticleIDBase::tofeValid  )  const [inline, inherited]
 

00105 {return TOFE_VALID;}

int ParticleIDBase::tofeValid  )  const [inline, inherited]
 

00105 {return TOFE_VALID;}

int ParticleIDBase::tofqValid  )  const [inline, inherited]
 

00106 {return TOFQ_VALID;}

int ParticleIDBase::tofqValid  )  const [inline, inherited]
 

00106 {return TOFQ_VALID;}

int ParticleIDBase::tofValid  )  const [inline, inherited]
 

00104 {return TOF_VALID;}

int ParticleIDBase::tofValid  )  const [inline, inherited]
 

00104 {return TOF_VALID;}

int ParticleIDBase::useDedx  )  const [inline, inherited]
 

00077 {return USE_DEDX;}

int ParticleIDBase::useDedx  )  const [inline, inherited]
 

00077 {return USE_DEDX;}

int ParticleIDBase::useEmc  )  const [inline, inherited]
 

00084 {return USE_EMC;}

int ParticleIDBase::useEmc  )  const [inline, inherited]
 

00084 {return USE_EMC;}

int ParticleIDBase::useMuc  )  const [inline, inherited]
 

00085 {return USE_MUC;}

int ParticleIDBase::useMuc  )  const [inline, inherited]
 

00085 {return USE_MUC;}

int ParticleIDBase::useTof  )  const [inline, inherited]
 

00078 {return USE_TOF;}

int ParticleIDBase::useTof  )  const [inline, inherited]
 

00078 {return USE_TOF;}

int ParticleIDBase::useTof1  )  const [inline, inherited]
 

00079 {return USE_TOF1;}

int ParticleIDBase::useTof1  )  const [inline, inherited]
 

00079 {return USE_TOF1;}

int ParticleIDBase::useTof2  )  const [inline, inherited]
 

00080 {return USE_TOF2;}

int ParticleIDBase::useTof2  )  const [inline, inherited]
 

00080 {return USE_TOF2;}

int ParticleIDBase::useTofC  )  const [inline, inherited]
 

00083 {return USE_TOFC;}

int ParticleIDBase::useTofC  )  const [inline, inherited]
 

00083 {return USE_TOFC;}

int ParticleIDBase::useTofE  )  const [inline, inherited]
 

00081 {return USE_TOFE;}

int ParticleIDBase::useTofE  )  const [inline, inherited]
 

00081 {return USE_TOFE;}

int ParticleIDBase::useTofQ  )  const [inline, inherited]
 

00082 {return USE_TOFQ;}

int ParticleIDBase::useTofQ  )  const [inline, inherited]
 

00082 {return USE_TOFQ;}

double ParticleIDBase::velc  )  [inherited]
 

double ParticleIDBase::velc  )  [inherited]
 

00041                             {
00042   //  double vel = 29.9792458;  // tof_path unit in cm.
00043   double vel = 299.792458;   // tof path unit in mm
00044   return vel;
00045 }

double ParticleIDBase::xmass int  n  )  [inherited]
 

double ParticleIDBase::xmass int  n  )  [inherited]
 

00035                                   {
00036   double mass[5] = {0.000511, 0.105658, 0.139570,0.493677, 0.938272};
00037   if(n < 0 || n >=5) return 0.0;
00038   return mass[n];
00039 }


Member Data Documentation

double TofPID::m_chi [private]
 

double TofPID::m_chimin [private]
 

int TofPID::m_ndof [private]
 

double TofPID::m_offset [private]
 

double TofPID::m_pdfmin [private]
 

TofPID* TofPID::m_pointer [static, private]
 

TofPID * TofPID::m_pointer = 0 [static, private]
 

double TofPID::m_prob [private]
 

double TofPID::m_sigma [private]
 

Tof1PID* TofPID::m_tof1pid [private]
 

Tof1PID* TofPID::m_tof1pid [private]
 

Tof2PID* TofPID::m_tof2pid [private]
 

Tof2PID* TofPID::m_tof2pid [private]
 

bool TofPID::val_tof1 [private]
 

bool TofPID::val_tof2 [private]
 

double TofPID::weight1 [private]
 

double TofPID::weight2 [private]
 


The documentation for this class was generated from the following files:
Generated on Wed Feb 2 18:59:40 2011 for BOSS6.5.5 by  doxygen 1.3.9.1