]> git.uio.no Git - u/mrichter/AliRoot.git/commitdiff
New ITS-SPD trackleter class (Mariella)
authorenrico <enrico@f7af4fe6-9843-0410-8265-dc069ae4e863>
Mon, 25 Oct 2010 08:47:37 +0000 (08:47 +0000)
committerenrico <enrico@f7af4fe6-9843-0410-8265-dc069ae4e863>
Mon, 25 Oct 2010 08:47:37 +0000 (08:47 +0000)
PWG2/EVCHAR/AliTrackletAlg.cxx [new file with mode: 0644]
PWG2/EVCHAR/AliTrackletAlg.h [new file with mode: 0644]

diff --git a/PWG2/EVCHAR/AliTrackletAlg.cxx b/PWG2/EVCHAR/AliTrackletAlg.cxx
new file mode 100644 (file)
index 0000000..696fbe7
--- /dev/null
@@ -0,0 +1,1220 @@
+/**************************************************************************
+ * Copyright(c) 2007-2009, ALICE Experiment at CERN, All rights reserved. *
+ *                                                                        *
+ * Author: The ALICE Off-line Project.                                    *
+ * Contributors are mentioned in the code where appropriate.              *
+ *                                                                        *
+ * Permission to use, copy, modify and distribute this software and its   *
+ * documentation strictly for non-commercial purposes is hereby granted   *
+ * without fee, provided that the above copyright notice appears in all   *
+ * copies and that both the copyright notice and this permission notice   *
+ * appear in the supporting documentation. The authors make no claims     *
+ * about the suitability of this software for any purpose. It is          *
+ * provided "as is" without express or implied warranty.                  *
+ **************************************************************************/
+
+//_________________________________________________________________________
+// 
+//        Implementation of the ITS-SPD trackleter class
+// Clone version of the AliITSMultReconstructor class (October 2010) 
+// that can be used in an AliAnalysisTask
+// 
+// Support and development: 
+//         Domenico Elia, Maria Nicassio (INFN Bari) 
+//         Domenico.Elia@ba.infn.it, Maria.Nicassio@ba.infn.it
+//
+//_________________________________________________________________________
+
+#include <TClonesArray.h>
+#include <TH1F.h>
+#include <TH2F.h>
+#include <TTree.h>
+#include <TBits.h>
+#include <TArrayI.h>
+
+#include "AliTrackletAlg.h"
+#include "../ITS/AliITSReconstructor.h"
+#include "../ITS/AliITSsegmentationSPD.h"
+#include "../ITS/AliITSRecPoint.h"
+#include "../ITS/AliITSRecPointContainer.h"
+#include "../ITS/AliITSgeom.h"
+#include "../ITS/AliITSgeomTGeo.h"
+#include "../ITS/AliITSDetTypeRec.h"
+#include "AliESDEvent.h"
+#include "AliESDVertex.h"
+#include "AliESDtrack.h"
+#include "AliMultiplicity.h"
+#include "AliLog.h"
+#include "TGeoGlobalMagField.h"
+#include "AliMagF.h"
+#include "AliESDv0.h"
+#include "AliV0.h"
+#include "AliKFParticle.h"
+#include "AliKFVertex.h"
+
+//____________________________________________________________________
+ClassImp(AliTrackletAlg)
+
+
+//____________________________________________________________________
+AliTrackletAlg::AliTrackletAlg():
+fDetTypeRec(0),fESDEvent(0),fTreeRP(0),fUsedClusLay1(0),fUsedClusLay2(0),
+fClustersLay1(0),
+fClustersLay2(0),
+fDetectorIndexClustersLay1(0),
+fDetectorIndexClustersLay2(0),
+fOverlapFlagClustersLay1(0),
+fOverlapFlagClustersLay2(0),
+fTracklets(0),
+fSClusters(0),
+fNClustersLay1(0),
+fNClustersLay2(0),
+fNTracklets(0),
+fNSingleCluster(0),
+fPhiWindow(0),
+fThetaWindow(0),
+fPhiShift(0),
+fRemoveClustersFromOverlaps(0),
+fPhiOverlapCut(0),
+fZetaOverlapCut(0),
+fPhiRotationAngle(0),
+//
+fCutPxDrSPDin(0.1),
+fCutPxDrSPDout(0.15),
+fCutPxDz(0.2),
+fCutDCArz(0.5),
+fCutMinElectronProbTPC(0.5),
+fCutMinElectronProbESD(0.1),
+fCutMinP(0.05),
+fCutMinRGamma(2.),
+fCutMinRK0(1.),
+fCutMinPointAngle(0.98),
+fCutMaxDCADauther(0.5),
+fCutMassGamma(0.03),
+fCutMassGammaNSigma(5.),
+fCutMassK0(0.03),
+fCutMassK0NSigma(5.),
+fCutChi2cGamma(2.),
+fCutChi2cK0(2.),
+fCutGammaSFromDecay(-10.),
+fCutK0SFromDecay(-10.),
+fCutMaxDCA(1.),
+//
+fHistOn(0),
+fhClustersDPhiAcc(0),
+fhClustersDThetaAcc(0),
+fhClustersDPhiAll(0),
+fhClustersDThetaAll(0),
+fhDPhiVsDThetaAll(0),
+fhDPhiVsDThetaAcc(0),
+fhetaTracklets(0),
+fhphiTracklets(0),
+fhetaClustersLay1(0),
+fhphiClustersLay1(0){
+
+  fNFiredChips[0] = 0;
+  fNFiredChips[1] = 0;
+  // Method to reconstruct the charged particles multiplicity with the 
+  // SPD (tracklets).
+
+  SetHistOn();
+
+  if(AliITSReconstructor::GetRecoParam()) { 
+    SetPhiWindow(AliITSReconstructor::GetRecoParam()->GetTrackleterPhiWindow());
+    SetThetaWindow(AliITSReconstructor::GetRecoParam()->GetTrackleterThetaWindow());
+    SetPhiShift(AliITSReconstructor::GetRecoParam()->GetTrackleterPhiShift());
+    SetRemoveClustersFromOverlaps(AliITSReconstructor::GetRecoParam()->GetTrackleterRemoveClustersFromOverlaps());
+    SetPhiOverlapCut(AliITSReconstructor::GetRecoParam()->GetTrackleterPhiOverlapCut());
+    SetZetaOverlapCut(AliITSReconstructor::GetRecoParam()->GetTrackleterZetaOverlapCut());
+    SetPhiRotationAngle(AliITSReconstructor::GetRecoParam()->GetTrackleterPhiRotationAngle());
+    //
+    SetCutPxDrSPDin(AliITSReconstructor::GetRecoParam()->GetMultCutPxDrSPDin());
+    SetCutPxDrSPDout(AliITSReconstructor::GetRecoParam()->GetMultCutPxDrSPDout());
+    SetCutPxDz(AliITSReconstructor::GetRecoParam()->GetMultCutPxDz());
+    SetCutDCArz(AliITSReconstructor::GetRecoParam()->GetMultCutDCArz());
+    SetCutMinElectronProbTPC(AliITSReconstructor::GetRecoParam()->GetMultCutMinElectronProbTPC());
+    SetCutMinElectronProbESD(AliITSReconstructor::GetRecoParam()->GetMultCutMinElectronProbESD());
+    SetCutMinP(AliITSReconstructor::GetRecoParam()->GetMultCutMinP());
+    SetCutMinRGamma(AliITSReconstructor::GetRecoParam()->GetMultCutMinRGamma());
+    SetCutMinRK0(AliITSReconstructor::GetRecoParam()->GetMultCutMinRK0());
+    SetCutMinPointAngle(AliITSReconstructor::GetRecoParam()->GetMultCutMinPointAngle());
+    SetCutMaxDCADauther(AliITSReconstructor::GetRecoParam()->GetMultCutMaxDCADauther());
+    SetCutMassGamma(AliITSReconstructor::GetRecoParam()->GetMultCutMassGamma());
+    SetCutMassGammaNSigma(AliITSReconstructor::GetRecoParam()->GetMultCutMassGammaNSigma());
+    SetCutMassK0(AliITSReconstructor::GetRecoParam()->GetMultCutMassK0());
+    SetCutMassK0NSigma(AliITSReconstructor::GetRecoParam()->GetMultCutMassK0NSigma());
+    SetCutChi2cGamma(AliITSReconstructor::GetRecoParam()->GetMultCutChi2cGamma());
+    SetCutChi2cK0(AliITSReconstructor::GetRecoParam()->GetMultCutChi2cK0());
+    SetCutGammaSFromDecay(AliITSReconstructor::GetRecoParam()->GetMultCutGammaSFromDecay());
+    SetCutK0SFromDecay(AliITSReconstructor::GetRecoParam()->GetMultCutK0SFromDecay());
+    SetCutMaxDCA(AliITSReconstructor::GetRecoParam()->GetMultCutMaxDCA());
+    //
+  } else {
+    SetPhiWindow();
+    SetThetaWindow();
+    SetPhiShift();
+    SetRemoveClustersFromOverlaps();
+    SetPhiOverlapCut();
+    SetZetaOverlapCut();
+    SetPhiRotationAngle();
+
+    //
+    SetCutPxDrSPDin();
+    SetCutPxDrSPDout();
+    SetCutPxDz();
+    SetCutDCArz();
+    SetCutMinElectronProbTPC();
+    SetCutMinElectronProbESD();
+    SetCutMinP();
+    SetCutMinRGamma();
+    SetCutMinRK0();
+    SetCutMinPointAngle();
+    SetCutMaxDCADauther();
+    SetCutMassGamma();
+    SetCutMassGammaNSigma();
+    SetCutMassK0();
+    SetCutMassK0NSigma();
+    SetCutChi2cGamma();
+    SetCutChi2cK0();
+    SetCutGammaSFromDecay();
+    SetCutK0SFromDecay();
+    SetCutMaxDCA();
+  } 
+  
+  fClustersLay1              = 0;
+  fClustersLay2              = 0;
+  fDetectorIndexClustersLay1 = 0;
+  fDetectorIndexClustersLay2 = 0;
+  fOverlapFlagClustersLay1   = 0;
+  fOverlapFlagClustersLay2   = 0;
+  fTracklets                 = 0;
+  fSClusters                 = 0;
+
+  // definition of histograms
+  Bool_t oldStatus = TH1::AddDirectoryStatus();
+  TH1::AddDirectory(kFALSE);
+  
+  fhClustersDPhiAcc   = new TH1F("dphiacc",  "dphi",  100,-0.1,0.1);
+  fhClustersDThetaAcc = new TH1F("dthetaacc","dtheta",100,-0.1,0.1);
+
+  fhDPhiVsDThetaAcc = new TH2F("dphiVsDthetaAcc","",100,-0.1,0.1,100,-0.1,0.1);
+
+  fhClustersDPhiAll   = new TH1F("dphiall",  "dphi",  100,0.0,0.5);
+  fhClustersDThetaAll = new TH1F("dthetaall","dtheta",100,0.0,0.5);
+
+  fhDPhiVsDThetaAll = new TH2F("dphiVsDthetaAll","",100,0.,0.5,100,0.,0.5);
+
+  fhetaTracklets  = new TH1F("etaTracklets",  "eta",  100,-2.,2.);
+  fhphiTracklets  = new TH1F("phiTracklets",  "phi",  100, 0., 2*TMath::Pi());
+  fhetaClustersLay1  = new TH1F("etaClustersLay1",  "etaCl1",  100,-2.,2.);
+  fhphiClustersLay1  = new TH1F("phiClustersLay1", "phiCl1", 100, 0., 2*TMath::Pi());
+  
+  TH1::AddDirectory(oldStatus);
+}
+
+//______________________________________________________________________
+AliTrackletAlg::AliTrackletAlg(const AliTrackletAlg &mr) : 
+AliTrackleter(mr),
+fDetTypeRec(0),fESDEvent(0),fTreeRP(0),fUsedClusLay1(0),fUsedClusLay2(0),
+fClustersLay1(0),
+fClustersLay2(0),
+fDetectorIndexClustersLay1(0),
+fDetectorIndexClustersLay2(0),
+fOverlapFlagClustersLay1(0),
+fOverlapFlagClustersLay2(0),
+fTracklets(0),
+fSClusters(0),
+fNClustersLay1(0),
+fNClustersLay2(0),
+fNTracklets(0),
+fNSingleCluster(0),
+fPhiWindow(0),
+fThetaWindow(0),
+fPhiShift(0),
+fRemoveClustersFromOverlaps(0),
+fPhiOverlapCut(0),
+fZetaOverlapCut(0),
+fPhiRotationAngle(0),
+//
+fCutPxDrSPDin(0.1),
+fCutPxDrSPDout(0.15),
+fCutPxDz(0.2),
+fCutDCArz(0.5),
+fCutMinElectronProbTPC(0.5),
+fCutMinElectronProbESD(0.1),
+fCutMinP(0.05),
+fCutMinRGamma(2.),
+fCutMinRK0(1.),
+fCutMinPointAngle(0.98),
+fCutMaxDCADauther(0.5),
+fCutMassGamma(0.03),
+fCutMassGammaNSigma(5.),
+fCutMassK0(0.03),
+fCutMassK0NSigma(5.),
+fCutChi2cGamma(2.),
+fCutChi2cK0(2.),
+fCutGammaSFromDecay(-10.),
+fCutK0SFromDecay(-10.),
+fCutMaxDCA(1.),
+//
+fHistOn(0),
+fhClustersDPhiAcc(0),
+fhClustersDThetaAcc(0),
+fhClustersDPhiAll(0),
+fhClustersDThetaAll(0),
+fhDPhiVsDThetaAll(0),
+fhDPhiVsDThetaAcc(0),
+fhetaTracklets(0),
+fhphiTracklets(0),
+fhetaClustersLay1(0),
+fhphiClustersLay1(0)
+ {
+  // Copy constructor :!!! RS ATTENTION: old c-tor reassigned the pointers instead of creating a new copy -> would crash on delete
+   AliError("May not use");
+}
+
+//______________________________________________________________________
+AliTrackletAlg& AliTrackletAlg::operator=(const AliTrackletAlg& mr){
+  // Assignment operator
+  if (this != &mr) {
+    this->~AliTrackletAlg();
+    new(this) AliTrackletAlg(mr);
+  }
+  return *this;
+}
+
+//______________________________________________________________________
+AliTrackletAlg::~AliTrackletAlg(){
+  // Destructor
+
+  // delete histograms
+  delete fhClustersDPhiAcc;
+  delete fhClustersDThetaAcc;
+  delete fhClustersDPhiAll;
+  delete fhClustersDThetaAll;
+  delete fhDPhiVsDThetaAll;
+  delete fhDPhiVsDThetaAcc;
+  delete fhetaTracklets;
+  delete fhphiTracklets;
+  delete fhetaClustersLay1;
+  delete fhphiClustersLay1;
+  delete[] fUsedClusLay1;
+  delete[] fUsedClusLay2;
+  // delete arrays    
+  for(Int_t i=0; i<fNTracklets; i++)
+    delete [] fTracklets[i];
+    
+  for(Int_t i=0; i<fNSingleCluster; i++)
+    delete [] fSClusters[i];
+    
+  delete [] fClustersLay1;
+  delete [] fClustersLay2;
+  delete [] fDetectorIndexClustersLay1;
+  delete [] fDetectorIndexClustersLay2;
+  delete [] fOverlapFlagClustersLay1;
+  delete [] fOverlapFlagClustersLay2;
+  delete [] fTracklets;
+  delete [] fSClusters;
+}
+
+//____________________________________________________________________
+void AliTrackletAlg::Reconstruct(AliESDEvent* esd, TTree* treeRP) 
+{  
+  if (!treeRP) { AliError(" Invalid ITS cluster tree !\n"); return; }
+  if (!esd) {AliError("ESDEvent is not available, use old reconstructor"); return;}
+  // reset counters
+  if (fMult) delete fMult; fMult = 0;
+  fNClustersLay1 = 0;
+  fNClustersLay2 = 0;
+  fNTracklets = 0; 
+  fNSingleCluster = 0;
+  //
+  fESDEvent = esd;
+  fTreeRP = treeRP;
+  //
+  // >>>> RS: this part is equivalent to former AliITSVertexer::FindMultiplicity
+  //
+  // see if there is a SPD vertex 
+  Bool_t isVtxOK=kTRUE, isCosmics=kFALSE;
+  AliESDVertex* vtx = (AliESDVertex*)fESDEvent->GetPrimaryVertexSPD();
+  if (!vtx || vtx->GetNContributors()<1) isVtxOK = kFALSE;
+  if (vtx && strstr(vtx->GetTitle(),"cosmics")) {
+    isVtxOK = kFALSE;
+    isCosmics = kTRUE;
+  }
+  //
+  if (!isVtxOK) {
+    if (!isCosmics) {
+      AliDebug(1,"Tracklets multiplicity not determined because the primary vertex was not found");
+      AliDebug(1,"Just counting the number of cluster-fired chips on the SPD layers");
+    }
+    vtx = 0;
+  }
+  if(vtx){
+    float vtxf[3] = {vtx->GetX(),vtx->GetY(),vtx->GetZ()};
+    FindTracklets(vtxf);
+  }
+  else {
+    FindTracklets(0);
+  }
+  //
+  CreateMultiplicityObject();
+}
+
+//____________________________________________________________________
+void AliTrackletAlg::Reconstruct(TTree* clusterTree, Float_t* vtx, Float_t* /* vtxRes*/) {
+  //
+  // RS NOTE - this is old reconstructor invocation, to be used from VertexFinder
+
+  if (fMult) delete fMult; fMult = 0;
+  fNClustersLay1 = 0;
+  fNClustersLay2 = 0;
+  fNTracklets = 0; 
+  fNSingleCluster = 0;
+  //
+  if (!clusterTree) { AliError(" Invalid ITS cluster tree !\n"); return; }
+  //
+  fESDEvent = 0;
+  fTreeRP = clusterTree;
+  //
+  FindTracklets(vtx);
+  //
+}
+
+//____________________________________________________________________
+void AliTrackletAlg::FindTracklets(const Float_t *vtx) 
+{
+  // - calls LoadClusterArrays that finds the position of the clusters
+  //   (in global coord) 
+
+  // - convert the cluster coordinates to theta, phi (seen from the
+  //   interaction vertex). Clusters in the inner layer can be now
+  //   rotated for combinatorial studies 
+  // - makes an array of tracklets 
+  //   
+  // After this method has been called, the clusters of the two layers
+  // and the tracklets can be retrieved by calling the Get'er methods.
+
+
+  // Find tracklets converging to vertex
+  //
+  LoadClusterArrays(fTreeRP);
+
+  // flag clusters used by ESD tracks
+  if (fESDEvent) ProcessESDTracks();
+
+  if (!vtx) return;
+
+  const Double_t pi = TMath::Pi();
+  Printf("pi %f",pi);
+  // dPhi shift is field dependent
+  // get average magnetic field
+  Float_t bz = 0;
+  AliMagF* field = 0;
+  if (TGeoGlobalMagField::Instance()) field = dynamic_cast<AliMagF*>(TGeoGlobalMagField::Instance()->GetField());
+  if (!field)
+  {
+    AliError("Could not retrieve magnetic field. Assuming no field. Delta Phi shift will be deactivated in AliTrackletAlg.")
+  }
+  else
+    bz = TMath::Abs(field->SolenoidField());
+  
+  const Double_t dPhiShift = fPhiShift / 5 * bz; 
+  AliDebug(1, Form("Using phi shift of %f", dPhiShift));
+//  Printf("dphishift... %f",dPhiShift); 
+  const Double_t dPhiWindow2 = fPhiWindow * fPhiWindow;
+//  Printf("phiwin... %f",fPhiWindow);
+//  Printf("thetawin... %f",fThetaWindow);
+//  Printf("phirotangle... %f",fPhiRotationAngle); 
+  const Double_t dThetaWindow2 = fThetaWindow * fThetaWindow;
+//  Printf("cl2... %d",fNClustersLay2); 
+  Int_t* partners = new Int_t[fNClustersLay2];
+  Float_t* minDists = new Float_t[fNClustersLay2];
+  Int_t* associatedLay1 = new Int_t[fNClustersLay1];
+  TArrayI** blacklist = new TArrayI*[fNClustersLay1];
+//  Printf("Vertex in find tracklets...%f %f %f",vtx[0],vtx[1],vtx[2]);
+  for (Int_t i=0; i<fNClustersLay2; i++) {
+    partners[i] = -1;
+    minDists[i] = 2;
+  }
+  for (Int_t i=0; i<fNClustersLay1; i++) 
+    associatedLay1[i] = 0; 
+  for (Int_t i=0; i<fNClustersLay1; i++)
+    blacklist[i] = 0;
+//  Printf("Looking for tracklets...");
+  // find the tracklets
+  AliDebug(1,"Looking for tracklets... ");  
+  
+  //###########################################################
+  // Loop on layer 1 : finding theta, phi and z 
+  for (Int_t iC1=0; iC1<fNClustersLay1; iC1++) {    
+//    Printf("looping on cl 1...");
+    float *clPar = GetClusterLayer1(iC1);
+    Float_t x = clPar[kClTh] - vtx[0];
+    Float_t y = clPar[kClPh] - vtx[1];
+    Float_t z = clPar[kClZ]  - vtx[2];
+
+    Float_t r    = TMath::Sqrt(x*x + y*y + z*z);
+    
+    clPar[kClTh] = TMath::ACos(z/r);                   // Store Theta
+    clPar[kClPh] = TMath::Pi() + TMath::ATan2(-y,-x);  // Store Phi
+    clPar[kClPh] = clPar[kClPh] + fPhiRotationAngle;   //rotation of inner layer for comb studies  
+//    Printf("ClPar1 %f %f ", clPar[0],clPar[1]);
+    if (fHistOn) {
+      Float_t eta = clPar[kClTh];
+      eta= TMath::Tan(eta/2.);
+      eta=-TMath::Log(eta);
+      fhetaClustersLay1->Fill(eta);    
+      fhphiClustersLay1->Fill(clPar[kClPh]);
+    }      
+  }
+  
+  // Loop on layer 2 : finding theta, phi and r   
+  for (Int_t iC2=0; iC2<fNClustersLay2; iC2++) {    
+    float *clPar = GetClusterLayer2(iC2);
+    Float_t x = clPar[kClTh] - vtx[0];
+    Float_t y = clPar[kClPh] - vtx[1];
+    Float_t z = clPar[kClZ]  - vtx[2];
+   
+    Float_t r    = TMath::Sqrt(x*x + y*y + z*z);
+
+    clPar[kClTh] = TMath::ACos(z/r);                   // Store Theta
+    clPar[kClPh] = TMath::Pi() + TMath::ATan2(-y,-x);  // Store Phi    
+//    Printf("ClPar2 %f %f ", clPar[0],clPar[1]);
+  }  
+  
+  //###########################################################
+  Int_t found = 1;
+  while (found > 0) {
+     Printf("Found something..."); 
+     Printf("cl1...%d",fNClustersLay1);
+     Printf("cl2...%d",fNClustersLay2);
+    
+    found = 0;
+
+    // Step1: find all tracklets allowing double assocation
+    // Loop on layer 1 
+    for (Int_t iC1=0; iC1<fNClustersLay1; iC1++) {    
+//      Printf("looping on cl 1...");
+      // already used ?
+      if (associatedLay1[iC1] != 0) continue; 
+
+      found++;
+
+      // reset of variables for multiple candidates
+      Int_t  iC2WithBestDist = -1;   // reset
+      Double_t minDist       =  2;   // reset
+      float* clPar1 = GetClusterLayer1(iC1);
+//      Printf("ClPar1 %f %f ", clPar1[0],clPar1[1]);
+
+      // Loop on layer 2 
+      for (Int_t iC2=0; iC2<fNClustersLay2; iC2++) {      
+//        Printf("looping on cl 2...");
+       float* clPar2 = GetClusterLayer2(iC2);
+//        Printf("ClPar2 %f %f ", clPar2[0],clPar2[1]);
+        if (blacklist[iC1]) {
+          Bool_t blacklisted = kFALSE;
+          for (Int_t i=blacklist[iC1]->GetSize(); i--;) {
+            if (blacklist[iC1]->At(i) == iC2) {
+              blacklisted = kTRUE;
+              break;
+            }
+          }
+          if (blacklisted) continue;
+        }
+
+       // find the difference in angles
+       Double_t dTheta = TMath::Abs(clPar2[kClTh] - clPar1[kClTh]); 
+         
+       Double_t dPhi   = TMath::Abs(clPar2[kClPh] - clPar1[kClPh]);
+//        Printf("detheta %f  ", dTheta);
+//        Printf("dephi %f  ", dPhi);
+         
+        // take into account boundary condition
+        if (dPhi>pi) dPhi=2.*pi-dPhi;
+        
+       if (fHistOn) {
+         fhClustersDPhiAll->Fill(dPhi);
+         fhClustersDThetaAll->Fill(dTheta);    
+         fhDPhiVsDThetaAll->Fill(dTheta, dPhi);
+       }
+        
+        dPhi -= dPhiShift;
+                
+       // make "elliptical" cut in Phi and Theta! 
+       Float_t d = dPhi*dPhi/dPhiWindow2 + dTheta*dTheta/dThetaWindow2;
+//        Float_t d = dTheta*dTheta/dThetaWindow2;
+//        Printf("distance %f",d);
+       // look for the minimum distance: the minimum is in iC2WithBestDist
+               if (d<1 && d<minDist) {
+         minDist=d;
+         iC2WithBestDist = iC2;
+       }
+      } // end of loop over clusters in layer 2 
+    
+      if (minDist<1) { // This means that a cluster in layer 2 was found that matches with iC1
+
+        if (minDists[iC2WithBestDist] > minDist) {
+          Int_t oldPartner = partners[iC2WithBestDist];
+          partners[iC2WithBestDist] = iC1;
+          minDists[iC2WithBestDist] = minDist;
+
+          // mark as assigned
+          associatedLay1[iC1] = 1;
+          
+          if (oldPartner != -1) {
+            // redo partner search for cluster in L0 (oldPartner), putting this one (iC2WithBestDist) on its blacklist
+            if (blacklist[oldPartner] == 0) {
+              blacklist[oldPartner] = new TArrayI(1);
+            } else blacklist[oldPartner]->Set(blacklist[oldPartner]->GetSize()+1);
+
+            blacklist[oldPartner]->AddAt(iC2WithBestDist, blacklist[oldPartner]->GetSize()-1);
+
+            // mark as free
+            associatedLay1[oldPartner] = 0;
+          }
+        } else {
+          // try again to find a cluster without considering iC2WithBestDist 
+          if (blacklist[iC1] == 0) {
+            blacklist[iC1] = new TArrayI(1);
+          }
+          else 
+            blacklist[iC1]->Set(blacklist[iC1]->GetSize()+1);
+   
+          blacklist[iC1]->AddAt(iC2WithBestDist, blacklist[iC1]->GetSize()-1);
+        } 
+
+      } else // cluster has no partner; remove
+        associatedLay1[iC1] = 2;   
+    } // end of loop over clusters in layer 1
+  }  
+  // Step2: store tracklets; remove used clusters
+  for (Int_t iC2=0; iC2<fNClustersLay2; iC2++) {
+
+    if (partners[iC2] == -1) continue;
+
+    if (fRemoveClustersFromOverlaps) FlagClustersInOverlapRegions (partners[iC2],iC2);
+    Printf("saving tracklets");
+
+    if (fOverlapFlagClustersLay1[partners[iC2]] || fOverlapFlagClustersLay2[iC2]) continue;
+
+    float* clPar2 = GetClusterLayer2(iC2);
+    float* clPar1 = GetClusterLayer1(partners[iC2]);
+
+    Float_t* tracklet = fTracklets[fNTracklets] = new Float_t[kTrNPar]; // RS Add also the cluster id's
+  
+    // use the theta from the clusters in the first layer
+    tracklet[kTrTheta] = clPar1[kClTh];
+    // use the phi from the clusters in the first layer
+    tracklet[kTrPhi] = clPar1[kClPh];
+    // store the difference between phi1 and phi2
+    tracklet[kTrDPhi] = clPar1[kClPh] - clPar2[kClPh];
+
+    // define dphi in the range [0,pi] with proper sign (track charge correlated)
+    if (tracklet[kTrDPhi] > TMath::Pi())   tracklet[kTrDPhi] = tracklet[kTrDPhi]-2.*TMath::Pi();
+    if (tracklet[kTrDPhi] < -TMath::Pi())  tracklet[kTrDPhi] = tracklet[kTrDPhi]+2.*TMath::Pi();
+
+    // store the difference between theta1 and theta2
+    tracklet[kTrDTheta] = clPar1[kClTh] - clPar2[kClTh];
+
+    if (fHistOn) {
+      fhClustersDPhiAcc->Fill(tracklet[kTrDPhi]); 
+      fhClustersDThetaAcc->Fill(tracklet[kTrDTheta]);    
+      fhDPhiVsDThetaAcc->Fill(tracklet[kTrDTheta],tracklet[kTrDPhi]);
+    }
+
+    // find label
+    // if equal label in both clusters found this label is assigned
+    // if no equal label can be found the first labels of the L1 AND L2 cluster are assigned
+    Int_t label1 = 0;
+    Int_t label2 = 0;
+    while (label2 < 3) {
+      if ((Int_t) clPar1[kClMC0+label1] != -2 && (Int_t) clPar1[kClMC0+label1] == (Int_t) clPar2[kClMC0+label2])
+        break;
+      label1++;
+      if (label1 == 3) {
+        label1 = 0;
+        label2++;
+      }
+    }
+    if (label2 < 3) {
+      AliDebug(AliLog::kDebug, Form("Found label %d == %d for tracklet candidate %d\n", (Int_t) clPar1[kClMC0+label1], (Int_t) clPar1[kClMC0+label2], fNTracklets));
+      tracklet[kTrLab1] = clPar1[kClMC0+label1];
+      tracklet[kTrLab2] = clPar2[kClMC0+label2];
+    } else {
+      AliDebug(AliLog::kDebug, Form("Did not find label %d %d %d %d %d %d for tracklet candidate %d\n", (Int_t) clPar1[kClMC0], (Int_t) clPar1[kClMC1], (Int_t) clPar1[kClMC2], (Int_t) clPar2[kClMC0], (Int_t) clPar2[kClMC1], (Int_t) clPar2[kClMC2], fNTracklets));
+      tracklet[kTrLab1] = clPar1[kClMC0];
+      tracklet[kTrLab2] = clPar2[kClMC0];
+    }
+
+    if (fHistOn) {
+      Float_t eta = tracklet[kTrTheta];
+      eta= TMath::Tan(eta/2.);
+      eta=-TMath::Log(eta);
+      fhetaTracklets->Fill(eta);
+      fhphiTracklets->Fill(tracklet[kTrPhi]);
+    }
+    //
+    tracklet[kClID1] = partners[iC2];
+    tracklet[kClID2] = iC2;
+    //
+//    Printf("Adding tracklet candidate");
+    AliDebug(1,Form(" Adding tracklet candidate %d ", fNTracklets));
+    AliDebug(1,Form(" Cl. %d of Layer 1 and %d of Layer 2", partners[iC2], iC2));
+    fNTracklets++;
+
+    associatedLay1[partners[iC2]] = 1;
+  }
+  
+  // Delete the following else if you do not want to save Clusters! 
+  // store the cluster
+  for (Int_t iC1=0; iC1<fNClustersLay1; iC1++) {
+//    Printf("saving single clusters...");
+    float* clPar1 = GetClusterLayer1(iC1);
+
+    if (associatedLay1[iC1]==2||associatedLay1[iC1]==0) { 
+      fSClusters[fNSingleCluster] = new Float_t[kClNPar];
+      fSClusters[fNSingleCluster][kSCTh] = clPar1[kClTh];
+      fSClusters[fNSingleCluster][kSCPh] = clPar1[kClPh];
+      fSClusters[fNSingleCluster][kSCLab] = clPar1[kClMC0]; 
+      fSClusters[fNSingleCluster][kSCID] = iC1;
+      AliDebug(1,Form(" Adding a single cluster %d (cluster %d  of layer 1)",
+                fNSingleCluster, iC1));
+      fNSingleCluster++;
+    }
+  }
+
+  delete[] partners;
+  delete[] minDists;
+
+  for (Int_t i=0; i<fNClustersLay1; i++)
+    if (blacklist[i])
+      delete blacklist[i];
+  delete[] blacklist;
+//  Printf("exiting...");
+  AliDebug(1,Form("%d tracklets found", fNTracklets));
+}
+
+//____________________________________________________________________
+void AliTrackletAlg::CreateMultiplicityObject()
+{
+  // create AliMultiplicity object and store it in the ESD event
+  //
+  TBits fastOrFiredMap,firedChipMap;
+  if (fDetTypeRec) {
+   fastOrFiredMap  = fDetTypeRec->GetFastOrFiredMap();
+   firedChipMap    = fDetTypeRec->GetFiredChipMap(fTreeRP);
+  }
+  //
+  fMult = new AliMultiplicity(fNTracklets,fNSingleCluster,fNFiredChips[0],fNFiredChips[1],fastOrFiredMap);
+  fMult->SetFiredChipMap(firedChipMap);
+  AliITSRecPointContainer* rcont = AliITSRecPointContainer::Instance();
+  fMult->SetITSClusters(0,rcont->GetNClustersInLayer(1,fTreeRP));
+  for(Int_t kk=2;kk<=6;kk++) fMult->SetITSClusters(kk-1,rcont->GetNClustersInLayerFast(kk));
+  //
+  for (int i=fNTracklets;i--;)  {
+    float* tlInfo = fTracklets[i];
+    fMult->SetTrackletData(i,tlInfo, fUsedClusLay1[int(tlInfo[kClID1])],fUsedClusLay2[int(tlInfo[kClID2])]);
+  }
+  //  
+  for (int i=fNSingleCluster;i--;) {
+    float* clInfo = fSClusters[i];
+    fMult->SetSingleClusterData(i,clInfo,fUsedClusLay1[int(clInfo[kSCID])]);
+  }
+  fMult->CompactBits();
+  //
+}
+
+
+//____________________________________________________________________
+void AliTrackletAlg::LoadClusterArrays(TTree* itsClusterTree) 
+{
+  // This method
+  // - gets the clusters from the cluster tree 
+  // - convert them into global coordinates 
+  // - store them in the internal arrays
+  // - count the number of cluster-fired chips
+  //
+  // RS: This method was strongly modified wrt original. In order to have the same numbering 
+  // of clusters as in the ITS reco I had to introduce sorting in Z
+  // Also note that now the clusters data are stored not in float[6] attached to float**, but in 1-D array
+  AliDebug(1,"Loading clusters and cluster-fired chips ...");
+  
+  fNClustersLay1 = 0;
+  fNClustersLay2 = 0;
+  fNFiredChips[0] = 0;
+  fNFiredChips[1] = 0;
+  
+  AliITSsegmentationSPD seg;
+
+//  AliITSRecPointContainer* rpcont=AliITSRecPointContainer::Instance();
+//  TClonesArray* itsClusters=rpcont->FetchClusters(0,itsClusterTree);
+//  if(!rpcont->IsSPDActive()){
+//    AliWarning("No SPD rec points found, multiplicity not calculated");
+//    return;
+//  }
+  
+  TClonesArray statITSrec("AliITSRecPoint");
+  TClonesArray* itsClusters= &statITSrec;    
+
+  TBranch* branch=itsClusterTree->GetBranch("ITSRecPoints");
+  if(!branch) {
+    printf("NO itsClusterTree branch available. Skipping...\n");
+    return;
+  }
+
+  branch->SetAddress(&itsClusters);
+  // count clusters
+  // loop over the SPD subdetectors
+  static TClonesArray clArr("AliITSRecPoint",100);
+//  Float_t cluGlo[3] = {0.,0.,0.};
+  for (int il=0;il<2;il++) {
+    int nclLayer = 0;
+    int detMin = AliITSgeomTGeo::GetModuleIndex(il+1,1,1);
+    int detMax = AliITSgeomTGeo::GetModuleIndex(il+2,1,1);
+    for (int idt=detMin;idt<detMax;idt++) {
+      branch->GetEvent(idt);
+      int nClusters = itsClusters->GetEntriesFast();
+//      itsClusters=rpcont->UncheckedGetClusters(idt);
+      if (!nClusters) continue;
+      Int_t nClustersInChip[5] = {0,0,0,0,0};
+      while(nClusters--) {
+       AliITSRecPoint* cluster = (AliITSRecPoint*)itsClusters->UncheckedAt(nClusters);
+       if (!cluster) continue;
+/*        cluster->GetGlobalXYZ(cluGlo);
+        if (idt==0) 
+                   Printf("First Cl1 LoadClArr %f %f %f ",cluGlo[0],cluGlo[1],cluGlo[2]);
+        if (idt==80) 
+                   Printf("First Cl2 LoadClArr %f %f %f ",cluGlo[0],cluGlo[1],cluGlo[2]);*/
+       new (clArr[nclLayer++]) AliITSRecPoint(*cluster);
+       nClustersInChip[ seg.GetChipFromLocal(0,cluster->GetDetLocalZ()) ]++; 
+      }
+      for(Int_t ifChip=5;ifChip--;) if (nClustersInChip[ifChip]) fNFiredChips[il]++;
+    }
+    // sort the clusters in Z (to have the same numbering as in ITS reco
+    Float_t *z    = new Float_t[nclLayer];
+    Int_t * index = new Int_t[nclLayer];
+    for (int ic=0;ic<nclLayer;ic++) z[ic] = ((AliITSRecPoint*)clArr[ic])->GetZ();
+    TMath::Sort(nclLayer,z,index,kFALSE);
+    Float_t*   clustersLay              = new Float_t[nclLayer*kClNPar];
+    Int_t*     detectorIndexClustersLay = new Int_t[nclLayer];
+    Bool_t*    overlapFlagClustersLay   = new Bool_t[nclLayer];
+    UInt_t*    usedClusLay              = new UInt_t[nclLayer];
+    //
+    for (int ic=0;ic<nclLayer;ic++) {
+      AliITSRecPoint* cluster = (AliITSRecPoint*)clArr[index[ic]];
+      float* clPar = &clustersLay[ic*kClNPar];
+      //      
+      cluster->GetGlobalXYZ( clPar );
+//      if (ic==0 && detMin==0) Printf("First Cl1 LoadClArrSorted %f %f %f ",clPar[kClTh],clPar[kClPh],clPar[kClZ]);
+//      if (ic==0 && detMin==80) Printf("First Cl2 LoadClArrSorted %f %f %f ",clPar[kClTh],clPar[kClPh],clPar[kClZ]);
+//      if (ic==0 && detMin==0) Printf("First Cl1 LoadClArrSorted %f %f %f ",clPar[0],clPar[1],clPar[2]);
+//      if (ic==0 && detMin==80) Printf("First Cl2 LoadClArrSorted %f %f %f ",clPar[0],clPar[1],clPar[2]);
+      detectorIndexClustersLay[ic] = cluster->GetDetectorIndex(); 
+      overlapFlagClustersLay[ic]   = kFALSE;
+      usedClusLay[ic]              = 0;
+      for (Int_t i=3;i--;) clPar[kClMC0+i] = cluster->GetLabel(i);
+    }
+    clArr.Clear();
+    delete[] z;
+    delete[] index;
+    //
+    if (il==0) {
+      fClustersLay1              = clustersLay;
+      fOverlapFlagClustersLay1   = overlapFlagClustersLay;
+      fDetectorIndexClustersLay1 = detectorIndexClustersLay;
+      fUsedClusLay1              = usedClusLay;
+      fNClustersLay1             = nclLayer;
+    }
+    else {
+      fClustersLay2              = clustersLay;
+      fOverlapFlagClustersLay2   = overlapFlagClustersLay;
+      fDetectorIndexClustersLay2 = detectorIndexClustersLay;
+      fUsedClusLay2              = usedClusLay;
+      fNClustersLay2             = nclLayer;
+    }
+  }
+//  Printf("First Cl1 %f %f %f ",fClustersLay1[0],fClustersLay1[1],fClustersLay1[2]);
+//  Printf("First Cl2 %f %f %f ",fClustersLay2[0],fClustersLay2[1],fClustersLay2[2]);
+  Printf("LoadClusterArr: N cl1 %d",fNClustersLay1);
+  Printf("LoadClusterArrN: N cl2 %d",fNClustersLay2);
+  //
+  // no double association allowed // ?? 
+  int nmaxT                  = TMath::Min(fNClustersLay1, fNClustersLay2);
+  fTracklets                 = new Float_t*[nmaxT];
+  fSClusters                 = new Float_t*[fNClustersLay1]; 
+  for (Int_t i=nmaxT;i--;) fTracklets[i] = 0;
+  //
+  AliDebug(1,Form("(clusters in layer 1 : %d,  layer 2: %d)",fNClustersLay1,fNClustersLay2));
+  AliDebug(1,Form("(cluster-fired chips in layer 1 : %d,  layer 2: %d)",fNFiredChips[0],fNFiredChips[1]));
+}
+//____________________________________________________________________
+void
+AliTrackletAlg::LoadClusterFiredChips(TTree* itsClusterTree) {
+  // This method    
+  // - gets the clusters from the cluster tree 
+  // - counts the number of (cluster)fired chips
+  
+  AliDebug(1,"Loading cluster-fired chips ...");
+  
+  fNFiredChips[0] = 0;
+  fNFiredChips[1] = 0;
+  
+  AliITSsegmentationSPD seg;   
+  AliITSRecPointContainer* rpcont=AliITSRecPointContainer::Instance();
+  TClonesArray* itsClusters=rpcont->FetchClusters(0,itsClusterTree);
+  if(!rpcont->IsSPDActive()){
+    AliWarning("No SPD rec points found, multiplicity not calculated");
+    return;
+  } 
+
+  // loop over the its subdetectors
+  Int_t nSPDmodules=AliITSgeomTGeo::GetModuleIndex(3,1,1);
+  for (Int_t iIts=0; iIts < nSPDmodules; iIts++) {
+    itsClusters=rpcont->UncheckedGetClusters(iIts);
+    Int_t nClusters = itsClusters->GetEntriesFast();
+
+    // number of clusters in each chip of the current module
+    Int_t nClustersInChip[5] = {0,0,0,0,0};
+    Int_t layer = 0;
+    
+    // loop over clusters
+    while(nClusters--) {
+      AliITSRecPoint* cluster = (AliITSRecPoint*)itsClusters->UncheckedAt(nClusters);
+      
+      layer = cluster->GetLayer();
+      if (layer>1) continue;            
+
+      // find the chip for the current cluster
+      Float_t locz = cluster->GetDetLocalZ();
+      Int_t iChip = seg.GetChipFromLocal(0,locz);
+      nClustersInChip[iChip]++; 
+      
+    }// end of cluster loop
+
+    // get number of fired chips in the current module
+    for(Int_t ifChip=0; ifChip<5; ifChip++) {
+      if(nClustersInChip[ifChip] >= 1)  fNFiredChips[layer]++;
+    }
+
+  } // end of its "subdetector" loop  
+  
+
+  AliDebug(1,Form("(cluster-fired chips in layer 1 : %d,  layer 2: %d)",fNFiredChips[0],fNFiredChips[1]));
+}
+//____________________________________________________________________
+void
+AliTrackletAlg::SaveHists() {
+  // This method save the histograms on the output file
+  // (only if fHistOn is TRUE). 
+  
+  if (!fHistOn)
+    return;
+
+  fhClustersDPhiAll->Write();
+  fhClustersDThetaAll->Write();
+  fhDPhiVsDThetaAll->Write();
+
+  fhClustersDPhiAcc->Write();
+  fhClustersDThetaAcc->Write();
+  fhDPhiVsDThetaAcc->Write();
+
+  fhetaTracklets->Write();
+  fhphiTracklets->Write();
+  fhetaClustersLay1->Write();
+  fhphiClustersLay1->Write();
+}
+
+//____________________________________________________________________
+void 
+AliTrackletAlg::FlagClustersInOverlapRegions (Int_t iC1, Int_t iC2WithBestDist) {
+
+  Float_t distClSameMod=0.;
+  Float_t distClSameModMin=0.;
+  Int_t   iClOverlap =0;
+  Float_t meanRadiusLay1 = 3.99335; // average radius inner layer
+  Float_t meanRadiusLay2 = 7.37935; // average radius outer layer;
+
+  Float_t zproj1=0.;
+  Float_t zproj2=0.;
+  Float_t deZproj=0.;
+  Float_t* clPar1  = GetClusterLayer1(iC1);
+  Float_t* clPar2B = GetClusterLayer2(iC2WithBestDist);
+  // Loop on inner layer clusters
+  for (Int_t iiC1=0; iiC1<fNClustersLay1; iiC1++) {
+    if (!fOverlapFlagClustersLay1[iiC1]) {
+      // only for adjacent modules
+      if ((TMath::Abs(fDetectorIndexClustersLay1[iC1]-fDetectorIndexClustersLay1[iiC1])==4)||
+         (TMath::Abs(fDetectorIndexClustersLay1[iC1]-fDetectorIndexClustersLay1[iiC1])==76)) {
+       Float_t *clPar11 = GetClusterLayer1(iiC1);
+        Float_t dePhi=TMath::Abs(clPar11[kClPh]-clPar1[kClPh]);
+        if (dePhi>TMath::Pi()) dePhi=2.*TMath::Pi()-dePhi;
+
+        zproj1=meanRadiusLay1/TMath::Tan(clPar1[kClTh]);
+        zproj2=meanRadiusLay1/TMath::Tan(clPar11[kClTh]);
+
+        deZproj=TMath::Abs(zproj1-zproj2);
+
+        distClSameMod = TMath::Sqrt(TMath::Power(deZproj/fZetaOverlapCut,2)+TMath::Power(dePhi/fPhiOverlapCut,2));
+        if (distClSameMod<=1.) fOverlapFlagClustersLay1[iiC1]=kTRUE;
+
+//        if (distClSameMod<=1.) {
+//          if (distClSameModMin==0. || distClSameMod<distClSameModMin) {
+//            distClSameModMin=distClSameMod;
+//            iClOverlap=iiC1;
+//          } 
+//        }
+
+
+      } // end adjacent modules
+    } 
+  } // end Loop on inner layer clusters
+
+//  if (distClSameModMin!=0.) fOverlapFlagClustersLay1[iClOverlap]=kTRUE;
+
+  distClSameMod=0.;
+  distClSameModMin=0.;
+  iClOverlap =0;
+  // Loop on outer layer clusters
+  for (Int_t iiC2=0; iiC2<fNClustersLay2; iiC2++) {
+    if (!fOverlapFlagClustersLay2[iiC2]) {
+      // only for adjacent modules
+      Float_t *clPar2 = GetClusterLayer2(iiC2);
+      if ((TMath::Abs(fDetectorIndexClustersLay2[iC2WithBestDist]-fDetectorIndexClustersLay2[iiC2])==4) ||
+         (TMath::Abs(fDetectorIndexClustersLay2[iC2WithBestDist]-fDetectorIndexClustersLay2[iiC2])==156)) {
+        Float_t dePhi=TMath::Abs(clPar2[kClPh]-clPar2B[kClPh]);
+        if (dePhi>TMath::Pi()) dePhi=2.*TMath::Pi()-dePhi;
+
+        zproj1=meanRadiusLay2/TMath::Tan(clPar2B[kClTh]);
+        zproj2=meanRadiusLay2/TMath::Tan(clPar2[kClTh]);
+
+        deZproj=TMath::Abs(zproj1-zproj2);
+        distClSameMod = TMath::Sqrt(TMath::Power(deZproj/fZetaOverlapCut,2)+TMath::Power(dePhi/fPhiOverlapCut,2));
+        if (distClSameMod<=1.) fOverlapFlagClustersLay2[iiC2]=kTRUE;
+
+//        if (distClSameMod<=1.) {
+//          if (distClSameModMin==0. || distClSameMod<distClSameModMin) {
+//            distClSameModMin=distClSameMod;
+//            iClOverlap=iiC2;
+//          }
+//        }
+
+      } // end adjacent modules
+    }
+  } // end Loop on outer layer clusters
+
+//  if (distClSameModMin!=0.) fOverlapFlagClustersLay2[iClOverlap]=kTRUE;
+
+}
+
+//____________________________________________________________________
+void AliTrackletAlg::ProcessESDTracks()
+{
+  // Flag the clusters used by ESD tracks
+  // Flag primary tracks to be used for multiplicity counting 
+  //
+  if (!fESDEvent) return;
+  AliESDVertex* vtx = (AliESDVertex*)fESDEvent->GetPrimaryVertexTracks();
+  if (!vtx || vtx->GetNContributors()<1) vtx = (AliESDVertex*)fESDEvent->GetPrimaryVertexSPD();
+  if (!vtx || vtx->GetNContributors()<1) {
+    AliDebug(1,"No primary vertex: cannot flag primary tracks");
+    return;
+  }
+  Int_t ntracks = fESDEvent->GetNumberOfTracks();
+  for(Int_t itr=0; itr<ntracks; itr++) {
+    AliESDtrack* track = fESDEvent->GetTrack(itr);
+    if (!track->IsOn(AliESDtrack::kITSin)) continue; // use only tracks propagated in ITS to vtx
+    FlagTrackClusters(itr);
+    FlagIfSecondary(track,vtx);
+  }
+  FlagV0s(vtx);
+  //
+}
+
+//____________________________________________________________________
+void AliTrackletAlg::FlagTrackClusters(Int_t id)
+{
+  // RS: flag the SPD clusters of the track if it is useful for the multiplicity estimation
+  //
+  const UInt_t   kMaskL = 0x0000ffff;
+  const UInt_t   kMaskH = 0xffff0000;
+  const UInt_t   kMaxTrID = kMaskL - 1; // max possible track id
+  if (UInt_t(id)>kMaxTrID) return;
+  const AliESDtrack* track = fESDEvent->GetTrack(id);
+  Int_t idx[12];
+  if ( track->GetITSclusters(idx)<3 ) return; // at least 3 clusters must be used in the fit
+  UInt_t *uClus[2] = {fUsedClusLay1,fUsedClusLay2};
+  //
+  UInt_t mark = id+1;
+  if (track->IsOn(AliESDtrack::kITSpureSA)) mark <<= 16;
+  //
+  for (int i=AliESDfriendTrack::kMaxITScluster;i--;) {
+    // note: i>=6 is for extra clusters
+    if (idx[i]<0) continue;
+    int layID= (idx[i] & 0xf0000000) >> 28; 
+    if (layID>1) continue; // SPD only
+    int clID = (idx[i] & 0x0fffffff);
+    //
+    if ( track->IsOn(AliESDtrack::kITSpureSA) ) {
+      if (uClus[layID][clID]&kMaskH) {
+       AliWarning(Form("Tracks %5d and %5d share cluster %6d of lr%d",id,int(uClus[layID][clID]>>16)-1,clID,layID));
+       uClus[layID][clID] &= kMaskL;
+      }
+    }
+    else if (uClus[layID][clID]&kMaskL) {
+      AliWarning(Form("Tracks %5d and %5d share cluster %6d of lr%d",id,int(uClus[layID][clID]&kMaskL)-1,clID,layID));
+      uClus[layID][clID] &= kMaskH;
+    }
+    uClus[layID][clID] |= mark;
+  }
+  //
+}
+
+//____________________________________________________________________
+void AliTrackletAlg::FlagIfSecondary(AliESDtrack* track, const AliVertex* vtx)
+{
+  // RS: check if the track is primary and set the flag
+  double cut = (track->HasPointOnITSLayer(0)||track->HasPointOnITSLayer(1)) ? fCutPxDrSPDin:fCutPxDrSPDout;
+  float xz[2];
+  track->GetDZ(vtx->GetX(),vtx->GetY(),vtx->GetZ(), fESDEvent->GetMagneticField(), xz);
+  if (TMath::Abs(xz[0]*track->P())>cut || TMath::Abs(xz[1]*track->P())>fCutPxDz ||
+      TMath::Abs(xz[0])>fCutDCArz   || TMath::Abs(xz[1])>fCutDCArz) 
+    track->SetStatus(AliESDtrack::kMultSec);
+  else track->ResetStatus(AliESDtrack::kMultSec);
+}
+
+//____________________________________________________________________
+void AliTrackletAlg::FlagV0s(const AliESDVertex *vtx)
+{
+  // flag tracks belonging to v0s
+  //
+  const double kK0Mass = 0.4976;
+  //
+  AliV0 pvertex;
+  AliKFVertex vertexKF;
+  AliKFParticle epKF0,epKF1,pipmKF0,piKF0,piKF1,gammaKF,k0KF;
+  Double_t mass,massErr,chi2c;
+  enum {kKFIni=BIT(14)};
+  //
+  double recVtx[3];
+  float recVtxF[3];
+  vtx->GetXYZ(recVtx);
+  for (int i=3;i--;) recVtxF[i] = recVtx[i];
+  //
+  int ntracks = fESDEvent->GetNumberOfTracks();
+  if (ntracks<2) return;
+  //
+  vertexKF.X() = recVtx[0];
+  vertexKF.Y() = recVtx[1];
+  vertexKF.Z() = recVtx[2];
+  vertexKF.Covariance(0,0) = vtx->GetXRes()*vtx->GetXRes();
+  vertexKF.Covariance(1,2) = vtx->GetYRes()*vtx->GetYRes();
+  vertexKF.Covariance(2,2) = vtx->GetZRes()*vtx->GetZRes();
+  //
+  AliESDtrack *trc0,*trc1;
+  for (int it0=0;it0<ntracks;it0++) {
+    trc0 = fESDEvent->GetTrack(it0);
+    if (trc0->IsOn(AliESDtrack::kMultInV0)) continue;
+    if (!trc0->IsOn(AliESDtrack::kITSin)) continue;
+    Bool_t isSAP = trc0->IsPureITSStandalone();
+    Int_t  q0 = trc0->Charge();
+    Bool_t testGamma = CanBeElectron(trc0);
+    epKF0.ResetBit(kKFIni);
+    piKF0.ResetBit(kKFIni);
+    double bestChi2=1e16;
+    int bestID = -1;
+    //    
+    for (int it1=it0+1;it1<ntracks;it1++) {
+      trc1 = fESDEvent->GetTrack(it1);
+      if (trc1->IsOn(AliESDtrack::kMultInV0)) continue;
+      if (!trc1->IsOn(AliESDtrack::kITSin)) continue;
+      if (trc1->IsPureITSStandalone() != isSAP) continue; // pair separately ITS_SA_Pure tracks and TPC/ITS+ITS_SA
+      if ( (q0+trc1->Charge())!=0 ) continue;             // don't pair like signs
+      //
+      pvertex.SetParamN(q0<0 ? *trc0:*trc1);
+      pvertex.SetParamP(q0>0 ? *trc0:*trc1);
+      pvertex.Update(recVtxF);
+      if (pvertex.P()<fCutMinP) continue;
+      if (pvertex.GetV0CosineOfPointingAngle()<fCutMinPointAngle) continue;
+      if (pvertex.GetDcaV0Daughters()>fCutMaxDCADauther) continue;
+      double d = pvertex.GetD(recVtx[0],recVtx[1],recVtx[2]);
+      if (d>fCutMaxDCA) continue;
+      double dx=recVtx[0]-pvertex.Xv(), dy=recVtx[1]-pvertex.Yv();
+      double rv = TMath::Sqrt(dx*dx+dy*dy);
+      //
+      // check gamma conversion hypothesis ----------------------------------------------------------->>>
+      Bool_t gammaOK = kFALSE;
+      while (testGamma && CanBeElectron(trc1)) {
+       if (rv<fCutMinRGamma) break;
+       if (!epKF0.TestBit(kKFIni)) {
+         new(&epKF0) AliKFParticle(*trc0,q0>0 ? kPositron:kElectron);
+         epKF0.SetBit(kKFIni);
+       }
+       new(&epKF1) AliKFParticle(*trc1,q0<0 ? kPositron:kElectron);
+       gammaKF.Initialize();
+       gammaKF += epKF0;
+       gammaKF += epKF1;      
+       gammaKF.SetProductionVertex(vertexKF);
+       gammaKF.GetMass(mass,massErr);
+       if (mass>fCutMassGamma || (massErr>0&&(mass>massErr*fCutMassGammaNSigma))) break;
+       if (gammaKF.GetS()<fCutGammaSFromDecay) break;
+       gammaKF.SetMassConstraint(0.,0.001);
+       chi2c = (gammaKF.GetNDF()!=0) ? gammaKF.GetChi2()/gammaKF.GetNDF() : 1000;
+       if (chi2c>fCutChi2cGamma) break;
+       gammaOK = kTRUE;
+       if (chi2c>bestChi2) break;
+       bestChi2 = chi2c;
+       bestID = it1;
+       break;
+      }
+      if (gammaOK) continue;
+      // check gamma conversion hypothesis -----------------------------------------------------------<<<
+      // check K0 conversion hypothesis    ----------------------------------------------------------->>>
+      while (1) {
+       if (rv<fCutMinRK0) break;
+       if (!piKF0.TestBit(kKFIni)) {
+         new(&piKF0) AliKFParticle(*trc0,q0>0 ? kPiPlus:kPiMinus);
+         piKF0.SetBit(kKFIni);
+       }
+       new(&piKF1) AliKFParticle(*trc1,q0<0 ? kPiPlus:kPiMinus);
+       k0KF.Initialize();
+       k0KF += piKF0;
+       k0KF += piKF1;      
+       k0KF.SetProductionVertex(vertexKF);
+       k0KF.GetMass(mass,massErr);
+       mass -= kK0Mass;
+       if (TMath::Abs(mass)>fCutMassK0 || (massErr>0&&(abs(mass)>massErr*fCutMassK0NSigma))) break;
+       if (k0KF.GetS()<fCutK0SFromDecay) break;
+       k0KF.SetMassConstraint(kK0Mass,0.001);
+       chi2c = (k0KF.GetNDF()!=0) ? k0KF.GetChi2()/k0KF.GetNDF() : 1000;
+       if (chi2c>fCutChi2cK0) break;
+       if (chi2c>bestChi2) break;
+       bestChi2 = chi2c;
+       bestID = it1;
+       break;
+      }
+      // check K0 conversion hypothesis    -----------------------------------------------------------<<<
+    }
+    //
+    if (bestID>=0) {
+      trc0->SetStatus(AliESDtrack::kMultInV0);
+      fESDEvent->GetTrack(bestID)->SetStatus(AliESDtrack::kMultInV0);
+    }
+  }
+  //
+}
+
+//____________________________________________________________________
+Bool_t AliTrackletAlg::CanBeElectron(const AliESDtrack* trc) const
+{
+  // check if the track can be electron
+  Double_t pid[AliPID::kSPECIES];
+  if (!trc->IsOn(AliESDtrack::kESDpid)) return kTRUE;
+  trc->GetESDpid(pid);
+  return (trc->IsOn(AliESDtrack::kTPCpid)) ? 
+    pid[AliPID::kElectron]>fCutMinElectronProbTPC : 
+    pid[AliPID::kElectron]>fCutMinElectronProbESD;
+  //
+}
diff --git a/PWG2/EVCHAR/AliTrackletAlg.h b/PWG2/EVCHAR/AliTrackletAlg.h
new file mode 100644 (file)
index 0000000..0bea6f8
--- /dev/null
@@ -0,0 +1,202 @@
+#ifndef ALITRACKLETALG_H
+#define ALITRACKLETALG_H
+/* Copyright(c) 1998-1999, ALICE Experiment at CERN, All rights reserved. *
+ * See cxx source for full Copyright notice                               */
+
+//_________________________________________________________________________
+// 
+//        Implementation of the ITS-SPD trackleter class
+//   Clone version of the AliITSMultReconstructor class (October 2010) 
+//   that can be used in an AliAnalysisTask
+//
+//_________________________________________________________________________
+#include "AliTrackleter.h"
+
+class TBits;
+class TTree;
+class TH1F;
+class TH2F; 
+class AliITSDetTypeRec;
+class AliITSgeom;
+class AliESDEvent;
+class AliESDtrack;
+class AliVertex;
+class AliESDVertex;
+class AliMultiplicity;
+
+class AliTrackletAlg : public AliTrackleter
+{
+public:
+  //
+  enum {kClTh,kClPh,kClZ,kClMC0,kClMC1,kClMC2,kClNPar};
+  enum {kTrTheta,kTrPhi,kTrDPhi,kTrDTheta,kTrLab1,kTrLab2,kClID1,kClID2,kTrNPar};
+  enum {kSCTh,kSCPh,kSCLab,kSCID,kSCNPar};   
+  enum {kITSTPC,kITSSAP,kITSTPCBit=BIT(kITSTPC),kITSSAPBit=BIT(kITSSAP)}; // RS
+  AliTrackletAlg();
+  virtual ~AliTrackletAlg();
+
+  void Reconstruct(AliESDEvent* esd, TTree* treeRP);
+  void Reconstruct(TTree* tree, Float_t* vtx, Float_t* vtxRes);   // old reconstructor invocation
+  void FindTracklets(const Float_t* vtx); 
+  void LoadClusterFiredChips(TTree* tree);
+  void FlagClustersInOverlapRegions(Int_t ic1,Int_t ic2);
+  void FlagTrackClusters(Int_t id);
+  void FlagIfSecondary(AliESDtrack* track, const AliVertex* vtx);
+  void FlagV0s(const AliESDVertex *vtx);
+  void ProcessESDTracks();
+  Bool_t  CanBeElectron(const AliESDtrack* trc) const;
+  
+  void CreateMultiplicityObject();
+  //
+  void SetPhiWindow(Float_t w=0.08) {fPhiWindow=w;}
+  void SetThetaWindow(Float_t w=0.025) {fThetaWindow=w;}
+  void SetPhiShift(Float_t w=0.0045) {fPhiShift=w;}
+  void SetRemoveClustersFromOverlaps(Bool_t b = kFALSE) {fRemoveClustersFromOverlaps = b;}
+  void SetPhiOverlapCut(Float_t w=0.005) {fPhiOverlapCut=w;}
+  void SetZetaOverlapCut(Float_t w=0.05) {fZetaOverlapCut=w;}
+  void SetPhiRotationAngle(Float_t w=0.0) {fPhiRotationAngle=w;}
+
+  Int_t GetNClustersLayer1() const {return fNClustersLay1;}
+  Int_t GetNClustersLayer2() const {return fNClustersLay2;}
+  Int_t GetNTracklets() const {return fNTracklets;}
+  Int_t GetNSingleClusters() const {return fNSingleCluster;}
+  Short_t GetNFiredChips(Int_t layer) const {return fNFiredChips[layer];}
+
+  Float_t* GetClusterLayer1(Int_t n) {return &fClustersLay1[n*kClNPar];}
+  Float_t* GetClusterLayer2(Int_t n) {return &fClustersLay2[n*kClNPar];}
+
+  Float_t* GetTracklet(Int_t n) {return fTracklets[n];}
+  Float_t* GetCluster(Int_t n) {return fSClusters[n];}
+
+  void SetHistOn(Bool_t b=kFALSE) {fHistOn=b;}
+  void SaveHists();
+
+  AliITSDetTypeRec *GetDetTypeRec() const {return fDetTypeRec;}
+  void SetDetTypeRec(AliITSDetTypeRec *ptr){fDetTypeRec = ptr;}
+  //
+  void    SetCutPxDrSPDin(Float_t v=0.1)             { fCutPxDrSPDin = v;}
+  void    SetCutPxDrSPDout(Float_t v=0.15)           { fCutPxDrSPDout = v;}
+  void    SetCutPxDz(Float_t v=0.2)                  { fCutPxDz = v;}
+  void    SetCutDCArz(Float_t v=0.5)                 { fCutDCArz = v;}
+  void    SetCutMinElectronProbTPC(Float_t v=0.5)    { fCutMinElectronProbTPC = v;}
+  void    SetCutMinElectronProbESD(Float_t v=0.1)    { fCutMinElectronProbESD = v;}
+  void    SetCutMinP(Float_t v=0.05)                 { fCutMinP = v;}
+  void    SetCutMinRGamma(Float_t v=2.)              { fCutMinRGamma = v;}
+  void    SetCutMinRK0(Float_t v=1.)                 { fCutMinRK0 = v;}
+  void    SetCutMinPointAngle(Float_t v=0.98)        { fCutMinPointAngle = v;}
+  void    SetCutMaxDCADauther(Float_t v=0.5)         { fCutMaxDCADauther = v;}
+  void    SetCutMassGamma(Float_t v=0.03)            { fCutMassGamma = v;}
+  void    SetCutMassGammaNSigma(Float_t v=5.)        { fCutMassGammaNSigma = v;}
+  void    SetCutMassK0(Float_t v=0.03)               { fCutMassK0 = v;}
+  void    SetCutMassK0NSigma(Float_t v=5.)           { fCutMassK0NSigma = v;}
+  void    SetCutChi2cGamma(Float_t v=2.)             { fCutChi2cGamma = v;}
+  void    SetCutChi2cK0(Float_t v=2.)                { fCutChi2cK0 = v;}
+  void    SetCutGammaSFromDecay(Float_t v=-10.)      { fCutGammaSFromDecay = v;}
+  void    SetCutK0SFromDecay(Float_t v=-10.)         { fCutK0SFromDecay = v;}
+  void    SetCutMaxDCA(Float_t v=1.)                 { fCutMaxDCA = v;}
+  //
+  Float_t GetCutPxDrSPDin()                    const {return fCutPxDrSPDin;}
+  Float_t GetCutPxDrSPDout()                   const {return fCutPxDrSPDout;}
+  Float_t GetCutPxDz()                         const {return fCutPxDz;}
+  Float_t GetCutDCArz()                        const {return fCutDCArz;}
+  Float_t GetCutMinElectronProbTPC()           const {return fCutMinElectronProbTPC;}
+  Float_t GetCutMinElectronProbESD()           const {return fCutMinElectronProbESD;}
+  Float_t GetCutMinP()                         const {return fCutMinP;}
+  Float_t GetCutMinRGamma()                    const {return fCutMinRGamma;}
+  Float_t GetCutMinRK0()                       const {return fCutMinRK0;}
+  Float_t GetCutMinPointAngle()                const {return fCutMinPointAngle;}
+  Float_t GetCutMaxDCADauther()                const {return fCutMaxDCADauther;}
+  Float_t GetCutMassGamma()                    const {return fCutMassGamma;}
+  Float_t GetCutMassGammaNSigma()              const {return fCutMassGammaNSigma;}
+  Float_t GetCutMassK0()                       const {return fCutMassK0;}
+  Float_t GetCutMassK0NSigma()                 const {return fCutMassK0NSigma;}
+  Float_t GetCutChi2cGamma()                   const {return fCutChi2cGamma;}
+  Float_t GetCutChi2cK0()                      const {return fCutChi2cK0;}
+  Float_t GetCutGammaSFromDecay()              const {return fCutGammaSFromDecay;}
+  Float_t GetCutK0SFromDecay()                 const {return fCutK0SFromDecay;}
+  Float_t GetCutMaxDCA()                       const {return fCutMaxDCA;}
+
+  //
+protected:
+  AliTrackletAlg(const AliTrackletAlg& mr);
+  AliTrackletAlg& operator=(const AliTrackletAlg& mr);
+  AliITSDetTypeRec* fDetTypeRec;            //! pointer to DetTypeRec
+  AliESDEvent*      fESDEvent;              //! pointer to ESD event
+  TTree*            fTreeRP;                //! ITS recpoints
+
+  UInt_t*       fUsedClusLay1;               // RS: flag of clusters usage in ESD tracks: 0=unused, else ID+1 in word0=TPC/ITS+ITSSA, word1=ITSSA_Pure
+  UInt_t*       fUsedClusLay2;               // RS: flag of clusters usage in ESD tracks: 0=unused, else ID+1 word0=TPC/ITS+ITSSA, word1=ITSSA_Pure
+
+  Float_t*      fClustersLay1;               // clusters in the 1st layer of ITS 
+  Float_t*      fClustersLay2;               // clusters in the 2nd layer of ITS 
+  Int_t*        fDetectorIndexClustersLay1;  // module index for clusters 1st ITS layer
+  Int_t*        fDetectorIndexClustersLay2;  // module index for clusters 2nd ITS layer
+  Bool_t*       fOverlapFlagClustersLay1;    // flag for clusters in the overlap regions 1st ITS layer
+  Bool_t*       fOverlapFlagClustersLay2;    // flag for clusters in the overlap regions 2nd ITS layer 
+
+  Float_t**     fTracklets;            // tracklets 
+  Float_t**     fSClusters;            // single clusters (unassociated)
+  
+  Int_t         fNClustersLay1;        // Number of clusters (Layer1)
+  Int_t         fNClustersLay2;        // Number of clusters (Layer2)
+  Int_t         fNTracklets;           // Number of tracklets
+  Int_t         fNSingleCluster;       // Number of unassociated clusters
+  Short_t       fNFiredChips[2];       // Number of fired chips in the two SPD layers
+  //
+  // Following members are set via AliITSRecoParam
+  //
+  Float_t       fPhiWindow;                    // Search window in phi
+  Float_t       fThetaWindow;                  // Search window in theta
+  Float_t       fPhiShift;                     // Phi shift reference value (at 0.5 T) 
+  Bool_t        fRemoveClustersFromOverlaps;   // Option to skip clusters in the overlaps
+  Float_t       fPhiOverlapCut;                // Fiducial window in phi for overlap cut
+  Float_t       fZetaOverlapCut;               // Fiducial window in eta for overlap cut
+  Float_t       fPhiRotationAngle;             // Angle to rotate the inner layer cluster for combinatorial reco only 
+
+  // cuts for secondaries identification
+  Float_t       fCutPxDrSPDin;                 // max P*DR for primaries involving at least 1 SPD
+  Float_t       fCutPxDrSPDout;                // max P*DR for primaries not involving any SPD
+  Float_t       fCutPxDz;                      // max P*DZ for primaries
+  Float_t       fCutDCArz;                     // max DR or DZ for primares
+  //
+  // cuts for flagging tracks in V0s
+  Float_t       fCutMinElectronProbTPC;     // min probability for e+/e- PID involving TPC
+  Float_t       fCutMinElectronProbESD;     // min probability for e+/e- PID not involving TPC
+  //
+  Float_t       fCutMinP;                   // min P of V0
+  Float_t       fCutMinRGamma;              // min transv. distance from ESDVertex to V0 for gammas
+  Float_t       fCutMinRK0;                 // min transv. distance from ESDVertex to V0 for K0s
+  Float_t       fCutMinPointAngle;          // min pointing angle cosine
+  Float_t       fCutMaxDCADauther;          // max DCA of daughters at V0
+  Float_t       fCutMassGamma;              // max gamma mass
+  Float_t       fCutMassGammaNSigma;        // max standard deviations from 0 for gamma
+  Float_t       fCutMassK0;                 // max K0 mass difference from PGD value
+  Float_t       fCutMassK0NSigma;           // max standard deviations for K0 mass from PDG value
+  Float_t       fCutChi2cGamma;             // max constrained chi2 cut for gammas
+  Float_t       fCutChi2cK0;                // max constrained chi2 cut for K0s
+  Float_t       fCutGammaSFromDecay;        // min path*P for gammas
+  Float_t       fCutK0SFromDecay;           // min path*P for K0s
+  Float_t       fCutMaxDCA;                 // max DCA for V0 at ESD vertex  
+
+  Bool_t        fHistOn;               // Option to define and fill the histograms 
+
+  TH1F*         fhClustersDPhiAcc;     // Phi2 - Phi1 for tracklets 
+  TH1F*         fhClustersDThetaAcc;   // Theta2 - Theta1 for tracklets 
+  TH1F*         fhClustersDPhiAll;     // Phi2 - Phi1 all the combinations 
+  TH1F*         fhClustersDThetaAll;   // Theta2 - Theta1 all the combinations
+  TH2F*         fhDPhiVsDThetaAll;     // 2D plot for all the combinations  
+  TH2F*         fhDPhiVsDThetaAcc;     // same plot for tracklets 
+
+  TH1F*         fhetaTracklets;        // Pseudorapidity distr. for tracklets 
+  TH1F*         fhphiTracklets;        // Azimuthal (Phi) distr. for tracklets  
+  TH1F*         fhetaClustersLay1;     // Pseudorapidity distr. for Clusters L. 1
+  TH1F*         fhphiClustersLay1;     // Azimuthal (Phi) distr. for Clusters L. 1 
+
+
+  void LoadClusterArrays(TTree* tree);
+
+  ClassDef(AliTrackletAlg,1) 
+};
+
+#endif