TofPID Class Reference

#include <TofPID.h>

Inheritance diagram for TofPID:

ParticleIDBase List of all members.

Public Member Functions

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

Static Public Member Functions

static TofPIDinstance ()

Protected Member Functions

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

Static Protected Attributes

static std::string path = ""

Private Member Functions

 TofPID ()

Private Attributes

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

Static Private Attributes

static TofPIDm_pointer = 0

Detailed Description

Definition at line 17 of file TofPID.h.


Constructor & Destructor Documentation

TofPID::~TofPID (  )  [inline]

Definition at line 22 of file TofPID.h.

00022 {;} 

TofPID::TofPID (  )  [private]

Definition at line 20 of file TofPID.cxx.

Referenced by instance().

00020               :ParticleIDBase() {
00021    ;
00022 }


Member Function Documentation

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

Definition at line 79 of file ParticleIDBase.h.

References ParticleIDBase::IDENTIFY_ELECTRON, ParticleIDBase::IDENTIFY_KAON, ParticleIDBase::IDENTIFY_PION, and ParticleIDBase::IDENTIFY_PROTON.

void TofPID::calculate (  )  [virtual]

Implements ParticleIDBase.

Definition at line 48 of file TofPID.cxx.

References m_ndof, and particleIDCalculation().

00048                        {
00049    if(particleIDCalculation() == 0) m_ndof=1;
00050 }

double ParticleIDBase::charge (  )  [inherited]

Definition at line 116 of file ParticleIDBase.cxx.

References DstMdcTrack::charge(), EvtRecTrack::isMdcTrackValid(), ParticleIDBase::m_trk, and EvtRecTrack::mdcTrack().

Referenced by TofCorrPID::particleIDCalculation(), Tof2PID::particleIDCalculation(), Tof1PID::particleIDCalculation(), and DedxPID::particleIDCalculation().

00116                               {
00117    double val = 999;
00118    if(!m_trk) return val;
00119    if(!m_trk->isMdcTrackValid()) return val;
00120    RecMdcTrack *mdcTrk = m_trk->mdcTrack();
00121    val = mdcTrk->charge() + 0.0;
00122    return val;
00123 }

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

Implements ParticleIDBase.

Definition at line 27 of file TofPID.h.

References m_chi.

Referenced by chilayer1(), and chilayer2().

00027 {return m_chi[n];}

double TofPID::chilayer1 ( int  n  )  const

Definition at line 36 of file TofPID.cxx.

References Tof1PID::chi(), chi(), m_tof1pid, and val_tof1.

00036                                       {
00037    double chi = 99;
00038    if(val_tof1) chi = m_tof1pid->chi(n);
00039    return chi;
00040 }

double TofPID::chilayer2 ( int  n  )  const

Definition at line 42 of file TofPID.cxx.

References Tof2PID::chi(), chi(), m_tof2pid, and val_tof2.

00042                                       {
00043    double chi = 99;
00044    if(val_tof2) chi = m_tof2pid->chi(n);
00045    return chi;
00046 }

double ParticleIDBase::chiMaxCut (  )  const [inline, inherited]

Definition at line 40 of file ParticleIDBase.h.

References ParticleIDBase::m_chimax_cut.

Referenced by TofCorrPID::correlationCheck(), TofCorrPID::particleIDCalculation(), and ParticleID::particleIDCalculation().

00040 {return m_chimax_cut;}

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

Definition at line 38 of file ParticleIDBase.h.

References ParticleIDBase::m_chimin_cut.

Referenced by TofCorrPID::correlationCheck(), particleIDCalculation(), TofCPID::particleIDCalculation(), TofCorrPID::particleIDCalculation(), Tof2PID::particleIDCalculation(), Tof1PID::particleIDCalculation(), ParticleID::particleIDCalculation(), and DedxPID::particleIDCalculation().

00038 {return m_chimin_cut;}

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

Definition at line 91 of file ParticleIDBase.h.

References ParticleIDBase::DEDX_VALID.

00091 {return DEDX_VALID;}

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

Definition at line 97 of file ParticleIDBase.h.

