]> git.uio.no Git - u/mrichter/AliRoot.git/blobdiff - RICH/AliRICHTracker.cxx
Max. angle in mag. field limited to 10deg.
[u/mrichter/AliRoot.git] / RICH / AliRICHTracker.cxx
index 3370fb0b3d705c09ad0ac0d548c1439202e6dda8..b4876601b31b3145ced9ebcc9a3abfbbaa918709 100644 (file)
@@ -1,10 +1,13 @@
 #include "AliRICHTracker.h" //class header
 #include "AliRICH.h"
 #include "AliRICHRecon.h"
+#include "AliRICHParam.h"
 #include <AliESD.h>
+#include <TGeoManager.h>     //EsdQA()
 #include <TVector3.h>
-#include <TTree.h>          //EsdPrint() 
-#include <TFile.h>          //EsdPrint()    
+#include <TTree.h>          //EsdQA() 
+#include <TFile.h>          //EsdQA()  
+#include <TProfile.h>   //EsdQA() 
 #include "AliRICHHelix.h"
 #include <AliMagF.h>
 #include <AliStack.h>
@@ -14,6 +17,9 @@
 #include <TNtupleD.h>            //RecWithStack();
 #include <AliTrackPointArray.h>  //GetTrackPoint()
 #include <AliAlignObj.h>         //GetTrackPoint()
+#include <TH1F.h>                //EsdQA()  
+#include <TH2F.h>                //EsdQA()  
+#include <TCanvas.h>             //EsdQA()  
 ClassImp(AliRICHTracker)
 //++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++
 AliRICHTracker::AliRICHTracker():AliTracker()
@@ -56,70 +62,50 @@ Int_t AliRICHTracker::PropagateBack(AliESD *pESD)
 // Interface callback methode invoked by AliRecontruction::RunTracking() during tracking after TOF. It's done just once per event
 // Arguments: pESD - pointer to Event Summary Data class instance which contains a list of tracks
 //   Returns: error code, 0 if no errors   
-  Int_t iNtracks=pESD->GetNumberOfTracks();
-  AliDebug(1,Form("Start with %i tracks",iNtracks));
+  Int_t iNtracks=pESD->GetNumberOfTracks();  AliDebug(1,Form("Start with %i tracks",iNtracks));
   AliRICH *pRich=((AliRICH*)gAlice->GetDetector("RICH"));  
   AliRICHRecon recon;
