]> git.uio.no Git - u/mrichter/AliRoot.git/blobdiff - MUON/MUONefficiency.C
added proper handling of EMCAL calibration events
[u/mrichter/AliRoot.git] / MUON / MUONefficiency.C
index 66f4dbae8ab936f9c25e49cc104578fa39b189f6..565b0db566ea13fc11001e53e47376a943633a7e 100644 (file)
 
 /* $Id$ */
 
-// Macro (upgraded version of MUONmassPlot_ESD.C) to make : 
-// 1) Ntuple (Ktuple) containing Upsilon kinematics variables (from kinematics.root files) 
-// 2) Ntuple (ESDtuple) containing Upsilon kinematics variables from reconstruction and 
-// combinations of 2 muons with opposite charges,
-// 3) Some QA histograms
-// Ntuple are stored in the file MUONefficiency.root and  ESD tree and QA histograms in AliESDs.root
-
-// Arguments:
-//   FirstEvent (default 0)
-//   LastEvent (default 0)
-//   ResType (default 553)
-//      553 for Upsilon, anything else for J/Psi
-//   Chi2Cut (default 100)
-//      to keep only tracks with chi2 per d.o.f. < Chi2Cut
-//   PtCutMin (default 1)
-//      to keep only tracks with transverse momentum > PtCutMin
-//   PtCutMax (default 10000)
-//      to keep only tracks with transverse momentum < PtCutMax
-//   massMin (default 9.17 for Upsilon) 
-//      &  massMax (default 9.77 for Upsilon) 
-//         to calculate the reconstruction efficiency for resonances with invariant mass
-//         massMin < mass < massMax.
-
-// Add parameters and histograms for analysis 
-
-// Christophe Suire, IPN Orsay
+/// \ingroup macros
+/// \file MUONefficiency.C
+/// \brief add brief description
+///
+/// Macro (upgraded version of MUONmassPlot_ESD.C, better handling of Jpsi) to make : 
+/// - Ntuple (Ktuple) containing Upsilon kinematics variables (from kinematics.root files) 
+/// - Ntuple (ESDtuple) containing Upsilon kinematics variables from reconstruction and 
+///   combinations of 2 muons with opposite charges (ESDtupleBck will be used later)
+/// - Some QA histograms
+/// Ntuple are stored in the file MUONefficiency.root and  ESD tree and QA histograms in AliESDs.root
+///
+/// \author Christophe Suire, IPN Orsay
+
+
 
 #if !defined(__CINT__) || defined(__MAKECINT__)
+
+// MUON includes
+#include "AliMUONCDB.h"
+#include "AliMUONTrackParam.h"
+#include "AliMUONTrackExtrap.h"
+#include "AliMUONESDInterface.h"
+
+// STEER includes
+#include "AliRun.h"
+#include "AliRunLoader.h"
+#include "AliHeader.h"
+#include "AliLoader.h"
+#include "AliStack.h"
+#include "AliESDEvent.h"
+#include "AliESDVertex.h"
+#include "AliCDBManager.h"
+#include "AliESDMuonTrack.h"
+
 // ROOT includes
 #include "TTree.h"
-#include "TBranch.h"
-#include "TClonesArray.h"
+#include "TNtuple.h"
 #include "TLorentzVector.h"
 #include "TFile.h"
 #include "TH1.h"
 #include "TH2.h"
 #include "TParticle.h"
-#include "TTree.h"
 #include "TString.h"
 #include <Riostream.h>
+#include <TGeoManager.h>
+#include <TROOT.h>
+#include <TF1.h>
+#include <TMath.h>
 
-// STEER includes
-#include "AliRun.h"
-#include "AliRunLoader.h"
-#include "AliHeader.h"
-#include "AliLoader.h"
-#include "AliStack.h"
-#include "AliMagF.h"
-#include "AliESD.h"
-
-// MUON includes
-#include "AliESDMuonTrack.h"
 #endif
 