References ParticleIDBase::EMC_VALID.

00097 {return EMC_VALID;}

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

Definition at line 44 of file ParticleIDBase.h.

References ParticleIDBase::m_runno.

Referenced by TofCPID::calculate(), DedxPID::CorrDedx(), TofCorrPID::init(), TofCPID::offsetTofC(), TofCorrPID::sigmaTof(), and TofCPID::sigmaTofC().

00044 {return m_runno;}

double TofPID::getweight1 (  )  const [inline]

Definition at line 32 of file TofPID.h.

References weight1.

00032 { return weight1;}

double TofPID::getweight2 (  )  const [inline]

Definition at line 33 of file TofPID.h.

References weight2.

00033 { return weight2;}

void TofPID::init (  )  [virtual]

Implements ParticleIDBase.

Definition at line 24 of file TofPID.cxx.

References genRecEmupikp::i, m_chi, m_chimin, m_ndof, m_offset, m_pdfmin, m_prob, and m_sigma.

Referenced by ParticleID::init().

00024                   {
00025    for(int i = 0; i < 5; i++) {
00026       m_chi[i] = 99.0;
00027       m_prob[i] = -1.0;
00028       m_sigma[i] = 1;
00029       m_offset[i] = 99.0;
00030    }
00031    m_chimin = 99.;
00032    m_pdfmin = 99.;
00033    m_ndof = 0;
00034 }

TofPID * TofPID::instance (  )  [static]

Definition at line 15 of file TofPID.cxx.

References m_pointer, and TofPID().

Referenced by ParticleID::init().

00015                           {
00016    if(!m_pointer) m_pointer = new TofPID();
00017    return m_pointer;
00018 }

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

Definition at line 125 of file ParticleIDBase.cxx.

00125                                                                    {
00126    double c1 = (y[0]-y[1])*(x[1]-x[2])-(x[0]-x[1])*(y[1]-y[2]);
00127    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]);
00128    double c = c1/c2;
00129    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]);
00130    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]);
00131    double b = b1/b2;
00132    double a = y[0] - b*x[0]-c*x[0]*x[0];
00133    double y1 = a + b*x1 +c*x1*x1;
00134    return y1;
00135 }

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

Implements ParticleIDBase.

Definition at line 26 of file TofPID.h.

References m_ndof.

00026 {return (m_ndof > 0); }

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

Implements ParticleIDBase.

Definition at line 41 of file TofPID.h.

00041 {return -1;}

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

Definition at line 87 of file ParticleIDBase.h.

References ParticleIDBase::LIKELIHOOD_PID.

00087 {return LIKELIHOOD_PID;}

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

Definition at line 89 of file ParticleIDBase.h.

References ParticleIDBase::NEURONNETWORK_PID.

00089 {return NEURONNETWORK_PID;}

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

Definition at line 88 of file ParticleIDBase.h.

References ParticleIDBase::PROBABILITY_PID.

00088 {return PROBABILITY_PID;}

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

Definition at line 98 of file ParticleIDBase.h.

References ParticleIDBase::MUC_VALID.

00098 {return MUC_VALID;}

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

Implements ParticleIDBase.

Definition at line 31 of file TofPID.h.

References m_ndof.

00031 {return m_ndof;}

int TofPID::neuronPIDCalculation (  )  [inline, protected]

Definition at line 40 of file TofPID.h.

00040 { return -1;}

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

Definition at line 29 of file TofPID.h.

References m_offset.

00029 {return m_offset[n];}

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

Definition at line 80 of file ParticleIDBase.h.

References ParticleIDBase::IDENTIFY_ELECTRON.

Referenced by ParticleID::LikelihoodCalculation(), and ParticleID::particleIDCalculation().

00080 {return IDENTIFY_ELECTRON;}

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

Definition at line 83 of file ParticleIDBase.h.

References ParticleIDBase::IDENTIFY_KAON.

Referenced by ParticleID::LikelihoodCalculation(), and ParticleID::particleIDCalculation().

00083 {return IDENTIFY_KAON;}

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

Definition at line 81 of file ParticleIDBase.h.