+  Int_t nphots =0;
    
   for(Int_t iTrk=0;iTrk<iNtracks;iTrk++){//ESD tracks loop
-    AliESDtrack *pTrack = pESD->GetTrack(iTrk);// get next reconstructed track    
-    AliRICHHelix helix(pTrack->X3(),pTrack->P3(),(Int_t)pTrack->GetSign(),GetBz()/10); //construct helix out of track running parameters  
-    helix.Print("Track");
+    AliESDtrack *pTrk = pESD->GetTrack(iTrk);// get next reconstructed track    
+    Double_t mom[3], pos[3];
+    pTrk->GetPxPyPz(mom); TVector3 mom3(mom[0],mom[1],mom[2]);
+    pTrk->GetXYZ(pos);    TVector3 pos3(pos[0],pos[1],pos[2]);
+    AliRICHHelix helix(pos3,mom3,(Int_t)pTrk->GetSign(),-0.1*GetBz()); //construct helix out of track running parameters  
+     //Printf(" magnetic field %f charged %f\n",GetBz(),pTrack->GetSign()); helix.Print("Track");
     Int_t iChamber=helix.RichIntersect(AliRICHParam::Instance());    
     if(!iChamber) continue;                                         //no intersection with chambers, ignore this track go after the next one
   
     //find MIP cluster candidate (closest to track intersection point cluster with large enough QDC)
-    Double_t    dR=9999,   dX=9999,   dY=9999; //distance between track-PC intersection point and current cluster
-    Double_t dRmip=9999,dXmip=9999,dYmip=9999; //distance between track-PC intersection point and nearest cluster
-    Int_t   iMipId=-1;                         //index of this nearest cluster
-    for(Int_t iClu=0;iClu<pRich->Clus(iChamber)->GetEntries();iClu++){//clusters loop for intersected chamber
-      AliRICHCluster *pClu=(AliRICHCluster*)pRich->Clus(iChamber)->UncheckedAt(iClu);//get pointer to current cluster
-      if(pClu->Q()<AliRICHParam::QthMIP()) continue; //to low QDC, go after another one
-      pClu->DistXY(helix.PosPc(),dX,dY); dR=TMath::Sqrt(dX*dX+dY*dY); //get distance for current cluster
-      if(dR<dRmip){iMipId=iClu; dRmip=dR; dXmip=dX; dYmip=dY; }       //current cluster is closer, overwrite data for min cluster
+    Double_t    dR=9999,   dX=9999,   dY=9999;                                             //distance between track-PC intersection point and current cluster
+    Double_t mipDr=9999,mipDx=9999,mipDy=9999,mipX=9999,mipY=9999; Int_t mipQ=0;           //nearest cluster parameters
+    Int_t   iMipId=-1;                                                                     //index of this nearest cluster
+    for(Int_t iClu=0;iClu<pRich->Clus(iChamber)->GetEntries();iClu++){                     //clusters loop for intersected chamber
+      AliRICHCluster *pClu=(AliRICHCluster*)pRich->Clus(iChamber)->UncheckedAt(iClu);      //get pointer to current cluster
+      if(pClu->Q()<AliRICHParam::QthMIP()) continue;                                       //to low QDC, go after another one
+      pClu->DistXY(helix.PosPc(),dX,dY); dR=TMath::Sqrt(dX*dX+dY*dY);                      //get distance for current cluster
+      if(dR<mipDr){iMipId=iClu; mipDr=dR; mipDx=dX; mipDy=dY; mipX=pClu->X(); mipY=pClu->Y(); mipQ=pClu->Q();} //current cluster is closer, overwrite data for min cluster
     }//clusters loop for intersected chamber
 
-    pTrack->SetRICHthetaPhi(helix.Ploc().Theta(),helix.Ploc().Phi()); //store track impact angles with respect to RICH planes
-    pTrack->SetRICHdxdy(dXmip,dYmip);                                 //distance between track-PC intersection and closest cluster with Qdc>100
+    pTrk->SetRICHthetaPhi(helix.Ploc().Theta(),helix.Ploc().Phi()); //store track impact angles with respect to RICH planes
+    pTrk->SetRICHdxdy(mipDx,mipDy);                                 //distance between track-PC intersection and closest cluster with Qdc>100
+    pTrk->SetRICHmipXY(mipX,mipY);                                  //position of that closest cluster with Qdc>100
+    pTrk->SetRICHnclusters(1000000*mipQ);                           //charge of that closest cluster with Qdc>100 
     
-    if(iMipId==-1)                        {pTrack->SetRICHsignal(kMipQdcCut);  continue;} //no cluster with enough QDC found
-    if(dRmip>AliRICHParam::DmatchMIP())   {pTrack->SetRICHsignal(kMipDistCut); continue;} //closest cluster with enough carge is still too far 
+    if(iMipId==-1)                        {pTrk->SetRICHsignal(kMipQdcCut);  continue;} //no cluster with enough QDC found
+    if(mipDr>AliRICHParam::DmatchMIP())   {pTrk->SetRICHsignal(kMipDistCut); continue;} //closest cluster with enough carge is still too far 
   
-    pTrack->SetRICHcluster(iMipId+1000000*iChamber);                                //set mip cluster index
-    pTrack->SetRICHsignal(recon.ThetaCerenkov(&helix,pRich->Clus(iChamber),iMipId));//search for mean Cerenkov angle for this track
-    pTrack->SetRICHnclusters(iMipId);                                               //on return iMipId is number of photon clusters accepted in reconstruction
+    pTrk->SetRICHcluster(iMipId+1000000*iChamber);                                //set mip cluster index
+    pTrk->SetRICHsignal(recon.ThetaCerenkov(&helix,pRich->Clus(iChamber),nphots));//search for mean Cerenkov angle for this track
+    pTrk->SetRICHnclusters(1000000*mipQ+nphots);                                  //on return nphots is number of photon clusters accepted in reconstruction
+    pTrk->SetRICHchi2(recon.GetRingSigma2());
 
     AliDebug(1,Form("Ch=%i PC Intersection=(%5.2f,%5.2f) cm MIP cluster dist=(%5.2f,%5.2f)=%5.2f cm ThetaCkov=%f",
-                     iChamber,helix.PosPc().X(),helix.PosPc().Y(),            dXmip,dYmip,dRmip,     pTrack->GetRICHsignal()));
+                     iChamber,helix.PosPc().X(),helix.PosPc().Y(),            mipDx,mipDy,mipDr,     pTrk->GetRICHsignal()));
     
 //here comes PID calculations    
