]> git.uio.no Git - u/mrichter/AliRoot.git/blobdiff - EMCAL/AliEMCALRecoUtils.cxx
Coding rule violation corrected.
[u/mrichter/AliRoot.git] / EMCAL / AliEMCALRecoUtils.cxx
index ad2866ed16a39e7b74bbf16bd9b45a8f65bdea44..58734f723d4d1eba6f3352809b6802dbabfbb102 100644 (file)
@@ -42,7 +42,6 @@
 // STEER includes
 #include "AliVCluster.h"
 #include "AliVCaloCells.h"
-#include "AliVEvent.h"
 #include "AliLog.h"
 #include "AliPID.h"
 #include "AliESDEvent.h"
 
 ClassImp(AliEMCALRecoUtils)
   
-//______________________________________________
+//_____________________________________
 AliEMCALRecoUtils::AliEMCALRecoUtils():
-  fParticleType(kPhoton),                 fPosAlgo(kUnchanged),                   fW0(4.), 
-  fNonLinearityFunction(kNoCorrection),   fNonLinearThreshold(30),
+  fParticleType(0),                       fPosAlgo(0),                            fW0(0), 
+  fNonLinearityFunction(0),               fNonLinearThreshold(0),
   fSmearClusterEnergy(kFALSE),            fRandom(),
   fCellsRecalibrated(kFALSE),             fRecalibration(kFALSE),                 fEMCALRecalibrationFactors(),
   fTimeRecalibration(kFALSE),             fEMCALTimeRecalibrationFactors(),
   fUseRunCorrectionFactors(kFALSE),       fRunCorrectionFactorsSet(kFALSE),
   fRemoveBadChannels(kFALSE),             fRecalDistToBadChannels(kFALSE),        fEMCALBadChannelMap(),
   fNCellsFromEMCALBorder(0),              fNoEMCALBorderAtEta0(kTRUE),
-  fRejectExoticCluster(kFALSE),           fPIDUtils(),                            fAODFilterMask(32),
+  fRejectExoticCluster(kFALSE),           fRejectExoticCells(kFALSE), 
+  fExoticCellFraction(0),                 fExoticCellDiffTime(0),                 fExoticCellMinAmplitude(0),
+  fPIDUtils(),                            fAODFilterMask(0),
   fMatchedTrackIndex(0x0),                fMatchedClusterIndex(0x0), 
-  fResidualEta(0x0), fResidualPhi(0x0),   fCutEtaPhiSum(kTRUE),                   fCutEtaPhiSeparate(kFALSE), 
-  fCutR(0.1),                             fCutEta(0.025),                         fCutPhi(0.05),
-  fClusterWindow(100),
-  fMass(0.139),                           fStepSurface(10.),                      fStepCluster(5.),
-  fTrackCutsType(kLooseCut),              fCutMinTrackPt(0),                      fCutMinNClusterTPC(-1), 
-  fCutMinNClusterITS(-1),                 fCutMaxChi2PerClusterTPC(1e10),         fCutMaxChi2PerClusterITS(1e10),
+  fResidualEta(0x0), fResidualPhi(0x0),   fCutEtaPhiSum(kFALSE),                  fCutEtaPhiSeparate(kFALSE), 
+  fCutR(0),                               fCutEta(0),                             fCutPhi(0),
+  fClusterWindow(0),                      fMass(0),                           
+  fStepSurface(0),                        fStepCluster(0),
+  fTrackCutsType(0),                      fCutMinTrackPt(0),                      fCutMinNClusterTPC(0), 
+  fCutMinNClusterITS(0),                  fCutMaxChi2PerClusterTPC(0),            fCutMaxChi2PerClusterITS(0),
   fCutRequireTPCRefit(kFALSE),            fCutRequireITSRefit(kFALSE),            fCutAcceptKinkDaughters(kFALSE),