References ParticleIDBase::IDENTIFY_MUON.

Referenced by ParticleID::LikelihoodCalculation(), and ParticleID::particleIDCalculation().

00081 {return IDENTIFY_MUON;}

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

Definition at line 82 of file ParticleIDBase.h.

References ParticleIDBase::IDENTIFY_PION.

Referenced by ParticleID::LikelihoodCalculation(), and ParticleID::particleIDCalculation().

00082 {return IDENTIFY_PION;}

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

Definition at line 76 of file ParticleIDBase.h.

References ParticleIDBase::IDENTIFY_KAON, and ParticleIDBase::IDENTIFY_PION.

00076 {return (IDENTIFY_PION | IDENTIFY_KAON);}

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

Definition at line 78 of file ParticleIDBase.h.

References ParticleIDBase::IDENTIFY_ELECTRON, ParticleIDBase::IDENTIFY_KAON, and ParticleIDBase::IDENTIFY_PION.

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

Definition at line 77 of file ParticleIDBase.h.

References ParticleIDBase::IDENTIFY_KAON, ParticleIDBase::IDENTIFY_PION, and ParticleIDBase::IDENTIFY_PROTON.

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

Definition at line 84 of file ParticleIDBase.h.

References ParticleIDBase::IDENTIFY_PROTON.

Referenced by ParticleID::LikelihoodCalculation(), and ParticleID::particleIDCalculation().

00084 {return IDENTIFY_PROTON;}

double ParticleIDBase::p (  )  [inherited]

Definition at line 100 of file ParticleIDBase.cxx.

References EvtRecTrack::isMdcTrackValid(), ParticleIDBase::m_trk, EvtRecTrack::mdcTrack(), and DstMdcTrack::p().

Referenced by DedxPID::cal_par(), TofCorrPID::particleIDCalculation(), and ParticleIDBase::probCalculate().

00100                          {
00101    double val = 999;
00102    if(!m_trk) return val;
00103    if(!m_trk->isMdcTrackValid()) return val;
00104    RecMdcTrack *mdcTrk = m_trk->mdcTrack();
00105    val = mdcTrk->p();
00106    return val;
00107 }

int TofPID::particleIDCalculation (  )  [protected, virtual]

Implements ParticleIDBase.

Definition at line 54 of file TofPID.cxx.

References Tof2PID::calculate(), Tof1PID::calculate(), Tof2PID::chi(), Tof1PID::chi(), ParticleIDBase::chiMinCut(), genRecEmupikp::i, Tof2PID::init(), Tof1PID::init(), Tof2PID::instance(), Tof1PID::instance(), Tof2PID::IsPidInfoValid(), Tof1PID::IsPidInfoValid(), m_chi, m_chimin, m_offset, m_pdfmin, m_prob, m_sigma, m_tof1pid, m_tof2pid, Tof2PID::offset(), Tof1PID::offset(), ParticleIDBase::pdfCalculate(), ParticleIDBase::pdfMinSigmaCut(), ParticleIDBase::PidTrk(), ParticleIDBase::probCalculate(), ParticleIDBase::setChiMinCut(), ParticleIDBase::setPdfMinSigmaCut(), ParticleIDBase::setRecTrack(), Tof2PID::sigma(), Tof1PID::sigma(), val_tof1, val_tof2, weight1, and weight2.

Referenced by calculate().

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

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

Definition at line 91 of file ParticleIDBase.cxx.

References exp(), M_PI, pi, and twoPi.

Referenced by TofCorrPID::correlationCheck(), ParticleID::LikelihoodCalculation(), particleIDCalculation(), TofEPID::particleIDCalculation(), TofCPID::particleIDCalculation(), TofCorrPID::particleIDCalculation(), Tof2PID::particleIDCalculation(), Tof1PID::particleIDCalculation(), and DedxPID::particleIDCalculation().

00091                                                               {
00092    //  const double pi =  3.141592653589793238;
00093    const double pi =  M_PI;
00094    const double twoPi = 2*pi;
00095    double chi2 = -0.5*offset*offset/(sigma*sigma);
00096    double pdf = exp(chi2)/(sigma*sqrt(twoPi));
00097    return pdf;
00098 }

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