-    if(pTrack->GetRICHsignal()>0) {
-      AliDebug(1,Form("Start to assign the probabilities"));
-      Double_t sigmaPID[AliPID::kSPECIES];
-      Double_t richPID[AliPID::kSPECIES];
-      for (Int_t iPart=0;iPart<AliPID::kSPECIES;iPart++) {
-        sigmaPID[iPart] = 0;
-        fErrPar[iPart] = 0;
-        for(Int_t iphot=0;iphot<pRich->Clus(iChamber)->GetEntries();iphot++) {
-          recon.SetPhotonIndex(iphot);
-          if(recon.GetPhotonFlag() == 2) {
-            Double_t theta_g=recon.GetTrackTheta();
-            Double_t phi_g=(recon.GetPhiPoint()-recon.GetTrackPhi());
-            Double_t sigma2 = AliRICHParam::Instance()->SigmaSinglePhoton(iPart,pTrack->GetP(),theta_g,phi_g).Mag2(); 
-            if(sigma2>0) sigmaPID[iPart] += 1/sigma2;
-          }
-        }
-        if (sigmaPID[iPart]>0)
-          sigmaPID[iPart] *= (Double_t)(iMipId-recon.GetPhotBKG())/(Double_t)(iMipId); // n total phots, m are background...the sigma are scaled..
-          if(sigmaPID[iPart]>0) sigmaPID[iPart] = 1/TMath::Sqrt(sigmaPID[iPart])*0.001; // sigma from parametrization are in mrad...
-          else                  sigmaPID[iPart] = 0;
-          fErrPar[iPart]=sigmaPID[iPart];
-        AliDebug(1,Form("sigma for %s is %f rad",AliPID::ParticleName(iPart),sigmaPID[iPart]));
-      }
-      CalcProb(pTrack->GetRICHsignal(),pTrack->GetP(),sigmaPID,richPID);
-      pTrack->SetRICHpid(richPID);         
-      AliDebug(1,Form("PROBABILITIES ---> %f - %f - %f - %f - %f",richPID[0],richPID[1],richPID[2],richPID[3],richPID[4]));
-    }    
+//    CalcProb(pTrack->GetRICHsignal(),pTrack->GetP(),sigmaPID,richPID);
   }//ESD tracks loop
   AliDebug(1,"Stop pattern recognition");
   return 0; // error code: 0=no error;
@@ -212,56 +198,131 @@ void AliRICHTracker::RecWithStack(TNtupleD *hn)
   AliDebug(1,"Stop.");  
 }//RecWithStack
 //++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++