-  fCutMaxDCAToVertexXY(1e10),             fCutMaxDCAToVertexZ(1e10),              fCutDCAToVertex2D(kFALSE)
+  fCutMaxDCAToVertexXY(0),                fCutMaxDCAToVertexZ(0),                 fCutDCAToVertex2D(kFALSE)
 {
 //
   // Constructor.
@@ -90,34 +91,8 @@ AliEMCALRecoUtils::AliEMCALRecoUtils():
   // during Reco algorithm execution
   //
   
-  //Misalignment matrices
-  for(Int_t i = 0; i < 15 ; i++) {
-      fMisalTransShift[i] = 0.; 
-      fMisalRotShift[i]   = 0.; 
-  }
-  
-  //Non linearity
-  for(Int_t i = 0; i < 7  ; i++) fNonLinearityParams[i] = 0.; 
-
-  //For kBeamTestCorrected case, but default is no correction
-  fNonLinearityParams[0] =  0.99078;
-  fNonLinearityParams[1] =  0.161499;
-  fNonLinearityParams[2] =  0.655166; 
-  fNonLinearityParams[3] =  0.134101;
-  fNonLinearityParams[4] =  163.282;
-  fNonLinearityParams[5] =  23.6904;
-  fNonLinearityParams[6] =  0.978;
-  
-  //For kPi0GammaGamma case
-  //fNonLinearityParams[0] = 0.1457/0.1349766/1.038;
-  //fNonLinearityParams[1] = -0.02024/0.1349766/1.038;
-  //fNonLinearityParams[2] = 1.046;
-
-  //Cluster energy smearing
-  fSmearClusterEnergy   = kFALSE;
-  fSmearClusterParam[0] = 0.07; // * sqrt E term
-  fSmearClusterParam[1] = 0.00; // * E term
-  fSmearClusterParam[2] = 0.00; // constant
+  // Init parameters
+  InitParameters();
   
   //Track matching
   fMatchedTrackIndex     = new TArrayI();
@@ -142,8 +117,10 @@ AliEMCALRecoUtils::AliEMCALRecoUtils(const AliEMCALRecoUtils & reco)
   fRemoveBadChannels(reco.fRemoveBadChannels),               fRecalDistToBadChannels(reco.fRecalDistToBadChannels),
   fEMCALBadChannelMap(reco.fEMCALBadChannelMap),
   fNCellsFromEMCALBorder(reco.fNCellsFromEMCALBorder),       fNoEMCALBorderAtEta0(reco.fNoEMCALBorderAtEta0),
-  fRejectExoticCluster(reco.fRejectExoticCluster),           fPIDUtils(reco.fPIDUtils), 
-  fAODFilterMask(reco.fAODFilterMask),
+  fRejectExoticCluster(reco.fRejectExoticCluster),           fRejectExoticCells(reco.fRejectExoticCells), 
+  fExoticCellFraction(reco.fExoticCellFraction),             fExoticCellDiffTime(reco.fExoticCellDiffTime),               
+  fExoticCellMinAmplitude(reco.fExoticCellMinAmplitude),
+  fPIDUtils(reco.fPIDUtils),                                 fAODFilterMask(reco.fAODFilterMask),
   fMatchedTrackIndex(  reco.fMatchedTrackIndex?  new TArrayI(*reco.fMatchedTrackIndex):0x0),
   fMatchedClusterIndex(reco.fMatchedClusterIndex?new TArrayI(*reco.fMatchedClusterIndex):0x0),
   fResidualEta(        reco.fResidualEta?        new TArrayF(*reco.fResidualEta):0x0),
@@ -206,8 +183,13 @@ AliEMCALRecoUtils & AliEMCALRecoUtils::operator = (const AliEMCALRecoUtils & rec
   
   fNCellsFromEMCALBorder     = reco.fNCellsFromEMCALBorder;
   fNoEMCALBorderAtEta0       = reco.fNoEMCALBorderAtEta0;
+  
   fRejectExoticCluster       = reco.fRejectExoticCluster;           
-
+  fRejectExoticCells         = reco.fRejectExoticCells; 
+  fExoticCellFraction        = reco.fExoticCellFraction;
+  fExoticCellDiffTime        = reco.fExoticCellDiffTime;              
+  fExoticCellMinAmplitude    = reco.fExoticCellMinAmplitude;
+  
   fPIDUtils                  = reco.fPIDUtils;
 
   fAODFilterMask             = reco.fAODFilterMask;
@@ -221,7 +203,6 @@ AliEMCALRecoUtils & AliEMCALRecoUtils::operator = (const AliEMCALRecoUtils & rec
   fMass                      = reco.fMass;
   fStepSurface               = reco.fStepSurface;
   fStepCluster               = reco.fStepCluster;
-  fRejectExoticCluster       = reco.fRejectExoticCluster;
 
   fTrackCutsType             = reco.fTrackCutsType;
   fCutMinTrackPt             = reco.fCutMinTrackPt;
@@ -288,24 +269,24 @@ AliEMCALRecoUtils & AliEMCALRecoUtils::operator = (const AliEMCALRecoUtils & rec
 }
 
 
-//__________________________________________________
+//_____________________________________
 AliEMCALRecoUtils::~AliEMCALRecoUtils()
 {
   //Destructor.
        
   if(fEMCALRecalibrationFactors) { 
     fEMCALRecalibrationFactors->Clear();
-    delete  fEMCALRecalibrationFactors;
+    delete fEMCALRecalibrationFactors;
   }    
   
   if(fEMCALTimeRecalibrationFactors) { 
-               fEMCALTimeRecalibrationFactors->Clear();
-               delete  fEMCALTimeRecalibrationFactors;
-       }       
+    fEMCALTimeRecalibrationFactors->Clear();
+    delete fEMCALTimeRecalibrationFactors;
+  }    
   
   if(fEMCALBadChannelMap) { 
     fEMCALBadChannelMap->Clear();
-    delete  fEMCALBadChannelMap;
+    delete fEMCALBadChannelMap;
   }
  
   delete fMatchedTrackIndex   ; 
@@ -317,6 +298,40 @@ AliEMCALRecoUtils::~AliEMCALRecoUtils()
   InitTrackCuts();
 }
 
+//_______________________________________________________________________________
+Bool_t AliEMCALRecoUtils::AcceptCalibrateCell(const Int_t absID, const Int_t bc,
+                                              Float_t  & amp,    Double_t & time, 
+                                              AliVCaloCells* cells) 
+{
+  // Reject cell if criteria not passed and calibrate it
+  
+  AliEMCALGeometry* geom = AliEMCALGeometry::GetInstance();
+  
+  if(absID < 0 || absID >= 24*48*geom->GetNumberOfSuperModules()) return kFALSE;
+  
+  Int_t imod = -1, iphi =-1, ieta=-1,iTower = -1, iIphi = -1, iIeta = -1; 
+  geom->GetCellIndex(absID,imod,iTower,iIphi,iIeta); 
+  geom->GetCellPhiEtaIndexInSModule(imod,iTower,iIphi, iIeta,iphi,ieta);       
+  
+  // Do not include bad channels found in analysis,
+  if( IsBadChannelsRemovalSwitchedOn() && GetEMCALChannelStatus(imod, ieta, iphi)) {
+    return kFALSE;
+  }
+  
+  //Recalibrate energy
+  amp  = cells->GetCellAmplitude(absID);
+  if(!fCellsRecalibrated && IsRecalibrationOn())
+    amp *= GetEMCALChannelRecalibrationFactor(imod,ieta,iphi);
+  
+  
+  // Recalibrate time
+  time = cells->GetCellTime(absID);
+  
+  RecalibrateCellTime(absID,bc,time);
+  
+  return kTRUE;
+}
+
 //_______________________________________________________________
 Bool_t AliEMCALRecoUtils::CheckCellFiducialRegion(AliEMCALGeometry* geom, AliVCluster* cluster, AliVCaloCells* cells) 
 {
@@ -387,19 +402,20 @@ Bool_t AliEMCALRecoUtils::CheckCellFiducialRegion(AliEMCALGeometry* geom, AliVCl
 
 
 //_________________________________________________________________________________________________________
-Bool_t AliEMCALRecoUtils::ClusterContainsBadChannel(AliEMCALGeometry* geom, UShort_t* cellList, const Int_t nCells){
-       // Check that in the cluster cells, there is no bad channel of those stored 
-       // in fEMCALBadChannelMap or fPHOSBadChannelMap
+Bool_t AliEMCALRecoUtils::ClusterContainsBadChannel(const AliEMCALGeometry* geom, const UShort_t* cellList, const Int_t nCells)
+{
+  // Check that in the cluster cells, there is no bad channel of those stored 
+  // in fEMCALBadChannelMap or fPHOSBadChannelMap
        
-       if(!fRemoveBadChannels)  return kFALSE;
-       if(!fEMCALBadChannelMap) return kFALSE;
+  if(!fRemoveBadChannels)  return kFALSE;
+  if(!fEMCALBadChannelMap) return kFALSE;
        
-       Int_t icol = -1;
-       Int_t irow = -1;
-       Int_t imod = -1;
-       for(Int_t iCell = 0; iCell<nCells; iCell++){
+  Int_t icol = -1;
+  Int_t irow = -1;
+  Int_t imod = -1;
+  for(Int_t iCell = 0; iCell<nCells; iCell++){
                
-               //Get the column and row
+    //Get the column and row
     Int_t iTower = -1, iIphi = -1, iIeta = -1; 
     geom->GetCellIndex(cellList[iCell],imod,iTower,iIphi,iIeta); 
     if(fEMCALBadChannelMap->GetEntries() <= imod) continue;
@@ -409,34 +425,101 @@ Bool_t AliEMCALRecoUtils::ClusterContainsBadChannel(AliEMCALGeometry* geom, USho
       return kTRUE;
     }
                
-       }// cell cluster loop
-       
-       return kFALSE;
+  }// cell cluster loop
        
+  return kFALSE;
+}
+
+//_______________________________________________________________________
+Bool_t AliEMCALRecoUtils::IsExoticCell(const Int_t absID, AliVCaloCells* cells, const Int_t bc)
+{
+  // Look to cell neighbourhood and reject if it seems exotic
+  // Do before recalibrating the cells
+
+  if(!fRejectExoticCells) return kFALSE;
+
+  AliEMCALGeometry * geom = AliEMCALGeometry::GetInstance();
+  
+  Int_t imod = -1, iphi =-1, ieta=-1,iTower = -1, iIphi = -1, iIeta = -1; 
+  geom->GetCellIndex(absID,imod,iTower,iIphi,iIeta); 
+  geom->GetCellPhiEtaIndexInSModule(imod,iTower,iIphi, iIeta,iphi,ieta);       
+  
+  //Get close cells index, energy and time, not in corners
+  Int_t absID1 = geom-> GetAbsCellIdFromCellIndexes(imod, iphi+1, ieta);
+  Int_t absID2 = geom-> GetAbsCellIdFromCellIndexes(imod, iphi-1, ieta);
+  Int_t absID3 = geom-> GetAbsCellIdFromCellIndexes(imod, iphi, ieta+1);
+  Int_t absID4 = geom-> GetAbsCellIdFromCellIndexes(imod, iphi, ieta-1);
+  
+  Float_t  ecell  = 0, ecell1  = 0, ecell2  = 0, ecell3  = 0, ecell4  = 0;
+  Double_t tcell  = 0, tcell1  = 0, tcell2  = 0, tcell3  = 0, tcell4  = 0;
+  Bool_t   accept = 0, accept1 = 0, accept2 = 0, accept3 = 0, accept4 = 0;
+  
+  accept  = AcceptCalibrateCell(absID, bc, ecell ,tcell ,cells); 
+    
+  if(!accept) return kTRUE; // reject this cell
+  
+  if(ecell < fExoticCellMinAmplitude) return kFALSE; // do not reject low energy cells
+  
+  accept1 = AcceptCalibrateCell(absID1,bc, ecell1,tcell1,cells); 
+  accept2 = AcceptCalibrateCell(absID2,bc, ecell2,tcell2,cells); 
+  accept3 = AcceptCalibrateCell(absID3,bc, ecell3,tcell3,cells); 
+  accept4 = AcceptCalibrateCell(absID4,bc, ecell4,tcell4,cells); 
+  
+  /*
+    printf("Cell absID %d \n",absID);
+    printf("\t  accept1 %d, accept2 %d, accept3 %d, accept4 %d\n",
+           accept1,accept2,accept3,accept4);
+    printf("\t id %d: id1 %d, id2 %d, id3 %d, id4 %d\n",
+           absID,absID1,absID2,absID3,absID4);
+    printf("\t e %f: e1 %f, e2 %f, e3 %f, e4 %f\n",
+           ecell,ecell1,ecell2,ecell3,ecell4);
+    printf("\t t %f: t1 %f, t2 %f, t3 %f, t4 %f;\n dt1 %f, dt2 %f, dt3 %f, dt4 %f\n",
+           tcell*1.e9,tcell1*1.e9,tcell2*1.e9,tcell3*1.e9,tcell4*1.e9,
+           TMath::Abs(tcell-tcell1)*1.e9, TMath::Abs(tcell-tcell2)*1.e9, TMath::Abs(tcell-tcell3)*1.e9, TMath::Abs(tcell-tcell4)*1.e9);
+  */
+  
+  if(TMath::Abs(tcell-tcell1)*1.e9 > fExoticCellDiffTime) ecell1 = 0 ;
+  if(TMath::Abs(tcell-tcell2)*1.e9 > fExoticCellDiffTime) ecell2 = 0 ;
+  if(TMath::Abs(tcell-tcell3)*1.e9 > fExoticCellDiffTime) ecell3 = 0 ;
+  if(TMath::Abs(tcell-tcell4)*1.e9 > fExoticCellDiffTime) ecell4 = 0 ;
+
+  Float_t eCross = ecell1+ecell2+ecell3+ecell4;
+
+  //printf("\t eCell %f, eCross %f, 1-eCross/eCell %f\n",ecell,eCross,1-eCross/ecell);
+  
+  if(1-eCross/ecell > fExoticCellFraction) {
+    AliDebug(2,Form("AliEMCALRecoUtils::IsExoticCell() - EXOTIC CELL id %d, eCell %f, eCross %f, 1-eCross/eCell %f\n",
+                    absID,ecell,eCross,1-eCross/ecell));
+    return kTRUE;
+  }
+
+  return kFALSE;
 }
 
 //_________________________________________________
-Bool_t AliEMCALRecoUtils::IsExoticCluster(AliVCluster *cluster) const {
-  // Check if the cluster has high energy  but small number of cells
-  // The criteria comes from Gustavo's study
-  //
+Bool_t AliEMCALRecoUtils::IsExoticCluster(AliVCluster *cluster, AliVCaloCells *cells, const Int_t bc) 
+{
+  // Check if the cluster highest energy tower is exotic
   
   if(!cluster){
     AliInfo("Cluster pointer null!");
     return kFALSE;
   }
   
-  Int_t nc = cluster->GetNCells() ;
-  
-  if      ( nc > 8 )                   return kFALSE ; // Good cluster, needed for 3x3 clusterizer  
-  else if ( nc < 1 + cluster->E()/3. ) return kTRUE  ; // Bad cluster
-  else                                 return kFALSE ; // Good cluster
+  if(!fRejectExoticCluster) return kFALSE;
   
+  // Get highest energy tower
+  AliEMCALGeometry* geom = AliEMCALGeometry::GetInstance();
+  Int_t iSupMod = -1, absId = -1, ieta = -1, iphi = -1;
+  Bool_t shared = kFALSE;
+  GetMaxEnergyCell(geom, cells, cluster, absId, iSupMod, ieta, iphi, shared);
+
+  return IsExoticCell(absId,cells,bc);
 }
 
 //__________________________________________________
-Float_t AliEMCALRecoUtils::SmearClusterEnergy(AliVCluster* cluster) {
-
+Float_t AliEMCALRecoUtils::SmearClusterEnergy(const AliVCluster* cluster) 
+{
   //In case of MC analysis, smear energy to match resolution/calibration in real data
   
   if(!cluster){
@@ -453,13 +536,13 @@ Float_t AliEMCALRecoUtils::SmearClusterEnergy(AliVCluster* cluster) {
     AliDebug(2, Form("Energy: original %f, smeared %f\n", energy, rdmEnergy));
   }
   
-  return rdmEnergy ;
-
+  return rdmEnergy;
 }
 
 //__________________________________________________
-Float_t AliEMCALRecoUtils::CorrectClusterEnergyLinearity(AliVCluster* cluster){
-// Correct cluster energy from non linearity functions
+Float_t AliEMCALRecoUtils::CorrectClusterEnergyLinearity(AliVCluster* cluster)
+{
+  // Correct cluster energy from non linearity functions
   
   if(!cluster){
     AliInfo("Cluster pointer null!");
@@ -467,7 +550,7 @@ Float_t AliEMCALRecoUtils::CorrectClusterEnergyLinearity(AliVCluster* cluster){
   }
   
   Float_t energy = cluster->E();
-  
+
   switch (fNonLinearityFunction) {
       
     case kPi0MC:
@@ -538,70 +621,62 @@ Float_t AliEMCALRecoUtils::CorrectClusterEnergyLinearity(AliVCluster* cluster){
       break;
       
   }
-  
-  return energy;
 
+  return energy;
 }
+
 //__________________________________________________
 void AliEMCALRecoUtils::InitNonLinearityParam()
 {
-       //Initialising Non Linearity Parameters
+  //Initialising Non Linearity Parameters
        
-       if(fNonLinearityFunction == kPi0MC)
-               {
-                       fNonLinearityParams[0] = 1.014;
-      fNonLinearityParams[1] = -0.03329;
-      fNonLinearityParams[2] = -0.3853;
-      fNonLinearityParams[3] = 0.5423;
-      fNonLinearityParams[4] = -0.4335;
-               }
-
-       if(fNonLinearityFunction == kPi0GammaGamma)
-               {
-                       fNonLinearityParams[0] = 1.04;
-                       fNonLinearityParams[1] = -0.1445;
-                       fNonLinearityParams[2] = 1.046;
-               }       
-
-       if(fNonLinearityFunction == kPi0GammaConversion)
-               {
-      fNonLinearityParams[0] = 0.139393;
-      fNonLinearityParams[1] = 0.0566186;
-      fNonLinearityParams[2] = 0.982133;
-               }       
-
-       if(fNonLinearityFunction == kBeamTest)
-               {
-                       if(fNonLinearThreshold == 30)
-                       {
-                               fNonLinearityParams[0] = 1.007; 
-                               fNonLinearityParams[1] = 0.894; 
-                               fNonLinearityParams[2] = 0.246; 
-                       }
-                       if(fNonLinearThreshold == 45)
-                       {
-                               fNonLinearityParams[0] = 1.003; 
-                               fNonLinearityParams[1] = 0.719; 
-                               fNonLinearityParams[2] = 0.334; 
-                       }
-                       if(fNonLinearThreshold == 75)
-                       {
-                               fNonLinearityParams[0] = 1.002; 
-                               fNonLinearityParams[1] = 0.797; 
-                               fNonLinearityParams[2] = 0.358; 
-                       }
-               }
-
-       if(fNonLinearityFunction == kBeamTestCorrected)
-               {
-                       fNonLinearityParams[0] =  0.99078;
-                       fNonLinearityParams[1] =  0.161499;
-                       fNonLinearityParams[2] =  0.655166; 
-                       fNonLinearityParams[3] =  0.134101;
-                       fNonLinearityParams[4] =  163.282;
-                       fNonLinearityParams[5] =  23.6904;
-                       fNonLinearityParams[6] =  0.978;
-               }
+  if(fNonLinearityFunction == kPi0MC) {
+    fNonLinearityParams[0] = 1.014;
+    fNonLinearityParams[1] = -0.03329;
+    fNonLinearityParams[2] = -0.3853;
+    fNonLinearityParams[3] = 0.5423;
+    fNonLinearityParams[4] = -0.4335;
+  }
+  
+  if(fNonLinearityFunction == kPi0GammaGamma) {
+    fNonLinearityParams[0] = 1.04;
+    fNonLinearityParams[1] = -0.1445;
+    fNonLinearityParams[2] = 1.046;
+  }    
+
+  if(fNonLinearityFunction == kPi0GammaConversion) {
+    fNonLinearityParams[0] = 0.139393;
+    fNonLinearityParams[1] = 0.0566186;
+    fNonLinearityParams[2] = 0.982133;
+  }    
+
+  if(fNonLinearityFunction == kBeamTest) {
+    if(fNonLinearThreshold == 30) {
+      fNonLinearityParams[0] = 1.007; 
+      fNonLinearityParams[1] = 0.894; 
+      fNonLinearityParams[2] = 0.246; 
+    }
+    if(fNonLinearThreshold == 45) {
+      fNonLinearityParams[0] = 1.003; 
+      fNonLinearityParams[1] = 0.719; 
+      fNonLinearityParams[2] = 0.334; 
+    }
+    if(fNonLinearThreshold == 75) {
+      fNonLinearityParams[0] = 1.002; 
+      fNonLinearityParams[1] = 0.797; 
+      fNonLinearityParams[2] = 0.358; 
+    }
+  }
+
+  if(fNonLinearityFunction == kBeamTestCorrected) {
+    fNonLinearityParams[0] =  0.99078;
+    fNonLinearityParams[1] =  0.161499;
+    fNonLinearityParams[2] =  0.655166; 
+    fNonLinearityParams[3] =  0.134101;
+    fNonLinearityParams[4] =  163.282;
+    fNonLinearityParams[5] =  23.6904;
+    fNonLinearityParams[6] =  0.978;
+  }
 }
 
 //__________________________________________________
@@ -650,12 +725,17 @@ Float_t  AliEMCALRecoUtils::GetDepth(const Float_t energy, const Int_t iParticle
   }  
   
   return depth;
-  
 }
 
-//__________________________________________________
-void AliEMCALRecoUtils::GetMaxEnergyCell(AliEMCALGeometry *geom, AliVCaloCells* cells, AliVCluster* clu, 
-                                         Int_t & absId,  Int_t& iSupMod, Int_t& ieta, Int_t& iphi, Bool_t &shared)
+//____________________________________________________________________
+void AliEMCALRecoUtils::GetMaxEnergyCell(const AliEMCALGeometry *geom, 
+                                         AliVCaloCells* cells, 
+                                         const AliVCluster* clu, 
+                                         Int_t & absId,  
+                                         Int_t& iSupMod, 
+                                         Int_t& ieta, 
+                                         Int_t& iphi, 
+                                         Bool_t &shared)
 {
   //For a given CaloCluster gets the absId of the cell 
   //with maximum energy deposit.
@@ -689,7 +769,7 @@ void AliEMCALRecoUtils::GetMaxEnergyCell(AliEMCALGeometry *geom, AliVCaloCells*
       shared = kTRUE;
       //printf("AliEMCALRecoUtils::GetMaxEnergyCell() - SHARED CLUSTER\n");
     }
-    if(IsRecalibrationOn()) {
+    if(!fCellsRecalibrated && IsRecalibrationOn()) {
       recalFactor = GetEMCALChannelRecalibrationFactor(iSupMod,ieta,iphi);
     }
     eCell  = cells->GetCellAmplitude(cellAbsId)*fraction*recalFactor;
@@ -708,84 +788,170 @@ void AliEMCALRecoUtils::GetMaxEnergyCell(AliEMCALGeometry *geom, AliVCaloCells*
                                          iIphi, iIeta,iphi,ieta); 
   //printf("Max id %d, iSM %d, col %d, row %d\n",absId,iSupMod,ieta,iphi);
   //printf("Max end---\n");
+}
+
+//______________________________________
+void AliEMCALRecoUtils::InitParameters()
+{
+  // Initialize data members with default values
+  
+  fParticleType = kPhoton;
+  fPosAlgo      = kUnchanged;
+  fW0           = 4.5;
+  
+  fNonLinearityFunction = kNoCorrection;
+  fNonLinearThreshold   = 30;
+  
+  fExoticCellFraction     = 0.97;
+  fExoticCellDiffTime     = 1e6;
+  fExoticCellMinAmplitude = 0.5;
+  
+  fAODFilterMask = 32;
+  
+  fCutEtaPhiSum      = kTRUE;
+  fCutEtaPhiSeparate = kFALSE;
   
+  fCutR   = 0.05; 
+  fCutEta = 0.025; 
+  fCutPhi = 0.05;
+  
+  fClusterWindow = 100;
+  fMass          = 0.139;
+  
+  fStepSurface   = 20.;                      
+  fStepCluster   = 5.;
+  fTrackCutsType = kLooseCut;
+  
+  fCutMinTrackPt     = 0;
+  fCutMinNClusterTPC = -1;
+  fCutMinNClusterITS = -1;
+  
+  fCutMaxChi2PerClusterTPC  = 1e10;
+  fCutMaxChi2PerClusterITS  = 1e10;
+  
+  fCutRequireTPCRefit     = kFALSE;
+  fCutRequireITSRefit     = kFALSE;
+  fCutAcceptKinkDaughters = kFALSE;
+  
+  fCutMaxDCAToVertexXY = 1e10;             
+  fCutMaxDCAToVertexZ  = 1e10;              
+  fCutDCAToVertex2D    = kFALSE;
+  
+  
+  //Misalignment matrices
+  for(Int_t i = 0; i < 15 ; i++) {
+    fMisalTransShift[i] = 0.; 
+    fMisalRotShift[i]   = 0.; 
+  }
+  
+  //Non linearity
+  for(Int_t i = 0; i < 7  ; i++) fNonLinearityParams[i] = 0.; 
+  
+  //For kBeamTestCorrected case, but default is no correction
+  fNonLinearityParams[0] =  0.99078;
+  fNonLinearityParams[1] =  0.161499;
+  fNonLinearityParams[2] =  0.655166; 
+  fNonLinearityParams[3] =  0.134101;
+  fNonLinearityParams[4] =  163.282;
+  fNonLinearityParams[5] =  23.6904;
+  fNonLinearityParams[6] =  0.978;
+  
+  //For kPi0GammaGamma case
+  //fNonLinearityParams[0] = 0.1457/0.1349766/1.038;
+  //fNonLinearityParams[1] = -0.02024/0.1349766/1.038;
+  //fNonLinearityParams[2] = 1.046;
+  
+  //Cluster energy smearing
+  fSmearClusterEnergy   = kFALSE;
+  fSmearClusterParam[0] = 0.07; // * sqrt E term
+  fSmearClusterParam[1] = 0.00; // * E term
+  fSmearClusterParam[2] = 0.00; // constant
 }
 
-//________________________________________________________________
-void AliEMCALRecoUtils::InitEMCALRecalibrationFactors(){
-       //Init EMCAL recalibration factors
-       AliDebug(2,"AliCalorimeterUtils::InitEMCALRecalibrationFactors()");
+//_____________________________________________________
+void AliEMCALRecoUtils::InitEMCALRecalibrationFactors()
+{
+  //Init EMCAL recalibration factors
+  AliDebug(2,"AliCalorimeterUtils::InitEMCALRecalibrationFactors()");
        //In order to avoid rewriting the same histograms
-       Bool_t oldStatus = TH1::AddDirectoryStatus();
-       TH1::AddDirectory(kFALSE);
-  
-       fEMCALRecalibrationFactors = new TObjArray(10);
-       for (int i = 0; i < 10; i++) fEMCALRecalibrationFactors->Add(new TH2F(Form("EMCALRecalFactors_SM%d",i),Form("EMCALRecalFactors_SM%d",i),  48, 0, 48, 24, 0, 24));
-       //Init the histograms with 1
-       for (Int_t sm = 0; sm < 10; sm++) {
-               for (Int_t i = 0; i < 48; i++) {
-                       for (Int_t j = 0; j < 24; j++) {
-                               SetEMCALChannelRecalibrationFactor(sm,i,j,1.);
-                       }
-               }
-       }
-       fEMCALRecalibrationFactors->SetOwner(kTRUE);
-       fEMCALRecalibrationFactors->Compress();
+  Bool_t oldStatus = TH1::AddDirectoryStatus();
+  TH1::AddDirectory(kFALSE);
+  
+  fEMCALRecalibrationFactors = new TObjArray(10);
+  for (int i = 0; i < 10; i++) 
+    fEMCALRecalibrationFactors->Add(new TH2F(Form("EMCALRecalFactors_SM%d",i),
+                                             Form("EMCALRecalFactors_SM%d",i),  48, 0, 48, 24, 0, 24));
+  //Init the histograms with 1
+  for (Int_t sm = 0; sm < 10; sm++) {
+    for (Int_t i = 0; i < 48; i++) {
+      for (Int_t j = 0; j < 24; j++) {
+        SetEMCALChannelRecalibrationFactor(sm,i,j,1.);
+      }
+    }
+  }
+  fEMCALRecalibrationFactors->SetOwner(kTRUE);
+  fEMCALRecalibrationFactors->Compress();
        
-       //In order to avoid rewriting the same histograms
-       TH1::AddDirectory(oldStatus);           
+  //In order to avoid rewriting the same histograms
+  TH1::AddDirectory(oldStatus);                
 }
 
 //________________________________________________________________
-void AliEMCALRecoUtils::InitEMCALTimeRecalibrationFactors(){
-       //Init EMCAL recalibration factors
-       AliDebug(2,"AliCalorimeterUtils::InitEMCALRecalibrationFactors()");
-       //In order to avoid rewriting the same histograms
-       Bool_t oldStatus = TH1::AddDirectoryStatus();
-       TH1::AddDirectory(kFALSE);
-  
-       fEMCALTimeRecalibrationFactors = new TObjArray(4);
-       for (int i = 0; i < 4; i++) 
+void AliEMCALRecoUtils::InitEMCALTimeRecalibrationFactors()
+{
+  //Init EMCAL recalibration factors
+  AliDebug(2,"AliCalorimeterUtils::InitEMCALRecalibrationFactors()");
+  //In order to avoid rewriting the same histograms
+  Bool_t oldStatus = TH1::AddDirectoryStatus();
+  TH1::AddDirectory(kFALSE);
+  
+  fEMCALTimeRecalibrationFactors = new TObjArray(4);
+  for (int i = 0; i < 4; i++) 
     fEMCALTimeRecalibrationFactors->Add(new TH1F(Form("hAllTimeAvBC%d",i),
                                                  Form("hAllTimeAvBC%d",i),  
                                                  48*24*10,0.,48*24*10)          );
-       //Init the histograms with 1
-       for (Int_t bc = 0; bc < 4; bc++) {
-                       for (Int_t i = 0; i < 48*24*10; i++) 
-        SetEMCALChannelTimeRecalibrationFactor(bc,i,0.);
+  //Init the histograms with 1
+  for (Int_t bc = 0; bc < 4; bc++) {
+    for (Int_t i = 0; i < 48*24*10; i++) 
+      SetEMCALChannelTimeRecalibrationFactor(bc,i,0.);
   }
-
-       fEMCALTimeRecalibrationFactors->SetOwner(kTRUE);
-       fEMCALTimeRecalibrationFactors->Compress();
-       
-       //In order to avoid rewriting the same histograms
-       TH1::AddDirectory(oldStatus);           
+  
+  fEMCALTimeRecalibrationFactors->SetOwner(kTRUE);
+  fEMCALTimeRecalibrationFactors->Compress();
+  
+  //In order to avoid rewriting the same histograms
+  TH1::AddDirectory(oldStatus);                
 }
 
 //________________________________________________________________
-void AliEMCALRecoUtils::InitEMCALBadChannelStatusMap(){
-       //Init EMCAL bad channels map
-       AliDebug(2,"AliEMCALRecoUtils::InitEMCALBadChannelStatusMap()");
-       //In order to avoid rewriting the same histograms
-       Bool_t oldStatus = TH1::AddDirectoryStatus();
-       TH1::AddDirectory(kFALSE);
-       
-       fEMCALBadChannelMap = new TObjArray(10);
-       //TH2F * hTemp = new  TH2I("EMCALBadChannelMap","EMCAL SuperModule bad channel map", 48, 0, 48, 24, 0, 24);
-       for (int i = 0; i < 10; i++) {
-               fEMCALBadChannelMap->Add(new TH2I(Form("EMCALBadChannelMap_Mod%d",i),Form("EMCALBadChannelMap_Mod%d",i), 48, 0, 48, 24, 0, 24));
-       }
-               
-       fEMCALBadChannelMap->SetOwner(kTRUE);
-       fEMCALBadChannelMap->Compress();
-       
-       //In order to avoid rewriting the same histograms
-       TH1::AddDirectory(oldStatus);           
+void AliEMCALRecoUtils::InitEMCALBadChannelStatusMap()
+{
+  //Init EMCAL bad channels map
+  AliDebug(2,"AliEMCALRecoUtils::InitEMCALBadChannelStatusMap()");
+  //In order to avoid rewriting the same histograms
+  Bool_t oldStatus = TH1::AddDirectoryStatus();
+  TH1::AddDirectory(kFALSE);
+  
+  fEMCALBadChannelMap = new TObjArray(10);
+  //TH2F * hTemp = new  TH2I("EMCALBadChannelMap","EMCAL SuperModule bad channel map", 48, 0, 48, 24, 0, 24);
+  for (int i = 0; i < 10; i++) {
+    fEMCALBadChannelMap->Add(new TH2I(Form("EMCALBadChannelMap_Mod%d",i),Form("EMCALBadChannelMap_Mod%d",i), 48, 0, 48, 24, 0, 24));
+  }
+  
+  fEMCALBadChannelMap->SetOwner(kTRUE);
+  fEMCALBadChannelMap->Compress();
+  
+  //In order to avoid rewriting the same histograms
+  TH1::AddDirectory(oldStatus);                
 }
 
-//________________________________________________________________
-void AliEMCALRecoUtils::RecalibrateClusterEnergy(AliEMCALGeometry* geom, AliVCluster * cluster, AliVCaloCells * cells, const Int_t bc){
-       // Recalibrate the cluster energy and Time, considering the recalibration map 
+//____________________________________________________________________________
+void AliEMCALRecoUtils::RecalibrateClusterEnergy(const AliEMCALGeometry* geom, 
+                                                 AliVCluster * cluster, 
+                                                 AliVCaloCells * cells, 
+                                                 const Int_t bc)
+{
+  // Recalibrate the cluster energy and Time, considering the recalibration map 
   // and the energy of the cells and time that compose the cluster.
   // bc= bunch crossing number returned by esdevent->GetBunchCrossNumber();
        
@@ -794,27 +960,26 @@ void AliEMCALRecoUtils::RecalibrateClusterEnergy(AliEMCALGeometry* geom, AliVClu
     return;
   }  
   
-       //Get the cluster number of cells and list of absId, check what kind of cluster do we have.
-       UShort_t * index    = cluster->GetCellsAbsId() ;
-       Double_t * fraction = cluster->GetCellsAmplitudeFraction() ;
-       Int_t ncells = cluster->GetNCells();
+  //Get the cluster number of cells and list of absId, check what kind of cluster do we have.
+  UShort_t * index    = cluster->GetCellsAbsId() ;
+  Double_t * fraction = cluster->GetCellsAmplitudeFraction() ;
+  Int_t ncells = cluster->GetNCells();
        
-       //Initialize some used variables
-       Float_t energy = 0;
-       Int_t   absId  =-1;
+  //Initialize some used variables
+  Float_t energy = 0;
+  Int_t   absId  =-1;
   Int_t   icol   =-1, irow =-1, imod=1;
-       Float_t factor = 1, frac = 0;
+  Float_t factor = 1, frac = 0;
   Int_t   absIdMax = -1;
   Float_t emax     = 0;
   
-       //Loop on the cells, get the cell amplitude and recalibration factor, multiply and and to the new energy
-       for(Int_t icell = 0; icell < ncells; icell++){
-               absId = index[icell];
-               frac =  fraction[icell];
-               if(frac < 1e-5) frac = 1; //in case of EMCAL, this is set as 0 since unfolding is off
+  //Loop on the cells, get the cell amplitude and recalibration factor, multiply and and to the new energy
+  for(Int_t icell = 0; icell < ncells; icell++){
+    absId = index[icell];
+    frac =  fraction[icell];
+    if(frac < 1e-5) frac = 1; //in case of EMCAL, this is set as 0 since unfolding is off
     
-    if(!fCellsRecalibrated && IsRecalibrationOn()){
-      
+    if(!fCellsRecalibrated && IsRecalibrationOn()) {
       // Energy  
       Int_t iTower = -1, iIphi = -1, iIeta = -1; 
       geom->GetCellIndex(absId,imod,iTower,iIphi,iIeta); 
@@ -827,22 +992,21 @@ void AliEMCALRecoUtils::RecalibrateClusterEnergy(AliEMCALGeometry* geom, AliVClu
       
     } 
     
-               energy += cells->GetCellAmplitude(absId)*factor*frac;
+    energy += cells->GetCellAmplitude(absId)*factor*frac;
     
     if(emax < cells->GetCellAmplitude(absId)*factor*frac){
       emax     = cells->GetCellAmplitude(absId)*factor*frac;
       absIdMax = absId;
     }
-
-       }
+  }
        
   cluster->SetE(energy);
 
   AliDebug(2,Form("AliEMCALRecoUtils::RecalibrateClusterEnergy - Energy before %f, after %f\n",cluster->E(),energy));
 
-       // Recalculate time of cluster only for ESDs
-  if(!strcmp("AliESDCaloCluster",Form("%s",cluster->ClassName()))){
-    
+  // Recalculate time of cluster only for ESDs
+  if(!strcmp("AliESDCaloCluster",Form("%s",cluster->ClassName()))) {
+
     // Time
     Double_t weightedTime = 0;
     Double_t weight       = 0;
@@ -865,7 +1029,8 @@ void AliEMCALRecoUtils::RecalibrateClusterEnergy(AliEMCALGeometry* geom, AliVClu
         geom->GetCellPhiEtaIndexInSModule(imod,iTower,iIphi, iIeta,irow,icol);                 
         factor = GetEMCALChannelRecalibrationFactor(imod,icol,irow);
         
-        AliDebug(2,Form("AliEMCALRecoUtils::RecalibrateClusterEnergy - recalibrate cell: module %d, col %d, row %d, cell fraction %f,recalibration factor %f, cell energy %f\n",
+        AliDebug(2,Form("AliEMCALRecoUtils::RecalibrateClusterEnergy - recalibrate cell:"
+                        " module %d, col %d, row %d, cell fraction %f,recalibration factor %f, cell energy %f\n",
                         imod,icol,irow,frac,factor,cells->GetCellTime(absId)));
         
       } 
@@ -873,20 +1038,19 @@ void AliEMCALRecoUtils::RecalibrateClusterEnergy(AliEMCALGeometry* geom, AliVClu
       weight        = GetCellWeight(cells->GetCellAmplitude(absId)*factor*frac , energy );
       weightTot    += weight;
       weightedTime += celltime * weight;
-      
     }
     
     if(weightTot > 0)
       cluster->SetTOF(weightedTime/weightTot);
     else 
       cluster->SetTOF(maxcellTime);
-    
   }
 }
 
 //________________________________________________________________
-void AliEMCALRecoUtils::RecalibrateCells(AliEMCALGeometry* geom, AliVCaloCells * cells, Int_t bc){
-       // Recalibrate the cells time and energy, considering the recalibration map and the energy 
+void AliEMCALRecoUtils::RecalibrateCells(AliVCaloCells * cells, Int_t bc)
+{
+  // Recalibrate the cells time and energy, considering the recalibration map and the energy 
   // of the cells that compose the cluster.
   // bc= bunch crossing number returned by esdevent->GetBunchCrossNumber();
 
@@ -897,52 +1061,38 @@ void AliEMCALRecoUtils::RecalibrateCells(AliEMCALGeometry* geom, AliVCaloCells *
     return;
   }  
   
-  fCellsRecalibrated = kTRUE;
-  
-  Int_t absId  =-1;
-  Int_t icol   =-1, irow  =-1, imod  = 1;
-  Int_t iTower =-1, iIeta =-1, iIphi =-1;
-
-  Int_t nEMcell = cells->GetNumberOfCells() ;
+  Int_t    absId  =-1;
+  Bool_t   accept = kFALSE;
+  Float_t  ecell  = 0;
+  Double_t tcell  = 0;
   
+  Int_t nEMcell  = cells->GetNumberOfCells() ;  
   for (Int_t iCell = 0; iCell < nEMcell; iCell++) { 
     
-    absId = cells->GetCellNumber(iCell);
+    absId  = cells->GetCellNumber(iCell);
     
-    // Energy
-    Float_t factor = 1;
-    if(IsRecalibrationOn()){
-      geom->GetCellIndex(absId,imod,iTower,iIphi,iIeta); 
-      if(fEMCALRecalibrationFactors->GetEntries() <= imod) continue;
-      geom->GetCellPhiEtaIndexInSModule(imod,iTower,iIphi, iIeta,irow,icol);   
-      factor = GetEMCALChannelRecalibrationFactor(imod,icol,irow);
-               }
-    
-    Float_t cellE      = cells->GetAmplitude(iCell) * factor ;
-    
-    //Time
-    Double_t celltime = cells->GetCellTime(absId);
-    RecalibrateCellTime(absId, bc, celltime);
+    accept = AcceptCalibrateCell(absId, bc, ecell ,tcell ,cells); 
+    if(!accept) {
+      ecell = 0;
+      tcell = 0;
+    }
     
     //Set new values
-    cells->SetCell(iCell,cells->GetCellNumber(iCell),cellE, celltime);
-    
+    cells->SetCell(iCell,absId,ecell, tcell);
   }
-  
+
+  fCellsRecalibrated = kTRUE;
 }
 
-//_________________________________________________________________________________________________
-void AliEMCALRecoUtils::RecalibrateCellTime(const Int_t absId, const Int_t bc, Double_t & celltime)
+//_______________________________________________________________________________________________________
+void AliEMCALRecoUtils::RecalibrateCellTime(const Int_t absId, const Int_t bc, Double_t & celltime) const
 {
-       // Recalibrate time of cell with absID  considering the recalibration map 
+  // Recalibrate time of cell with absID  considering the recalibration map 
   // bc= bunch crossing number returned by esdevent->GetBunchCrossNumber();
   
-  if(!fCellsRecalibrated && IsTimeRecalibrationOn()){
-    
+  if(!fCellsRecalibrated && IsTimeRecalibrationOn() && bc >= 0){
     celltime -= GetEMCALChannelTimeRecalibrationFactor(bc%4,absId)*1.e-9;    ;  
-    
   }
-  
 }
   
 //__________________________________________________
@@ -958,7 +1108,6 @@ void AliEMCALRecoUtils::RecalculateClusterPosition(AliEMCALGeometry *geom, AliVC
   if     (fPosAlgo==kPosTowerGlobal) RecalculateClusterPositionFromTowerGlobal( geom, cells, clu);
   else if(fPosAlgo==kPosTowerIndex)  RecalculateClusterPositionFromTowerIndex ( geom, cells, clu);
   else   AliDebug(2,"Algorithm to recalculate position not selected, do nothing.");
-  
 }  
 
 //__________________________________________________
@@ -987,12 +1136,11 @@ void AliEMCALRecoUtils::RecalculateClusterPositionFromTowerGlobal(AliEMCALGeomet
   
   for (Int_t iDig=0; iDig< clu->GetNCells(); iDig++) {
     
-      absId = clu->GetCellAbsId(iDig);
-      fraction  = clu->GetCellAmplitudeFraction(iDig);
-      if(fraction < 1e-4) fraction = 1.; // in case unfolding is off
+    absId = clu->GetCellAbsId(iDig);
+    fraction  = clu->GetCellAmplitudeFraction(iDig);
+    if(fraction < 1e-4) fraction = 1.; // in case unfolding is off
     
-    if(!fCellsRecalibrated){
-
+    if (!fCellsRecalibrated){
       geom->GetCellIndex(absId,iSM,iTower,iIphi,iIeta); 
       geom->GetCellPhiEtaIndexInSModule(iSM,iTower,iIphi, iIeta,iphi,ieta);                    
       
@@ -1012,7 +1160,6 @@ void AliEMCALRecoUtils::RecalculateClusterPositionFromTowerGlobal(AliEMCALGeomet
     //printf("pLocal (%f,%f,%f)\n",pGlobal[0],pGlobal[1],pGlobal[2]);
 
     for(int i=0; i<3; i++ ) newPos[i] += (weight*pGlobal[i]);
-    
   }// cell loop
   
   if(totalWeight>0){
@@ -1024,24 +1171,20 @@ void AliEMCALRecoUtils::RecalculateClusterPositionFromTowerGlobal(AliEMCALGeomet
   //printf("OldPos  : %2.3f,%2.3f,%2.3f\n",pos[0],pos[1],pos[2]);
   //printf("NewPos  : %2.3f,%2.3f,%2.3f\n",newPos[0],newPos[1],newPos[2]);
   
-       if(iSupModMax > 1) {//sector 1
-         newPos[0] +=fMisalTransShift[3];//-=3.093; 
-         newPos[1] +=fMisalTransShift[4];//+=6.82;
-         newPos[2] +=fMisalTransShift[5];//+=1.635;
+  if(iSupModMax > 1) {//sector 1
+    newPos[0] +=fMisalTransShift[3];//-=3.093; 
+    newPos[1] +=fMisalTransShift[4];//+=6.82;
+    newPos[2] +=fMisalTransShift[5];//+=1.635;
     //printf("   +    : %2.3f,%2.3f,%2.3f\n",fMisalTransShift[3],fMisalTransShift[4],fMisalTransShift[5]);
-
-       }
-       else {//sector 0
-         newPos[0] +=fMisalTransShift[0];//+=1.134;
-         newPos[1] +=fMisalTransShift[1];//+=8.2;
-         newPos[2] +=fMisalTransShift[2];//+=1.197;
+  } else {//sector 0
+    newPos[0] +=fMisalTransShift[0];//+=1.134;
+    newPos[1] +=fMisalTransShift[1];//+=8.2;
+    newPos[2] +=fMisalTransShift[2];//+=1.197;
     //printf("   +    : %2.3f,%2.3f,%2.3f\n",fMisalTransShift[0],fMisalTransShift[1],fMisalTransShift[2]);
-
-       }
+  }
   //printf("NewPos : %2.3f,%2.3f,%2.3f\n",newPos[0],newPos[1],newPos[2]);
 
   clu->SetPosition(newPos);
-  
 }  
 
 //__________________________________________________
@@ -1057,7 +1200,7 @@ void AliEMCALRecoUtils::RecalculateClusterPositionFromTowerIndex(AliEMCALGeometr
   Int_t absId   = -1;
   Int_t iTower  = -1;
   Int_t iIphi   = -1, iIeta   = -1;
-       Int_t iSupMod = -1, iSupModMax = -1;
+  Int_t iSupMod = -1, iSupModMax = -1;
   Int_t iphi = -1, ieta =-1;
   Bool_t shared = kFALSE;
 
@@ -1082,12 +1225,9 @@ void AliEMCALRecoUtils::RecalculateClusterPositionFromTowerIndex(AliEMCALGeometr
     geom->GetCellIndex(absId,iSupMod,iTower,iIphi,iIeta); 
     geom->GetCellPhiEtaIndexInSModule(iSupMod,iTower,iIphi, iIeta,iphi,ieta);          
     
-    if(!fCellsRecalibrated){
-      
+    if (!fCellsRecalibrated){
       if(IsRecalibrationOn()) {
-                
         recalFactor = GetEMCALChannelRecalibrationFactor(iSupMod,ieta,iphi);
-        
       }
     }
     
@@ -1100,8 +1240,7 @@ void AliEMCALRecoUtils::RecalculateClusterPositionFromTowerIndex(AliEMCALGeometr
     weightedRow += iphi*weight;
     
     //printf("Max cell? cell %d, amplitude org %f, fraction %f, recalibration %f, amplitude new %f \n",cellAbsId, cells->GetCellAmplitude(cellAbsId), fraction, recalFactor, eCell) ;
-    
-    }// cell loop
+  }// cell loop
     
   Float_t xyzNew[]={0.,0.,0.};
   if(areInSameSM == kTRUE) {
@@ -1109,19 +1248,17 @@ void AliEMCALRecoUtils::RecalculateClusterPositionFromTowerIndex(AliEMCALGeometr
     weightedCol = weightedCol/totalWeight;
     weightedRow = weightedRow/totalWeight;
     geom->RecalculateTowerPosition(weightedRow, weightedCol, iSupModMax, depth, fMisalTransShift, fMisalRotShift, xyzNew); 
-  }
-  else {
+  } else {
     //printf("In Different SM\n");
     geom->RecalculateTowerPosition(iphi,        ieta,        iSupModMax, depth, fMisalTransShift, fMisalRotShift, xyzNew); 
   }
   
   clu->SetPosition(xyzNew);
-  
 }
 
 //____________________________________________________________________________
-void AliEMCALRecoUtils::RecalculateClusterDistanceToBadChannel(AliEMCALGeometry * geom, AliVCaloCells* cells, AliVCluster * cluster){           
-       
+void AliEMCALRecoUtils::RecalculateClusterDistanceToBadChannel(AliEMCALGeometry * geom, AliVCaloCells* cells, AliVCluster * cluster)
+{           
   //re-evaluate distance to bad channel with updated bad map
   
   if(!fRecalDistToBadChannels) return;
@@ -1131,78 +1268,72 @@ void AliEMCALRecoUtils::RecalculateClusterDistanceToBadChannel(AliEMCALGeometry
     return;
   }  
   
-       //Get channels map of the supermodule where the cluster is.
+  //Get channels map of the supermodule where the cluster is.
   Int_t absIdMax       = -1, iSupMod =-1, icolM = -1, irowM = -1;
   Bool_t shared = kFALSE;
   GetMaxEnergyCell(geom, cells, cluster, absIdMax,  iSupMod, icolM, irowM, shared);
   TH2D* hMap  = (TH2D*)fEMCALBadChannelMap->At(iSupMod);
 
   Int_t dRrow, dRcol;  
-       Float_t  minDist = 10000.;
-       Float_t  dist    = 0.;
+  Float_t  minDist = 10000.;
+  Float_t  dist    = 0.;
   
   //Loop on tower status map 
-       for(Int_t irow = 0; irow < AliEMCALGeoParams::fgkEMCALRows; irow++){
-               for(Int_t icol = 0; icol < AliEMCALGeoParams::fgkEMCALCols; icol++){
-                       //Check if tower is bad.
-                       if(hMap->GetBinContent(icol,irow)==0) continue;
+  for(Int_t irow = 0; irow < AliEMCALGeoParams::fgkEMCALRows; irow++){
+    for(Int_t icol = 0; icol < AliEMCALGeoParams::fgkEMCALCols; icol++){
+      //Check if tower is bad.
+      if(hMap->GetBinContent(icol,irow)==0) continue;
       //printf("AliEMCALRecoUtils::RecalculateDistanceToBadChannels() - \n \t Bad channel in SM %d, col %d, row %d, \n \t Cluster max in col %d, row %d\n",
       //       iSupMod,icol, irow, icolM,irowM);
       
       dRrow=TMath::Abs(irowM-irow);
       dRcol=TMath::Abs(icolM-icol);
       dist=TMath::Sqrt(dRrow*dRrow+dRcol*dRcol);
-                       if(dist < minDist){
+      if(dist < minDist){
         //printf("MIN DISTANCE TO BAD %2.2f\n",dist);
         minDist = dist;
       }
-      
-               }
-       }
+    }
+  }
   
-       //In case the cluster is shared by 2 SuperModules, need to check the map of the second Super Module
-       if (shared) {
-               TH2D* hMap2 = 0;
-               Int_t iSupMod2 = -1;
+  //In case the cluster is shared by 2 SuperModules, need to check the map of the second Super Module
+  if (shared) {
+    TH2D* hMap2 = 0;
+    Int_t iSupMod2 = -1;
     
-               //The only possible combinations are (0,1), (2,3) ... (8,9)
-               if(iSupMod%2) iSupMod2 = iSupMod-1;
-               else          iSupMod2 = iSupMod+1;
-               hMap2  = (TH2D*)fEMCALBadChannelMap->At(iSupMod2);
+    //The only possible combinations are (0,1), (2,3) ... (8,9)
+    if(iSupMod%2) iSupMod2 = iSupMod-1;
+    else          iSupMod2 = iSupMod+1;
+    hMap2  = (TH2D*)fEMCALBadChannelMap->At(iSupMod2);
     
-               //Loop on tower status map of second super module
-               for(Int_t irow = 0; irow < AliEMCALGeoParams::fgkEMCALRows; irow++){
-                       for(Int_t icol = 0; icol < AliEMCALGeoParams::fgkEMCALCols; icol++){
-                               //Check if tower is bad.
-                               if(hMap2->GetBinContent(icol,irow)==0) continue;
-                               //printf("AliEMCALRecoUtils::RecalculateDistanceToBadChannels(shared) - \n \t Bad channel in SM %d, col %d, row %d \n \t Cluster max in SM %d, col %d, row %d\n",
-          //     iSupMod2,icol, irow,iSupMod,icolM,irowM);
-        
+    //Loop on tower status map of second super module
+    for(Int_t irow = 0; irow < AliEMCALGeoParams::fgkEMCALRows; irow++){
+      for(Int_t icol = 0; icol < AliEMCALGeoParams::fgkEMCALCols; icol++){
+        //Check if tower is bad.
+        if(hMap2->GetBinContent(icol,irow)==0) continue;
+        //printf("AliEMCALRecoUtils::RecalculateDistanceToBadChannels(shared) - \n \t Bad channel in SM %d, col %d, row %d \n \t Cluster max in SM %d, col %d, row %d\n",
+        //     iSupMod2,icol, irow,iSupMod,icolM,irowM);
         dRrow=TMath::Abs(irow-irowM);
         
         if(iSupMod%2) {
-                                 dRcol=TMath::Abs(icol-(AliEMCALGeoParams::fgkEMCALCols+icolM));
-                               }
-        else {
+          dRcol=TMath::Abs(icol-(AliEMCALGeoParams::fgkEMCALCols+icolM));
+        } else {
           dRcol=TMath::Abs(AliEMCALGeoParams::fgkEMCALCols+icol-icolM);
-                               }                    
+        }                    
         
-                               dist=TMath::Sqrt(dRrow*dRrow+dRcol*dRcol);
+        dist=TMath::Sqrt(dRrow*dRrow+dRcol*dRcol);
         if(dist < minDist) minDist = dist;        
-        
-                       }
-               }
-    
-       }// shared cluster in 2 SuperModules
+      }
+    }
+  }// shared cluster in 2 SuperModules
   
   AliDebug(2,Form("Max cluster cell (SM,col,row)=(%d %d %d) - Distance to Bad Channel %2.2f",iSupMod, icolM, irowM, minDist));
   cluster->SetDistanceToBadChannel(minDist);
-  
 }
 
 //____________________________________________________________________________
-void AliEMCALRecoUtils::RecalculateClusterPID(AliVCluster * cluster){           
-       
+void AliEMCALRecoUtils::RecalculateClusterPID(AliVCluster * cluster)
+{           
   //re-evaluate identification parameters with bayesian
   
   if(!cluster){
@@ -1210,14 +1341,13 @@ void AliEMCALRecoUtils::RecalculateClusterPID(AliVCluster * cluster){
     return;
   }
   
-       if ( cluster->GetM02() != 0)
+  if ( cluster->GetM02() != 0)
     fPIDUtils->ComputePID(cluster->E(),cluster->GetM02());
   
   Float_t pidlist[AliPID::kSPECIESN+1];
        for(Int_t i = 0; i < AliPID::kSPECIESN+1; i++) pidlist[i] = fPIDUtils->GetPIDFinal(i);
-  
+        
   cluster->SetPID(pidlist);
-       
 }
 
 //____________________________________________________________________________
@@ -1266,12 +1396,10 @@ void AliEMCALRecoUtils::RecalculateClusterShowerShapeParameters(AliEMCALGeometry
     fraction  = cluster->GetCellAmplitudeFraction(iDigit);
     if(fraction < 1e-4) fraction = 1.; // in case unfolding is off
     
-    if(!fCellsRecalibrated){
-      
+    if (!fCellsRecalibrated){
       if(IsRecalibrationOn()) {
         recalFactor = GetEMCALChannelRecalibrationFactor(iSupMod,ieta,iphi);
       }
-      
     }
     
     eCell  = cells->GetCellAmplitude(cluster->GetCellAbsId(iDigit))*fraction*recalFactor;
@@ -1292,8 +1420,7 @@ void AliEMCALRecoUtils::RecalculateClusterShowerShapeParameters(AliEMCALGeometry
         zmean+= w * phii ; 
         dxz  += w * etai * phii ; 
       }
-    }
-    else
+    } else
       AliError(Form("Wrong energy %f and/or amplitude %f\n", eCell, cluster->E()));
   }//cell loop
   
@@ -1315,7 +1442,7 @@ void AliEMCALRecoUtils::RecalculateClusterShowerShapeParameters(AliEMCALGeometry
     //Get the cell energy, if recalibration is on, apply factors
     fraction  = cluster->GetCellAmplitudeFraction(iDigit);
     if(fraction < 1e-4) fraction = 1.; // in case unfolding is off
-    if(IsRecalibrationOn()) {
+    if (IsRecalibrationOn()) {
       recalFactor = GetEMCALChannelRecalibrationFactor(iSupMod,ieta,iphi);
     }
     eCell  = cells->GetCellAmplitude(cluster->GetCellAbsId(iDigit))*fraction*recalFactor;
@@ -1364,19 +1491,40 @@ void AliEMCALRecoUtils::FindMatches(AliVEvent *event,TObjArray * clusterArr,  Al
   //Given the input event, loop over all the tracks, select the closest cluster as matched with fCutR
   //Store matched cluster indexes and residuals
   
-  fMatchedTrackIndex->Reset();
+  fMatchedTrackIndex  ->Reset();
   fMatchedClusterIndex->Reset();
   fResidualPhi->Reset();
   fResidualEta->Reset();
   
-  fMatchedTrackIndex->Set(500);
-  fMatchedClusterIndex->Set(500);
-  fResidualPhi->Set(500);
-  fResidualEta->Set(500);
+  fMatchedTrackIndex  ->Set(1000);
+  fMatchedClusterIndex->Set(1000);
+  fResidualPhi->Set(1000);
+  fResidualEta->Set(1000);
   
   AliESDEvent* esdevent = dynamic_cast<AliESDEvent*> (event);
   AliAODEvent* aodevent = dynamic_cast<AliAODEvent*> (event);
-
+  
+  // init the magnetic field if not already on
+  if(!TGeoGlobalMagField::Instance()->GetField()){
+    AliInfo("Init the magnetic field\n");
+    if     (esdevent) 
+    {
+      esdevent->InitMagneticField();
+    }
+    else if(aodevent)
+    {
+      Double_t curSol = 30000*aodevent->GetMagneticField()/5.00668;
+      Double_t curDip = 6000 *aodevent->GetMuonMagFieldScale();
+      AliMagF *field  = AliMagF::CreateFieldMap(curSol,curDip);
+      TGeoGlobalMagField::Instance()->SetField(field);
+    }
+    else
+    {
+      AliInfo("Mag Field not initialized, null esd/aod evetn pointers");
+    }
+    
+  } // Init mag field
+  
   TObjArray *clusterArray = 0x0;
   if(!clusterArr)
     {
@@ -1588,11 +1736,16 @@ Int_t  AliEMCALRecoUtils::FindMatchedClusterInClusterArr(AliExternalTrackParam *
   return index;
 }
 
-//
-//------------------------------------------------------------------------------
-//
-Bool_t AliEMCALRecoUtils::ExtrapolateTrackToEMCalSurface(AliExternalTrackParam *trkParam, Double_t emcalR, Double_t mass, Double_t step, Float_t &eta, Float_t &phi)
+//------------------------------------------------------------------------------------
+Bool_t AliEMCALRecoUtils::ExtrapolateTrackToEMCalSurface(AliExternalTrackParam *trkParam, 
+                                                         Double_t emcalR,
+                                                         Double_t mass, 
+                                                         Double_t step, 
+                                                         Float_t &eta, 
+                                                         Float_t &phi)
 {
+  //Extrapolate track to EMCAL surface
+  
   eta = -999, phi = -999;
   if(!trkParam) return kFALSE;
   if(!AliTrackerBase::PropagateTrackToBxByBz(trkParam, emcalR, mass, step, kTRUE, 0.8, -1)) return kFALSE;
@@ -1607,11 +1760,13 @@ Bool_t AliEMCALRecoUtils::ExtrapolateTrackToEMCalSurface(AliExternalTrackParam *
   return kTRUE;
 }
 
-
-//
-//------------------------------------------------------------------------------
-//
-Bool_t AliEMCALRecoUtils::ExtrapolateTrackToPosition(AliExternalTrackParam *trkParam, Float_t *clsPos, Double_t mass, Double_t step, Float_t &tmpEta, Float_t &tmpPhi)
+//-----------------------------------------------------------------------------------
+Bool_t AliEMCALRecoUtils::ExtrapolateTrackToPosition(AliExternalTrackParam *trkParam, 
+                                                     const Float_t *clsPos, 
+                                                     Double_t mass, 
+                                                     Double_t step, 
+                                                     Float_t &tmpEta, 
+                                                     Float_t &tmpPhi)
 {
   //
   //Return the residual by extrapolating a track param to a global position
@@ -1636,10 +1791,13 @@ Bool_t AliEMCALRecoUtils::ExtrapolateTrackToPosition(AliExternalTrackParam *trkP
   return kTRUE;
 }
 
-
-//
-//------------------------------------------------------------------------------
-Bool_t AliEMCALRecoUtils::ExtrapolateTrackToCluster(AliExternalTrackParam *trkParam, AliVCluster *cluster, Double_t mass, Double_t step, Float_t &tmpEta, Float_t &tmpPhi)
+//----------------------------------------------------------------------------------
+Bool_t AliEMCALRecoUtils::ExtrapolateTrackToCluster(AliExternalTrackParam *trkParam, 
+                                                    AliVCluster *cluster, 
+                                                    Double_t mass, 
+                                                    Double_t step, 
+                                                    Float_t &tmpEta, 
+                                                    Float_t &tmpPhi)
 {
   //
   //Return the residual by extrapolating a track param to a cluster
@@ -1654,9 +1812,11 @@ Bool_t AliEMCALRecoUtils::ExtrapolateTrackToCluster(AliExternalTrackParam *trkPa
   return ExtrapolateTrackToPosition(trkParam, clsPos, mass, step, tmpEta, tmpPhi);
 }
 
-//
-//------------------------------------------------------------------------------
-Bool_t AliEMCALRecoUtils::ExtrapolateTrackToCluster(AliExternalTrackParam *trkParam, AliVCluster *cluster, Float_t &tmpEta, Float_t &tmpPhi)
+//---------------------------------------------------------------------------------
+Bool_t AliEMCALRecoUtils::ExtrapolateTrackToCluster(AliExternalTrackParam *trkParam, 
+                                                    AliVCluster *cluster, 
+                                                    Float_t &tmpEta, 
+                                                    Float_t &tmpPhi)
 {
   //
   //Return the residual by extrapolating a track param to a clusterfStepCluster
@@ -1665,8 +1825,7 @@ Bool_t AliEMCALRecoUtils::ExtrapolateTrackToCluster(AliExternalTrackParam *trkPa
   return ExtrapolateTrackToCluster(trkParam, cluster, fMass, fStepCluster, tmpEta, tmpPhi);
 }
 
-
-//________________________________________________________________________________
+//_______________________________________________________________________________________
 void AliEMCALRecoUtils::GetMatchedResiduals(Int_t clsIndex, Float_t &dEta, Float_t &dPhi)
 {
   //Given a cluster index as in AliESDEvent::GetCaloCluster(clsIndex)
@@ -1683,7 +1842,8 @@ void AliEMCALRecoUtils::GetMatchedResiduals(Int_t clsIndex, Float_t &dEta, Float
   dEta = fResidualEta->At(FindMatchedPosForCluster(clsIndex));
   dPhi = fResidualPhi->At(FindMatchedPosForCluster(clsIndex));
 }
-//________________________________________________________________________________
+
+//______________________________________________________________________________________________
 void AliEMCALRecoUtils::GetMatchedClusterResiduals(Int_t trkIndex, Float_t &dEta, Float_t &dPhi)
 {
   //Given a track index as in AliESDEvent::GetTrack(trkIndex)
@@ -1757,18 +1917,15 @@ UInt_t AliEMCALRecoUtils::FindMatchedPosForCluster(Int_t clsIndex) const
   Float_t tmpR = fCutR;
   UInt_t pos = 999;
   
-  for(Int_t i=0; i<fMatchedClusterIndex->GetSize(); i++)
-  {
-    if(fMatchedClusterIndex->At(i)==clsIndex)
-      {
-       Float_t r = TMath::Sqrt(fResidualEta->At(i)*fResidualEta->At(i) + fResidualPhi->At(i)*fResidualPhi->At(i));
-       if(r<tmpR)
-         {
-           pos=i;
-           tmpR=r;
-           AliDebug(3,Form("Matched cluster index: index: %d, dEta: %2.4f, dPhi: %2.4f.\n",fMatchedClusterIndex->At(i),fResidualEta->At(i),fResidualPhi->At(i)));
-         }
+  for(Int_t i=0; i<fMatchedClusterIndex->GetSize(); i++) {
+    if(fMatchedClusterIndex->At(i)==clsIndex) {
+      Float_t r = TMath::Sqrt(fResidualEta->At(i)*fResidualEta->At(i) + fResidualPhi->At(i)*fResidualPhi->At(i));
+      if(r<tmpR) {
+        pos=i;
+        tmpR=r;
+        AliDebug(3,Form("Matched cluster index: index: %d, dEta: %2.4f, dPhi: %2.4f.\n",fMatchedClusterIndex->At(i),fResidualEta->At(i),fResidualPhi->At(i)));
       }
+    }
   }
   return pos;
 }
@@ -1781,33 +1938,35 @@ UInt_t AliEMCALRecoUtils::FindMatchedPosForTrack(Int_t trkIndex) const
   Float_t tmpR = fCutR;
   UInt_t pos = 999;
   
-  for(Int_t i=0; i<fMatchedTrackIndex->GetSize(); i++)
-  {
-    if(fMatchedTrackIndex->At(i)==trkIndex)
-      {
-       Float_t r = TMath::Sqrt(fResidualEta->At(i)*fResidualEta->At(i) + fResidualPhi->At(i)*fResidualPhi->At(i));
-       if(r<tmpR)
-         {
-           pos=i;
-           tmpR=r;
-           AliDebug(3,Form("Matched track index: index: %d, dEta: %2.4f, dPhi: %2.4f.\n",fMatchedTrackIndex->At(i),fResidualEta->At(i),fResidualPhi->At(i)));
-         }
+  for(Int_t i=0; i<fMatchedTrackIndex->GetSize(); i++) {
+    if(fMatchedTrackIndex->At(i)==trkIndex) {
+      Float_t r = TMath::Sqrt(fResidualEta->At(i)*fResidualEta->At(i) + fResidualPhi->At(i)*fResidualPhi->At(i));
+      if(r<tmpR) {
+        pos=i;
+        tmpR=r;
+        AliDebug(3,Form("Matched track index: index: %d, dEta: %2.4f, dPhi: %2.4f.\n",fMatchedTrackIndex->At(i),fResidualEta->At(i),fResidualPhi->At(i)));
       }
+    }
   }
   return pos;
 }
 
-//__________________________________________________________
-Bool_t AliEMCALRecoUtils::IsGoodCluster(AliVCluster *cluster, AliEMCALGeometry *geom, AliVCaloCells* cells)
+//___________________________________________________________________________________
+Bool_t AliEMCALRecoUtils::IsGoodCluster(AliVCluster *cluster, AliEMCALGeometry *geom, 
+                                        AliVCaloCells* cells,const Int_t bc)
 {
   // check if the cluster survives some quality cut
   //
   //
   Bool_t isGood=kTRUE;
-  if(!cluster || !cluster->IsEMCAL()) return kFALSE;
+  
+  if(!cluster || !cluster->IsEMCAL())              return kFALSE;
+  
   if(ClusterContainsBadChannel(geom,cluster->GetCellsAbsId(),cluster->GetNCells())) return kFALSE;
+  
   if(!CheckCellFiducialRegion(geom,cluster,cells)) return kFALSE;
-  if(fRejectExoticCluster && IsExoticCluster(cluster)) return kFALSE;
+  
+  if(IsExoticCluster(cluster, cells,bc))           return kFALSE;
 
   return isGood;
 }
@@ -1905,8 +2064,7 @@ Bool_t AliEMCALRecoUtils::IsAccepted(AliESDtrack *esdTrack)
     return kTRUE;
 }
 
-
-//__________________________________________________
+//_____________________________________
 void AliEMCALRecoUtils::InitTrackCuts()
 {
   //Intilize the track cut criteria
@@ -1914,54 +2072,124 @@ void AliEMCALRecoUtils::InitTrackCuts()
   //Also you can customize the cuts using the setters
   
   switch (fTrackCutsType)
-    {
+  {
     case kTPCOnlyCut:
-      {
-       AliInfo(Form("Track cuts for matching: GetStandardTPCOnlyTrackCuts()"));
-       //TPC
-       SetMinNClustersTPC(70);
-       SetMaxChi2PerClusterTPC(4);
-       SetAcceptKinkDaughters(kFALSE);
-       SetRequireTPCRefit(kFALSE);
-
-       //ITS
-       SetRequireITSRefit(kFALSE);
-       SetMaxDCAToVertexZ(3.2);
-       SetMaxDCAToVertexXY(2.4);
-       SetDCAToVertex2D(kTRUE);
-
-       break;
-      }
-    
+    {
+      AliInfo(Form("Track cuts for matching: GetStandardTPCOnlyTrackCuts()"));
+      //TPC
+      SetMinNClustersTPC(70);
+      SetMaxChi2PerClusterTPC(4);
+      SetAcceptKinkDaughters(kFALSE);
+      SetRequireTPCRefit(kFALSE);
+      
+      //ITS
+      SetRequireITSRefit(kFALSE);
+      SetMaxDCAToVertexZ(3.2);
+      SetMaxDCAToVertexXY(2.4);
+      SetDCAToVertex2D(kTRUE);
+      
+      break;
+    }
+      
     case kGlobalCut:
-      {
-       AliInfo(Form("Track cuts for matching: GetStandardITSTPCTrackCuts2010(kTURE)"));
-       //TPC
-       SetMinNClustersTPC(70);
-       SetMaxChi2PerClusterTPC(4);
-       SetAcceptKinkDaughters(kFALSE);
-       SetRequireTPCRefit(kTRUE);
-
-       //ITS
-       SetRequireITSRefit(kTRUE);
-       SetMaxDCAToVertexZ(2);
-       SetMaxDCAToVertexXY();
-       SetDCAToVertex2D(kFALSE);
-
-       break;
-      }
-
+    {
+      AliInfo(Form("Track cuts for matching: GetStandardITSTPCTrackCuts2010(kTURE)"));
+      //TPC
+      SetMinNClustersTPC(70);
+      SetMaxChi2PerClusterTPC(4);
+      SetAcceptKinkDaughters(kFALSE);
+      SetRequireTPCRefit(kTRUE);
+      
+      //ITS
+      SetRequireITSRefit(kTRUE);
+      SetMaxDCAToVertexZ(2);
+      SetMaxDCAToVertexXY();
+      SetDCAToVertex2D(kFALSE);
+      
+      break;
+    }
+      
     case kLooseCut:
-      {
-       AliInfo(Form("Track cuts for matching: Loose cut w/o DCA cut"));
-       SetMinNClustersTPC(50);
-       SetAcceptKinkDaughters(kTRUE);
+    {
+      AliInfo(Form("Track cuts for matching: Loose cut w/o DCA cut"));
+      SetMinNClustersTPC(50);
+      SetAcceptKinkDaughters(kTRUE);
+      
+      break;
+    }
+  }
+}
+
+
+//________________________________________________________________________
+void AliEMCALRecoUtils::SetClusterMatchedToTrack(const AliESDEvent *event)
+{
+  // Checks if tracks are matched to EMC clusters and set the matched EMCAL cluster index to ESD track. 
+  
+  Int_t nTracks = event->GetNumberOfTracks();
+  for (Int_t iTrack = 0; iTrack < nTracks; ++iTrack) {
+    AliESDtrack* track = event->GetTrack(iTrack);
+    if (!track) {
+      AliWarning(Form("Could not receive track %d", iTrack));
+      continue;
+    }
+    Int_t matchClusIndex = GetMatchedClusterIndex(iTrack);                
+    track->SetEMCALcluster(matchClusIndex); //sets -1 if track not matched within residual
+    if(matchClusIndex != -1) 
+      track->SetStatus(AliESDtrack::kEMCALmatch);
+    else
+      track->ResetStatus(AliESDtrack::kEMCALmatch);
+  }
+  AliDebug(2,"Track matched to closest cluster");      
+}
 
-       break;
+//_________________________________________________________________________
+void AliEMCALRecoUtils::SetTracksMatchedToCluster(const AliESDEvent *event)
+{
+  // Checks if EMC clusters are matched to ESD track.
+  // Adds track indexes of all the tracks matched to a cluster withing residuals in ESDCalocluster.
+  
+  for (Int_t iClus=0; iClus < event->GetNumberOfCaloClusters(); ++iClus) {
+    AliESDCaloCluster *cluster = event->GetCaloCluster(iClus);
+    if (!cluster->IsEMCAL()) 
+      continue;
+    
+    Int_t nTracks = event->GetNumberOfTracks();
+    TArrayI arrayTrackMatched(nTracks);
+    
+    // Get the closest track matched to the cluster
+    Int_t nMatched = 0;
+    Int_t matchTrackIndex = GetMatchedTrackIndex(iClus);
+    if (matchTrackIndex != -1) {
+      arrayTrackMatched[nMatched] = matchTrackIndex;
+      nMatched++;
+    }
+    
+    // Get all other tracks matched to the cluster
+    for(Int_t iTrk=0; iTrk<nTracks; ++iTrk) {
+      AliESDtrack* track = event->GetTrack(iTrk);
+      if(iTrk == matchTrackIndex) continue;
+      if(track->GetEMCALcluster() == iClus){
+        arrayTrackMatched[nMatched] = iTrk;
+        ++nMatched;
       }
     }
+    
+    //printf("Tender::SetTracksMatchedToCluster - cluster E %f, N matches %d, first match %d\n",cluster->E(),nMatched,arrayTrackMatched[0]);
+    
+    arrayTrackMatched.Set(nMatched);
+    cluster->AddTracksMatched(arrayTrackMatched);
+    
+    Float_t eta= -999, phi = -999;
+    if (matchTrackIndex != -1) 
+      GetMatchedResiduals(iClus, eta, phi);
+    cluster->SetTrackDistance(phi, eta);
+  }
+  
+  AliDebug(2,"Cluster matched to tracks");     
 }
 
+
 //___________________________________________________
 void AliEMCALRecoUtils::Print(const Option_t *) const 
 {
@@ -2005,11 +2233,11 @@ void AliEMCALRecoUtils::Print(const Option_t *) const
   printf("MinNCulsterTPC = %d, MinNClusterITS = %d\n",fCutMinNClusterTPC,fCutMinNClusterITS);
   printf("MaxChi2TPC = %2.2f, MaxChi2ITS = %2.2f\n",fCutMaxChi2PerClusterTPC,fCutMaxChi2PerClusterITS);
   printf("DCSToVertex2D = %d, MaxDCAToVertexXY = %2.2f, MaxDCAToVertexZ = %2.2f\n",fCutDCAToVertex2D,fCutMaxDCAToVertexXY,fCutMaxDCAToVertexZ);
-
 }
 
 //_____________________________________________________________________
-void AliEMCALRecoUtils::SetRunDependentCorrections(Int_t runnumber){
+void AliEMCALRecoUtils::SetRunDependentCorrections(Int_t runnumber)
+{
   //Get EMCAL time dependent corrections from file and put them in the recalibration histograms
   //Do it only once and only if it is requested
   
@@ -2034,6 +2262,5 @@ void AliEMCALRecoUtils::SetRunDependentCorrections(Int_t runnumber){
       }
     }
   }
-   fRunCorrectionFactorsSet = kTRUE;
+  fRunCorrectionFactorsSet = kTRUE;
 }
-