Definition at line 42 of file ParticleIDBase.h.

References ParticleIDBase::m_pdfsigmamin_cut.

Referenced by TofCorrPID::correlationCheck(), ParticleID::LikelihoodCalculation(), particleIDCalculation(), TofCPID::particleIDCalculation(), TofCorrPID::particleIDCalculation(), Tof2PID::particleIDCalculation(), Tof1PID::particleIDCalculation(), and DedxPID::particleIDCalculation().

00042 {return m_pdfsigmamin_cut;}

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

Definition at line 36 of file ParticleIDBase.h.

References ParticleIDBase::m_trk.

Referenced by TofQPID::particleIDCalculation(), particleIDCalculation(), TofEPID::particleIDCalculation(), TofCPID::particleIDCalculation(), TofCorrPID::particleIDCalculation(), Tof2PID::particleIDCalculation(), Tof1PID::particleIDCalculation(), MucPID::particleIDCalculation(), EmcPID::particleIDCalculation(), and DedxPID::particleIDCalculation().

00036 {return m_trk;}

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

Definition at line 137 of file ParticleIDBase.cxx.

00137                                                  {
00138    double y=x;
00139    //    return par[0] + (par[1] * y) +(par[2] * y * y);
00140    return par[0] + y*(par[1] + y*(par[2]));
00141 }

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

Definition at line 143 of file ParticleIDBase.cxx.

00143                                                  {
00144    double y=x;
00145    //    return par[0] + (par[1] * y) +(par[2] * y * y)+(par[3] * y * y*y);
00146    return par[0] + y*(par[1] + y*(par[2] + y*(par[3])));
00147 }

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

Definition at line 149 of file ParticleIDBase.cxx.

00149                                                  {
00150    double y=x;
00151    //    return par[0] + (par[1] * y) +(par[2] * y * y)+(par[3] * y * y*y) + (par[4] * y * y*y*y);
00152    return par[0] + y*(par[1] + y*(par[2] + y*(par[3] + y*(par[4]))));
00153 }

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

Implements ParticleIDBase.

Definition at line 28 of file TofPID.h.

References m_prob.

00028 {return m_prob[n];}

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

Definition at line 83 of file ParticleIDBase.cxx.

References ParticleIDBase::p().

Referenced by particleIDCalculation(), TofEPID::particleIDCalculation(), TofCPID::particleIDCalculation(), TofCorrPID::particleIDCalculation(), Tof2PID::particleIDCalculation(), Tof1PID::particleIDCalculation(), ParticleID::particleIDCalculation(), and DedxPID::particleIDCalculation().

00083                                                           {
00084    double p = -1.0;
00085    if(chi2 < 0) return p;
00086    p = TMath::Prob(chi2, ndof);
00087    return p;
00088 }

double ParticleIDBase::pt (  )  [inherited]

Definition at line 108 of file ParticleIDBase.cxx.

References EvtRecTrack::isMdcTrackValid(), ParticleIDBase::m_trk, EvtRecTrack::mdcTrack(), and DstMdcTrack::pxy().

00108                           {
00109    double val = 999;
00110    if(!m_trk) return val;
00111    if(!m_trk->isMdcTrackValid()) return val;
00112    RecMdcTrack *mdcTrk = m_trk->mdcTrack();
00113    val = mdcTrk->pxy();
00114    return val;
00115 }

void ParticleIDBase::set_path ( std::string  s_path  )  [inline, inherited]

Definition at line 105 of file ParticleIDBase.h.

References ParticleIDBase::path.

00105 {path = s_path;}

void ParticleIDBase::set_path ( const char *  s_path = 0  )  [inherited]

Definition at line 55 of file ParticleIDBase.cxx.

References ParticleIDBase::path, and deljobs::string.

Referenced by ParticleIDBase::ParticleIDBase().

