]> git.uio.no Git - u/mrichter/AliRoot.git/blobdiff - STEER/AliESDpid.cxx
Optimisation
[u/mrichter/AliRoot.git] / STEER / AliESDpid.cxx
index 280f11a5a8176ea3a7482417acdd7a1fdc3e4492..1effca1d5e22ff15288b241eaf7f3f2967f1c39a 100644 (file)
 //      Origin: Iouri Belikov, CERN, Jouri.Belikov@cern.ch
 //-----------------------------------------------------------------
 
+#include "TArrayI.h"
+#include "TArrayF.h"
+
 #include "AliLog.h"
 #include "AliPID.h"
+#include "AliTOFHeader.h"
 #include "AliESDpid.h"
 #include "AliESDEvent.h"
 #include "AliESDtrack.h"
 
 ClassImp(AliESDpid)
 
-Int_t AliESDpid::MakePID(AliESDEvent *event, Bool_t TPConly, Float_t TimeZeroTOF) const {
+Int_t AliESDpid::MakePID(AliESDEvent *event, Bool_t TPConly, Float_t timeZeroTOF) const {
   //
   //  Calculate probabilities for all detectors, except if TPConly==kTRUE
   //  and combine PID
@@ -42,9 +46,9 @@ Int_t AliESDpid::MakePID(AliESDEvent *event, Bool_t TPConly, Float_t TimeZeroTOF
   //
 
   /*
-  Float_t TimeZeroTOF = 0;
+  Float_t timeZeroTOF = 0;
   if (subtractT0) 
-    TimeZeroTOF = event->GetT0();
+    timeZeroTOF = event->GetT0();
   */
   Int_t nTrk=event->GetNumberOfTracks();
   for (Int_t iTrk=0; iTrk<nTrk; iTrk++) {  
@@ -52,7 +56,7 @@ Int_t AliESDpid::MakePID(AliESDEvent *event, Bool_t TPConly, Float_t TimeZeroTOF
     MakeTPCPID(track);
     if (!TPConly) {
       MakeITSPID(track);
-      MakeTOFPID(track, TimeZeroTOF);
+      MakeTOFPID(track, timeZeroTOF);
       //MakeHMPIDPID(track);
       //MakeTRDPID(track);
     }
@@ -94,7 +98,7 @@ void AliESDpid::MakeTPCPID(AliESDtrack *track) const
     }
 
     if (mismatch)
-       for (Int_t j=0; j<AliPID::kSPECIES; j++) p[j]=1/AliPID::kSPECIES;
+       for (Int_t j=0; j<AliPID::kSPECIES; j++) p[j]=1./AliPID::kSPECIES;
 
     track->SetTPCpid(p);
 
@@ -118,12 +122,28 @@ void AliESDpid::MakeITSPID(AliESDtrack *track) const
   Double_t mom=track->GetP();  
   if (fITSPIDmethod == kITSTruncMean) {
     Double_t dedx=track->GetITSsignal();
+    Bool_t isSA=kTRUE;
+    Double_t momITS=mom;
+    ULong_t trStatus=track->GetStatus();
+    if(trStatus&AliESDtrack::kTPCin) isSA=kFALSE;
+    UChar_t clumap=track->GetITSClusterMap();
+    Int_t nPointsForPid=0;
+    for(Int_t i=2; i<6; i++){
+      if(clumap&(1<<i)) ++nPointsForPid;
+    }
+
+    if(nPointsForPid<3) { // track not to be used for combined PID purposes
+      track->ResetStatus(AliESDtrack::kITSpid);
+      return;
+    }
+
     Double_t p[10];
+
     Bool_t mismatch=kTRUE, heavy=kTRUE;
     for (Int_t j=0; j<AliPID::kSPECIES; j++) {
       Double_t mass=AliPID::ParticleMass(j);//GeV/c^2
-      Double_t bethe=fITSResponse.Bethe(mom,mass);
-      Double_t sigma=fITSResponse.GetResolution(bethe);
+      Double_t bethe=fITSResponse.Bethe(momITS,mass);
+      Double_t sigma=fITSResponse.GetResolution(bethe,nPointsForPid,isSA);
       if (TMath::Abs(dedx-bethe) > fRange*sigma) {
        p[j]=TMath::Exp(-0.5*fRange*fRange)/sigma;
       } else {
@@ -153,14 +173,18 @@ void AliESDpid::MakeITSPID(AliESDtrack *track) const
 
 }
 //_________________________________________________________________________
-void AliESDpid::MakeTOFPID(AliESDtrack *track, Float_t TimeZeroTOF) const
+void AliESDpid::MakeTOFPID(AliESDtrack *track, Float_t /*timeZeroTOF*/) const
 {
   //
   //   TOF PID using gaussian response
   //
+
   if ((track->GetStatus()&AliESDtrack::kTOFout)==0) return;
   if ((track->GetStatus()&AliESDtrack::kTIME)==0) return;
 
+  Int_t ibin = fTOFResponse.GetMomBin(track->GetP());
+  Float_t timezero = fTOFResponse.GetT0bin(ibin);
+
   Double_t time[AliPID::kSPECIESN];
   track->GetIntegratedTimes(time);
 
@@ -186,14 +210,14 @@ void AliESDpid::MakeTOFPID(AliESDtrack *track, Float_t TimeZeroTOF) const
                  sigma[AliPID::kProton]
                  ));
 
-  Double_t tof = track->GetTOFsignal() - TimeZeroTOF;
+  Double_t tof = track->GetTOFsignal() - timezero;
 
   Double_t p[AliPID::kSPECIES];
   Bool_t mismatch = kTRUE, heavy = kTRUE;
   for (Int_t j=0; j<AliPID::kSPECIES; j++) {
     Double_t sig = sigma[j];
-    if (TMath::Abs(tof-time[j]) > fRange*sig) {
-      p[j] = TMath::Exp(-0.5*fRange*fRange)/sig;
+    if (TMath::Abs(tof-time[j]) > (fRange+2)*sig) {
+       p[j] = TMath::Exp(-0.5*(fRange+2)*(fRange+2))/sig;
     } else
       p[j] = TMath::Exp(-0.5*(tof-time[j])*(tof-time[j])/(sig*sig))/sig;
 
@@ -208,11 +232,13 @@ void AliESDpid::MakeTOFPID(AliESDtrack *track, Float_t TimeZeroTOF) const
   }
 
   if (mismatch)
-    for (Int_t j=0; j<AliPID::kSPECIES; j++) p[j]=1/AliPID::kSPECIES;
+    for (Int_t j=0; j<AliPID::kSPECIES; j++) p[j]=1./AliPID::kSPECIES;
 
   track->SetTOFpid(p);
 
   if (heavy) track->ResetStatus(AliESDtrack::kTOFpid);    
+  if (!CheckTOFMatching(track)) track->SetStatus(AliESDtrack::kTOFmismatch);
+  
 }
 //_________________________________________________________________________
 void AliESDpid::MakeTRDPID(AliESDtrack *track) const
@@ -274,3 +300,247 @@ void AliESDpid::CombinePID(AliESDtrack *track) const
 
   track->SetESDpid(p);
 }
+//_________________________________________________________________________
+Bool_t AliESDpid::CheckTOFMatching(AliESDtrack *track) const{
+    Bool_t status = kFALSE;
+    
+    Double_t exptimes[5];
+    track->GetIntegratedTimes(exptimes);
+    
+    Float_t p = track->P();
+    
+    Float_t dedx = track->GetTPCsignal();
+    Float_t time = track->GetTOFsignal() - fTOFResponse.GetStartTime(p);
+    
+    Double_t ptpc[3];
+    track->GetInnerPxPyPz(ptpc);
+    Float_t momtpc=TMath::Sqrt(ptpc[0]*ptpc[0] + ptpc[1]*ptpc[1] + ptpc[2]*ptpc[2]);
+    
+    for(Int_t i=0;i < 5;i++){
+       AliPID::EParticleType type=AliPID::EParticleType(i);
+       
+       Float_t resolutionTOF = fTOFResponse.GetExpectedSigma(p, exptimes[i], AliPID::ParticleMass(i));
+       if(TMath::Abs(exptimes[i] - time) < fRange * resolutionTOF){
+           Float_t dedxExp = fTPCResponse.GetExpectedSignal(momtpc,type);
+           Float_t resolutionTPC = fTPCResponse.GetExpectedSigma(momtpc,track->GetTPCsignalN(),type);
+           
+           if(TMath::Abs(dedx - dedxExp) < fRangeTOFMismatch * resolutionTPC){
+               status = kTRUE;
+           }
+       }
+    }
+    
+    // for nuclei
+    Float_t resolutionTOFpr = fTOFResponse.GetExpectedSigma(p, exptimes[4], AliPID::ParticleMass(4));
+    if(!status && (exptimes[4] + fRange*resolutionTOFpr < time)) status = kTRUE;
+    
+    
+    return status;
+}
+//_________________________________________________________________________
+void AliESDpid::SetTOFResponse(AliESDEvent *event,EStartTimeType_t option){
+  //
+  // Set TOF response function
+  // Input option for event_time used
+  //
+
+    Float_t t0spread = 0.; //event->GetEventTimeSpread();
+    if(t0spread < 10) t0spread = 80;
+
+    // T0 from TOF algorithm
+
+    Bool_t flagT0TOF=kFALSE;
+    Bool_t flagT0T0=kFALSE;
+    Float_t *startTime = new Float_t[fTOFResponse.GetNmomBins()];
+    Float_t *startTimeRes = new Float_t[fTOFResponse.GetNmomBins()];
+    Int_t *startTimeMask = new Int_t[fTOFResponse.GetNmomBins()];
+
+    // T0-TOF arrays
+    Float_t *estimatedT0event = new Float_t[fTOFResponse.GetNmomBins()];
+    Float_t *estimatedT0resolution = new Float_t[fTOFResponse.GetNmomBins()];
+    for(Int_t i=0;i<fTOFResponse.GetNmomBins();i++){
+      estimatedT0event[i]=0.0;
+      estimatedT0resolution[i]=0.0;
+      startTimeMask[i] = 0;
+    }
+
+    Float_t resT0A=75,resT0C=65,resT0AC=55;
+    if(event->GetT0TOF()){ // check if T0 detector information is available
+       flagT0T0=kTRUE;
+    }
+
+
+    AliTOFHeader *tofHeader =(AliTOFHeader*)event->GetTOFHeader();
+
+    if(tofHeader){ // read global info and T0-TOF info from ESD
+      fTOFResponse.SetTimeResolution(tofHeader->GetTOFResolution());
+      t0spread = tofHeader->GetT0spread(); // read t0 sprad
+      if(t0spread < 10) t0spread = 80;
+
+      flagT0TOF=kTRUE;
+      for(Int_t i=0;i<fTOFResponse.GetNmomBins();i++){ // read T0-TOF default value
+       startTime[i]=tofHeader->GetDefaultEventTimeVal();
+       startTimeRes[i]=tofHeader->GetDefaultEventTimeRes();
+      }
+
+      TArrayI *ibin=tofHeader->GetNvalues();
+      TArrayF *t0Bin=tofHeader->GetEventTimeValues();
+      TArrayF *t0ResBin=tofHeader->GetEventTimeRes();
+      for(Int_t j=0;j < tofHeader->GetNbins();j++){ // fill T0-TOF in p-bins
+       Int_t icurrent = (Int_t)ibin->GetAt(j);
+       startTime[icurrent]=t0Bin->GetAt(j);
+       startTimeRes[icurrent]=t0ResBin->GetAt(j);
+      }
+    }
+
+    // for cut of 3 sigma on t0 spread
+    Float_t t0cut = 3 * t0spread;
+    if(t0cut < 500) t0cut = 500;
+
+    if(option == kFILL_T0){ // T0-FILL is used
+       for(Int_t i=0;i<fTOFResponse.GetNmomBins();i++){
+         estimatedT0event[i]=0.0;
+         estimatedT0resolution[i]=t0spread;
+       }
+       fTOFResponse.SetT0event(estimatedT0event);
+       fTOFResponse.SetT0resolution(estimatedT0resolution);
+    }
+
+    if(option == kTOF_T0){ // T0-TOF is used when available (T0-FILL otherwise) from ESD
+       if(flagT0TOF){
+           fTOFResponse.SetT0event(startTime);
+           fTOFResponse.SetT0resolution(startTimeRes);
+           for(Int_t i=0;i<fTOFResponse.GetNmomBins();i++){
+             if(startTimeRes[i]<t0spread) startTimeMask[i]=1;
+             fTOFResponse.SetT0binMask(i,startTimeMask[i]);
+           }
+       }
+       else{
+           for(Int_t i=0;i<fTOFResponse.GetNmomBins();i++){
+             estimatedT0event[i]=0.0;
+             estimatedT0resolution[i]=t0spread;
+             fTOFResponse.SetT0binMask(i,startTimeMask[i]);
+           }
+           fTOFResponse.SetT0event(estimatedT0event);
+           fTOFResponse.SetT0resolution(estimatedT0resolution);
+       }
+    }
+    else if(option == kBest_T0){ // T0-T0 or T0-TOF are used when available (T0-FILL otherwise) from ESD
+       Float_t t0AC=-10000;
+       Float_t t0A=-10000;
+       Float_t t0C=-10000;
+       if(flagT0T0){
+           t0AC= event->GetT0TOF()[0];
+           t0A= event->GetT0TOF()[1];
+           t0C= event->GetT0TOF()[2];
+       }
+
+       Float_t t0t0Best = 0;
+       Float_t t0t0BestRes = 9999;
+       Int_t t0used=0;
+       if(TMath::Abs(t0A) < t0cut && TMath::Abs(t0C) < t0cut && TMath::Abs(t0C-t0A) < 500){
+           t0t0Best = t0AC;
+           t0t0BestRes = resT0AC;
+           t0used=6;
+       }
+       else if(TMath::Abs(t0C) < t0cut){
+           t0t0Best = t0C;
+           t0t0BestRes = resT0C;
+           t0used=4;
+       }
+       else if(TMath::Abs(t0A) < t0cut){
+           t0t0Best = t0A;
+           t0t0BestRes = resT0A;
+           t0used=2;
+       }
+
+       if(flagT0TOF){ // if T0-TOF info is available
+           for(Int_t i=0;i<fTOFResponse.GetNmomBins();i++){
+               if(t0t0BestRes < 999){
+                 if(startTimeRes[i] < t0spread){
+                   Double_t wtot = 1./startTimeRes[i]/startTimeRes[i] + 1./t0t0BestRes/t0t0BestRes;
+                   Double_t t0best = startTime[i]/startTimeRes[i]/startTimeRes[i] + t0t0Best/t0t0BestRes/t0t0BestRes;
+                   estimatedT0event[i]=t0best / wtot;
+                   estimatedT0resolution[i]=1./TMath::Sqrt(wtot);
+                   startTimeMask[i] = t0used+1;
+                 }
+                 else {
+                   estimatedT0event[i]=t0t0Best;
+                   estimatedT0resolution[i]=t0t0BestRes;
+                   startTimeMask[i] = t0used;
+                 }
+               }
+               else{
+                 estimatedT0event[i]=startTime[i];
+                 estimatedT0resolution[i]=startTimeRes[i];
+                 if(startTimeRes[i]<t0spread) startTimeMask[i]=1;
+               }
+               fTOFResponse.SetT0binMask(i,startTimeMask[i]);
+           }
+           fTOFResponse.SetT0event(estimatedT0event);
+           fTOFResponse.SetT0resolution(estimatedT0resolution);
+       }
+       else{ // if no T0-TOF info is available
+           for(Int_t i=0;i<fTOFResponse.GetNmomBins();i++){
+             fTOFResponse.SetT0binMask(i,t0used);
+             if(t0t0BestRes < 999){
+               estimatedT0event[i]=t0t0Best;
+               estimatedT0resolution[i]=t0t0BestRes;
+             }
+             else{
+               estimatedT0event[i]=0.0;
+               estimatedT0resolution[i]=t0spread;
+             }
+           }
+           fTOFResponse.SetT0event(estimatedT0event);
+           fTOFResponse.SetT0resolution(estimatedT0resolution);
+       }
+    }
+
+    else if(option == kT0_T0){ // T0-T0 is used when available (T0-FILL otherwise) from ESD
+       Float_t t0AC=-10000;
+       Float_t t0A=-10000;
+       Float_t t0C=-10000;
+       if(flagT0T0){
+           t0AC= event->GetT0TOF()[0];
+           t0A= event->GetT0TOF()[1];
+           t0C= event->GetT0TOF()[2];
+       }
+
+       if(TMath::Abs(t0A) < t0cut && TMath::Abs(t0C) < t0cut && TMath::Abs(t0C-t0A) < 500){
+           for(Int_t i=0;i<fTOFResponse.GetNmomBins();i++){
+             estimatedT0event[i]=t0AC;
+             estimatedT0resolution[i]=resT0AC;
+             fTOFResponse.SetT0binMask(i,6);
+           }
+       }
+       else if(TMath::Abs(t0C) < t0cut){
+           for(Int_t i=0;i<fTOFResponse.GetNmomBins();i++){
+             estimatedT0event[i]=t0C;
+             estimatedT0resolution[i]=resT0C;
+             fTOFResponse.SetT0binMask(i,4);
+           }
+       }
+       else if(TMath::Abs(t0A) < t0cut){
+           for(Int_t i=0;i<fTOFResponse.GetNmomBins();i++){
+             estimatedT0event[i]=t0A;
+             estimatedT0resolution[i]=resT0A;
+             fTOFResponse.SetT0binMask(i,2);
+           }
+       }
+       else{
+           for(Int_t i=0;i<fTOFResponse.GetNmomBins();i++){
+             estimatedT0event[i]=0.0;
+             estimatedT0resolution[i]=t0spread;
+             fTOFResponse.SetT0binMask(i,0);
+           }
+       }
+       fTOFResponse.SetT0event(estimatedT0event);
+       fTOFResponse.SetT0resolution(estimatedT0resolution);
+    }
+    delete [] startTime;
+    delete [] startTimeRes;
+    delete [] startTimeMask;
+    delete [] estimatedT0event;
+    delete [] estimatedT0resolution;
+}