-void AliRICHTracker::CalcProb(Double_t thetaCer,Double_t pmod, Double_t *sigmaPID, Double_t *richPID)
+void AliRICHTracker::EsdQA(Bool_t isPrint)
 {
-// Calculates probability to be a electron-muon-pion-kaon-proton
-// from the given Cerenkov angle and momentum assuming no initial particle composition
-// (i.e. apriory probability to be the particle of the given sort is the same for all sorts)
-  Double_t height[AliPID::kSPECIES];Double_t totalHeight=0;
-  Double_t thetaTh[AliPID::kSPECIES];
-  for(Int_t iPart=0;iPart<AliPID::kSPECIES;iPart++){
-    height[iPart]=0;
-    Double_t mass = AliRICHParam::fgMass[iPart];
-    Double_t refIndex=AliRICHParam::Instance()->IdxC6F14(AliRICHParam::EckovMean());
-    Double_t cosThetaTh = TMath::Sqrt(mass*mass+pmod*pmod)/(refIndex*pmod);
-    thetaTh[iPart]=0;
-    if(cosThetaTh>=1) continue;
-    thetaTh[iPart] = TMath::ACos(cosThetaTh);
-//    Double_t sinThetaThNorm = TMath::Sin(thetaTh)/TMath::Sqrt(1-1/(refIndex*refIndex));
-//    Double_t sigmaThetaTh = (0.014*(1/sinThetaThNorm-1) + 0.0043)*1.25;
-//    height[iPart] = TMath::Gaus(thetaCer,thetaTh,sigmaThetaTh);
-    if(sigmaPID[iPart]>0) height[iPart] = TMath::Gaus(thetaCer,thetaTh[iPart],sigmaPID[iPart],kTRUE);
-    else                  height[iPart] = 0;
-    totalHeight +=height[iPart];
-    AliDebugClass(1,Form(" Particle %s with mass %f with height %f and thetaTH %f",AliPID::ParticleName(iPart),mass,height[iPart],thetaTh[iPart]));
-    AliDebugClass(1,Form(" partial height %15.14f total height %15.14f",height[iPart],totalHeight));
+// Reads ESD file and print out or plot some information for QA
+// Arguments: isPrint is a flag to choose between printing (isPrint = kTRUE) and plotting (isPrint = kFALSE)
+//   Returns: none
+    
+  TFile *pFile=TFile::Open("AliESDs.root","read");              if(!pFile) {Printf("ERROR: AliESDs.root does not exist!");return;} 
+  TTree *pTr=(TTree*)pFile->Get("esdTree");                     if(!pTr)   {Printf("ERROR: AliESDs.root, no ESD tree inside!");return;} 
+  AliESD *pEsd=new AliESD;  pTr->SetBranchAddress("ESD", &pEsd); 
+  
+  TH1D     *pProbEl=0,*pProbMu=0,*pProbPi=0,*pProbKa=0,*pProbPr=0,*pMom=0,*pMipQ=0; 
+  TH2F     *pThP=0,*pDxDy=0; 
+  TProfile *pChiTh=0;
+  if(!isPrint){
+    TH1::AddDirectory(kFALSE);    
+    pProbEl=new TH1D("RiProbE" ,"Prob e"       ,101  ,0   ,1.05); pProbEl->SetLineColor(kGreen); 
+    pProbPi=new TH1D("RiProbPi","Prob #pi"     ,101  ,0   ,1.05); pProbPi->SetLineColor(kRed);
+    pProbMu=new TH1D("RiProbMu","Prob #mu"     ,101  ,0   ,1.05); pProbMu->SetLineColor(kBlue);
+    pProbKa=new TH1D("RiProbK" ,"Prob K"       ,101  ,0   ,1.05);
+    pProbPr=new TH1D("RiProbP" ,"Prob p"       ,101  ,0   ,1.05);
+    pMom   =new TH1D("pMom"    ,"Track P, GeV" ,200  ,0   ,20  );
+    pMipQ  =new TH1D("RiMipQ"  ,"Mip Q, ADC"   ,2000 ,0   ,4000);
+    pThP   =new TH2F("RiThP"   ,"#theta_{Ckov} radian;P GeV"              ,65 ,-0.5,6.0,75,0,0.75); pThP->SetStats(0);
+    pDxDy  =new TH2F("RiDxDy"  ,"distance between mip and track;cm",300,-2.5,2.5, 300,-2.5,2.5);
+    pChiTh =new TProfile("RiChiTh","#chi^{2};#theta_{C}"            ,80 ,0,0.8 , -2,2);
   }
-  if(totalHeight<1e-5) {for(Int_t iPart=0;iPart<AliPID::kSPECIES;iPart++)richPID[iPart]=1.0/AliPID::kSPECIES;return;}
-  for(Int_t iPart=0;iPart<AliPID::kSPECIES;iPart++) richPID[iPart] = height[iPart]/totalHeight;
-  Int_t iPartNear = TMath::LocMax(AliPID::kSPECIES,richPID);
-  if(TMath::Abs(thetaCer-thetaTh[iPartNear])>5.*sigmaPID[iPartNear]) for(Int_t iPart=0;iPart<AliPID::kSPECIES;iPart++)richPID[iPart]=1.0/AliPID::kSPECIES;
-  //last line is to check if the nearest thetacerenkov to the teorethical one is within 5 sigma, otherwise no response (equal prob to every particle
-
-}//CalcProb
-//++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++
-void AliRICHTracker::EsdPrint()
-{
-  TFile *pFile=TFile::Open("AliESDs.root","read"); if(!pFile) {Printf("ERROR: No AliESDs.root in current directory!");return;}
-  TTree *pEsdTr = (TTree*)pFile->Get("esdTree");   if(!pEsdTr){Printf("ERROR: Bad AliESDs.root, no ESD tree inside!");return;} 
-  AliESD *pESD=new AliESD;  pEsdTr->SetBranchAddress("ESD", &pESD);
   
-  Int_t iNevt=pEsdTr->GetEntries();  Printf("This ESD contains %i events",iNevt);
-  for(Int_t iEvt=0;iEvt<iNevt;iEvt++){//ESD events loop
-    pEsdTr->GetEvent(iEvt);
-    Int_t iNtracks=pESD->GetNumberOfTracks(); Printf("ESD contains %i tracks created in Bz=%.2f Tesla",iNtracks,pESD->GetMagneticField()/10.);
-    for(Int_t iTrk=0;iTrk<iNtracks;iTrk++){//ESD tracks loop
-      AliESDtrack *pTrack = pESD->GetTrack(iTrk);// get next reconstructed track
-      Double_t dx,dy;         pTrack->GetRICHdxdy(dx,dy);
-      Double_t theta,phi;     pTrack->GetRICHthetaPhi(theta,phi);
-      Printf("Track %2i Q=%4.1f P=%.3f GeV RICH: ChamberCluster %7i Track-Mip=(%7.2f,%7.2f)=%5.2f cm ThetaCer %7.1f rad",iTrk,pTrack->GetSign(),pTrack->GetP(),
-                   pTrack->GetRICHcluster(),dx,dy,TMath::Sqrt(dx*dx+dy*dy),pTrack->GetRICHsignal());
+  Int_t iEvtCnt=0,iTrkCnt=0,iGoodCnt=0;   Float_t bz=0;
+  for(Int_t iEvt=0;iEvt<pTr->GetEntries();iEvt++){//ESD events loop
+    pTr->GetEvent(iEvt); iEvtCnt++; if(isPrint) Printf("");
+    bz=pEsd->GetMagneticField()/10.;
+    for(Int_t iTrk=0;iTrk<pEsd->GetNumberOfTracks();iTrk++){//ESD tracks loop
+      AliESDtrack *pTrk=pEsd->GetTrack(iTrk); iTrkCnt++;         //get next reconstructed track and increment total tracks counter
+      
+      Float_t mom           =pTrk->GetP();                       //track momentum
+      Double_t sign         =pTrk->GetSign();                    //track sign 
+      Float_t ckov          =pTrk->GetRICHsignal();              //Theta ckov for this track, rad
+      Float_t chi2          =pTrk->GetRICHchi2();                //Theta ckov error for this track, rad^2 
+      Int_t   qdc           =pTrk->GetRICHnclusters()/1000000;   //Mip candidate charge, qdc 
+      Int_t   nphot         =pTrk->GetRICHnclusters()%1000000;   //number of photon candidates
+      Float_t dx,dy;         pTrk->GetRICHdxdy(dx,dy);           //distance between mip position and track instersection
+      Float_t theta,phi;     pTrk->GetRICHthetaPhi(theta,phi);   //track inclination angles in LORS
+      Double_t pid[5];       pTrk->GetRICHpid(pid);              //pid vector
+      
+      if(ckov>0) iGoodCnt++;
+      if(isPrint){
+        TString comment;
+        if(ckov>0)                         comment="OK";
+        else if(ckov==kMipQdcCut)          comment="small QDC";
+        else if(ckov==kMipDistCut)         comment="mip too far";
+        else if(ckov==-1)                  comment="no intersection";
+        Printf("Tr=%2i Q=%4.1f P=%.3f R=%4.2f Th=%6.3f MipQ= %4i Nph=%2i" " rad Prob : e=%.4f mu=%.4f pi=%.4f K=%.4f p=%.4f %s" ,
+                     iTrk,sign,mom,TMath::Sqrt(dx*dx+dy*dy),ckov,qdc,nphot,           pid[0],pid[1],pid[2],pid[3],pid[4], comment.Data());
+      }else{//collect hists
+                                 pMom->Fill(mom); 
+        pMipQ->Fill(qdc);
+                                 pDxDy->Fill(dx,dy);
+        pThP->Fill(mom,ckov); 
+                                 pChiTh->Fill(ckov,chi2);
+        pProbEl->Fill(pid[0]); 
+                                 pProbMu->Fill(pid[1]); 
+        pProbPi->Fill(pid[2]);  
+                                 pProbKa->Fill(pid[3]);  
+        pProbPr->Fill(pid[4]); 
+      }//if plot
     }//ESD tracks loop
   }//ESD events loop
-  delete pESD;  pFile->Close();//close AliESDs.root
+  delete pEsd;  pFile->Close();//close AliESDs.root
+  
+  TString summary=Form("Events: %i Tracks %i Good RICH: %i Mag Fld %.2f Tesla",iEvtCnt,iTrkCnt,iGoodCnt,bz);
+  if(isPrint){
+    Printf(summary.Data());
+  }else{  
+    TCanvas *pC=new TCanvas("c",summary.Data()); pC->Divide(2,2);
+    TF1 *pPion = new TF1("RITheor","acos(sqrt(x*x+[0]*[0])/(x*[1]))",1.2,6); pPion->SetLineWidth(1);
+                                                                    pPion->SetParameter(1,1.292);                                  //ref idx
+    AliPID ppp;                        pPion->SetLineColor(kRed);   pPion->SetParameter(0,AliPID::ParticleMass(AliPID::kPion));    //mass
+    TF1 *pKaon = (TF1*)pPion->Clone(); pKaon->SetLineColor(kGreen); pKaon->SetParameter(0,AliPID::ParticleMass(AliPID::kKaon)); 
+    TF1 *pProt = (TF1*)pPion->Clone(); pProt->SetLineColor(kBlue);  pProt->SetParameter(0,AliPID::ParticleMass(AliPID::kProton)); 
+    
+    pC->cd(1);        pDxDy->Draw();                                                                     //distance between mip and track intersection 
+    pC->cd(2);        pMipQ->Draw();
+    pC->cd(3);        pThP->Draw();       pPion->Draw("same"); pKaon->Draw("same"); pProt->Draw("same"); //Theta Ckov versus p + theoretical curves
+    pC->cd(4);        pChiTh->Draw();                                                                    //Theta Ckov error versus theta Ckov
+    
+    TCanvas *pC2=new TCanvas("c2",summary.Data()); pC2->Divide(2,2);
+    pC2->cd(1);        pProbPi->Draw(); pProbMu->Draw("same"); pProbEl->Draw("same");
+    pC2->cd(2);        pProbKa->Draw();
+    pC2->cd(3);        pProbPr->Draw();
+    pC2->cd(4);        pMom->Draw();
+  }
+}//EsdQA()
+//++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++
+void AliRICHTracker::MatrixPrint(Double_t probCut)
+{
+// Reads a set of 3  ESD files from current directory and prints out the matrix of probabilities to pion kaon or proton completely blindly withou nay assumption on the contents of files.
+// Normally it implies that those 3 ESDs contain only particles of the same sort namly pions, kaons and protons in that order.  
+// Arguments: probCut - cut on probability 
+//   Returns: none
+  for(Int_t iFile=0;iFile<3;iFile++){
+    TFile *pFile=TFile::Open(Form("Esd%1i.root",iFile+1),"read"); if(!pFile) {Printf("ERROR: Esd%1i.root does not exist!",iFile+1);return;} 
+    TTree *pTr=(TTree*)pFile->Get("esdTree");                     if(!pTr)   {Printf("ERROR: Esd%1i.root, no ESD tree inside!",iFile+1);return;} 
+    AliESD *pEsd=new AliESD;  pTr->SetBranchAddress("ESD", &pEsd); 
+    Int_t iProtCnt=0,iKaonCnt=0,iPionCnt=0,iUnreconCnt=0,iTrkCnt=0; //counters
+    
+    for(Int_t iEvt=0;iEvt<pTr->GetEntries();iEvt++){//ESD events loop
+      pTr->GetEvent(iEvt);
+      iTrkCnt+=pEsd->GetNumberOfTracks();
+      for(Int_t iTrk=0;iTrk<pEsd->GetNumberOfTracks();iTrk++){//ESD tracks loop
+        AliESDtrack *pTrack = pEsd->GetTrack(iTrk);// get next reconstructed track
+        Float_t dx,dy;         pTrack->GetRICHdxdy(dx,dy);
+        Float_t theta,phi;     pTrack->GetRICHthetaPhi(theta,phi);
+        Double_t prob[5];       pTrack->GetRICHpid(prob);
+        if(pTrack->GetRICHsignal()>0){
+          if(prob[4]>probCut)                         iProtCnt++; 
+          if(prob[3]>probCut)                         iKaonCnt++;
+          if((prob[0]+prob[1]+prob[2])>probCut)       iPionCnt++;
+        } else
+          iUnreconCnt++;       
+      }//ESD tracks loop
+      
+    }//ESD events loop
+    Printf("Bz=%5.2f Events=%i Total tracks=%i No recognized tracks=%i Pion=%i Kaon=%i Proton=%i ProbCut=%.2f",
+        0.1*pEsd->GetMagneticField(),pTr->GetEntries(),iTrkCnt,iUnreconCnt,iPionCnt,iKaonCnt,iProtCnt,probCut);
+    delete pEsd;  pFile->Close();//close AliESDs.root
+  }//files loop
 }
 //++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++