00056 {
00057    if ( s_path ) {
00058       path = string(s_path);
00059    } else {
00060       char* env_path = getenv("PARTICLEIDROOT");
00061       if ( !env_path ) {
00062          cout << "  ParticleIDBase::set_path ERROR:"
00063               " the environment PARTICLEIDROOT not defined " << endl;
00064          exit(1);
00065       }
00066       path = string(env_path);
00067    }
00068 }

void ParticleIDBase::setChiMaxCut ( const double  chi = 6  )  [inline, inherited]

Definition at line 41 of file ParticleIDBase.h.

References ParticleIDBase::chi(), and ParticleIDBase::m_chimax_cut.

Referenced by ParticleID::init().

00041 {m_chimax_cut = chi;}

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

Definition at line 39 of file ParticleIDBase.h.

References ParticleIDBase::chi(), and ParticleIDBase::m_chimin_cut.

Referenced by ParticleID::init(), and particleIDCalculation().

00039 {m_chimin_cut = chi;}

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

Definition at line 43 of file ParticleIDBase.h.

References ParticleIDBase::m_pdfsigmamin_cut.

Referenced by particleIDCalculation().

00043 {m_pdfsigmamin_cut= pdf;}

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

Definition at line 37 of file ParticleIDBase.h.

References ParticleIDBase::m_trk.

Referenced by particleIDCalculation().

00037 {m_trk = trk;}

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

Definition at line 45 of file ParticleIDBase.h.

References ParticleIDBase::m_runno.

00045 {m_runno = runh;}

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

Definition at line 30 of file TofPID.h.

References m_sigma.

00030 {return m_sigma[n];}

int ParticleIDBase::tofcorrValid (  )  const [inline, inherited]

Definition at line 96 of file ParticleIDBase.h.

References ParticleIDBase::TOFCorr_VALID.

00096 {return TOFCorr_VALID;}

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

Definition at line 95 of file ParticleIDBase.h.

References ParticleIDBase::TOFC_VALID.

00095 {return TOFC_VALID;}

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

Definition at line 93 of file ParticleIDBase.h.

References ParticleIDBase::TOFE_VALID.

00093 {return TOFE_VALID;}

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

Definition at line 94 of file ParticleIDBase.h.

References ParticleIDBase::TOFQ_VALID.

00094 {return TOFQ_VALID;}

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

Definition at line 92 of file ParticleIDBase.h.

References ParticleIDBase::TOF_VALID.

00092 {return TOF_VALID;}

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

Definition at line 64 of file ParticleIDBase.h.

References ParticleIDBase::USE_DEDX.

Referenced by ParticleID::IsDedxInfoUsed().

00064 {return USE_DEDX;}

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

Definition at line 72 of file ParticleIDBase.h.

References ParticleIDBase::USE_EMC.

Referenced by ParticleID::IsEmcInfoUsed().

00072 {return USE_EMC;}

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

Definition at line 73 of file ParticleIDBase.h.

References ParticleIDBase::USE_MUC.

Referenced by ParticleID::IsMucInfoUsed().

00073 {return USE_MUC;}

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

Definition at line 65 of file ParticleIDBase.h.

References ParticleIDBase::USE_TOF.

Referenced by ParticleID::IsTofInfoUsed().

00065 {return USE_TOF;}

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

Definition at line 66 of file ParticleIDBase.h.

References ParticleIDBase::USE_TOF1.

Referenced by ParticleID::IsTof1InfoUsed().

00066 {return USE_TOF1;}

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

Definition at line 67 of file ParticleIDBase.h.

References ParticleIDBase::USE_TOF2.

Referenced by ParticleID::IsTof2InfoUsed().

00067 {return USE_TOF2;}

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

Definition at line 70 of file ParticleIDBase.h.

References ParticleIDBase::USE_TOFC.

Referenced by ParticleID::IsTofCInfoUsed().

00070 {return USE_TOFC;}

int ParticleIDBase::useTofCorr (  )  const [inline, inherited]

Definition at line 71 of file ParticleIDBase.h.

References ParticleIDBase::USE_TOFCorr.

Referenced by ParticleID::IsTofCorrInfoUsed().

00071 {return USE_TOFCorr;}

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