+Bool_t MUONefficiency(const char* filename = "generated/galice.root", const char* esdFileName = "AliESDs.root",
+                     const char* geoFilename = "geometry.root", const char* ocdbPath = "local://$ALICE_ROOT/OCDB",
+                     Int_t ExtrapToVertex = -1, Int_t ResType = 553, Int_t FirstEvent = 0, Int_t LastEvent = 1000000 )
+{ 
+/// \param ExtrapToVertex (default -1) 
+///  - <0: no extrapolation;
+///  - =0: extrapolation to (0,0,0);
+///  - >0: extrapolation to ESDVertex if available, else to (0,0,0)
+/// \param ResType    553 for Upsilon, 443 for J/Psi (default 553)  
+/// \param FirstEvent (default 0)
+/// \param LastEvent  (default 1.e6)
+/// \param Chi2Cut    to keep only tracks with chi2 per d.o.f. < Chi2Cut (default 100)  
+
+
+  // MUONefficiency starts
+
+  Double_t MUON_MASS = 0.105658369;
+  Double_t UPSILON_MASS = 9.4603 ;
+  Double_t JPSI_MASS = 3.097;
+
+  // Upper and lower bound for counting entries in the mass peak
+  // +/- 300 MeV/c^2 in this case.
+  Float_t countingRange = 0.300 ;  
+  
+  Float_t massResonance = 5.;
+  Float_t invMassMinInPeak = 0. ; 
+  Float_t invMassMaxInPeak = 0. ; 
+  
+  Float_t nBinsPerGev = 40 ; 
+  Float_t invMassMin = 0;   Float_t invMassMax = 20; 
+  Float_t ptMinResonance = 0 ; Float_t ptMaxResonance = 20 ; Int_t ptBinsResonance = 100; 
+
+  if (ResType==443) {
+    massResonance = JPSI_MASS ;
+    invMassMinInPeak =  JPSI_MASS - countingRange  ; invMassMaxInPeak = JPSI_MASS + countingRange ; 
+    //limits for histograms
+    invMassMin = 0 ; invMassMax = 6.;
+    ptMinResonance = 0 ; ptMaxResonance = 20 ; ptBinsResonance = 100; 
+  }
+  if (ResType==553) {
+    massResonance = UPSILON_MASS;
+    invMassMinInPeak = UPSILON_MASS - countingRange ; invMassMaxInPeak = UPSILON_MASS + countingRange; 
+    //limits for histograms 
+    invMassMin = 0 ; invMassMax = 12.;
+    ptMinResonance = 0 ; ptMaxResonance = 20 ; ptBinsResonance = 100; 
+  }
+  
+  // Single Tracks muon cuts
+  Float_t Chi2Cut = 100.;
+  Float_t PtCutMin = 0. ;
+  Float_t PtCutMax = 10000. ; 
 
-Bool_t MUONefficiency(char* filename = "galice.root", Int_t FirstEvent = 0, Int_t LastEvent = 11000000,
-                 char* esdFileName = "AliESDs.root", Int_t ResType = 553, 
-                  Float_t Chi2Cut = 100., Float_t PtCutMin = 0., Float_t PtCutMax = 10000.,
-                  Float_t massMin = 9.17,Float_t massMax = 9.77)
-{ // MUONefficiency starts
-  cout << "MUONmassPlot " << endl;
-  cout << "FirstEvent " << FirstEvent << endl;
-  cout << "LastEvent " << LastEvent << endl;
-  cout << "ResType " << ResType << endl;
-  cout << "Chi2Cut " << Chi2Cut << endl;
-  cout << "PtCutMin " << PtCutMin << endl;
-  cout << "PtCutMax " << PtCutMax << endl;
-  cout << "massMin " << massMin << endl;
-  cout << "massMax " << massMax << endl;
 
+  // Limits for histograms 
+  Float_t ptMinMuon = 0. ; Float_t ptMaxMuon = 20.; Int_t ptBinsMuon = 100 ;
+  Float_t pMinMuon = 0.  ; Float_t pMaxMuon = 200.; Int_t pBinsMuon = 100 ;
  
+
   //Reset ROOT and connect tree file
   gROOT->Reset();
   
   // Printing Level 
   Int_t PRINTLEVEL = 0 ;
-  Int_t SELECT =  0 ; // not used
   
   //for kinematic, i.e. reference tracks
   TNtuple *Ktuple = new TNtuple("Ktuple","Kinematics NTuple","ev:npart:id:idmo:idgdmo:p:pt:y:theta:pseudorap:vx:vy:vz");
 
-  //for reconstruction
-  TH1F *hPtMuon = new TH1F("hPtMuon", "Muon Pt (GeV/c)", 100, 0., 20.);
-  TH1F *hPtMuonPlus = new TH1F("hPtMuonPlus", "Muon+ Pt (GeV/c)", 100, 0., 20.);
-  TH1F *hPtMuonMinus = new TH1F("hPtMuonMinus", "Muon- Pt (GeV/c)", 100, 0., 20.);
-  TH1F *hPMuon = new TH1F("hPMuon", "Muon P (GeV/c)", 100, 0., 200.);
-  TH1F *hChi2PerDof = new TH1F("hChi2PerDof", "Muon track chi2/d.o.f.", 100, 0., 20.);
-  TH1F *hInvMassAll = new TH1F("hInvMassAll", "Mu+Mu- invariant mass (GeV/c2)", 480, 0., 12.);
-  TH1F *hInvMassBg = new TH1F("hInvMassBg", "Mu+Mu- invariant mass BG(GeV/c2)", 480, 0., 12.);
-  TH2F *hInvMassAll_vs_Pt = new TH2F("hInvMassAll_vs_Pt","hInvMassAll_vs_Pt",480,0.,12.,80,0.,20.);
-  TH2F *hInvMassBgk_vs_Pt = new TH2F("hInvMassBgk_vs_Pt","hInvMassBgk_vs_Pt",480,0.,12.,80,0.,20.);
+  //for reconstruction  
+  TH1F *hPtMuon = new TH1F("hPtMuon", "Muon Pt (GeV/c)", ptBinsMuon, ptMinMuon, ptMaxMuon);
+  TH1F *hPtMuonPlus = new TH1F("hPtMuonPlus", "Muon+ Pt (GeV/c)", ptBinsMuon, ptMinMuon, ptMaxMuon);
+  TH1F *hPtMuonMinus = new TH1F("hPtMuonMinus", "Muon- Pt (GeV/c)", ptBinsMuon, ptMinMuon, ptMaxMuon);
+  TH1F *hPMuon = new TH1F("hPMuon", "Muon P (GeV/c)", pBinsMuon, pMinMuon, pMaxMuon);
+  
+  TH1F *hInvMassAll;
+  TH1F *hInvMassBg;
+  TH2F *hInvMassAll_vs_Pt;
+  TH2F *hInvMassBgk_vs_Pt;
   TH1F *hInvMassRes;
-  if (ResType == 553) {
-    hInvMassRes = new TH1F("hInvMassRes", "Mu+Mu- invariant mass (GeV/c2) around Upsilon", 60, 8., 11.);
-  } else {
-    hInvMassRes = new TH1F("hInvMassRes", "Mu+Mu- invariant mass (GeV/c2) around J/Psi", 80, 0., 5.);
-  }
 
+
+  hInvMassAll = new TH1F("hInvMassAll", "Mu+Mu- invariant mass (GeV/c2)", (Int_t) (nBinsPerGev*(invMassMax - invMassMin)), invMassMin, invMassMax);
+  hInvMassBg = new TH1F("hInvMassBg", "Mu+Mu- invariant mass BG(GeV/c2)", (Int_t) (nBinsPerGev*(invMassMax- invMassMin)), invMassMin, invMassMax);
+  hInvMassAll_vs_Pt = new TH2F("hInvMassAll_vs_Pt","hInvMassAll_vs_Pt",(Int_t) (nBinsPerGev*(invMassMax- invMassMin)), invMassMin, invMassMax,ptBinsResonance,ptMinResonance,ptMaxResonance);
+  hInvMassBgk_vs_Pt = new TH2F("hInvMassBgk_vs_Pt","hInvMassBgk_vs_Pt",(Int_t) (nBinsPerGev*(invMassMax- invMassMin)), invMassMin, invMassMax,ptBinsResonance,ptMinResonance,ptMaxResonance);
+  
+  hInvMassRes = new TH1F("hInvMassRes", "Mu+Mu- invariant mass (GeV/c2) around Resonance",(Int_t) (nBinsPerGev*3*countingRange*2),massResonance-3*countingRange,massResonance+3*countingRange);
+
+  TH1F *hPrimaryVertex = new TH1F("hPrimaryVertex","SPD reconstructed Z vertex",150,-15,15);
+  TH1F *hChi2PerDof = new TH1F("hChi2PerDof", "Muon track chi2/d.o.f.", 100, 0., 20.);
   TH1F *hNumberOfTrack = new TH1F("hNumberOfTrack","nb of track /evt ",20,-0.5,19.5);
   TH1F *hRapMuon = new TH1F("hRapMuon"," Muon Rapidity",50,-4.5,-2);
   TH1F *hRapResonance = new TH1F("hRapResonance"," Resonance Rapidity",50,-4.5,-2);
   TH1F *hPtResonance = new TH1F("hPtResonance", "Resonance Pt (GeV/c)", 100, 0., 20.);
   TH2F *hThetaPhiPlus = new TH2F("hThetaPhiPlus", "Theta vs Phi +", 760, -190., 190., 400, 160., 180.);
   TH2F *hThetaPhiMinus = new TH2F("hThetaPhiMinus", "Theta vs Phi -", 760, -190., 190., 400, 160., 180.);
-
+  
   TNtuple *ESDtuple = new TNtuple("ESDtuple","Reconstructed Mu+Mu- pairs and Upsilon","ev:tw:pt:y:theta:minv:pt1:y1:theta1:q1:trig1:pt2:y2:theta2:q2:trig2");
   TNtuple *ESDtupleBck = new TNtuple("ESDtupleBck","Reconstructed Mu+Mu- pairs for Background","ev:pt:y:theta:minv:pt1:y1:theta1:pt2:y2:theta2");
 
 
-  // settings
+  // Variables
   Int_t EventInMass = 0;
-  Float_t muonMass = 0.105658389;
-  Float_t UpsilonMass = 9.46037;
-  Float_t JPsiMass = 3.097;
+  Int_t EventInMassMatch = 0;
+  Int_t NbTrigger = 0;
+  Int_t ptTrig = 0;
+
+  Double_t fXVertex=0;
+  Double_t fYVertex=0;
+  Double_t fZVertex=0;
+  Double_t errXVtx=0;
+  Double_t errYVtx=0;
 
-  Double_t thetaX, thetaY, pYZ;
   Double_t fPxRec1, fPyRec1, fPzRec1, fE1;
   Double_t fPxRec2, fPyRec2, fPzRec2, fE2;
   Int_t fCharge1, fCharge2;
 
-  Int_t ntrackhits, nevents;
+  Int_t ntrackhits, nevents; 
+  Int_t nprocessedevents = 0 ;
   Double_t fitfmin;
 
   TLorentzVector fV1, fV2, fVtot;
 
-  // set off mag field 
-  AliMagF::SetReadField(kFALSE);
+  // Import TGeo geometry (needed by AliMUONTrackExtrap::ExtrapToVertex)
+  if (!gGeoManager) {
+    TGeoManager::Import(geoFilename);
+    if (!gGeoManager) {
+      Error("MUONefficiency", "getting geometry from file %s failed", geoFilename);
+      return kFALSE;
+    }
+  }
+  
+  // open the ESD file
+  TFile* esdFile = TFile::Open(esdFileName);
+  if (!esdFile || !esdFile->IsOpen()) {
+    Error("MUONefficiency", "opening ESD file %s failed", esdFileName);
+    return kFALSE;
+  }
+
+  AliESDEvent* esd = new AliESDEvent();
+  TTree* tree = (TTree*) esdFile->Get("esdTree");
+  if (!tree) {
+    Error("MUONefficiency", "no ESD tree found");
+    return kFALSE;
+  } 
+  esd->ReadFromTree(tree);
+
+  // get run number
+  if (tree->GetEvent(0) <= 0) {
+    Error("MUONefficiency", "no ESD object found for event 0");
+    return kFALSE;
+  }
+  Int_t runNumber = esd->GetRunNumber();
+
+  // load necessary data from OCDB
+  AliCDBManager::Instance()->SetDefaultStorage(ocdbPath);
+  AliCDBManager::Instance()->SetSpecificStorage("GRP/GRP/Data",
+                         Form("local://%s",gSystem->pwd()));
+  AliCDBManager::Instance()->SetRun(runNumber);
+  if (!AliMUONCDB::LoadField()) return kFALSE;
+
+  // set the magnetic field for track extrapolations
+  AliMUONTrackExtrap::SetField();
 
   // open run loader and load gAlice, kinematics and header
   AliRunLoader* runLoader = AliRunLoader::Open(filename);
@@ -156,39 +242,25 @@ Bool_t MUONefficiency(char* filename = "galice.root", Int_t FirstEvent = 0, Int_
     Error("MUONefficiency", "no galice object found");
     return kFALSE;
   }
-  
-  // open the ESD file
-  TFile* esdFile = TFile::Open(esdFileName);
-  if (!esdFile || !esdFile->IsOpen()) {
-    Error("MUONefficiency", "opening ESD file %s failed", esdFileName);
-    return kFALSE;
-  }
-  
-  AliESD* esd = new AliESD();
-  TTree* tree = (TTree*) esdFile->Get("esdTree");
-  if (!tree) {
-    Error("CheckESD", "no ESD tree found");
+
+  runLoader->LoadHeader();
+  if (runNumber != runLoader->GetHeader()->GetRun()) {
+    Error("MUONefficiency", "mismatch between run number from ESD and from runLoader");
     return kFALSE;
   }
-  tree->SetBranchAddress("ESD", &esd);
 
-  runLoader->LoadHeader();
   nevents = runLoader->GetNumberOfEvents();
-  
+  AliMUONTrackParam trackParam;
+
   // to access the particle  Stack
   runLoader->LoadKinematics("READ");
 
+  Int_t numberOfGeneratedResonances = 0 ;
+
   TParticle *particle; 
-  Int_t track1Id = 0 ;
-  Int_t track1PDGId = 0 ;
-  Int_t track1MotherId = 0 ;
-  Int_t track1MotherPDGId = 0 ;
+  
   Int_t track1Trigger = 0 ;
   Float_t track1TriggerChi2 = 0 ;
-  Int_t track2Id = 0 ;
-  Int_t track2PDGId = 0 ;
-  Int_t track2MotherId = 0 ;
-  Int_t track2MotherPDGId = 0 ;
   Int_t track2Trigger = 0 ;
   Float_t track2TriggerChi2 = 0 ;
 
@@ -201,7 +273,8 @@ Bool_t MUONefficiency(char* filename = "galice.root", Int_t FirstEvent = 0, Int_
 
     // get current event
     runLoader->GetEvent(iEvent);
-   
+    nprocessedevents++;
+
     // get the stack and fill the kine tree
     AliStack *theStack = runLoader->Stack();
     if (PRINTLEVEL > 0) theStack->DumpPStack ();    
@@ -209,11 +282,9 @@ Bool_t MUONefficiency(char* filename = "galice.root", Int_t FirstEvent = 0, Int_
     Int_t nparticles = (Int_t)runLoader->TreeK()->GetEntries();
     Int_t nprimarypart = theStack->GetNprimary();
     Int_t ntracks = theStack->GetNtrack();
-    
+  
     if (PRINTLEVEL || (iEvent%100==0)) printf("\n  >>> Event %d \n",iEvent);
-    if (PRINTLEVEL) cout << nprimarypart << " Particles generated (total is " << ntracks << ")"<< endl ;
-    
-
+    if (PRINTLEVEL) cout << nprimarypart << " Particles generated (total is " << ntracks << ")"<< endl ;    
     
     for(Int_t iparticle=0; iparticle<nparticles; iparticle++) { // Start loop over particles
       particle = theStack->Particle(iparticle);
@@ -225,11 +296,8 @@ Bool_t MUONefficiency(char* filename = "galice.root", Int_t FirstEvent = 0, Int_
       Float_t muPt = TMath::Sqrt(particle->Px()*particle->Px()+particle->Py()*particle->Py());
       Float_t muY  = 0.5*TMath::Log((particle->Energy()+particle->Pz()+1.e-13)/(particle->Energy()-particle->Pz()+1.e-13));
       if (muM >= 0) {
-       //cout << "in stack " << partM <<  endl ;
        TParticle *theMum = theStack->Particle(muM);
        muM  =  theMum->GetPdgCode();
-       //cout << "the Mum " << partM << endl ;
-       
        muGM  = theMum->GetFirstMother() ;
        if (muGM >= 0){
          TParticle *grandMa = theStack->Particle(muGM);
@@ -238,7 +306,10 @@ Bool_t MUONefficiency(char* filename = "galice.root", Int_t FirstEvent = 0, Int_
        else muGM=0;
       }
       else muM=0;
-      
+    
+      if (muId==ResType) numberOfGeneratedResonances++;
+
+  
       Float_t muT  = particle->Theta()*180/TMath::Pi();
       Float_t muE  = particle->Eta();
       
@@ -257,13 +328,23 @@ Bool_t MUONefficiency(char* filename = "galice.root", Int_t FirstEvent = 0, Int_
 
     
     // get the event summary data
-    tree->GetEvent(iEvent);
-    if (!esd) {
+    if (tree->GetEvent(iEvent) <= 0) {
       Error("CheckESD", "no ESD object found for event %d", iEvent);
       return kFALSE;
     }
-
-    Int_t triggerWord = esd->GetTrigger();
+    
+    // get the SPD reconstructed vertex (vertexer) and fill the histogram
+    AliESDVertex* Vertex = (AliESDVertex*) esd->GetVertex();
+    if (Vertex->GetNContributors()) {
+      fZVertex = Vertex->GetZv();
+      fYVertex = Vertex->GetYv();
+      fXVertex = Vertex->GetXv();      
+      errXVtx = Vertex->GetXRes();
+      errYVtx = Vertex->GetYRes();
+    }
+    hPrimaryVertex->Fill(fZVertex);
+    
+    Int_t triggerWord = esd->GetTriggerMask();
     Int_t nTracks = (Int_t)esd->GetNumberOfMuonTracks() ; 
 
     if (PRINTLEVEL > 0){
@@ -274,17 +355,20 @@ Bool_t MUONefficiency(char* filename = "galice.root", Int_t FirstEvent = 0, Int_
     // loop over all reconstructed tracks (also first track of combination)
     for (Int_t iTrack = 0; iTrack <  nTracks;  iTrack++) {
 
-      AliESDMuonTrack* muonTrack = esd->GetMuonTrack(iTrack);
+      // skip ghosts
+      if (!esd->GetMuonTrack(iTrack)->ContainTrackerData()) continue;
 
-      //if (PRINTLEVEL > 5) cout << "1st muonTrack->GetTrackID() : " << track1Id << endl; 
+      AliESDMuonTrack* muonTrack = new AliESDMuonTrack(*(esd->GetMuonTrack(iTrack)));
 
-      if(SELECT && track1Id) {
-       particle = theStack->Particle(track1Id);
-       track1PDGId = particle->GetPdgCode() ;
-       track1MotherId = particle->GetFirstMother();
-       if (track1MotherId >=0 )
-         track1MotherPDGId = ((TParticle*) theStack->Particle(track1MotherId))->GetPdgCode();
-       if (PRINTLEVEL > 0) cout << "track1MotherPDGId = " << track1MotherPDGId << endl ;
+      // extrapolate to vertex if required and available
+      if (ExtrapToVertex > 0 && Vertex->GetNContributors()) {
+       AliMUONESDInterface::GetParamAtFirstCluster(*muonTrack, trackParam);
+       AliMUONTrackExtrap::ExtrapToVertex(&trackParam, fXVertex, fYVertex, fZVertex, errXVtx, errYVtx);
+       AliMUONESDInterface::SetParamAtVertex(trackParam, *muonTrack); // put the new parameters in this copy of AliESDMuonTrack
+      } else if ((ExtrapToVertex > 0 && !Vertex->GetNContributors()) || ExtrapToVertex == 0){
+       AliMUONESDInterface::GetParamAtFirstCluster(*muonTrack, trackParam);
+       AliMUONTrackExtrap::ExtrapToVertex(&trackParam, 0., 0., 0., 0., 0.);
+       AliMUONESDInterface::SetParamAtVertex(trackParam, *muonTrack); // put the new parameters in this copy of AliESDMuonTrack
       }
 
       // Trigger
@@ -295,17 +379,9 @@ Bool_t MUONefficiency(char* filename = "galice.root", Int_t FirstEvent = 0, Int_
       else 
        track1TriggerChi2 = 0. ;
 
-      thetaX = muonTrack->GetThetaX();
-      thetaY = muonTrack->GetThetaY();
-
-      pYZ     =  1./TMath::Abs(muonTrack->GetInverseBendingMomentum());
-      fPzRec1  = - pYZ / TMath::Sqrt(1.0 + TMath::Tan(thetaY)*TMath::Tan(thetaY));
-      fPxRec1  = fPzRec1 * TMath::Tan(thetaX);
-      fPyRec1  = fPzRec1 * TMath::Tan(thetaY);
       fCharge1 = Int_t(TMath::Sign(1.,muonTrack->GetInverseBendingMomentum()));
       
-      fE1 = TMath::Sqrt(muonMass * muonMass + fPxRec1 * fPxRec1 + fPyRec1 * fPyRec1 + fPzRec1 * fPzRec1);
-      fV1.SetPxPyPzE(fPxRec1, fPyRec1, fPzRec1, fE1);
+      muonTrack->LorentzP(fV1);
 
       ntrackhits = muonTrack->GetNHit();
       fitfmin    = muonTrack->GetChi2();
@@ -322,7 +398,7 @@ Bool_t MUONefficiency(char* filename = "galice.root", Int_t FirstEvent = 0, Int_
       // chi2 per d.o.f.
       
       Float_t ch1 =  fitfmin / (2.0 * ntrackhits - 5);
-      if (PRINTLEVEL > 5 ) printf(" px %f py %f pz %f pt %f NHits %d  Norm.chi2 %f charge %d\n",fPxRec1, fPyRec1, fPzRec1, pt1, ntrackhits, ch1, fCharge1);
+      if (PRINTLEVEL > 5 ) printf(" px %f py %f pz %f pt %f NHits %d  Norm.chi2 %f charge %d\n",fV1.Px(), fV1.Py(), fV1.Pz(), pt1, ntrackhits, ch1, fCharge1);
       
       
       if ((ch1 < Chi2Cut) && (pt1 > PtCutMin) && (pt1 < PtCutMax)) { // condition for good track (Chi2Cut and PtCut)
@@ -336,47 +412,43 @@ Bool_t MUONefficiency(char* filename = "galice.root", Int_t FirstEvent = 0, Int_
 
        if (fCharge1 > 0) {
          hPtMuonPlus->Fill(pt1);
-         hThetaPhiPlus->Fill(TMath::ATan2(fPyRec1,fPxRec1)*180./TMath::Pi(),TMath::ATan2(pt1,fPzRec1)*180./3.1415);
+         hThetaPhiPlus->Fill(fV1.Phi()*180./TMath::Pi(),fV1.Theta()*180./TMath::Pi());
        } else {
          hPtMuonMinus->Fill(pt1);
-         hThetaPhiMinus->Fill(TMath::ATan2(fPyRec1,fPxRec1)*180./TMath::Pi(),TMath::ATan2(pt1,fPzRec1)*180./3.1415);
+         hThetaPhiMinus->Fill(fV1.Phi()*180./TMath::Pi(),fV1.Theta()*180./TMath::Pi());
        }
 
        // loop over second track of combination
        for (Int_t iTrack2 = iTrack + 1; iTrack2 < nTracks; iTrack2++) {
          
-         AliESDMuonTrack* muonTrack = esd->GetMuonTrack(iTrack2);
-         //Int_t track2Id = muonTrack->GetTrackID();
-         //if (PRINTLEVEL > 5) cout << "2nd muonTrack->GetTrackID() : " << track2Id << endl;
-
-         if(SELECT && track2Id) {
-           particle = theStack->Particle(track2Id);
-           track2PDGId = particle->GetPdgCode();
-           track2MotherId = particle->GetFirstMother();
-           if (track2MotherId >=0 ) 
-             track2MotherPDGId = ((TParticle*) theStack->Particle(track2MotherId))->GetPdgCode();
+         // skip ghosts
+         if (!esd->GetMuonTrack(iTrack2)->ContainTrackerData()) continue;
+         
+         AliESDMuonTrack* muonTrack2 = new AliESDMuonTrack(*(esd->GetMuonTrack(iTrack2)));
+          
+         // extrapolate to vertex if required and available
+         if (ExtrapToVertex > 0 && Vertex->GetNContributors()) {
+           AliMUONESDInterface::GetParamAtFirstCluster(*muonTrack2, trackParam);
+           AliMUONTrackExtrap::ExtrapToVertex(&trackParam, fXVertex, fYVertex, fZVertex, errXVtx, errYVtx);
+           AliMUONESDInterface::SetParamAtVertex(trackParam, *muonTrack2); // put the new parameters in this copy of AliESDMuonTrack
+         } else if ((ExtrapToVertex > 0 && !Vertex->GetNContributors()) || ExtrapToVertex == 0){
+           AliMUONESDInterface::GetParamAtFirstCluster(*muonTrack2, trackParam);
+           AliMUONTrackExtrap::ExtrapToVertex(&trackParam, 0., 0., 0., 0., 0.);
+           AliMUONESDInterface::SetParamAtVertex(trackParam, *muonTrack2); // put the new parameters in this copy of AliESDMuonTrack
          }
 
-         track2Trigger = muonTrack->GetMatchTrigger();
+         track2Trigger = muonTrack2->GetMatchTrigger();
          if (track2Trigger) 
-           track2TriggerChi2 = muonTrack->GetChi2MatchTrigger();
+           track2TriggerChi2 = muonTrack2->GetChi2MatchTrigger();
          else 
            track2TriggerChi2 = 0. ;
 
-         thetaX = muonTrack->GetThetaX();
-         thetaY = muonTrack->GetThetaY();
-
-         pYZ     =  1./TMath::Abs(muonTrack->GetInverseBendingMomentum());
-         fPzRec2  = - pYZ / TMath::Sqrt(1.0 + TMath::Tan(thetaY)*TMath::Tan(thetaY));
-         fPxRec2  = fPzRec2 * TMath::Tan(thetaX);
-         fPyRec2  = fPzRec2 * TMath::Tan(thetaY);
-         fCharge2 = Int_t(TMath::Sign(1.,muonTrack->GetInverseBendingMomentum()));
+         fCharge2 = Int_t(TMath::Sign(1.,muonTrack2->GetInverseBendingMomentum()));
 
-         fE2 = TMath::Sqrt(muonMass * muonMass + fPxRec2 * fPxRec2 + fPyRec2 * fPyRec2 + fPzRec2 * fPzRec2);
-         fV2.SetPxPyPzE(fPxRec2, fPyRec2, fPzRec2, fE2);
+         muonTrack2->LorentzP(fV2);
 
-         ntrackhits = muonTrack->GetNHit();
-         fitfmin    = muonTrack->GetChi2();
+         ntrackhits = muonTrack2->GetNHit();
+         fitfmin    = muonTrack2->GetChi2();
 
          // transverse momentum
          Float_t pt2 = fV2.Pt();
@@ -384,48 +456,58 @@ Bool_t MUONefficiency(char* filename = "galice.root", Int_t FirstEvent = 0, Int_
          // chi2 per d.o.f.
          Float_t ch2 = fitfmin  / (2.0 * ntrackhits - 5);
 
-         if (PRINTLEVEL > 5)  cout << "track1MotherId : "<< track1MotherId << "    track2MotherId : " << track2MotherId << endl ;
-         if (PRINTLEVEL > 5) cout << "track1MotherPDGId : " << track1MotherPDGId << "    track2MotherPDGId : "  << track2MotherPDGId << endl ;
-
-         // Select Condition
-         if (!SELECT || (track2MotherId == track1MotherId && track2MotherPDGId == ResType && TMath::Abs(track1PDGId)==13 && TMath::Abs(track2PDGId)==13 )) {
 
-           // condition for good track (Chi2Cut and PtCut)
-           if ((ch2 < Chi2Cut) && (pt2 > PtCutMin)  && (pt2 < PtCutMax)) {
+         // condition for good track (Chi2Cut and PtCut)
+         if ((ch2 < Chi2Cut) && (pt2 > PtCutMin)  && (pt2 < PtCutMax)) {
            
-             // condition for opposite charges
-             if ((fCharge1 * fCharge2) == -1) {
-
-               if (PRINTLEVEL > 8) cout << "---------> Now filling the Ntuple "  <<  endl ;
-               
-               // invariant mass
-               fVtot = fV1 + fV2;
-               Float_t invMass = fVtot.M();
+           // condition for opposite charges
+           if ((fCharge1 * fCharge2) == -1) {
+             
+             if (PRINTLEVEL > 8) cout << "---------> Now filling the Ntuple "  <<  endl ;
+             
+             // invariant mass
+             fVtot = fV1 + fV2;
+             Float_t invMass = fVtot.M();
+             
+             if (fCharge1 < 0){ //mu_minus is index 1 in the ntuple
+               Float_t ESDFill[16] = {iEvent,triggerWord,fVtot.Pt(),fVtot.Rapidity(),fVtot.Theta()/TMath::Pi()*180,invMass,fV1.Pt(),fV1.Rapidity(),fV1.Theta()/TMath::Pi()*180,fCharge1,track1TriggerChi2,fV2.Pt(),fV2.Rapidity(),fV2.Theta()/TMath::Pi()*180,fCharge2,track2TriggerChi2};
+               ESDtuple->Fill(ESDFill);
+             }
+             else{
+               Float_t ESDFill[16] = {iEvent,triggerWord,fVtot.Pt(),fVtot.Rapidity(),fVtot.Theta()/TMath::Pi()*180,invMass,fV2.Pt(),fV2.Rapidity(),fV2.Theta()/TMath::Pi()*180,fCharge2,track2TriggerChi2,fV1.Pt(),fV1.Rapidity(),fV1.Theta()/TMath::Pi()*180,fCharge1,track1TriggerChi2};
+               ESDtuple->Fill(ESDFill);
+             }
+             
+             // fill histos hInvMassAll and hInvMassRes
+             hInvMassAll->Fill(invMass);
+             hInvMassRes->Fill(invMass);
+             hInvMassAll_vs_Pt->Fill(invMass,fVtot.Pt());
+             
+             //trigger info 
+             if (ResType == 553)
+               ptTrig = 0x08;// mask for Hpt unlike sign pair
+             else if (ResType == 443)
+               ptTrig = 0x04;// mask for Lpt unlike sign pair
+             
+             
+             if (esd->GetTriggerMask() &  ptTrig) NbTrigger++;
+             
+             if (invMass > invMassMinInPeak && invMass < invMassMaxInPeak) {
+               EventInMass++;
+               hRapResonance->Fill(fVtot.Rapidity());
+               hPtResonance->Fill(fVtot.Pt());
                
-               if (fCharge1 < 0){ //mu_minus is index 1 in the ntuple
-                 Float_t ESDFill[16] = {iEvent,triggerWord,fVtot.Pt(),fVtot.Rapidity(),fVtot.Theta()/TMath::Pi()*180,invMass,fV1.Pt(),fV1.Rapidity(),fV1.Theta()/TMath::Pi()*180,fCharge1,track1TriggerChi2,fV2.Pt(),fV2.Rapidity(),fV2.Theta()/TMath::Pi()*180,fCharge2,track2TriggerChi2};
-                 ESDtuple->Fill(ESDFill);
-               }
-               else{
-                 Float_t ESDFill[16] = {iEvent,triggerWord,fVtot.Pt(),fVtot.Rapidity(),fVtot.Theta()/TMath::Pi()*180,invMass,fV2.Pt(),fV2.Rapidity(),fV2.Theta()/TMath::Pi()*180,fCharge2,track2TriggerChi2,fV1.Pt(),fV1.Rapidity(),fV1.Theta()/TMath::Pi()*180,fCharge1,track1TriggerChi2};
-                 ESDtuple->Fill(ESDFill);
-               }
+               // match with trigger
+               if (muonTrack2->GetMatchTrigger()>=0 && (esd->GetTriggerMask() & ptTrig))  EventInMassMatch++;
                
-               // fill histos hInvMassAll and hInvMassRes
-               hInvMassAll->Fill(invMass);
-               hInvMassRes->Fill(invMass);
-               hInvMassAll_vs_Pt->Fill(invMass,fVtot.Pt());
-               if (invMass > massMin && invMass < massMax) {
-                 EventInMass++;
-                 hRapResonance->Fill(fVtot.Rapidity());
-                 hPtResonance->Fill(fVtot.Pt());
-               }
-               
-             } // if (fCharge1 * fCharge2) == -1)
-           } // if ((ch2 < Chi2Cut) && (pt2 > PtCutMin) && (pt2 < PtCutMax))
-         } // if (track2MotherId == track1MotherId && track2MotherPDGId == ResType)
+             }
+             
+           } // if (fCharge1 * fCharge2) == -1)
+         } // if ((ch2 < Chi2Cut) && (pt2 > PtCutMin) && (pt2 < PtCutMax))
+          delete muonTrack2;
        } //  for (Int_t iTrack2 = iTrack + 1; iTrack2 < iTrack; iTrack2++)
       } // if (ch1 < Chi2Cut) && (pt1 > PtCutMin)&& (pt1 < PtCutMax) )
+      delete muonTrack;
     } // for (Int_t iTrack = 0; iTrack < nrectracks; iTrack++)
     
     hNumberOfTrack->Fill(nTracks);
@@ -441,7 +523,7 @@ Bool_t MUONefficiency(char* filename = "galice.root", Int_t FirstEvent = 0, Int_
   Float_t PtMinus, PtPlus;
   
   for (Int_t iEvent = 0; iEvent < hInvMassAll->Integral(); iEvent++) {  // Loop over events for bg event
-    // according to Christian a 3d histo phi-theta-pt would take better care 
+    // according to Christian a 3d phi-theta-pt random pick  would take better care 
     // of all correlations 
 
     hThetaPhiPlus->GetRandom2(phiPlus, thetaPlus);
@@ -453,14 +535,14 @@ Bool_t MUONefficiency(char* filename = "galice.root", Int_t FirstEvent = 0, Int_
     fPyRec1  = PtPlus * TMath::Sin(TMath::Pi()/180.*phiPlus);
     fPzRec1  = PtPlus / TMath::Tan(TMath::Pi()/180.*thetaPlus);
 
-    fE1 = TMath::Sqrt(muonMass * muonMass + fPxRec1 * fPxRec1 + fPyRec1 * fPyRec1 + fPzRec1 * fPzRec1);
+    fE1 = TMath::Sqrt(MUON_MASS * MUON_MASS + fPxRec1 * fPxRec1 + fPyRec1 * fPyRec1 + fPzRec1 * fPzRec1);
     fV1.SetPxPyPzE(fPxRec1, fPyRec1, fPzRec1, fE1);
 
     fPxRec2  = PtMinus * TMath::Cos(TMath::Pi()/180.*phiMinus);
     fPyRec2  = PtMinus * TMath::Sin(TMath::Pi()/180.*phiMinus);
     fPzRec2  = PtMinus / TMath::Tan(TMath::Pi()/180.*thetaMinus);
 
-    fE2 = TMath::Sqrt(muonMass * muonMass + fPxRec2 * fPxRec2 + fPyRec2 * fPyRec2 + fPzRec2 * fPzRec2);
+    fE2 = TMath::Sqrt(MUON_MASS * MUON_MASS + fPxRec2 * fPxRec2 + fPyRec2 * fPyRec2 + fPzRec2 * fPzRec2);
     fV2.SetPxPyPzE(fPxRec2, fPyRec2, fPzRec2, fE2);
 
     // invariant mass
@@ -478,25 +560,63 @@ Bool_t MUONefficiency(char* filename = "galice.root", Int_t FirstEvent = 0, Int_
 
   // File for histograms and histogram booking
   TString outfilename = "MUONefficiency.root";
-  TFile *histoFile = new TFile(outfilename.Data(), "RECREATE");  
+  TFile *ntupleFile = new TFile(outfilename.Data(), "RECREATE");  
   
   Ktuple->Write();
   ESDtuple->Write();
-  //histoFile->Write();
+  ESDtupleBck->Write();
+
+  ntupleFile->Close();
   
+  TFile *histoFile = new TFile("MUONhistos.root", "RECREATE");  
+  hPrimaryVertex->Write();
+  hPtMuon->Write();
+  hPtMuonPlus->Write();
+  hPtMuonMinus->Write();
+  hPMuon->Write();
+  hChi2PerDof->Write();
+  hInvMassAll->Write();
+  hInvMassBg->Write();
+  hInvMassAll_vs_Pt ->Write();
+  hInvMassBgk_vs_Pt->Write();
+  hInvMassRes->Write();
+  hNumberOfTrack->Write();
+  hRapMuon ->Write();
+  hRapResonance ->Write();
+  hPtResonance ->Write();
+  hThetaPhiPlus ->Write();
+  hThetaPhiMinus ->Write();
   histoFile->Close();
+
+  cout << "" << endl ;
+  cout << "*************************************************" << endl;
+  cout << "MUONefficiency : " << nprocessedevents  << " events processed" << endl;
+  if (ResType==443)
+    cout << "Number of generated J/Psi (443)  : " <<  numberOfGeneratedResonances  << endl ;
+  if (ResType==553)
+    cout << "Number of generated Upsilon (553)  :" <<  numberOfGeneratedResonances  << endl ;
+  cout << "Chi2Cut for muon tracks = " << Chi2Cut << endl;
+  cout << "PtCutMin for muon tracks = " << PtCutMin << endl;
+  cout << "PtCutMax for muon tracks = " << PtCutMax << endl;
+  
+  cout << "Entries (unlike sign dimuons) : " << hInvMassAll->GetEntries();
   
-  cout << "MUONefficiency " << endl;
-  cout << "FirstEvent " << FirstEvent << endl;
-  cout << "LastEvent " << LastEvent << endl;
-  cout << "ResType " << ResType << endl;
-  cout << "Chi2Cut " << Chi2Cut << endl;
-  cout << "PtCutMin " << PtCutMin << endl;
-  cout << "PtCutMax " << PtCutMax << endl;
-  cout << "massMin " << massMin << endl;
-  cout << "massMax " << massMax << endl;
-  cout << "EventInMass " << EventInMass << endl;
+  if (hInvMassAll->GetEntries() > 0) {
+    hInvMassAll->Fit("gaus","q0");
+    TF1* f1 = hInvMassAll->GetFunction("gaus");
+    cout << Form(". Rough sigma = %7.2f MeV/c2",f1->GetParameter(2)*1000.0);
+  }
+  
+  cout << endl << "Entries (unlike sign dimuons) in the mass range  ["<<invMassMinInPeak<<";"<<invMassMaxInPeak<<"] : " << EventInMass <<endl;
+  
+  if (ptTrig==0x800) cout << "Unlike Pair - All Pt" ;   
+  if (ptTrig==0x400) cout << "Unlike Pair - High Pt" ;   
+  if (ptTrig==0x200) cout << "Unlike Pair - Low Pt" ; 
+  cout << " triggers : " << NbTrigger << endl;
+  
+  cout << "Entries in the mass range with matching between reconstructed tracks and trigger tracks " << EventInMassMatch << endl;
+
 
   return kTRUE;
 }
-