Definition at line 68 of file ParticleIDBase.h.

References ParticleIDBase::USE_TOFE.

Referenced by ParticleID::IsTofEInfoUsed().

00068 {return USE_TOFE;}

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

Definition at line 69 of file ParticleIDBase.h.

References ParticleIDBase::USE_TOFQ.

Referenced by ParticleID::IsTofQInfoUsed().

00069 {return USE_TOFQ;}

double ParticleIDBase::velc (  )  [inherited]

Definition at line 77 of file ParticleIDBase.cxx.

Referenced by TofEPID::particleIDCalculation(), TofCPID::particleIDCalculation(), Tof2PID::particleIDCalculation(), and Tof1PID::particleIDCalculation().

00077                             {
00078    //  double vel = 29.9792458;  // tof_path unit in cm.
00079    double vel = 299.792458;   // tof path unit in mm
00080    return vel;
00081 }

double ParticleIDBase::xmass ( int  n  )  [inherited]

Definition at line 71 of file ParticleIDBase.cxx.

References mass.

Referenced by TofCorrPID::offsetTof(), TofCorrPID::particleIDCalculation(), and TofCorrPID::sigmaTof().

00071                                   {
00072    double mass[5] = {0.000511, 0.105658, 0.139570,0.493677, 0.938272};
00073    if(n < 0 || n >=5) return 0.0;
00074    return mass[n];
00075 }


Member Data Documentation

double TofPID::m_chi[5] [private]

Definition at line 46 of file TofPID.h.

Referenced by chi(), init(), and particleIDCalculation().

double TofPID::m_chimin [private]

Definition at line 50 of file TofPID.h.

Referenced by init(), and particleIDCalculation().

int TofPID::m_ndof [private]

Definition at line 52 of file TofPID.h.

Referenced by calculate(), init(), IsPidInfoValid(), and ndof().

double TofPID::m_offset[5] [private]

Definition at line 47 of file TofPID.h.

Referenced by init(), offset(), and particleIDCalculation().

double TofPID::m_pdfmin [private]

Definition at line 51 of file TofPID.h.

Referenced by init(), and particleIDCalculation().

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

Definition at line 59 of file TofPID.h.

Referenced by instance().

double TofPID::m_prob[5] [private]

Definition at line 48 of file TofPID.h.

Referenced by init(), particleIDCalculation(), and prob().

double TofPID::m_sigma[5] [private]

Definition at line 49 of file TofPID.h.

Referenced by init(), particleIDCalculation(), and sigma().

Tof1PID* TofPID::m_tof1pid [private]

Definition at line 53 of file TofPID.h.

Referenced by chilayer1(), and particleIDCalculation().

Tof2PID* TofPID::m_tof2pid [private]

Definition at line 54 of file TofPID.h.

Referenced by chilayer2(), and particleIDCalculation().

std::string ParticleIDBase::path = "" [static, protected, inherited]

Definition at line 102 of file ParticleIDBase.h.

Referenced by TofCPID::calculate(), EmcPID::EmcPID(), MucPID::init(), DedxPID::inputpar(), TofCorrPID::inputParameter(), MucPID::MucPID(), ParticleIDBase::ParticleIDBase(), TofEPID::particleIDCalculation(), TofCPID::particleIDCalculation(), Tof2PID::particleIDCalculation(), Tof1PID::particleIDCalculation(), and ParticleIDBase::set_path().

bool TofPID::val_tof1 [private]

Definition at line 44 of file TofPID.h.

Referenced by chilayer1(), and particleIDCalculation().

bool TofPID::val_tof2 [private]

Definition at line 45 of file TofPID.h.

Referenced by chilayer2(), and particleIDCalculation().

double TofPID::weight1 [private]

Definition at line 55 of file TofPID.h.

Referenced by getweight1(), and particleIDCalculation().

double TofPID::weight2 [private]

Definition at line 56 of file TofPID.h.

Referenced by getweight2(), and particleIDCalculation().


Generated on Tue Nov 29 23:36:06 2016 for BOSS_7.0.2 by  doxygen 1.4.7