ROOT logo
/***************************************************************************
 * Copyright(c) 1998-1999, 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.                  *
 **************************************************************************/

/*
$Log: AliTOFClusterFinderV1.cxx,v $
Revision 2009/04/20 A. De Caro
    - added two new global variables, called fTOFGeometry and fTOFdigits;
    - added a new method, called FindClustersWithoutTOT,
      to transform TOF digits with fTOT=0 in one pad clusters;
    - update of the covariance matrix elements for the TOF clusters

Revision 0.01  2008/05/10 A. De Caro
 */

/////////////////////////////////////////
//                                     //
//  Class for TOF cluster finder (V1)  //
//                                     //
//  Input data: Raw Data or Digits;    //
//  Output data: Digits or Rec Points  //
//                                     //
/////////////////////////////////////////

#include "Riostream.h"

#include "TClonesArray.h"
#include "TStopwatch.h"
#include "TTree.h"
#include "TGeoMatrix.h"
#include "TString.h"

#include "AliDAQ.h"
#include "AliLog.h"
#include "AliRawReader.h"
#include "AliLoader.h"
#include "AliRunLoader.h"
#include "AliGeomManager.h"

#include "AliTOFcalib.h"
#include "AliTOFChannelOnlineArray.h"
#include "AliTOFChannelOnlineStatusArray.h"
#include "AliTOFChannelOffline.h"
#include "AliTOFClusterFinderV1.h"
#include "AliTOFcluster.h"
#include "AliTOFdigit.h"
#include "AliTOFDigitMap.h"
#include "AliTOFrawData.h"
#include "AliTOFReconstructor.h"
#include "AliTOFRecoParam.h"

using std::endl;
using std::cout;
using std::ofstream;
using std::ios;
ClassImp(AliTOFClusterFinderV1)

//_____________________________________________________________________________
AliTOFClusterFinderV1::AliTOFClusterFinderV1(AliTOFcalib *calib):
  TTask("AliTOFClusterFinderV1",""),
  fRunLoader(0),
  fDigits(new TClonesArray("AliTOFdigit", 4000)),
  fRecPoints(new TClonesArray("AliTOFcluster", 4000)),
  fNumberOfTofClusters(0),
  fNumberOfTofDigits(0),
  fNumberOfTofTrgPads(0),
  fkRecoParam(0),//AliTOFReconstructor::GetRecoParam()),
  fMaxDeltaTime(0),//fkRecoParam->GetMaxDeltaTime()),
  fVerbose(0),
  fDecoderVersion(0),
  fTOFcalib(calib),
  fTOFdigitMap(new AliTOFDigitMap()),
  fTOFGeometry(new AliTOFGeometry()),
  fTOFdigits(new TTree()),
  fTOFRawStream(AliTOFRawStream()),
  fCalibrateTOFtimes(1)
{
//
// Constructor
//

  for (Int_t ii=0; ii<kTofMaxCluster; ii++) fTofClusters[ii]=0x0;

  if (AliTOFReconstructor::GetRecoParam()) {
    fkRecoParam = AliTOFReconstructor::GetRecoParam();
    fMaxDeltaTime = fkRecoParam->GetMaxDeltaTime();
  }
  else
    fMaxDeltaTime = 2;

  TString validity = (TString)fTOFcalib->GetOfflineValidity();
  if (validity.CompareTo("valid")==0) {
    AliInfo(Form(" validity = %s - Using offline calibration parameters", validity.Data()));
  } else {
    AliInfo(Form(" validity = %s - Using online calibration parameters", validity.Data()));
  }

}

//_____________________________________________________________________________
AliTOFClusterFinderV1::AliTOFClusterFinderV1(AliRunLoader* runLoader, AliTOFcalib *calib):
  TTask("AliTOFClusterFinderV1",""),
  fRunLoader(runLoader),
  fDigits(new TClonesArray("AliTOFdigit", 4000)),
  fRecPoints(new TClonesArray("AliTOFcluster", 4000)),
  fNumberOfTofClusters(0),
  fNumberOfTofDigits(0),
  fNumberOfTofTrgPads(0),
  fkRecoParam(0),//AliTOFReconstructor::GetRecoParam()),
  fMaxDeltaTime(0),//fkRecoParam->GetMaxDeltaTime()),
  fVerbose(0),
  fDecoderVersion(0),
  fTOFcalib(calib),
  fTOFdigitMap(new AliTOFDigitMap()),
  fTOFGeometry(new AliTOFGeometry()),
  fTOFdigits(new TTree()),
  fTOFRawStream(AliTOFRawStream()),
  fCalibrateTOFtimes(1)
{
//
// Constructor
//

  for (Int_t ii=0; ii<kTofMaxCluster; ii++) fTofClusters[ii]=0x0;

  if (AliTOFReconstructor::GetRecoParam()) {
    fkRecoParam = AliTOFReconstructor::GetRecoParam();
    fMaxDeltaTime = fkRecoParam->GetMaxDeltaTime();
  }
  else
    fMaxDeltaTime = 2;

  TString validity = (TString)fTOFcalib->GetOfflineValidity();
  if (validity.CompareTo("valid")==0) {
    AliInfo(Form(" validity = %s - Using offline calibration parameters", validity.Data()));
  } else {
    AliInfo(Form(" validity = %s - Using online calibration parameters", validity.Data()));
  }

}
//_____________________________________________________________________________

AliTOFClusterFinderV1::AliTOFClusterFinderV1(const AliTOFClusterFinderV1 &source)
  :TTask(source),
   fRunLoader(0),
   fDigits(source.fDigits),
   fRecPoints(source.fRecPoints),
   fNumberOfTofClusters(0),
   fNumberOfTofDigits(0),
   fNumberOfTofTrgPads(0),
   fkRecoParam(0),//AliTOFReconstructor::GetRecoParam()),
   fMaxDeltaTime(0),//fkRecoParam->GetMaxDeltaTime()),
   fVerbose(0),
   fDecoderVersion(source.fDecoderVersion),
   fTOFcalib(source.fTOFcalib),
   fTOFdigitMap(new AliTOFDigitMap()),
   fTOFGeometry(new AliTOFGeometry()),
   fTOFdigits(source.fTOFdigits),
   fTOFRawStream(source.fTOFRawStream),
   fCalibrateTOFtimes(1)
{
  // copy constructor

  for (Int_t ii=0; ii<kTofMaxCluster; ii++) fTofClusters[ii]=source.fTofClusters[ii];

  if (AliTOFReconstructor::GetRecoParam()) {
    fkRecoParam = AliTOFReconstructor::GetRecoParam();
    fMaxDeltaTime = fkRecoParam->GetMaxDeltaTime();
  }
  else
    fMaxDeltaTime = 2;

}
//_____________________________________________________________________________

AliTOFClusterFinderV1& AliTOFClusterFinderV1::operator=(const AliTOFClusterFinderV1 &source)
{
  // ass. op.

  if (this == &source)
    return *this;

  TObject::operator=(source);
  for (Int_t ii=0; ii<kTofMaxCluster; ii++) fTofClusters[ii]=source.fTofClusters[ii];
  fDigits=source.fDigits;
  fRecPoints=source.fRecPoints;
  fNumberOfTofClusters=source.fNumberOfTofClusters;
  fNumberOfTofTrgPads=source.fNumberOfTofTrgPads;
  fNumberOfTofDigits=source.fNumberOfTofDigits;
  fVerbose=source.fVerbose;
  fDecoderVersion=source.fDecoderVersion;
  fTOFcalib=source.fTOFcalib;
  fTOFdigitMap=source.fTOFdigitMap;
  fTOFGeometry=source.fTOFGeometry;
  fTOFdigits=source.fTOFdigits;
  fTOFRawStream=source.fTOFRawStream;
  fCalibrateTOFtimes=source.fCalibrateTOFtimes;
  return *this;

}
//_____________________________________________________________________________

AliTOFClusterFinderV1::~AliTOFClusterFinderV1()
{

  //
  // Destructor
  //

  if (fDigits)
    {
      fDigits->Delete();
      delete fDigits;
      fDigits=0;
    }
  if (fRecPoints)
    {
      fRecPoints->Delete();
      delete fRecPoints;
      fRecPoints=0;
    }

  delete fTOFdigitMap;

  delete fTOFGeometry;

  delete fTOFdigits;

  //if (fTofClusters || fNumberOfTofClusters) {
  if (fNumberOfTofClusters) {
    for (Int_t ii=0; ii<fNumberOfTofClusters; ii++)
      if (fTofClusters[ii]) fTofClusters[ii]->Delete();
    fNumberOfTofClusters = 0;
  }

}
//_____________________________________________________________________________

void AliTOFClusterFinderV1::Digits2RecPoints(TTree* digitsTree, TTree* clusterTree)
{
  //
  // Converts digits to recPoints for TOF
  //

  TStopwatch stopwatch;
  stopwatch.Start();

  Int_t inholes = 0;

  ResetRecpoint();

  fDigits->Clear();
  TClonesArray &aDigits = *fDigits;

  if (digitsTree == 0x0) {
    AliFatal("Can not get TreeD for TOF");
    return;
  }

  TBranch *branch = digitsTree->GetBranch("TOF");
  if (!branch) {
    AliError("Can not get branch with the TOF digits !");
    return;
  }

  TClonesArray staticDigits("AliTOFdigit",10000);
  staticDigits.Clear();
  TClonesArray *digits = &staticDigits;
  branch->SetAddress(&digits);
  digitsTree->GetEvent(0);
  AliDebug(1,Form("Number of TOF digits: %d", digits->GetEntriesFast()));

  AliTOFdigit *tofDigit;

  Int_t jj = 0;
  Int_t detectorIndex[5];
  for (jj=0; jj<5; jj++) detectorIndex[jj] = -1;
  Int_t info[4];
  for (jj=0; jj<4; jj++) info[jj] = -1;
  Int_t *tracks;
  Int_t tdcCorr;
  Int_t dummy = -1;
  Int_t last = -1;

  Bool_t status = kTRUE;

  AliDebug(1," Calibrating TOF Digits");
  /*
  TString validity = (TString)fTOFcalib->GetOfflineValidity();
  if (validity.CompareTo("valid")==0) {
    AliInfo(Form(" validity = %s - Using offline calibration parameters", validity.Data()));
  } else
    AliInfo(Form(" validity = %s - Using online calibration parameters", validity.Data()));
  */

  Int_t ii = 0;
  for (ii=0; ii<digits->GetEntriesFast(); ii++) {
    tofDigit = (AliTOFdigit*)digits->UncheckedAt(ii);
    detectorIndex[0] = tofDigit->GetSector();
    detectorIndex[1] = tofDigit->GetPlate();
    detectorIndex[2] = tofDigit->GetStrip();
    detectorIndex[3] = tofDigit->GetPadz();
    detectorIndex[4] = tofDigit->GetPadx();

    if (detectorIndex[0]==13 || detectorIndex[0]==14 || detectorIndex[0]==15 ) { // sectors with holes
      if (detectorIndex[1]==2) { // plate with holes
	inholes++;
	continue;
      }
    }

    tdcCorr = tofDigit->GetTdc();
    status = MakeSlewingCorrection(detectorIndex, tofDigit->GetToT(), tofDigit->GetTdc(), tdcCorr);

    for (jj=0; jj<4; jj++) info[jj] = -1;
    info[0] = tdcCorr;//tofDigit->GetTdc();
    info[1] = tofDigit->GetAdc();
    info[2] = tofDigit->GetToT();
    info[3] = tofDigit->GetTdcND();//tofDigit->GetTdc();//
    tracks  = tofDigit->GetTracks();

    dummy = detectorIndex[3];
    detectorIndex[3] = detectorIndex[4];//padx
    detectorIndex[4] = dummy;//padz
    last = fDigits->GetEntriesFast();
    new (aDigits[last]) AliTOFdigit(tracks, detectorIndex, info);
    if (status) fTOFdigitMap->AddDigit(detectorIndex, last);

    AliDebug(2, Form(" Digits reading %2d -> %2d %1d %2d %1d %2d (%d, %d, %d)",
		     last,
		     detectorIndex[0], detectorIndex[1], detectorIndex[2], detectorIndex[3], detectorIndex[4],
		     info[0], info[1], info[3]));

  }

  fNumberOfTofDigits = fDigits->GetEntriesFast();

  ResetRecpoint();

  Int_t bufsize = 32000;
  clusterTree->Branch("TOF", &fRecPoints, bufsize);

  FillRecPoint();
  clusterTree->Fill();

  AliDebug(1,Form("Number of found clusters: %d", fNumberOfTofClusters));

//  ResetRecpoint();

  fTOFdigitMap->Clear();

  ResetDigits();

  AliDebug(1,Form("Execution time to read TOF digits and to write TOF clusters : R:%.4fs C:%.4fs",
		  stopwatch.RealTime(),stopwatch.CpuTime()));

  if (inholes) AliWarning(Form("Clusters in the TOF holes: %d",inholes));

}
//_____________________________________________________________________________

void AliTOFClusterFinderV1::Digits2RecPoints(AliRawReader *rawReader, TTree *clustersTree)
{
  //
  // Converts raw data to recPoints for TOF
  //

  TStopwatch stopwatch;
  stopwatch.Start();

  ResetRecpoint();

  AliDebug(2, "TreeD re-creation");
  //TTree *digitsTree = new TTree();
  //Raw2Digits(rawReader, digitsTree);

  Raw2Digits(rawReader, fTOFdigits);

  AliDebug(1,Form("Number of TOF digits: %d", fNumberOfTofDigits));
  ResetRecpoint();

  Int_t bufsize = 32000;
  clustersTree->Branch("TOF", &fRecPoints, bufsize);
  FillRecPoint();

  clustersTree->Fill();

  AliDebug(1,Form("Number of found clusters: %d", fNumberOfTofClusters));

//  ResetRecpoint();

  fTOFdigitMap->Clear();

  ResetDigits();

  AliDebug(1,Form("Execution time to read TOF raw data and to write TOF clusters : R:%.4fs C:%.4fs",
		  stopwatch.RealTime(),stopwatch.CpuTime()));

}

//_____________________________________________________________________________

void AliTOFClusterFinderV1::Raw2Digits(AliRawReader *rawReader, TTree* digitsTree)
{
  //
  // Converts raw data to digits for TOF
  //

  TStopwatch stopwatch;
  stopwatch.Start();

  Int_t inholes = 0;

  const Int_t kMaxNumberOfTracksPerDigit = 3;
  const Int_t kDDL = AliDAQ::NumberOfDdls("TOF");

  digitsTree->Branch("TOF", &fDigits);
  TClonesArray &aDigits = *fDigits;

  fTOFRawStream.Clear();
  fTOFRawStream.SetRawReader(rawReader);

  ofstream ftxt;
  if (fVerbose==2) ftxt.open("TOFdigitsRead.txt",ios::app);

  TClonesArray staticRawData("AliTOFrawData",10000);
  staticRawData.Clear();
  TClonesArray * clonesRawData = &staticRawData;

  Int_t dummy = -1;
  Int_t detectorIndex[5] = {-1, -1, -1, -1, -1};
  Int_t digit[4];
  Int_t tracks[kMaxNumberOfTracksPerDigit];
  for (Int_t ii=0; ii<kMaxNumberOfTracksPerDigit; ii++)
    tracks[ii] = -1;
  Int_t last = -1;
  Int_t tdcCorr = 0;

  Bool_t status = kTRUE;

  /*
  TString validity = (TString)fTOFcalib->GetOfflineValidity();
  if (validity.CompareTo("valid")==0) {
    AliInfo(Form(" validity = %s - Using offline calibration parameters", validity.Data()));
  } else
    AliInfo(Form(" validity = %s - Using online calibration parameters", validity.Data()));
  */

  if (fDecoderVersion)
    AliInfo("Using New Decoder");

  Int_t indexDDL = 0;
  Int_t iRawData = 0;
  for (indexDDL=0; indexDDL<kDDL; indexDDL++) {

    rawReader->Reset();
    if (fDecoderVersion)
      fTOFRawStream.LoadRawDataBuffers(indexDDL,fVerbose);
    else fTOFRawStream.LoadRawData(indexDDL);

    clonesRawData = (TClonesArray*)fTOFRawStream.GetRawData();
    if (clonesRawData->GetEntriesFast()!=0) AliDebug(2,Form(" TOF raw data number = %3d", clonesRawData->GetEntriesFast()));
    for (iRawData = 0; iRawData<clonesRawData->GetEntriesFast(); iRawData++) {

      AliTOFrawData *tofRawDatum = (AliTOFrawData*)clonesRawData->UncheckedAt(iRawData);

      //if (tofRawDatum->GetTOT()==-1 || tofRawDatum->GetTOF()==-1) continue;
      if (tofRawDatum->GetTOF()==-1) continue;

      fTOFRawStream.EquipmentId2VolumeId(indexDDL, tofRawDatum->GetTRM(), tofRawDatum->GetTRMchain(),
					 tofRawDatum->GetTDC(), tofRawDatum->GetTDCchannel(), detectorIndex);

      tdcCorr = 0;
      dummy = detectorIndex[3];
      detectorIndex[3] = detectorIndex[4];//padz
      detectorIndex[4] = dummy;//padx

      tdcCorr = tofRawDatum->GetTOF();
      status = MakeSlewingCorrection(detectorIndex, tofRawDatum->GetTOT(), tofRawDatum->GetTOF(), tdcCorr);

      digit[0] = tdcCorr;
      digit[1] = tofRawDatum->GetTOT();
      digit[2] = tofRawDatum->GetTOT();
      digit[3] = -1;//tofRawDatum->GetTOF(); //tofND

      // noferini
      Float_t pos[3];
      AliTOFGeometry::GetPosPar(detectorIndex, pos);
      Float_t length = 0.;
      for (Int_t ic = 0; ic < 3; ic++) length += pos[ic] * pos[ic];
      length = TMath::Sqrt(length);
      Float_t timealligned = tdcCorr*24.4 - length * 0.0333564095198152043; // subtract the minimal time in
      
      if(status &&  timealligned > -1000 && timealligned < 24000){
	fNumberOfTofTrgPads++;
      }

      dummy = detectorIndex[3];
      detectorIndex[3] = detectorIndex[4];//padx
      detectorIndex[4] = dummy;//padz

      /* check valid index */
      if (detectorIndex[0]==-1||detectorIndex[1]==-1||detectorIndex[2]==-1||detectorIndex[3]==-1||detectorIndex[4]==-1) continue;

      // Do not reconstruct anything in the holes
      if (detectorIndex[0]==13 || detectorIndex[0]==14 || detectorIndex[0]==15 ) { // sectors with holes
	if (detectorIndex[1]==2) { // plate with holes
	  inholes++;
	  continue;
	}
      }

      last = fDigits->GetEntriesFast();
      new (aDigits[last]) AliTOFdigit(tracks, detectorIndex, digit);
      if (status) fTOFdigitMap->AddDigit(detectorIndex, last);
      

      if (fVerbose==2) {
	if (indexDDL<10) ftxt << "  " << indexDDL;
	else         ftxt << " " << indexDDL;
	if (tofRawDatum->GetTRM()<10) ftxt << "  " << tofRawDatum->GetTRM();
	else         ftxt << " " << tofRawDatum->GetTRM();
	ftxt << "  " << tofRawDatum->GetTRMchain();
	if (tofRawDatum->GetTDC()<10) ftxt << "  " << tofRawDatum->GetTDC();
	else         ftxt << " " << tofRawDatum->GetTDC();
	ftxt << "  " << tofRawDatum->GetTDCchannel();

	if (detectorIndex[0]<10) ftxt  << "  ->  " << detectorIndex[0];
	else              ftxt  << "  -> " << detectorIndex[0];
	ftxt << "  " << detectorIndex[1];
	if (detectorIndex[2]<10) ftxt << "  " << detectorIndex[2];
	else              ftxt << " " << detectorIndex[2];
	ftxt << "  " << detectorIndex[4];
	if (detectorIndex[4]<10) ftxt << "  " << detectorIndex[3];
	else              ftxt << " " << detectorIndex[3];

	if (digit[1]<10)ftxt << "        " << digit[1];
	else if (digit[1]>=10 && digit[1]<100) ftxt << "      " << digit[1];
	else ftxt << "      " << digit[1];
	if (digit[0]<10) ftxt << "      " << digit[0] << endl;
	else if (digit[0]>=10 && digit[0]<100)   ftxt << "    " << digit[0] << endl;
	else if (digit[0]>=100 && digit[0]<1000) ftxt << "    " << digit[0] << endl;
	else ftxt << "   " << digit[3] << endl;
      }

      AliDebug(2, Form(" Raw data reading %2d -> %2d %1d %2d %1d %2d (%d, %d, %d)",
		       last,
		       detectorIndex[0], detectorIndex[1], detectorIndex[2], detectorIndex[4], detectorIndex[3],
		       digit[0], digit[1], digit[3]));

    } // while loop

    clonesRawData->Clear();

  } // DDL Loop

  if (fVerbose==2) ftxt.close();

  digitsTree->Fill();

  fNumberOfTofDigits = fDigits->GetEntries();

  AliDebug(1, Form("Got %d TOF digits", fNumberOfTofDigits));
  AliDebug(1, Form("Execution time to read TOF raw data and fill TOF digit tree : R:%.2fs C:%.2fs",
		   stopwatch.RealTime(),stopwatch.CpuTime()));

  if (inholes) AliWarning(Form("Clusters in the TOF holes: %d",inholes));

}
//_____________________________________________________________________________

void AliTOFClusterFinderV1::FillRecPoint()
{
  //
  // Fill the global TClonesArray of AliTOFcluster objects,
  // i.e. fRecPoints
  //

  Int_t dummy4 = -1;
  Int_t dummy3 = -1;
  Int_t dummy2 = -1;
  Int_t dummy  = -1;

  for(Int_t iPlate=AliTOFGeometry::NPlates()-1; iPlate>=0; iPlate--) {
    for(Int_t iStrip=AliTOFGeometry::NStrip(iPlate)-1; iStrip>=0; iStrip--) {
      //for (Int_t iSector=AliTOFGeometry::NSectors()-1; iSector>=0; iSector--) {
      for (Int_t iSector=0; iSector<AliTOFGeometry::NSectors(); iSector++) {


	if (fTOFdigitMap->StripDigitCheck(iSector,iPlate,iStrip))
	  AliDebug(1,Form(" Number of TOF digits in (%2d,%1d,%2d) -> %d",
			  iSector,iPlate,iStrip,fTOFdigitMap->FilledCellsInStrip(iSector,iPlate,iStrip)));

	if (!(fTOFdigitMap->StripDigitCheck(iSector,iPlate,iStrip))) continue;
	FindClustersWithoutTOT(iSector, iPlate, iStrip); // clusters coming from digits without TOT measurement

	if (fMaxDeltaTime>0) {

	  if (!(fTOFdigitMap->StripDigitCheck(iSector,iPlate,iStrip))) continue;
	  //if (fTOFdigitMap->FilledCellsInStrip(iSector,iPlate,iStrip)>=4)
	  FindClustersPerStrip(iSector, iPlate, iStrip, 4); // 4 pads clusters
	  if (!(fTOFdigitMap->StripDigitCheck(iSector,iPlate,iStrip))) continue;

	  dummy4 = fNumberOfTofClusters;
	  FindClustersPerStrip(iSector, iPlate, iStrip, 4); // 4 pads clusters
	  if (fNumberOfTofClusters!=dummy4)
	    AliDebug(2, Form(" (4): n1= %5d, n2 = %5d", dummy4, fNumberOfTofClusters));


	  if (!(fTOFdigitMap->StripDigitCheck(iSector,iPlate,iStrip))) continue;
	  FindClustersPerStrip(iSector, iPlate, iStrip, 3); // 3 pads clusters
	  if (!(fTOFdigitMap->StripDigitCheck(iSector,iPlate,iStrip))) continue;

	  dummy3 = fNumberOfTofClusters;
	  FindClustersPerStrip(iSector, iPlate, iStrip, 3); // 3 pads clusters
	  if (fNumberOfTofClusters!=dummy3)
	    AliDebug(2, Form(" (3): n1= %5d, n2 = %5d", dummy3, fNumberOfTofClusters));


	  if (!(fTOFdigitMap->StripDigitCheck(iSector,iPlate,iStrip))) continue;
	  FindClustersPerStrip(iSector, iPlate, iStrip, 2); // 2 pads clusters
	  if (!(fTOFdigitMap->StripDigitCheck(iSector,iPlate,iStrip))) continue;

	  dummy2 = fNumberOfTofClusters;
	  FindClustersPerStrip(iSector, iPlate, iStrip, 2); // 2 pads clusters
	  if (fNumberOfTofClusters!=dummy2)
	    AliDebug(2, Form(" (2): n1= %5d, n2 =%5d", dummy2, fNumberOfTofClusters));


	  if (!(fTOFdigitMap->StripDigitCheck(iSector,iPlate,iStrip))) continue;
	  dummy = fNumberOfTofClusters;
	  FindClusters34(iSector, iPlate, iStrip); // 3 pads clusters between 4 hit pads
	  if (fNumberOfTofClusters!=dummy)
	    AliDebug(2, Form(" (3 between 4): n1 = %5d, n2 = %5d", fNumberOfTofClusters, dummy));


	  if (!(fTOFdigitMap->StripDigitCheck(iSector,iPlate,iStrip))) continue;
	  dummy = fNumberOfTofClusters;
	  FindClusters23(iSector, iPlate, iStrip); // 2 pads clusters between 3 hit pads
	  if (fNumberOfTofClusters!=dummy)
	    AliDebug(2, Form(" (2 between 3): n1 = %5d, n2 = %5d", fNumberOfTofClusters, dummy));

	  if (!(fTOFdigitMap->StripDigitCheck(iSector,iPlate,iStrip))) continue;
	  dummy = fNumberOfTofClusters;
	  FindClusters24(iSector, iPlate, iStrip); // 2 pads clusters between 4 hit pads
	  if (fNumberOfTofClusters!=dummy)
	    AliDebug(2, Form(" (2 between 4): n1 = %5d, n2 = %5d", fNumberOfTofClusters, dummy));


	  if (!(fTOFdigitMap->StripDigitCheck(iSector,iPlate,iStrip))) continue;
	  dummy = fNumberOfTofClusters;
	  FindOnePadClusterPerStrip(iSector, iPlate, iStrip); // 1 pad clusters
	  if (fNumberOfTofClusters!=dummy)
	    AliDebug(2,Form(" (1): n1 = %5d, n2 = %5d", fNumberOfTofClusters, dummy));

	  if (fTOFdigitMap->DigitInStrip(iSector,iPlate,iStrip)>0)
	    AliDebug(2, Form(" (1): number of clusters = %5d (remaining digit %2d), -%2d %1d %2d-",
			     fNumberOfTofClusters, fTOFdigitMap->DigitInStrip(iSector,iPlate,iStrip),
			     iSector, iPlate, iStrip));

	}
	else {
	  if (!(fTOFdigitMap->StripDigitCheck(iSector,iPlate,iStrip))) continue;
	  dummy = fNumberOfTofClusters;
	  FindOnePadClusterPerStrip(iSector, iPlate, iStrip); // 1 pad clusters
	  if (fNumberOfTofClusters!=dummy)
	    AliDebug(2,Form(" (1): n1 = %5d, n2 = %5d", fNumberOfTofClusters, dummy));

	  if (fTOFdigitMap->DigitInStrip(iSector,iPlate,iStrip)>0)
	    AliDebug(2, Form(" (1): number of clusters = %5d (remaining digit %2d), -%2d %1d %2d-",
			     fNumberOfTofClusters, fTOFdigitMap->DigitInStrip(iSector,iPlate,iStrip),
			     iSector, iPlate, iStrip));

	}


      }
    }
  }


  TClonesArray &lRecPoints = *fRecPoints;
  
  Int_t ii, jj;

  Int_t detectorIndex[5];
  for (jj=0; jj<5; jj++) detectorIndex[jj] = -1;
  Int_t parTOF[7];
  for (jj=0; jj<7; jj++) parTOF[jj] = -1;
  Int_t trackLabels[3];
  for (jj=0; jj<3; jj++) trackLabels[jj] = -1;
  Int_t digitIndex = -1;
  Bool_t status = kTRUE;
  Float_t posClus[3];
  for (ii=0; ii<3; ii++) posClus[ii] = 0.;
  //Float_t covClus[6];
  //for (ii=0; ii<6; ii++) covClus[ii] = 0.;
  UShort_t volIdClus;

  for (ii=0; ii<fNumberOfTofClusters; ii++) {
    AliTOFcluster* clOr = fTofClusters[ii];
    fTofClusters[ii] = 0;
    digitIndex = clOr->GetIndex();
    for(jj=0; jj<5; jj++) detectorIndex[jj] = clOr->GetDetInd(jj);
    volIdClus = fTOFGeometry->GetAliSensVolIndex(detectorIndex[0],detectorIndex[1],detectorIndex[2]);
    //volIdClus = GetClusterVolIndex(detectorIndex);
    for(jj=0; jj<3; jj++) trackLabels[jj] = clOr->GetLabel(jj);
    parTOF[0] = clOr->GetTDC(); // TDC
    parTOF[1] = clOr->GetToT(); // TOT
    parTOF[2] = clOr->GetADC(); // ADC=TOT
    parTOF[3] = clOr->GetTDCND(); // TDCND
    parTOF[4] = clOr->GetTDCRAW();//RAW
    parTOF[5] = 0;
    parTOF[6] = 0;
    status = clOr->GetStatus();

    posClus[0] = clOr->GetX();
    posClus[1] = clOr->GetY();
    posClus[2] = clOr->GetZ();

    //for (jj=0; jj<6; jj++) covClus[jj] = 0.;
    //((AliCluster*)clOr)->GetGlobalCov(covClus);

    new(lRecPoints[ii]) AliTOFcluster(volIdClus, (Double_t)posClus[0], (Double_t)posClus[1], (Double_t)posClus[2],
				      (Double_t)(clOr->GetSigmaX2()),
				      (Double_t)(clOr->GetSigmaXY()),
				      (Double_t)(clOr->GetSigmaXZ()),
				      (Double_t)(clOr->GetSigmaY2()),
				      (Double_t)(clOr->GetSigmaYZ()),
				      (Double_t)(clOr->GetSigmaZ2()),
				      //(Double_t)covClus[0], (Double_t)covClus[1], (Double_t)covClus[2],
				      //(Double_t)covClus[3], (Double_t)covClus[4], (Double_t)covClus[5],
				      trackLabels, detectorIndex, parTOF, status, digitIndex);

    AliDebug(2, Form(" %4d  %4d  %f %f %f  %f %f %f %f %f %f  %3d %3d %3d  %2d %1d %2d %1d %2d  %4d %3d %3d %4d %4d  %1d  %4d", 
		     ii, volIdClus, posClus[0], posClus[1], posClus[2],
		     clOr->GetSigmaX2(),
		     clOr->GetSigmaXY(),
		     clOr->GetSigmaXZ(),
		     clOr->GetSigmaY2(),
		     clOr->GetSigmaYZ(),
		     clOr->GetSigmaZ2(),
		     trackLabels[0], trackLabels[1], trackLabels[2],
		     detectorIndex[0], detectorIndex[1], detectorIndex[2], detectorIndex[3], detectorIndex[4],
		     parTOF[0], parTOF[1], parTOF[2], parTOF[3], parTOF[4],
		     status, digitIndex));

    delete clOr;
  }

  for (Int_t iSector=0; iSector<AliTOFGeometry::NSectors(); iSector++)
    for(Int_t iPlate=0; iPlate<AliTOFGeometry::NPlates(); iPlate++) {
      for(Int_t iStrip=0; iStrip<AliTOFGeometry::NStrip(iPlate); iStrip++) {
	if (!(fTOFdigitMap->StripDigitCheck(iSector,iPlate,iStrip))) continue;
	AliDebug(2, Form(" END %2d %1d %2d   %5d",
			 iSector, iPlate, iStrip, fTOFdigitMap->DigitInStrip(iSector,iPlate,iStrip)));
      }
    }

}
//_____________________________________________________________________________

void AliTOFClusterFinderV1::FindOnePadClusterPerStrip(Int_t nSector,
						      Int_t nPlate,
						      Int_t nStrip)
{
  //
  // This function searches the isolated digits (stored in the fDigits object),
  // to perform clusters (stored in the fTofClusters array).
  // This research has been made by checking the fTOFdigitMap object,
  // filled at digits/raw-data reading time.
  //

  const Int_t kMaxNumberOfTracksPerDigit = 3;
  const Int_t kMaxNumberOfDigitsPerVolume = 10;

  Int_t jj = 0;

  Int_t det[5] = {nSector,nPlate,nStrip,-1,-1};//sector,plate,strip,padZ,padX
  Int_t vol[5] = {nSector,nPlate,nStrip,-1,-1};//sector,plate,strip,padX,padZ
  UShort_t volIdClus = 0;

  Float_t pos[3];
  for (jj=0; jj<3; jj++) pos[jj] = 0.;
  Double_t posClus[3];
  for (jj=0; jj<3; jj++) posClus[jj] = 0.;

  Double_t covClus[6];
  for (jj=0; jj<6; jj++) covClus[jj] = 0.;

  Int_t parTOF[7];
  for (jj=0; jj<7; jj++) parTOF[jj] = 0;

  Bool_t status = kTRUE; //assume all sim channels ok in the beginning...

  Int_t tracks[kMaxNumberOfTracksPerDigit];
  for (jj=0; jj<kMaxNumberOfTracksPerDigit; jj++) tracks[jj] = -1;

  Int_t dummyCounter=-1;

  AliTOFdigit *digitInteresting;

  Int_t iPadX = -1;
  Int_t iPadZ = -1;
  for (iPadX=0; iPadX<AliTOFGeometry::NpadX(); iPadX++) {
    for (iPadZ=0; iPadZ<AliTOFGeometry::NpadZ(); iPadZ++) {
      vol[4] = iPadZ  , vol[3]  = iPadX;

      AliDebug(3, Form(" %1d %2d\n", iPadZ, iPadX));

      if (fTOFdigitMap->GetNumberOfDigits(vol)==0) continue;

      for(Int_t digIndex=0; digIndex<kMaxNumberOfDigitsPerVolume; digIndex++) {
	if (fTOFdigitMap->GetDigitIndex(vol,digIndex)<0) continue;
	digitInteresting = (AliTOFdigit*)fDigits->UncheckedAt(fTOFdigitMap->GetDigitIndex(vol,digIndex));

	AliDebug(2, Form(" %3d  %5d    %2d %1d %2d %1d %2d  %d %d %d  %5d  %5d %5d %5d",
			 fTOFdigitMap->GetNumberOfDigits(vol), digIndex,
			 vol[0], vol[1], vol[2] ,vol[4], vol[3],
			 digitInteresting->GetTdc(), digitInteresting->GetAdc(),
			 digitInteresting->GetToT(),
			 fTOFdigitMap->GetDigitIndex(vol,digIndex),
			 digitInteresting->GetTrack(0), digitInteresting->GetTrack(1), digitInteresting->GetTrack(2)));
	
	det[3] = vol[4]; // padz
	det[4] = vol[3]; // padx
	fTOFGeometry->GetPosPar(det,pos);
	AliDebug(1,Form(" %f %f %f", pos[0], pos[1], pos[2]));

	//insert cluster
	for (jj=0; jj<3; jj++) posClus[jj] = pos[jj];

	parTOF[0] = Int_t(digitInteresting->GetTdc());
	parTOF[1] = Int_t(digitInteresting->GetToT());
	parTOF[2] = Int_t(digitInteresting->GetAdc());
	parTOF[3] = Int_t(digitInteresting->GetTdcND());
	parTOF[4] = Int_t(digitInteresting->GetTdc());
	parTOF[5] = 0;
	parTOF[6] = 0;

	volIdClus = fTOFGeometry->GetAliSensVolIndex(det[0],det[1],det[2]);
	//volIdClus = GetClusterVolIndex(det);

	for (jj=0; jj<6; jj++) covClus[jj] = 0.;
	GetClusterPars(det, posClus, covClus);

	// To fill the track index array
	dummyCounter=-1;
	for (jj=0; jj<kMaxNumberOfTracksPerDigit; jj++) tracks[jj] = -1;
	for (jj=0; jj<kMaxNumberOfTracksPerDigit; jj++) { // three is the max number of tracks associated to one digit
	  if (digitInteresting->GetTrack(jj)==-1) continue;
	  else {
	    dummyCounter++;
	    tracks[dummyCounter] = digitInteresting->GetTrack(jj);
	  }
	}

	AliTOFcluster *tofCluster =
	  new AliTOFcluster(volIdClus, posClus[0], posClus[1], posClus[2],
			    covClus[0], covClus[1], covClus[2], covClus[3], covClus[4], covClus[5],
			    tracks, det, parTOF, status, fTOFdigitMap->GetDigitIndex(vol,digIndex));
	InsertCluster(tofCluster);

	AliDebug(2, Form("       %4d  %f %f %f  %f %f %f %f %f %f  %3d %3d %3d  %2d %1d %2d %1d %2d  %4d %3d %3d %4d %4d  %1d  %4d", 
			 volIdClus, posClus[0], posClus[1], posClus[2],
			 covClus[0], covClus[1], covClus[2], covClus[3], covClus[4], covClus[5],
			 tracks[0], tracks[1], tracks[2],
			 det[0], det[1], det[2], det[3], det[4],
			 parTOF[0], parTOF[1], parTOF[2], parTOF[3], parTOF[4],
			 status, fTOFdigitMap->GetDigitIndex(vol,digIndex)));

	AliDebug(2, Form("        %f %f %f", pos[0], pos[1], pos[2]));
	AliDebug(2, Form("           %d %d", parTOF[0], parTOF[2]));

	fTOFdigitMap->ResetDigit(vol, digIndex);

      }

    }
  }

}
//_____________________________________________________________________________

void AliTOFClusterFinderV1::FindClustersWithoutTOT(Int_t nSector,
						   Int_t nPlate,
						   Int_t nStrip)
{
  //
  // This function searches the isolated digits without TOT
  // measurement (stored in the fDigits object), to perform clusters
  // (stored in the fTofClusters array). This research has been made
  // by checking the fTOFdigitMap object, filled at digits/raw-data
  // reading time.
  //

  const Int_t kMaxNumberOfTracksPerDigit = 3;
  const Int_t kMaxNumberOfDigitsPerVolume = 10;

  Int_t jj = 0;

  Int_t det[5] = {nSector,nPlate,nStrip,-1,-1};//sector,plate,strip,padZ,padX
  Int_t vol[5] = {nSector,nPlate,nStrip,-1,-1};//sector,plate,strip,padX,padZ
  UShort_t volIdClus = 0;

  Float_t pos[3];
  for (jj=0; jj<3; jj++) pos[jj] = 0.;
  Double_t posClus[3];
  for (jj=0; jj<3; jj++) posClus[jj] = 0.;

  Double_t covClus[6];
  for (jj=0; jj<6; jj++) covClus[jj] = 0.;

  Int_t parTOF[7];
  for (jj=0; jj<7; jj++) parTOF[jj] = 0;

  Bool_t status = kTRUE; //assume all sim channels ok in the beginning...
  Int_t tracks[kMaxNumberOfTracksPerDigit];
  for (jj=0; jj<kMaxNumberOfTracksPerDigit; jj++) tracks[jj] = -1;

  Int_t dummyCounter=-1;

  AliTOFdigit *digitInteresting;

  Int_t iPadX = -1;
  Int_t iPadZ = -1;
  for (iPadX=0; iPadX<AliTOFGeometry::NpadX(); iPadX++) {
    for (iPadZ=0; iPadZ<AliTOFGeometry::NpadZ(); iPadZ++) {
      vol[4] = iPadZ  , vol[3]  = iPadX;

      AliDebug(3, Form(" %1d %2d\n", iPadZ, iPadX));

      if (fTOFdigitMap->GetNumberOfDigits(vol)==0) continue;

      for(Int_t digIndex=0; digIndex<kMaxNumberOfDigitsPerVolume; digIndex++) {
	if (fTOFdigitMap->GetDigitIndex(vol,digIndex)<0) continue;
	digitInteresting = (AliTOFdigit*)fDigits->UncheckedAt(fTOFdigitMap->GetDigitIndex(vol,digIndex));
	if (digitInteresting->GetToT()>0) continue; // AdC

	AliDebug(2, Form(" %3d  %5d    %2d %1d %2d %1d %2d  %d %d %d  %5d  %5d %5d %5d",
			 fTOFdigitMap->GetNumberOfDigits(vol), digIndex,
			 vol[0], vol[1], vol[2] ,vol[4], vol[3],
			 digitInteresting->GetTdc(), digitInteresting->GetAdc(),
			 digitInteresting->GetToT(),
			 fTOFdigitMap->GetDigitIndex(vol,digIndex),
			 digitInteresting->GetTrack(0), digitInteresting->GetTrack(1), digitInteresting->GetTrack(2)));
	
	det[3] = vol[4]; // padz
	det[4] = vol[3]; // padx
	fTOFGeometry->GetPosPar(det,pos);
	AliDebug(1,Form(" %f %f %f", pos[0], pos[1], pos[2]));

	//insert cluster
	for (jj=0; jj<3; jj++) posClus[jj] = pos[jj];

	parTOF[0] = Int_t(digitInteresting->GetTdc());
	parTOF[1] = Int_t(digitInteresting->GetToT());
	parTOF[2] = Int_t(digitInteresting->GetAdc());
	parTOF[3] = Int_t(digitInteresting->GetTdcND());
	parTOF[4] = Int_t(digitInteresting->GetTdc());
	parTOF[5] = 0;
	parTOF[6] = 0;

	volIdClus = fTOFGeometry->GetAliSensVolIndex(det[0],det[1],det[2]);
	//volIdClus = GetClusterVolIndex(det);

	for (jj=0; jj<6; jj++) covClus[jj] = 0.;
	GetClusterPars(det, posClus, covClus);

	// To fill the track index array
	dummyCounter=-1;
	for (jj=0; jj<kMaxNumberOfTracksPerDigit; jj++) tracks[jj] = -1;
	for (jj=0; jj<kMaxNumberOfTracksPerDigit; jj++) { // three is the max number of tracks associated to one digit
	  if (digitInteresting->GetTrack(jj)==-1) continue;
	  else {
	    dummyCounter++;
	    tracks[dummyCounter] = digitInteresting->GetTrack(jj);
	  }
	}

	AliTOFcluster *tofCluster =
	  new AliTOFcluster(volIdClus, posClus[0], posClus[1], posClus[2],
			    covClus[0], covClus[1], covClus[2], covClus[3], covClus[4], covClus[5],
			    tracks, det, parTOF, status, fTOFdigitMap->GetDigitIndex(vol,digIndex));
	InsertCluster(tofCluster);

	AliDebug(2, Form("       %4d  %f %f %f  %f %f %f %f %f %f  %3d %3d %3d  %2d %1d %2d %1d %2d  %4d %3d %3d %4d %4d  %1d  %4d", 
			 volIdClus, posClus[0], posClus[1], posClus[2],
			 covClus[0], covClus[1], covClus[2], covClus[3], covClus[4], covClus[5],
			 tracks[0], tracks[1], tracks[2],
			 det[0], det[1], det[2], det[3], det[4],
			 parTOF[0], parTOF[1], parTOF[2], parTOF[3], parTOF[4],
			 status, fTOFdigitMap->GetDigitIndex(vol,digIndex)));

	AliDebug(2, Form("        %f %f %f", pos[0], pos[1], pos[2]));
	AliDebug(2, Form("           %d %d", parTOF[0], parTOF[2]));

	fTOFdigitMap->ResetDigit(vol, digIndex);

      }

    }
  }

}
//_____________________________________________________________________________

void AliTOFClusterFinderV1::FindClusters34(Int_t nSector,
					   Int_t nPlate,
					   Int_t nStrip)
{
  //
  // This function searches the neighbouring digits (stored in the fDigits object),
  // to perform clusters (stored in the fTofClusters array).
  //
  // This research has been made by checking the fTOFdigitMap object,
  // filled at digits/raw-data reading time.
  //

  const Int_t kMaxNumberOfInterestingPads = 4;
  const Int_t kMaxNumberOfTracksPerDigit = 3;
  const Int_t kMaxNumberOfDigitsPerVolume = 10;

  Int_t ii = 0;

  Int_t digitsInVolumeIndices[kMaxNumberOfDigitsPerVolume];
  for (ii=0; ii<kMaxNumberOfDigitsPerVolume; ii++)
    digitsInVolumeIndices[ii] = -1;

  Int_t vol[5] = {nSector,nPlate,nStrip,-1,-1};

  Float_t pos[3] = {0.,0.,0.};

  Int_t jj = 0;
  Int_t interestingPadX[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingPadX[jj] = -1;
  Int_t interestingPadZ[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingPadZ[jj] = -1;
  Double_t interestingTOT[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingTOT[jj] = 0;
  Double_t interestingADC[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingADC[jj] = 0;
  Double_t interestingTOF[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingTOF[jj] = 0;
  Double_t interestingWeight[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingWeight[jj] = 0;

  Float_t interestingX[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingX[jj] = 0;
  Float_t interestingY[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingY[jj] = 0;
  Float_t interestingZ[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingZ[jj] = 0;

  Float_t interDigit[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interDigit[jj] = 0;

  Int_t padsCluster[11];
  padsCluster[0] = nSector;
  padsCluster[1] = nPlate;
  padsCluster[2] = nStrip;
  for (jj=3; jj<11; jj++) padsCluster[jj] = -1;

  Int_t interestingCounter=-1;
  Int_t  digitIndexLocal=-1; // AdC
  Int_t iPad  = -1;
  Int_t iPadX = -1;
  Int_t iPadZ = -1;

  Int_t parTOF[7];
  for (jj=0; jj<7; jj++) parTOF[jj] = 0;
  Double_t posClus[3];
  for (jj=0; jj<3; jj++) posClus[jj] = 0.;
  Int_t det[5];
  for (jj=0; jj<5; jj++) det[jj] = -1;
  Float_t posF[3];
  for (jj=0; jj<3; jj++) posF[jj] = 0.;
  UShort_t volIdClus = 0;
  Bool_t check = kFALSE;
  Bool_t status = kTRUE; //assume all sim channels ok in the beginning...
  Double_t covClus[6];
  for (jj=0; jj<6; jj++) covClus[jj] = 0.;
  Int_t tracks[kMaxNumberOfTracksPerDigit];
  for (jj=0; jj<kMaxNumberOfTracksPerDigit; jj++) tracks[jj] = -1;
  Int_t dummyCounter=-1;
  Bool_t alreadyStored = kFALSE;

  AliTOFselectedDigit ***selectedDigit = new AliTOFselectedDigit**[kMaxNumberOfInterestingPads];
  for (ii=0; ii<kMaxNumberOfInterestingPads; ii++)
    selectedDigit[ii] = new AliTOFselectedDigit*[kMaxNumberOfDigitsPerVolume];

  for (ii=0; ii<kMaxNumberOfInterestingPads; ii++)
    for (jj=0; jj<kMaxNumberOfDigitsPerVolume; jj++) selectedDigit[ii][jj] = 0x0;

  AliTOFdigit *digitInteresting;

  for (iPad=0; iPad<AliTOFGeometry::NpadZ()*AliTOFGeometry::NpadX()-3; iPad+=2) {

    iPadZ = iPad%AliTOFGeometry::NpadZ(); //iPad%2;
    iPadX = iPad/AliTOFGeometry::NpadZ(); //iPad/2;

    AliDebug(3, Form("%2d %1d %2d\n", iPad, iPadZ, iPadX));






    interestingCounter=-1;

    vol[4] = iPadZ  , vol[3]  = iPadX;
    if (fTOFdigitMap->GetNumberOfDigits(vol)>0)
      interestingCounter++;

    vol[4] = iPadZ, vol[3] = iPadX+1;
    if (fTOFdigitMap->GetNumberOfDigits(vol)>0)
      interestingCounter++;

    vol[4] = AliTOFGeometry::NpadZ()-(iPadZ+1), vol[3] = iPadX;
    if (fTOFdigitMap->GetNumberOfDigits(vol)>0)
      interestingCounter++;

    vol[4] = AliTOFGeometry::NpadZ()-(iPadZ+1), vol[3] = iPadX+1;
    if (fTOFdigitMap->GetNumberOfDigits(vol)>0)
      interestingCounter++;

    if (interestingCounter+1!=4) continue; // the hit pads have to be 4
    else interestingCounter=-1;


    for (ii=0; ii<kMaxNumberOfInterestingPads; ii++)
      for (jj=0; jj<kMaxNumberOfDigitsPerVolume; jj++)
	selectedDigit[ii][jj] = 0x0;


    vol[4] = iPadZ, vol[3] = iPadX;

    if (fTOFdigitMap->GetNumberOfDigits(vol)>0) {
      interestingCounter++;
      for (ii=0; ii<kMaxNumberOfDigitsPerVolume; ii++)
	digitsInVolumeIndices[ii] = -1;
      fTOFdigitMap->GetDigitIndex(vol, digitsInVolumeIndices);
      digitIndexLocal=-1; // AdC
      for(Int_t digIndex=0; digIndex<kMaxNumberOfDigitsPerVolume; digIndex++) {
	if (digitsInVolumeIndices[digIndex]<0) continue;
	digitInteresting = (AliTOFdigit*)fDigits->UncheckedAt(digitsInVolumeIndices[digIndex]);
	if (digitInteresting->GetToT()<=0) continue; // AdC
	digitIndexLocal++; // AdC

	AliDebug(1,Form(" %2d %1d %2d %1d %2d  %d %d %d %d  %5d  %5d %5d %5d",
			vol[0], vol[1], vol[2] ,vol[4], vol[3],
			digitInteresting->GetTdc(), digitInteresting->GetAdc(),
			digitInteresting->GetToT(), digitInteresting->GetToT()*digitInteresting->GetToT(),
			digitsInVolumeIndices[digIndex],
			digitInteresting->GetTrack(0), digitInteresting->GetTrack(1), digitInteresting->GetTrack(2)));


	selectedDigit[interestingCounter][digitIndexLocal] = new // AdC
	  AliTOFselectedDigit(vol, digitInteresting->GetTdc(),
			      digitInteresting->GetAdc(), digitInteresting->GetToT(),
			      digitInteresting->GetToT()*digitInteresting->GetToT(),
			      digitsInVolumeIndices[digIndex],
			      digitInteresting->GetTracks());
      }
      if (digitIndexLocal==-1) interestingCounter--; // AdC
    }


    vol[4] = iPadZ, vol[3] = iPadX+1;

    if (fTOFdigitMap->GetNumberOfDigits(vol)>0) {
      interestingCounter++;
      for (ii=0; ii<kMaxNumberOfDigitsPerVolume; ii++)
	digitsInVolumeIndices[ii] = -1;
      fTOFdigitMap->GetDigitIndex(vol, digitsInVolumeIndices);
      digitIndexLocal=-1; // AdC
      for(Int_t digIndex=0; digIndex<kMaxNumberOfDigitsPerVolume; digIndex++) {
	if (digitsInVolumeIndices[digIndex]<0) continue;
	digitInteresting = (AliTOFdigit*)fDigits->UncheckedAt(digitsInVolumeIndices[digIndex]);
	if (digitInteresting->GetToT()<=0) continue; // AdC
	digitIndexLocal++; // AdC

	AliDebug(1,Form(" %2d %1d %2d %1d %2d  %d %d %d %d  %5d  %5d %5d %5d",
			vol[0], vol[1], vol[2] ,vol[4], vol[3],
			digitInteresting->GetTdc(), digitInteresting->GetAdc(),
			digitInteresting->GetToT(), digitInteresting->GetToT()*digitInteresting->GetToT(),
			digitsInVolumeIndices[digIndex],
			digitInteresting->GetTrack(0), digitInteresting->GetTrack(1), digitInteresting->GetTrack(2)));


	selectedDigit[interestingCounter][digitIndexLocal] = new // AdC
	  AliTOFselectedDigit(vol, digitInteresting->GetTdc(),
			      digitInteresting->GetAdc(), digitInteresting->GetToT(),
			      digitInteresting->GetToT()*digitInteresting->GetToT(),
			      digitsInVolumeIndices[digIndex],
			      digitInteresting->GetTracks());
      }
      if (digitIndexLocal==-1) interestingCounter--; // AdC
    }


    vol[4] = AliTOFGeometry::NpadZ()-(iPadZ+1), vol[3] = iPadX;

    if (fTOFdigitMap->GetNumberOfDigits(vol)>0) {
      interestingCounter++;
      for (ii=0; ii<kMaxNumberOfDigitsPerVolume; ii++)
	digitsInVolumeIndices[ii] = -1;
      fTOFdigitMap->GetDigitIndex(vol, digitsInVolumeIndices);
      digitIndexLocal=-1; // AdC
      for(Int_t digIndex=0; digIndex<kMaxNumberOfDigitsPerVolume; digIndex++) {
	if (digitsInVolumeIndices[digIndex]<0) continue;
	digitInteresting = (AliTOFdigit*)fDigits->UncheckedAt(digitsInVolumeIndices[digIndex]);
	if (digitInteresting->GetToT()<=0) continue; // AdC
	digitIndexLocal++; // AdC

	AliDebug(1,Form(" %2d %1d %2d %1d %2d  %d %d %d %d  %5d  %5d %5d %5d",
			vol[0], vol[1], vol[2] ,vol[4], vol[3],
			digitInteresting->GetTdc(), digitInteresting->GetAdc(),
			digitInteresting->GetToT(), digitInteresting->GetToT()*digitInteresting->GetToT(),
			digitsInVolumeIndices[digIndex],
			digitInteresting->GetTrack(0), digitInteresting->GetTrack(1), digitInteresting->GetTrack(2)));


	selectedDigit[interestingCounter][digitIndexLocal] = new // AdC
	  AliTOFselectedDigit(vol, digitInteresting->GetTdc(),
			      digitInteresting->GetAdc(), digitInteresting->GetToT(),
			      digitInteresting->GetToT()*digitInteresting->GetToT(),
			      digitsInVolumeIndices[digIndex],
			      digitInteresting->GetTracks());
      }
      if (digitIndexLocal==-1) interestingCounter--; // AdC
    }


    vol[4] = AliTOFGeometry::NpadZ()-(iPadZ+1), vol[3] = iPadX+1;

    if (fTOFdigitMap->GetNumberOfDigits(vol)>0) {
      interestingCounter++;
      for (ii=0; ii<kMaxNumberOfDigitsPerVolume; ii++)
	digitsInVolumeIndices[ii] = -1;
      fTOFdigitMap->GetDigitIndex(vol, digitsInVolumeIndices);
      digitIndexLocal=-1;
      for(Int_t digIndex=0; digIndex<kMaxNumberOfDigitsPerVolume; digIndex++) {
	if (digitsInVolumeIndices[digIndex]<0) continue;
	digitInteresting = (AliTOFdigit*)fDigits->UncheckedAt(digitsInVolumeIndices[digIndex]);
	if (digitInteresting->GetToT()<=0) continue; // AdC
	digitIndexLocal++; // AdC

	AliDebug(1,Form(" %2d %1d %2d %1d %2d  %d %d %d %d  %5d  %5d %5d %5d",
			vol[0], vol[1], vol[2] ,vol[4], vol[3],
			digitInteresting->GetTdc(), digitInteresting->GetAdc(),
			digitInteresting->GetToT(), digitInteresting->GetToT()*digitInteresting->GetToT(),
			digitsInVolumeIndices[digIndex],
			digitInteresting->GetTrack(0), digitInteresting->GetTrack(1), digitInteresting->GetTrack(2)));

	selectedDigit[interestingCounter][digitIndexLocal] = new // AdC
	  AliTOFselectedDigit(vol, digitInteresting->GetTdc(),
			      digitInteresting->GetAdc(), digitInteresting->GetToT(),
			      digitInteresting->GetToT()*digitInteresting->GetToT(),
			      digitsInVolumeIndices[digIndex],
			      digitInteresting->GetTracks());
      }
      if (digitIndexLocal==-1) interestingCounter--; // AdC
    }

    AliDebug(1,Form(" e adesso %1d", interestingCounter+1));

    for (Int_t adesso1=0; adesso1<interestingCounter+1; adesso1++) {
      for (Int_t firstIndex=0; firstIndex<kMaxNumberOfDigitsPerVolume; firstIndex++) {
	if (selectedDigit[adesso1][firstIndex]==0x0) continue;

	for (Int_t adesso2=adesso1+1; adesso2<interestingCounter+1; adesso2++) {
	  for (Int_t secondIndex=0; secondIndex<kMaxNumberOfDigitsPerVolume; secondIndex++) {
	    if (selectedDigit[adesso2][secondIndex]==0x0) continue;

	    for (Int_t adesso3=adesso2+1; adesso3<interestingCounter+1; adesso3++) {
	      for (Int_t thirdIndex=0; thirdIndex<kMaxNumberOfDigitsPerVolume; thirdIndex++) {
		if (selectedDigit[adesso3][thirdIndex]==0x0) continue;


		if (TMath::Abs(selectedDigit[adesso1][firstIndex]->GetTDC()-selectedDigit[adesso2][secondIndex]->GetTDC())>fMaxDeltaTime
		    ||
		    TMath::Abs(selectedDigit[adesso1][firstIndex]->GetTDC()-selectedDigit[adesso3][thirdIndex]->GetTDC())>fMaxDeltaTime
		    ||
		    TMath::Abs(selectedDigit[adesso2][secondIndex]->GetTDC()-selectedDigit[adesso3][thirdIndex]->GetTDC())>fMaxDeltaTime) continue;

		interestingTOF[0] = selectedDigit[adesso1][firstIndex]->GetTDC();
		interestingTOT[0] = selectedDigit[adesso1][firstIndex]->GetTOT();
		interestingADC[0] = selectedDigit[adesso1][firstIndex]->GetADC();
		interestingWeight[0] = selectedDigit[adesso1][firstIndex]->GetWeight();
		Int_t vol1[5]; for(jj=0; jj<5; jj++) vol1[jj] = selectedDigit[adesso1][firstIndex]->GetDetectorIndex(jj);
		AliDebug(1,Form(" %2d %1d %2d %1d %2d", vol1[0], vol1[1], vol1[2], vol1[4], vol1[3]));
		Int_t volDum = vol1[3];
		vol1[3] = vol1[4];
		vol1[4] = volDum;
		fTOFGeometry->GetPosPar(vol1,pos);
		interestingX[0] = pos[0];
		interestingY[0] = pos[1];
		interestingZ[0] = pos[2];

		interestingTOF[1] = selectedDigit[adesso2][secondIndex]->GetTDC();
		interestingTOT[1] = selectedDigit[adesso2][secondIndex]->GetTOT();
		interestingADC[1] = selectedDigit[adesso2][secondIndex]->GetADC();
		interestingWeight[1] = selectedDigit[adesso2][secondIndex]->GetWeight();
		Int_t vol2[5]; for(jj=0; jj<5; jj++) vol2[jj] = selectedDigit[adesso2][secondIndex]->GetDetectorIndex(jj);
		AliDebug(1,Form(" %2d %1d %2d %1d %2d", vol2[0], vol2[1], vol2[2], vol2[4], vol2[3]));
		volDum = vol2[3];
		vol2[3] = vol2[4];
		vol2[4] = volDum;
		fTOFGeometry->GetPosPar(vol2,pos);
		interestingX[1] = pos[0];
		interestingY[1] = pos[1];
		interestingZ[1] = pos[2];

		interestingTOF[2] = selectedDigit[adesso3][thirdIndex]->GetTDC();
		interestingTOT[2] = selectedDigit[adesso3][thirdIndex]->GetTOT();
		interestingADC[2] = selectedDigit[adesso3][thirdIndex]->GetADC();
		interestingWeight[2] = selectedDigit[adesso3][thirdIndex]->GetWeight();
		Int_t vol3[5]; for(jj=0; jj<5; jj++) vol3[jj] = selectedDigit[adesso3][thirdIndex]->GetDetectorIndex(jj);
		AliDebug(1,Form(" %2d %1d %2d %1d %2d", vol3[0], vol3[1], vol3[2], vol3[4], vol3[3]));
		volDum = vol3[3];
		vol3[3] = vol3[4];
		vol3[4] = volDum;
		fTOFGeometry->GetPosPar(vol3,pos);
		interestingX[2] = pos[0];
		interestingY[2] = pos[1];
		interestingZ[2] = pos[2];


		AverageCalculations(3, interestingX, interestingY, interestingZ,
				    interestingTOF, interestingTOT, interestingADC,
				    interestingWeight,
				    parTOF, posClus, check);


		for (jj=0; jj<5; jj++) det[jj] = -1;
		for (jj=0; jj<3; jj++) posF[jj] = posClus[jj];
		fTOFGeometry->GetDetID(posF, det);

		volIdClus = fTOFGeometry->GetAliSensVolIndex(det[0],det[1],det[2]);
		//volIdClus = GetClusterVolIndex(det);

		for (jj=3; jj<11; jj++) padsCluster[jj] = -1;
		padsCluster[3] = selectedDigit[adesso1][firstIndex]->GetDetectorIndex(4);
		padsCluster[4] = selectedDigit[adesso1][firstIndex]->GetDetectorIndex(3);
		padsCluster[5] = selectedDigit[adesso2][secondIndex]->GetDetectorIndex(4);
		padsCluster[6] = selectedDigit[adesso2][secondIndex]->GetDetectorIndex(3);
		padsCluster[7] = selectedDigit[adesso3][thirdIndex]->GetDetectorIndex(4);
		padsCluster[8] = selectedDigit[adesso3][thirdIndex]->GetDetectorIndex(3);

		for (jj=0; jj<6; jj++) covClus[jj] = 0.;
		Int_t ** indDet = new Int_t*[3];
		for (jj=0; jj<3; jj++) indDet[jj] = new Int_t [5];
		for (jj=0; jj<3; jj++) indDet[jj][0] = nSector;
		for (jj=0; jj<3; jj++) indDet[jj][1] = nPlate;
		for (jj=0; jj<3; jj++) indDet[jj][2] = nStrip;
		for (jj=0; jj<3; jj++) indDet[jj][3] = padsCluster[2*jj+3];
		for (jj=0; jj<3; jj++) indDet[jj][4] = padsCluster[2*jj+1+3];
		GetClusterPars(/*check,*/ 3, indDet, interestingWeight, posClus, covClus);
		for (jj=0; jj<3; jj++) delete [] indDet[jj];
		delete [] indDet;

		// To fill the track index array
		dummyCounter=-1;
		for (jj=0; jj<kMaxNumberOfTracksPerDigit; jj++) tracks[jj] = -1;
		for (Int_t kk=0; kk<kMaxNumberOfTracksPerDigit; kk++) { // three is the max number of tracks associated to one digit
		  if (selectedDigit[adesso1][firstIndex]->GetTrackLabel(kk)==-1) continue;
		  else {
		    dummyCounter++;
		    tracks[dummyCounter] = selectedDigit[adesso1][firstIndex]->GetTrackLabel(kk);
		  }
		}
		for (Int_t kk=0; kk<kMaxNumberOfTracksPerDigit; kk++) { // three is the max number of tracks associated to one digit
		  if (selectedDigit[adesso2][secondIndex]->GetTrackLabel(kk)==-1) continue;
		  else {

		    alreadyStored = kFALSE;
		    for (jj=0; jj<dummyCounter+1; jj++)
		      alreadyStored = alreadyStored || (tracks[jj]!=-1 && tracks[jj]==selectedDigit[adesso2][secondIndex]->GetTrackLabel(kk));

		    if (alreadyStored) continue;
		    if (dummyCounter==2) { // three is the max number of tracks associated to one cluster
		      AliWarning("  Siamo al limite!");
		      continue;
		    }

		    dummyCounter++;
		    tracks[dummyCounter] = selectedDigit[adesso2][secondIndex]->GetTrackLabel(kk);

		  }

		}
		for (Int_t kk=0; kk<kMaxNumberOfTracksPerDigit; kk++) { // three is the max number of tracks associated to one digit
		  if (selectedDigit[adesso3][thirdIndex]->GetTrackLabel(kk)==-1) continue;
		  else {

		    alreadyStored = kFALSE;
		    for (jj=0; jj<dummyCounter+1; jj++)
		      alreadyStored = alreadyStored || (tracks[jj]!=-1 && tracks[jj]==selectedDigit[adesso3][thirdIndex]->GetTrackLabel(kk));

		    if (alreadyStored) continue;
		    if (dummyCounter==2) { // three is the max number of tracks associated to one cluster
		      AliWarning("  Siamo al limite!");
		      continue;
		    }

		    dummyCounter++;
		    tracks[dummyCounter] = selectedDigit[adesso3][thirdIndex]->GetTrackLabel(kk);

		  }

		}


		AliTOFcluster *tofCluster =
		  new AliTOFcluster(volIdClus, posClus[0], posClus[1], posClus[2],
				    covClus[0], covClus[1], covClus[2], covClus[3], covClus[4], covClus[5],
				    tracks, det, parTOF, status, selectedDigit[adesso1][firstIndex]->GetIndex()); // to be updated
		InsertCluster(tofCluster);

		AliDebug(2, Form("       %4d  %f %f %f  %f %f %f %f %f %f  %3d %3d %3d  %2d %1d %2d %1d %2d  %4d %3d %3d %4d %4d  %1d  %4d", 
				 volIdClus, posClus[0], posClus[1], posClus[2],
				 covClus[0], covClus[1], covClus[2], covClus[3], covClus[4], covClus[5],
				 tracks[0], tracks[1], tracks[2],
				 det[0], det[1], det[2], det[3], det[4],
				 parTOF[0], parTOF[1], parTOF[2], parTOF[3], parTOF[4],
				 status, selectedDigit[adesso1][firstIndex]->GetIndex()));


		volDum = vol1[3];
		vol1[3] = vol1[4];
		vol1[4] = volDum;
		fTOFdigitMap->ResetDigitNumber(vol1,selectedDigit[adesso1][firstIndex]->GetIndex());
		volDum = vol2[3];
		vol2[3] = vol2[4];
		vol2[4] = volDum;
		fTOFdigitMap->ResetDigitNumber(vol2,selectedDigit[adesso2][secondIndex]->GetIndex());
		volDum = vol3[3];
		vol3[3] = vol3[4];
		vol3[4] = volDum;
		fTOFdigitMap->ResetDigitNumber(vol3,selectedDigit[adesso3][thirdIndex]->GetIndex());


	      } // close loop on third digit
	    } // close loop on adesso3

	  } // close loop on second digit
	} // close loop on adesso2

      } // close loop on first digit
    } // close loop on adesso1

    for (ii=0; ii<kMaxNumberOfInterestingPads; ii++)
      for (jj=0; jj<kMaxNumberOfDigitsPerVolume; jj++)
	selectedDigit[ii][jj] = 0x0;

  } // loop on iPad

  for (ii=0; ii<kMaxNumberOfInterestingPads; ii++) {
    for (jj=0; jj<kMaxNumberOfDigitsPerVolume; jj++) {
      delete [] selectedDigit[ii][jj];
      selectedDigit[ii][jj] = 0x0;
    }
    delete [] selectedDigit[ii];
    selectedDigit[ii] = 0x0;
  }
  delete [] selectedDigit;
  selectedDigit = 0x0;

}
//_____________________________________________________________________________

void AliTOFClusterFinderV1::FindClusters23(Int_t nSector,
					   Int_t nPlate,
					   Int_t nStrip)
{
  //
  // This function searches the neighbouring digits (stored in the fDigits object),
  // to perform clusters (stored in the fTofClusters array).
  //
  // This research has been made by checking the fTOFdigitMap object,
  // filled at digits/raw-data reading time.
  //

  const Int_t kMaxNumberOfInterestingPads = 4;
  const Int_t kMaxNumberOfTracksPerDigit = 3;
  const Int_t kMaxNumberOfDigitsPerVolume = 10;

  Int_t ii = 0;

  Int_t digitsInVolumeIndices[kMaxNumberOfDigitsPerVolume];
  for (ii=0; ii<kMaxNumberOfDigitsPerVolume; ii++)
    digitsInVolumeIndices[ii] = -1;

  Int_t vol[5] = {nSector,nPlate,nStrip,-1,-1};

  Float_t pos[3] = {0.,0.,0.};

  Int_t jj = 0;
  Int_t interestingPadX[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingPadX[jj] = -1;
  Int_t interestingPadZ[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingPadZ[jj] = -1;
  Double_t interestingTOT[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingTOT[jj] = 0;
  Double_t interestingADC[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingADC[jj] = 0;
  Double_t interestingTOF[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingTOF[jj] = 0;
  Double_t interestingWeight[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingWeight[jj] = 0;

  Float_t interestingX[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingX[jj] = 0;
  Float_t interestingY[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingY[jj] = 0;
  Float_t interestingZ[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingZ[jj] = 0;

  Float_t interDigit[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interDigit[jj] = 0;

  Int_t padsCluster[11];
  padsCluster[0] = nSector;
  padsCluster[1] = nPlate;
  padsCluster[2] = nStrip;
  for (jj=3; jj<11; jj++) padsCluster[jj] = -1;

  Int_t interestingCounter=-1;
  Int_t digitIndexLocal = -1;
  Int_t iPad  = -1;
  Int_t iPadX = -1;
  Int_t iPadZ = -1;

  Bool_t check = kFALSE;
  Int_t parTOF[7];
  for (jj=0; jj<7; jj++) parTOF[jj] = 0;
  Double_t posClus[3];
  for (jj=0; jj<3; jj++) posClus[jj] = 0.;
  Int_t det[5];
  for (jj=0; jj<5; jj++) det[jj] = -1;
  Float_t posF[3];
  for (jj=0; jj<3; jj++) posF[jj] = 0.;
  UShort_t volIdClus = 0;
  Bool_t status = kTRUE; //assume all sim channels ok in the beginning...
  Double_t covClus[6];
  for (jj=0; jj<6; jj++) covClus[jj] = 0.;
  Int_t tracks[kMaxNumberOfTracksPerDigit];
  for (jj=0; jj<kMaxNumberOfTracksPerDigit; jj++) tracks[jj] = -1;
  Int_t dummyCounter=-1;
  Bool_t alreadyStored = kFALSE;

  AliTOFselectedDigit ***selectedDigit = new AliTOFselectedDigit**[kMaxNumberOfInterestingPads];
  for (ii=0; ii<kMaxNumberOfInterestingPads; ii++)
    selectedDigit[ii] = new AliTOFselectedDigit*[kMaxNumberOfDigitsPerVolume];

  for (ii=0; ii<kMaxNumberOfInterestingPads; ii++)
    for (jj=0; jj<kMaxNumberOfDigitsPerVolume; jj++) selectedDigit[ii][jj] = 0x0;

  AliTOFdigit *digitInteresting;

  for (iPad=0; iPad<AliTOFGeometry::NpadZ()*AliTOFGeometry::NpadX()-3; iPad+=2) {

    iPadZ = iPad%AliTOFGeometry::NpadZ(); //iPad%2;
    iPadX = iPad/AliTOFGeometry::NpadZ(); //iPad/2;

    AliDebug(3, Form("%2d %1d %2d\n", iPad, iPadZ, iPadX));






    interestingCounter=-1;

    vol[4] = iPadZ  , vol[3]  = iPadX;
    if (fTOFdigitMap->GetNumberOfDigits(vol)>0)
      interestingCounter++;

    vol[4] = iPadZ, vol[3] = iPadX+1;
    if (fTOFdigitMap->GetNumberOfDigits(vol)>0)
      interestingCounter++;

    vol[4] = AliTOFGeometry::NpadZ()-(iPadZ+1), vol[3] = iPadX;
    if (fTOFdigitMap->GetNumberOfDigits(vol)>0)
      interestingCounter++;

    vol[4] = AliTOFGeometry::NpadZ()-(iPadZ+1), vol[3] = iPadX+1;
    if (fTOFdigitMap->GetNumberOfDigits(vol)>0)
      interestingCounter++;

    if (interestingCounter+1!=3) continue; // the hit pads have to be 3
    else interestingCounter=-1;


    for (ii=0; ii<kMaxNumberOfInterestingPads; ii++)
      for (jj=0; jj<kMaxNumberOfDigitsPerVolume; jj++)
	selectedDigit[ii][jj] = 0x0;


    vol[4] = iPadZ, vol[3] = iPadX;

    if (fTOFdigitMap->GetNumberOfDigits(vol)>0) {
      interestingCounter++;
      for (ii=0; ii<kMaxNumberOfDigitsPerVolume; ii++)
	digitsInVolumeIndices[ii] = -1;
      fTOFdigitMap->GetDigitIndex(vol, digitsInVolumeIndices);
      digitIndexLocal=-1;
      for(Int_t digIndex=0; digIndex<kMaxNumberOfDigitsPerVolume; digIndex++) {
	if (digitsInVolumeIndices[digIndex]<0) continue;
	digitInteresting = (AliTOFdigit*)fDigits->UncheckedAt(digitsInVolumeIndices[digIndex]);
	if (digitInteresting->GetToT()<=0) continue; // AdC
	digitIndexLocal++; // AdC

	AliDebug(1,Form(" %2d %1d %2d %1d %2d  %d %d %d %d  %5d  %5d %5d %5d",
			vol[0], vol[1], vol[2] ,vol[4], vol[3],
			digitInteresting->GetTdc(), digitInteresting->GetAdc(),
			digitInteresting->GetToT(), digitInteresting->GetToT()*digitInteresting->GetToT(),
			digitsInVolumeIndices[digIndex],
			digitInteresting->GetTrack(0), digitInteresting->GetTrack(1), digitInteresting->GetTrack(2)));

	selectedDigit[interestingCounter][digitIndexLocal] = new // AdC
	  AliTOFselectedDigit(vol, digitInteresting->GetTdc(),
			      digitInteresting->GetAdc(), digitInteresting->GetToT(),
			      digitInteresting->GetToT()*digitInteresting->GetToT(),
			      digitsInVolumeIndices[digIndex],
			      digitInteresting->GetTracks());
      }
      if (digitIndexLocal==-1) interestingCounter--; // AdC
    }


    vol[4] = iPadZ, vol[3] = iPadX+1;

    if (fTOFdigitMap->GetNumberOfDigits(vol)>0) {
      interestingCounter++;
      for (ii=0; ii<kMaxNumberOfDigitsPerVolume; ii++)
	digitsInVolumeIndices[ii] = -1;
      fTOFdigitMap->GetDigitIndex(vol, digitsInVolumeIndices);
      digitIndexLocal=-1; // AdC
      for(Int_t digIndex=0; digIndex<kMaxNumberOfDigitsPerVolume; digIndex++) {
	if (digitsInVolumeIndices[digIndex]<0) continue;
	digitInteresting = (AliTOFdigit*)fDigits->UncheckedAt(digitsInVolumeIndices[digIndex]);
	if (digitInteresting->GetToT()<=0) continue; // AdC
	digitIndexLocal++; // AdC

	AliDebug(1,Form(" %2d %1d %2d %1d %2d  %d %d %d %d  %5d  %5d %5d %5d",
			vol[0], vol[1], vol[2] ,vol[4], vol[3],
			digitInteresting->GetTdc(), digitInteresting->GetAdc(),
			digitInteresting->GetToT(), digitInteresting->GetToT()*digitInteresting->GetToT(),
			digitsInVolumeIndices[digIndex],
			digitInteresting->GetTrack(0), digitInteresting->GetTrack(1), digitInteresting->GetTrack(2)));

	selectedDigit[interestingCounter][digitIndexLocal] = new // AdC
	  AliTOFselectedDigit(vol, digitInteresting->GetTdc(),
			      digitInteresting->GetAdc(), digitInteresting->GetToT(),
			      digitInteresting->GetToT()*digitInteresting->GetToT(),
			      digitsInVolumeIndices[digIndex],
			      digitInteresting->GetTracks());
      }
      if (digitIndexLocal==-1) interestingCounter--; // AdC
    }


    vol[4] = AliTOFGeometry::NpadZ()-(iPadZ+1), vol[3] = iPadX;

    if (fTOFdigitMap->GetNumberOfDigits(vol)>0) {
      interestingCounter++;
      for (ii=0; ii<kMaxNumberOfDigitsPerVolume; ii++)
	digitsInVolumeIndices[ii] = -1;
      fTOFdigitMap->GetDigitIndex(vol, digitsInVolumeIndices);
      digitIndexLocal=-1; // AdC
      for(Int_t digIndex=0; digIndex<kMaxNumberOfDigitsPerVolume; digIndex++) {
	if (digitsInVolumeIndices[digIndex]<0) continue;
	digitInteresting = (AliTOFdigit*)fDigits->UncheckedAt(digitsInVolumeIndices[digIndex]);
	if (digitInteresting->GetToT()<=0) continue; // AdC
	digitIndexLocal++; // AdC

	AliDebug(1,Form(" %2d %1d %2d %1d %2d  %d %d %d %d  %5d  %5d %5d %5d",
			vol[0], vol[1], vol[2] ,vol[4], vol[3],
			digitInteresting->GetTdc(), digitInteresting->GetAdc(),
			digitInteresting->GetToT(), digitInteresting->GetToT()*digitInteresting->GetToT(),
			digitsInVolumeIndices[digIndex],
			digitInteresting->GetTrack(0), digitInteresting->GetTrack(1), digitInteresting->GetTrack(2)));

	selectedDigit[interestingCounter][digitIndexLocal] = new // AdC
	  AliTOFselectedDigit(vol, digitInteresting->GetTdc(),
			      digitInteresting->GetAdc(), digitInteresting->GetToT(),
			      digitInteresting->GetToT()*digitInteresting->GetToT(),
			      digitsInVolumeIndices[digIndex],
			      digitInteresting->GetTracks());
      }
      if (digitIndexLocal==-1) interestingCounter--; // AdC
    }


    vol[4] = AliTOFGeometry::NpadZ()-(iPadZ+1), vol[3] = iPadX+1;

    if (fTOFdigitMap->GetNumberOfDigits(vol)>0) {
      interestingCounter++;
      for (ii=0; ii<kMaxNumberOfDigitsPerVolume; ii++)
	digitsInVolumeIndices[ii] = -1;
      fTOFdigitMap->GetDigitIndex(vol, digitsInVolumeIndices);
      digitIndexLocal=-1; // AdC
      for(Int_t digIndex=0; digIndex<kMaxNumberOfDigitsPerVolume; digIndex++) {
	if (digitsInVolumeIndices[digIndex]<0) continue;
	digitInteresting = (AliTOFdigit*)fDigits->UncheckedAt(digitsInVolumeIndices[digIndex]);
	if (digitInteresting->GetToT()<=0) continue; // AdC
	digitIndexLocal++; // AdC

	AliDebug(1,Form(" %2d %1d %2d %1d %2d  %d %d %d %d  %5d  %5d %5d %5d",
			vol[0], vol[1], vol[2] ,vol[4], vol[3],
			digitInteresting->GetTdc(), digitInteresting->GetAdc(),
			digitInteresting->GetToT(), digitInteresting->GetToT()*digitInteresting->GetToT(),
			digitsInVolumeIndices[digIndex],
			digitInteresting->GetTrack(0), digitInteresting->GetTrack(1), digitInteresting->GetTrack(2)));

	selectedDigit[interestingCounter][digitIndexLocal] = new // AdC
	  AliTOFselectedDigit(vol, digitInteresting->GetTdc(),
			      digitInteresting->GetAdc(), digitInteresting->GetToT(),
			      digitInteresting->GetToT()*digitInteresting->GetToT(),
			      digitsInVolumeIndices[digIndex],
			      digitInteresting->GetTracks());
      }
      if (digitIndexLocal==-1) interestingCounter--; // AdC
    }

    AliDebug(1,Form(" e adesso %1d", interestingCounter+1));

    for (Int_t adesso1=0; adesso1<interestingCounter+1; adesso1++) {
      for (Int_t firstIndex=0; firstIndex<kMaxNumberOfDigitsPerVolume; firstIndex++) {
	if (selectedDigit[adesso1][firstIndex]==0x0) continue;

	for (Int_t adesso2=adesso1+1; adesso2<interestingCounter+1; adesso2++) {
	  for (Int_t secondIndex=0; secondIndex<kMaxNumberOfDigitsPerVolume; secondIndex++) {
	    if (selectedDigit[adesso2][secondIndex]==0x0) continue;

	    if (TMath::Abs(selectedDigit[adesso1][firstIndex]->GetTDC()-selectedDigit[adesso2][secondIndex]->GetTDC())>fMaxDeltaTime) continue;

	    interestingTOF[0] = selectedDigit[adesso1][firstIndex]->GetTDC();
	    interestingTOT[0] = selectedDigit[adesso1][firstIndex]->GetTOT();
	    interestingADC[0] = selectedDigit[adesso1][firstIndex]->GetADC();
	    interestingWeight[0] = selectedDigit[adesso1][firstIndex]->GetWeight();
	    Int_t vol1[5]; for(jj=0; jj<5; jj++) vol1[jj] = selectedDigit[adesso1][firstIndex]->GetDetectorIndex(jj);
	    AliDebug(1,Form(" %2d %1d %2d %1d %2d", vol1[0], vol1[1], vol1[2], vol1[4], vol1[3]));
	    Int_t volDum = vol1[3];
	    vol1[3] = vol1[4];
	    vol1[4] = volDum;
	    fTOFGeometry->GetPosPar(vol1,pos);
	    interestingX[0] = pos[0];
	    interestingY[0] = pos[1];
	    interestingZ[0] = pos[2];

	    interestingTOF[1] = selectedDigit[adesso2][secondIndex]->GetTDC();
	    interestingTOT[1] = selectedDigit[adesso2][secondIndex]->GetTOT();
	    interestingADC[1] = selectedDigit[adesso2][secondIndex]->GetADC();
	    interestingWeight[1] = selectedDigit[adesso2][secondIndex]->GetWeight();
	    Int_t vol2[5]; for(jj=0; jj<5; jj++) vol2[jj] = selectedDigit[adesso2][secondIndex]->GetDetectorIndex(jj);
	    AliDebug(1,Form(" %2d %1d %2d %1d %2d", vol2[0], vol2[1], vol2[2], vol2[4], vol2[3]));
	    volDum = vol2[3];
	    vol2[3] = vol2[4];
	    vol2[4] = volDum;
	    fTOFGeometry->GetPosPar(vol2,pos);
	    interestingX[1] = pos[0];
	    interestingY[1] = pos[1];
	    interestingZ[1] = pos[2];

	    AverageCalculations(2, interestingX, interestingY, interestingZ,
				interestingTOF, interestingTOT, interestingADC,
				interestingWeight,
				parTOF, posClus, check);

	    for (jj=0; jj<5; jj++) det[jj] = -1;
	    for (jj=0; jj<3; jj++) posF[jj] = posClus[jj];
	    fTOFGeometry->GetDetID(posF, det);

	    volIdClus = fTOFGeometry->GetAliSensVolIndex(det[0],det[1],det[2]);
	    //volIdClus = GetClusterVolIndex(det);

	    for (jj=3; jj<11; jj++) padsCluster[jj] = -1;
	    padsCluster[3] = selectedDigit[adesso1][firstIndex]->GetDetectorIndex(4);
	    padsCluster[4] = selectedDigit[adesso1][firstIndex]->GetDetectorIndex(3);
	    padsCluster[5] = selectedDigit[adesso2][secondIndex]->GetDetectorIndex(4);
	    padsCluster[6] = selectedDigit[adesso2][secondIndex]->GetDetectorIndex(3);

	    for (jj=0; jj<6; jj++) covClus[jj] = 0.;
	    Int_t ** indDet = new Int_t*[2];
	    for (jj=0; jj<2; jj++) indDet[jj] = new Int_t [5];
	    for (jj=0; jj<2; jj++) indDet[jj][0] = nSector;
	    for (jj=0; jj<2; jj++) indDet[jj][1] = nPlate;
	    for (jj=0; jj<2; jj++) indDet[jj][2] = nStrip;
	    for (jj=0; jj<2; jj++) indDet[jj][3] = padsCluster[2*jj+3];
	    for (jj=0; jj<2; jj++) indDet[jj][4] = padsCluster[2*jj+1+3];
	    GetClusterPars(/*check,*/ 2, indDet, interestingWeight, posClus, covClus);
	    for (jj=0; jj<2; jj++) delete [] indDet[jj];
	    delete [] indDet;

	    // To fill the track index array
	    dummyCounter=-1;
	    for (jj=0; jj<kMaxNumberOfTracksPerDigit; jj++) tracks[jj] = -1;
	    for (Int_t kk=0; kk<kMaxNumberOfTracksPerDigit; kk++) { // three is the max number of tracks associated to one digit
	      if (selectedDigit[adesso1][firstIndex]->GetTrackLabel(kk)==-1) continue;
	      else {
		dummyCounter++;
		tracks[dummyCounter] = selectedDigit[adesso1][firstIndex]->GetTrackLabel(kk);
	      }
	    }
	    for (Int_t kk=0; kk<kMaxNumberOfTracksPerDigit; kk++) { // three is the max number of tracks associated to one digit
	      if (selectedDigit[adesso2][secondIndex]->GetTrackLabel(kk)==-1) continue;
	      else {

		alreadyStored = kFALSE;
		for (jj=0; jj<dummyCounter+1; jj++)
		  alreadyStored = alreadyStored || (tracks[jj]!=-1 && tracks[jj]==selectedDigit[adesso2][secondIndex]->GetTrackLabel(kk));

		if (alreadyStored) continue;
		if (dummyCounter==2) { // three is the max number of tracks associated to one cluster
		  AliWarning("  Siamo al limite!");
		  continue;
		}

		dummyCounter++;
		tracks[dummyCounter] = selectedDigit[adesso2][secondIndex]->GetTrackLabel(kk);

	      }

	    }


	    AliTOFcluster *tofCluster =
	      new AliTOFcluster(volIdClus, posClus[0], posClus[1], posClus[2],
				covClus[0], covClus[1], covClus[2], covClus[3], covClus[4], covClus[5],
				tracks, det, parTOF, status, selectedDigit[adesso1][firstIndex]->GetIndex()); // to be updated
	    InsertCluster(tofCluster);

	    AliDebug(2, Form("       %4d  %f %f %f  %f %f %f %f %f %f  %3d %3d %3d  %2d %1d %2d %1d %2d  %4d %3d %3d %4d %4d  %1d  %4d", 
			     volIdClus, posClus[0], posClus[1], posClus[2],
			     covClus[0], covClus[1], covClus[2], covClus[3], covClus[4], covClus[5],
			     tracks[0], tracks[1], tracks[2],
			     det[0], det[1], det[2], det[3], det[4],
			     parTOF[0], parTOF[1], parTOF[2], parTOF[3], parTOF[4],
			     status, selectedDigit[adesso1][firstIndex]->GetIndex()));

	    volDum = vol1[3];
	    vol1[3] = vol1[4];
	    vol1[4] = volDum;
	    fTOFdigitMap->ResetDigitNumber(vol1,selectedDigit[adesso1][firstIndex]->GetIndex());
	    volDum = vol2[3];
	    vol2[3] = vol2[4];
	    vol2[4] = volDum;
	    fTOFdigitMap->ResetDigitNumber(vol2,selectedDigit[adesso2][secondIndex]->GetIndex());


	  } // close loop on second digit
	} // close loop on adesso2

      } // close loop on first digit
    } // close loop on adesso1

    for (ii=0; ii<kMaxNumberOfInterestingPads; ii++)
      for (jj=0; jj<kMaxNumberOfDigitsPerVolume; jj++)
	selectedDigit[ii][jj] = 0x0;

  } // loop on iPad

  for (ii=0; ii<kMaxNumberOfInterestingPads; ii++) {
    for (jj=0; jj<kMaxNumberOfDigitsPerVolume; jj++) {
      delete [] selectedDigit[ii][jj];
      selectedDigit[ii][jj] = 0x0;
    }
    delete [] selectedDigit[ii];
    selectedDigit[ii] = 0x0;
  }
  delete [] selectedDigit;
  selectedDigit = 0x0;

}
//_____________________________________________________________________________

void AliTOFClusterFinderV1::FindClusters24(Int_t nSector,
					   Int_t nPlate,
					   Int_t nStrip)
{
  //
  // This function searches the neighbouring digits (stored in the fDigits object),
  // to perform clusters (stored in the fTofClusters array).
  //
  // This research has been made by checking the fTOFdigitMap object,
  // filled at digits/raw-data reading time.
  //

  const Int_t kMaxNumberOfInterestingPads = 4;
  const Int_t kMaxNumberOfTracksPerDigit = 3;
  const Int_t kMaxNumberOfDigitsPerVolume = 10;

  Int_t ii = 0;

  Int_t digitsInVolumeIndices[kMaxNumberOfDigitsPerVolume];
  for (ii=0; ii<kMaxNumberOfDigitsPerVolume; ii++)
    digitsInVolumeIndices[ii] = -1;

  Int_t vol[5] = {nSector,nPlate,nStrip,-1,-1};

  Float_t pos[3] = {0.,0.,0.};

  Int_t jj = 0;
  Int_t interestingPadX[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingPadX[jj] = -1;
  Int_t interestingPadZ[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingPadZ[jj] = -1;
  Double_t interestingTOT[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingTOT[jj] = 0;
  Double_t interestingADC[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingADC[jj] = 0;
  Double_t interestingTOF[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingTOF[jj] = 0;
  Double_t interestingWeight[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingWeight[jj] = 0;

  Float_t interestingX[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingX[jj] = 0;
  Float_t interestingY[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingY[jj] = 0;
  Float_t interestingZ[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingZ[jj] = 0;

  Float_t interDigit[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interDigit[jj] = 0;

  Int_t padsCluster[11];
  padsCluster[0] = nSector;
  padsCluster[1] = nPlate;
  padsCluster[2] = nStrip;
  for (jj=3; jj<11; jj++) padsCluster[jj] = -1;

  Int_t interestingCounter=-1;
  Int_t digitIndexLocal = -1;
  Int_t iPad  = -1;
  Int_t iPadX = -1;
  Int_t iPadZ = -1;

  Bool_t check = kFALSE;
  Int_t parTOF[7];
  for (jj=0; jj<7; jj++) parTOF[jj] = 0;
  Double_t posClus[3];
  for (jj=0; jj<3; jj++) posClus[jj] = 0.;
  Int_t det[5];
  for (jj=0; jj<5; jj++) det[jj] = -1;
  Float_t posF[3];
  for (jj=0; jj<3; jj++) posF[jj] = 0.;
  UShort_t volIdClus = 0;
  Bool_t status = kTRUE; //assume all sim channels ok in the beginning...
  Double_t covClus[6];
  for (jj=0; jj<6; jj++) covClus[jj] = 0.;
  Int_t tracks[kMaxNumberOfTracksPerDigit];
  for (jj=0; jj<kMaxNumberOfTracksPerDigit; jj++) tracks[jj] = -1;
  Int_t dummyCounter=-1;
  Bool_t alreadyStored = kFALSE;

  AliTOFselectedDigit ***selectedDigit = new AliTOFselectedDigit**[kMaxNumberOfInterestingPads];
  for (ii=0; ii<kMaxNumberOfInterestingPads; ii++)
    selectedDigit[ii] = new AliTOFselectedDigit*[kMaxNumberOfDigitsPerVolume];

  for (ii=0; ii<kMaxNumberOfInterestingPads; ii++)
    for (jj=0; jj<kMaxNumberOfDigitsPerVolume; jj++) selectedDigit[ii][jj] = 0x0;

  AliTOFdigit *digitInteresting;

  for (iPad=0; iPad<AliTOFGeometry::NpadZ()*AliTOFGeometry::NpadX()-3; iPad+=2) {

    iPadZ = iPad%AliTOFGeometry::NpadZ(); //iPad%2;
    iPadX = iPad/AliTOFGeometry::NpadZ(); //iPad/2;

    AliDebug(3, Form("%2d %1d %2d\n", iPad, iPadZ, iPadX));






    interestingCounter=-1;

    vol[4] = iPadZ  , vol[3]  = iPadX;
    if (fTOFdigitMap->GetNumberOfDigits(vol)>0)
      interestingCounter++;

    vol[4] = iPadZ, vol[3] = iPadX+1;
    if (fTOFdigitMap->GetNumberOfDigits(vol)>0)
      interestingCounter++;

    vol[4] = AliTOFGeometry::NpadZ()-(iPadZ+1), vol[3] = iPadX;
    if (fTOFdigitMap->GetNumberOfDigits(vol)>0)
      interestingCounter++;

    vol[4] = AliTOFGeometry::NpadZ()-(iPadZ+1), vol[3] = iPadX+1;
    if (fTOFdigitMap->GetNumberOfDigits(vol)>0)
      interestingCounter++;

    if (interestingCounter+1!=4) continue; // the hit pads have to be 4
    else interestingCounter=-1;


    for (ii=0; ii<kMaxNumberOfInterestingPads; ii++)
      for (jj=0; jj<kMaxNumberOfDigitsPerVolume; jj++)
	selectedDigit[ii][jj] = 0x0;


    vol[4] = iPadZ, vol[3] = iPadX;

    if (fTOFdigitMap->GetNumberOfDigits(vol)>0) {
      interestingCounter++;
      for (ii=0; ii<kMaxNumberOfDigitsPerVolume; ii++)
	digitsInVolumeIndices[ii] = -1;
      fTOFdigitMap->GetDigitIndex(vol, digitsInVolumeIndices);
      digitIndexLocal=-1; // AdC
      for(Int_t digIndex=0; digIndex<kMaxNumberOfDigitsPerVolume; digIndex++) {
	if (digitsInVolumeIndices[digIndex]<0) continue;
	digitInteresting = (AliTOFdigit*)fDigits->UncheckedAt(digitsInVolumeIndices[digIndex]);
	if (digitInteresting->GetToT()<=0) continue; // AdC
	digitIndexLocal++; // AdC

	AliDebug(1,Form(" %2d %1d %2d %1d %2d  %d %d %d %d  %5d  %5d %5d %5d",
			vol[0], vol[1], vol[2] ,vol[4], vol[3],
			digitInteresting->GetTdc(), digitInteresting->GetAdc(),
			digitInteresting->GetToT(), digitInteresting->GetToT()*digitInteresting->GetToT(),
			digitsInVolumeIndices[digIndex],
			digitInteresting->GetTrack(0), digitInteresting->GetTrack(1), digitInteresting->GetTrack(2)));

	selectedDigit[interestingCounter][digitIndexLocal] = new // AdC
	  AliTOFselectedDigit(vol, digitInteresting->GetTdc(),
			      digitInteresting->GetAdc(), digitInteresting->GetToT(),
			      digitInteresting->GetToT()*digitInteresting->GetToT(),
			      digitsInVolumeIndices[digIndex],
			      digitInteresting->GetTracks());
      }
      if (digitIndexLocal==-1) interestingCounter--; // AdC
    }


    vol[4] = iPadZ, vol[3] = iPadX+1;

    if (fTOFdigitMap->GetNumberOfDigits(vol)>0) {
      interestingCounter++;
      for (ii=0; ii<kMaxNumberOfDigitsPerVolume; ii++)
	digitsInVolumeIndices[ii] = -1;
      fTOFdigitMap->GetDigitIndex(vol, digitsInVolumeIndices);
      digitIndexLocal=-1; // AdC
      for(Int_t digIndex=0; digIndex<kMaxNumberOfDigitsPerVolume; digIndex++) {
	if (digitsInVolumeIndices[digIndex]<0) continue;
	digitInteresting = (AliTOFdigit*)fDigits->UncheckedAt(digitsInVolumeIndices[digIndex]);
	if (digitInteresting->GetToT()<=0) continue; // AdC
	digitIndexLocal++; // AdC

	AliDebug(1,Form(" %2d %1d %2d %1d %2d  %d %d %d %d  %5d  %5d %5d %5d",
			vol[0], vol[1], vol[2] ,vol[4], vol[3],
			digitInteresting->GetTdc(), digitInteresting->GetAdc(),
			digitInteresting->GetToT(), digitInteresting->GetToT()*digitInteresting->GetToT(),
			digitsInVolumeIndices[digIndex],
			digitInteresting->GetTrack(0), digitInteresting->GetTrack(1), digitInteresting->GetTrack(2)));

	selectedDigit[interestingCounter][digitIndexLocal] = new // AdC
	  AliTOFselectedDigit(vol, digitInteresting->GetTdc(),
			      digitInteresting->GetAdc(), digitInteresting->GetToT(),
			      digitInteresting->GetToT()*digitInteresting->GetToT(),
			      digitsInVolumeIndices[digIndex],
			      digitInteresting->GetTracks());
      }
      if (digitIndexLocal==-1) interestingCounter--; // AdC
    }


    vol[4] = AliTOFGeometry::NpadZ()-(iPadZ+1), vol[3] = iPadX;

    if (fTOFdigitMap->GetNumberOfDigits(vol)>0) {
      interestingCounter++;
      for (ii=0; ii<kMaxNumberOfDigitsPerVolume; ii++)
	digitsInVolumeIndices[ii] = -1;
      fTOFdigitMap->GetDigitIndex(vol, digitsInVolumeIndices);
      digitIndexLocal=-1; // AdC
      for(Int_t digIndex=0; digIndex<kMaxNumberOfDigitsPerVolume; digIndex++) {
	if (digitsInVolumeIndices[digIndex]<0) continue;
	digitInteresting = (AliTOFdigit*)fDigits->UncheckedAt(digitsInVolumeIndices[digIndex]);
	if (digitInteresting->GetToT()<=0) continue; // AdC
	digitIndexLocal++; // AdC

	AliDebug(1,Form(" %2d %1d %2d %1d %2d  %d %d %d %d  %5d  %5d %5d %5d",
			vol[0], vol[1], vol[2] ,vol[4], vol[3],
			digitInteresting->GetTdc(), digitInteresting->GetAdc(),
			digitInteresting->GetToT(), digitInteresting->GetToT()*digitInteresting->GetToT(),
			digitsInVolumeIndices[digIndex],
			digitInteresting->GetTrack(0), digitInteresting->GetTrack(1), digitInteresting->GetTrack(2)));

	selectedDigit[interestingCounter][digitIndexLocal] = new // AdC
	  AliTOFselectedDigit(vol, digitInteresting->GetTdc(),
			      digitInteresting->GetAdc(), digitInteresting->GetToT(),
			      digitInteresting->GetToT()*digitInteresting->GetToT(),
			      digitsInVolumeIndices[digIndex],
			      digitInteresting->GetTracks());
      }
      if (digitIndexLocal==-1) interestingCounter--; // AdC
    }


    vol[4] = AliTOFGeometry::NpadZ()-(iPadZ+1), vol[3] = iPadX+1;

    if (fTOFdigitMap->GetNumberOfDigits(vol)>0) {
      interestingCounter++;
      for (ii=0; ii<kMaxNumberOfDigitsPerVolume; ii++)
	digitsInVolumeIndices[ii] = -1;
      fTOFdigitMap->GetDigitIndex(vol, digitsInVolumeIndices);
      digitIndexLocal=-1; // AdC
      for(Int_t digIndex=0; digIndex<kMaxNumberOfDigitsPerVolume; digIndex++) {
	if (digitsInVolumeIndices[digIndex]<0) continue;
	digitInteresting = (AliTOFdigit*)fDigits->UncheckedAt(digitsInVolumeIndices[digIndex]);
	if (digitInteresting->GetToT()<=0) continue; // AdC
	digitIndexLocal++; // AdC

	AliDebug(1,Form(" %2d %1d %2d %1d %2d  %d %d %d %d  %5d  %5d %5d %5d",
			vol[0], vol[1], vol[2] ,vol[4], vol[3],
			digitInteresting->GetTdc(), digitInteresting->GetAdc(),
			digitInteresting->GetToT(), digitInteresting->GetToT()*digitInteresting->GetToT(),
			digitsInVolumeIndices[digIndex],
			digitInteresting->GetTrack(0), digitInteresting->GetTrack(1), digitInteresting->GetTrack(2)));

	selectedDigit[interestingCounter][digitIndexLocal] = new // AdC
	  AliTOFselectedDigit(vol, digitInteresting->GetTdc(),
			      digitInteresting->GetAdc(), digitInteresting->GetToT(),
			      digitInteresting->GetToT()*digitInteresting->GetToT(),
			      digitsInVolumeIndices[digIndex],
			      digitInteresting->GetTracks());
      }
      if (digitIndexLocal==-1) interestingCounter--; // AdC
    }

    AliDebug(1,Form(" e adesso %1d", interestingCounter+1));

    for (Int_t adesso1=0; adesso1<interestingCounter+1; adesso1++) {
      for (Int_t firstIndex=0; firstIndex<kMaxNumberOfDigitsPerVolume; firstIndex++) {
	if (selectedDigit[adesso1][firstIndex]==0x0) continue;

	for (Int_t adesso2=adesso1+1; adesso2<interestingCounter+1; adesso2++) {
	  for (Int_t secondIndex=0; secondIndex<kMaxNumberOfDigitsPerVolume; secondIndex++) {
	    if (selectedDigit[adesso2][secondIndex]==0x0) continue;

	    if (TMath::Abs(selectedDigit[adesso1][firstIndex]->GetTDC()-selectedDigit[adesso2][secondIndex]->GetTDC())>fMaxDeltaTime) continue;

	    interestingTOF[0] = selectedDigit[adesso1][firstIndex]->GetTDC();
	    interestingTOT[0] = selectedDigit[adesso1][firstIndex]->GetTOT();
	    interestingADC[0] = selectedDigit[adesso1][firstIndex]->GetADC();
	    interestingWeight[0] = selectedDigit[adesso1][firstIndex]->GetWeight();
	    Int_t vol1[5]; for(jj=0; jj<5; jj++) vol1[jj] = selectedDigit[adesso1][firstIndex]->GetDetectorIndex(jj);
	    AliDebug(1,Form(" %2d %1d %2d %1d %2d", vol1[0], vol1[1], vol1[2], vol1[4], vol1[3]));
	    Int_t volDum = vol1[3];
	    vol1[3] = vol1[4];
	    vol1[4] = volDum;
	    fTOFGeometry->GetPosPar(vol1,pos);
	    interestingX[0] = pos[0];
	    interestingY[0] = pos[1];
	    interestingZ[0] = pos[2];

	    interestingTOF[1] = selectedDigit[adesso2][secondIndex]->GetTDC();
	    interestingTOT[1] = selectedDigit[adesso2][secondIndex]->GetTOT();
	    interestingADC[1] = selectedDigit[adesso2][secondIndex]->GetADC();
	    interestingWeight[1] = selectedDigit[adesso2][secondIndex]->GetWeight();
	    Int_t vol2[5]; for(jj=0; jj<5; jj++) vol2[jj] = selectedDigit[adesso2][secondIndex]->GetDetectorIndex(jj);
	    AliDebug(1,Form(" %2d %1d %2d %1d %2d", vol2[0], vol2[1], vol2[2], vol2[4], vol2[3]));
	    volDum = vol2[3];
	    vol2[3] = vol2[4];
	    vol2[4] = volDum;
	    fTOFGeometry->GetPosPar(vol2,pos);
	    interestingX[1] = pos[0];
	    interestingY[1] = pos[1];
	    interestingZ[1] = pos[2];


	    AverageCalculations(2, interestingX, interestingY, interestingZ,
				interestingTOF, interestingTOT, interestingADC,
				interestingWeight,
				parTOF, posClus, check);

	    for (jj=0; jj<5; jj++) det[jj] = -1;
	    for (jj=0; jj<3; jj++) posF[jj] = posClus[jj];
	    fTOFGeometry->GetDetID(posF, det);

	    volIdClus = fTOFGeometry->GetAliSensVolIndex(det[0],det[1],det[2]);
	    //volIdClus = GetClusterVolIndex(det);

	    for (jj=3; jj<11; jj++) padsCluster[jj] = -1;
	    padsCluster[3] = selectedDigit[adesso1][firstIndex]->GetDetectorIndex(4);
	    padsCluster[4] = selectedDigit[adesso1][firstIndex]->GetDetectorIndex(3);
	    padsCluster[5] = selectedDigit[adesso2][secondIndex]->GetDetectorIndex(4);
	    padsCluster[6] = selectedDigit[adesso2][secondIndex]->GetDetectorIndex(3);

	    for (jj=0; jj<6; jj++) covClus[jj] = 0.;
	    Int_t ** indDet = new Int_t*[2];
	    for (jj=0; jj<2; jj++) indDet[jj] = new Int_t [5];
	    for (jj=0; jj<2; jj++) indDet[jj][0] = nSector;
	    for (jj=0; jj<2; jj++) indDet[jj][1] = nPlate;
	    for (jj=0; jj<2; jj++) indDet[jj][2] = nStrip;
	    for (jj=0; jj<2; jj++) indDet[jj][3] = padsCluster[2*jj+3];
	    for (jj=0; jj<2; jj++) indDet[jj][4] = padsCluster[2*jj+1+3];
	    GetClusterPars(/*check,*/ 2, indDet, interestingWeight, posClus, covClus);
	    for (jj=0; jj<2; jj++) delete [] indDet[jj];
	    delete [] indDet;

	    // To fill the track index array
	    dummyCounter=-1;
	    for (jj=0; jj<kMaxNumberOfTracksPerDigit; jj++) tracks[jj] = -1;
	    for (Int_t kk=0; kk<kMaxNumberOfTracksPerDigit; kk++) { // three is the max number of tracks associated to one digit
	      if (selectedDigit[adesso1][firstIndex]->GetTrackLabel(kk)==-1) continue;
	      else {
		dummyCounter++;
		tracks[dummyCounter] = selectedDigit[adesso1][firstIndex]->GetTrackLabel(kk);
	      }
	    }
	    for (Int_t kk=0; kk<kMaxNumberOfTracksPerDigit; kk++) { // three is the max number of tracks associated to one digit
	      if (selectedDigit[adesso2][secondIndex]->GetTrackLabel(kk)==-1) continue;
	      else {

		alreadyStored = kFALSE;
		for (jj=0; jj<dummyCounter+1; jj++)
		  alreadyStored = alreadyStored || (tracks[jj]!=-1 && tracks[jj]==selectedDigit[adesso2][secondIndex]->GetTrackLabel(kk));

		if (alreadyStored) continue;
		if (dummyCounter==2) { // three is the max number of tracks associated to one cluster
		  AliWarning("  Siamo al limite!");
		  continue;
		}

		dummyCounter++;
		tracks[dummyCounter] = selectedDigit[adesso2][secondIndex]->GetTrackLabel(kk);

	      }

	    }


	    AliTOFcluster *tofCluster =
	      new AliTOFcluster(volIdClus, posClus[0], posClus[1], posClus[2],
				covClus[0], covClus[1], covClus[2], covClus[3], covClus[4], covClus[5],
				tracks, det, parTOF, status, selectedDigit[adesso1][firstIndex]->GetIndex()); // to be updated
	    InsertCluster(tofCluster);

	    AliDebug(2, Form("       %4d  %f %f %f  %f %f %f %f %f %f  %3d %3d %3d  %2d %1d %2d %1d %2d  %4d %3d %3d %4d %4d  %1d  %4d", 
			     volIdClus, posClus[0], posClus[1], posClus[2],
			     covClus[0], covClus[1], covClus[2], covClus[3], covClus[4], covClus[5],
			     tracks[0], tracks[1], tracks[2],
			     det[0], det[1], det[2], det[3], det[4],
			     parTOF[0], parTOF[1], parTOF[2], parTOF[3], parTOF[4],
			     status, selectedDigit[adesso1][firstIndex]->GetIndex()));

	    volDum = vol1[3];
	    vol1[3] = vol1[4];
	    vol1[4] = volDum;
	    fTOFdigitMap->ResetDigitNumber(vol1,selectedDigit[adesso1][firstIndex]->GetIndex());
	    volDum = vol2[3];
	    vol2[3] = vol2[4];
	    vol2[4] = volDum;
	    fTOFdigitMap->ResetDigitNumber(vol2,selectedDigit[adesso2][secondIndex]->GetIndex());


	  } // close loop on second digit
	} // close loop on adesso2

      } // close loop on first digit
    } // close loop on adesso1

    for (ii=0; ii<kMaxNumberOfInterestingPads; ii++)
      for (jj=0; jj<kMaxNumberOfDigitsPerVolume; jj++)
	selectedDigit[ii][jj] = 0x0;

  } // loop on iPad

  for (ii=0; ii<kMaxNumberOfInterestingPads; ii++) {
    for (jj=0; jj<kMaxNumberOfDigitsPerVolume; jj++) {
      delete [] selectedDigit[ii][jj];
      selectedDigit[ii][jj] = 0x0;
    }
    delete [] selectedDigit[ii];
    selectedDigit[ii] = 0x0;
  }
  delete [] selectedDigit;
  selectedDigit = 0x0;

}
//_____________________________________________________________________________

void AliTOFClusterFinderV1::FindClustersPerStrip(Int_t nSector,
						 Int_t nPlate,
						 Int_t nStrip,
						 Int_t group)
{
  //
  // This function searches the neighbouring digits (stored in the fDigits object),
  // to perform clusters (stored in the fTofClusters array).
  //
  // Each strip is read four times:
  //  - 1st time: it searches possible clusters formed by four
  //              neighbouring digits;
  //  - 2nd time: it searches possible clusters formed by three
  //              neighbouring digits;
  //  - 3rd time: it searches possible clusters formed by two
  //              neighbouring digits;
  //  - 4th time: the remaining isolated digits have been transformed
  //              in clusters.
  // This research has been made by checking the fTOFdigitMap object,
  // filled at digits/raw-data reading time.
  //

  const Int_t kMaxNumberOfInterestingPads = 4;
  const Int_t kMaxNumberOfTracksPerDigit = 3;
  const Int_t kMaxNumberOfDigitsPerVolume = 10;

  Int_t ii = 0;

  Int_t digitsInVolumeIndices[kMaxNumberOfDigitsPerVolume];
  for (ii=0; ii<kMaxNumberOfDigitsPerVolume; ii++)
    digitsInVolumeIndices[ii] = -1;

  Int_t vol[5] = {nSector,nPlate,nStrip,-1,-1};

  Float_t pos[3] = {0.,0.,0.};

  Int_t jj = 0;
  Int_t interestingPadX[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingPadX[jj] = -1;
  Int_t interestingPadZ[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingPadZ[jj] = -1;
  Double_t interestingTOT[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingTOT[jj] = 0;
  Double_t interestingADC[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingADC[jj] = 0;
  Double_t interestingTOF[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingTOF[jj] = 0;
  Double_t interestingWeight[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingWeight[jj] = 0;

  Float_t interestingX[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingX[jj] = 0;
  Float_t interestingY[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingY[jj] = 0;
  Float_t interestingZ[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interestingZ[jj] = 0;

  Float_t interDigit[kMaxNumberOfInterestingPads];
  for (jj=0; jj<kMaxNumberOfInterestingPads; jj++) interDigit[jj] = 0;

  Int_t padsCluster[11];
  padsCluster[0] = nSector;
  padsCluster[1] = nPlate;
  padsCluster[2] = nStrip;
  for (jj=3; jj<11; jj++) padsCluster[jj] = -1;

  Int_t interestingCounter=-1;
  Int_t digitIndexLocal = -1;
  Int_t iPad  = -1;
  Int_t iPadX = -1;
  Int_t iPadZ = -1;

  Bool_t check = kFALSE;
  Int_t parTOF[7];
  for (jj=0; jj<7; jj++) parTOF[jj] = 0;
  Double_t posClus[3];
  for (jj=0; jj<3; jj++) posClus[jj] = 0.;
  Int_t det[5];
  for (jj=0; jj<5; jj++) det[jj] = -1;
  Float_t posF[3];
  for (jj=0; jj<3; jj++) posF[jj] = 0.;
  UShort_t volIdClus = 0;
  Bool_t status = kTRUE; //assume all sim channels ok in the beginning...
  Double_t covClus[6];
  for (jj=0; jj<6; jj++) covClus[jj] = 0.;
  Int_t tracks[kMaxNumberOfTracksPerDigit];
  for (jj=0; jj<kMaxNumberOfTracksPerDigit; jj++) tracks[jj] = -1;
  Int_t dummyCounter=-1;
  Bool_t alreadyStored = kFALSE;

  AliTOFselectedDigit ***selectedDigit = new AliTOFselectedDigit**[kMaxNumberOfInterestingPads];
  for (ii=0; ii<kMaxNumberOfInterestingPads; ii++)
    selectedDigit[ii] = new AliTOFselectedDigit*[kMaxNumberOfDigitsPerVolume];

  for (ii=0; ii<kMaxNumberOfInterestingPads; ii++)
    for (jj=0; jj<kMaxNumberOfDigitsPerVolume; jj++) selectedDigit[ii][jj] = 0x0;

  AliTOFdigit *digitInteresting;

  group = group-1;

  for (iPad=0; iPad<AliTOFGeometry::NpadZ()*AliTOFGeometry::NpadX()-3; iPad+=2) {

    iPadZ = iPad%AliTOFGeometry::NpadZ(); //iPad%2;
    iPadX = iPad/AliTOFGeometry::NpadZ(); //iPad/2;

    AliDebug(3, Form("%2d %1d %2d\n", iPad, iPadZ, iPadX));






    interestingCounter=-1;

    vol[4] = iPadZ  , vol[3]  = iPadX;
    if (fTOFdigitMap->GetNumberOfDigits(vol)>0)
      interestingCounter++;

    vol[4] = iPadZ, vol[3] = iPadX+1;
    if (fTOFdigitMap->GetNumberOfDigits(vol)>0)
      interestingCounter++;

    vol[4] = AliTOFGeometry::NpadZ()-(iPadZ+1), vol[3] = iPadX;
    if (fTOFdigitMap->GetNumberOfDigits(vol)>0)
      interestingCounter++;

    vol[4] = AliTOFGeometry::NpadZ()-(iPadZ+1), vol[3] = iPadX+1;
    if (fTOFdigitMap->GetNumberOfDigits(vol)>0)
      interestingCounter++;

    if (interestingCounter!=group) continue;
    else interestingCounter=-1;


    for (ii=0; ii<kMaxNumberOfInterestingPads; ii++)
      for (jj=0; jj<kMaxNumberOfDigitsPerVolume; jj++)
	selectedDigit[ii][jj] = 0x0;


    vol[4] = iPadZ, vol[3] = iPadX;

    if (fTOFdigitMap->GetNumberOfDigits(vol)>0) {
      interestingCounter++;
      for (ii=0; ii<kMaxNumberOfDigitsPerVolume; ii++)
	digitsInVolumeIndices[ii] = -1;
      fTOFdigitMap->GetDigitIndex(vol, digitsInVolumeIndices);
      digitIndexLocal=-1; // AdC
      for(Int_t digIndex=0; digIndex<kMaxNumberOfDigitsPerVolume; digIndex++) {
	if (digitsInVolumeIndices[digIndex]<0) continue;
	digitInteresting = (AliTOFdigit*)fDigits->UncheckedAt(digitsInVolumeIndices[digIndex]);
	if (digitInteresting->GetToT()<=0) continue; // AdC
	digitIndexLocal++; // AdC

	AliDebug(1,Form(" %2d %1d %2d %1d %2d  %d %d %d %d  %5d  %5d %5d %5d",
			vol[0], vol[1], vol[2] ,vol[4], vol[3],
			digitInteresting->GetTdc(), digitInteresting->GetAdc(),
			digitInteresting->GetToT(), digitInteresting->GetToT()*digitInteresting->GetToT(),
			digitsInVolumeIndices[digIndex],
			digitInteresting->GetTrack(0), digitInteresting->GetTrack(1), digitInteresting->GetTrack(2)));
	AliDebug(1,Form("   to try   %d %d ",digIndex, interestingCounter));

	selectedDigit[interestingCounter][digitIndexLocal] = new // AdC
	  AliTOFselectedDigit(vol, digitInteresting->GetTdc(),
			      digitInteresting->GetAdc(), digitInteresting->GetToT(),
			      digitInteresting->GetToT()*digitInteresting->GetToT(),
			      digitsInVolumeIndices[digIndex],
			      digitInteresting->GetTracks());
      }
      if (digitIndexLocal==-1) interestingCounter--; // AdC
    }


    vol[4] = iPadZ, vol[3] = iPadX+1;

    if (fTOFdigitMap->GetNumberOfDigits(vol)>0) {
      interestingCounter++;
      for (ii=0; ii<kMaxNumberOfDigitsPerVolume; ii++)
	digitsInVolumeIndices[ii] = -1;
      fTOFdigitMap->GetDigitIndex(vol, digitsInVolumeIndices);
      digitIndexLocal=-1; // AdC
      for(Int_t digIndex=0; digIndex<kMaxNumberOfDigitsPerVolume; digIndex++) {
	if (digitsInVolumeIndices[digIndex]<0) continue;
	digitInteresting = (AliTOFdigit*)fDigits->UncheckedAt(digitsInVolumeIndices[digIndex]);
	if (digitInteresting->GetToT()<=0) continue; // AdC
	digitIndexLocal++; // AdC

	AliDebug(1,Form(" %2d %1d %2d %1d %2d  %d %d %d %d  %5d  %5d %5d %5d",
			vol[0], vol[1], vol[2] ,vol[4], vol[3],
			digitInteresting->GetTdc(), digitInteresting->GetAdc(),
			digitInteresting->GetToT(), digitInteresting->GetToT()*digitInteresting->GetToT(),
			digitsInVolumeIndices[digIndex],
			digitInteresting->GetTrack(0), digitInteresting->GetTrack(1), digitInteresting->GetTrack(2)));
	AliDebug(1,Form("   to try   %d %d ",digIndex, interestingCounter));

	selectedDigit[interestingCounter][digitIndexLocal] = new // AdC
	  AliTOFselectedDigit(vol, digitInteresting->GetTdc(),
			      digitInteresting->GetAdc(), digitInteresting->GetToT(),
			      digitInteresting->GetToT()*digitInteresting->GetToT(),
			      digitsInVolumeIndices[digIndex],
			      digitInteresting->GetTracks());
      }
      if (digitIndexLocal==-1) interestingCounter--; // AdC
    }


    vol[4] = AliTOFGeometry::NpadZ()-(iPadZ+1), vol[3] = iPadX;

    if (fTOFdigitMap->GetNumberOfDigits(vol)>0) {
      interestingCounter++;
      for (ii=0; ii<kMaxNumberOfDigitsPerVolume; ii++)
	digitsInVolumeIndices[ii] = -1;
      fTOFdigitMap->GetDigitIndex(vol, digitsInVolumeIndices);
      digitIndexLocal=-1; // AdC
      for(Int_t digIndex=0; digIndex<kMaxNumberOfDigitsPerVolume; digIndex++) {
	if (digitsInVolumeIndices[digIndex]<0) continue;
	digitInteresting = (AliTOFdigit*)fDigits->UncheckedAt(digitsInVolumeIndices[digIndex]);
	if (digitInteresting->GetToT()<=0) continue; // AdC
	digitIndexLocal++; // AdC

	AliDebug(1,Form(" %2d %1d %2d %1d %2d  %d %d %d %d  %5d  %5d %5d %5d",
			vol[0], vol[1], vol[2] ,vol[4], vol[3],
			digitInteresting->GetTdc(), digitInteresting->GetAdc(),
			digitInteresting->GetToT(), digitInteresting->GetToT()*digitInteresting->GetToT(),
			digitsInVolumeIndices[digIndex],
			digitInteresting->GetTrack(0), digitInteresting->GetTrack(1), digitInteresting->GetTrack(2)));
	AliDebug(1,Form("   to try   %d %d ",digIndex, interestingCounter));

	selectedDigit[interestingCounter][digitIndexLocal] = new // AdC
	  AliTOFselectedDigit(vol, digitInteresting->GetTdc(),
			      digitInteresting->GetAdc(), digitInteresting->GetToT(),
			      digitInteresting->GetToT()*digitInteresting->GetToT(),
			      digitsInVolumeIndices[digIndex],
			      digitInteresting->GetTracks());
      }
      if (digitIndexLocal==-1) interestingCounter--; // AdC
    }


    vol[4] = AliTOFGeometry::NpadZ()-(iPadZ+1), vol[3] = iPadX+1;

    if (fTOFdigitMap->GetNumberOfDigits(vol)>0) {
      interestingCounter++;
      for (ii=0; ii<kMaxNumberOfDigitsPerVolume; ii++)
	digitsInVolumeIndices[ii] = -1;
      fTOFdigitMap->GetDigitIndex(vol, digitsInVolumeIndices);
      digitIndexLocal=-1; // AdC
      for(Int_t digIndex=0; digIndex<kMaxNumberOfDigitsPerVolume; digIndex++) {
	if (digitsInVolumeIndices[digIndex]<0) continue;
	digitInteresting = (AliTOFdigit*)fDigits->UncheckedAt(digitsInVolumeIndices[digIndex]);
	if (digitInteresting->GetToT()<=0) continue; // AdC
	digitIndexLocal++; // AdC

	AliDebug(1,Form(" %2d %1d %2d %1d %2d  %d %d %d %d  %5d  %5d %5d %5d",
			vol[0], vol[1], vol[2] ,vol[4], vol[3],
			digitInteresting->GetTdc(), digitInteresting->GetAdc(),
			digitInteresting->GetToT(), digitInteresting->GetToT()*digitInteresting->GetToT(),
			digitsInVolumeIndices[digIndex],
			digitInteresting->GetTrack(0), digitInteresting->GetTrack(1), digitInteresting->GetTrack(2)));
	AliDebug(1,Form("   to try   %d %d ",digIndex, interestingCounter));

	selectedDigit[interestingCounter][digitIndexLocal] = new // AdC
	  AliTOFselectedDigit(vol, digitInteresting->GetTdc(),
			      digitInteresting->GetAdc(), digitInteresting->GetToT(),
			      digitInteresting->GetToT()*digitInteresting->GetToT(),
			      digitsInVolumeIndices[digIndex],
			      digitInteresting->GetTracks());
      }
      if (digitIndexLocal==-1) interestingCounter--; // AdC
    }

    AliDebug(1,Form(" e adesso %1d", interestingCounter+1));

    Int_t adesso1 = -1;
    Int_t adesso2 = -1;
    Int_t adesso3 = -1;
    Int_t adesso4 = -1;

    switch(interestingCounter+1) {

    case 2:

      //for (adesso1=0; adesso1<interestingCounter+1; adesso1++) {
      adesso1 = 0;
	for (Int_t firstIndex=0; firstIndex<kMaxNumberOfDigitsPerVolume; firstIndex++) {
	  if (selectedDigit[adesso1][firstIndex]==0x0) continue;

	  //for (adesso2=adesso1+1; adesso2<interestingCounter+1; adesso2++) {
	  adesso2 = 1;
	    for (Int_t secondIndex=0; secondIndex<kMaxNumberOfDigitsPerVolume; secondIndex++) {
	      if (selectedDigit[adesso2][secondIndex]==0x0) continue;

	      if (TMath::Abs(selectedDigit[adesso1][firstIndex]->GetTDC()-selectedDigit[adesso2][secondIndex]->GetTDC())>fMaxDeltaTime) {
		AliDebug(1,Form(" selD1[%d][%d]->GetTDC()=%d selD2[%d][%d]->GetTDC()=%d -- %d ",
				adesso1,firstIndex,(Int_t)selectedDigit[adesso1][firstIndex]->GetTDC(),
				adesso2,secondIndex,(Int_t)selectedDigit[adesso2][secondIndex]->GetTDC(),
				fMaxDeltaTime));
		continue;
	      }

	      AliDebug(1, Form(" %1d %1d (0x%p) %1d %1d (0x%p)", adesso1, firstIndex,selectedDigit[adesso1][firstIndex],
			       adesso2, secondIndex,selectedDigit[adesso2][secondIndex]));

	      interestingTOF[0] = selectedDigit[adesso1][firstIndex]->GetTDC();
	      interestingTOT[0] = selectedDigit[adesso1][firstIndex]->GetTOT();
	      interestingADC[0] = selectedDigit[adesso1][firstIndex]->GetADC();
	      interestingWeight[0] = selectedDigit[adesso1][firstIndex]->GetWeight();
	      Int_t vol1[5]; for(jj=0; jj<5; jj++) vol1[jj] = selectedDigit[adesso1][firstIndex]->GetDetectorIndex(jj);
	      AliDebug(1,Form(" %2d %1d %2d %1d %2d", vol1[0], vol1[1], vol1[2], vol1[4], vol1[3]));
	      Int_t volDum = vol1[3];
	      vol1[3] = vol1[4];
	      vol1[4] = volDum;
	      fTOFGeometry->GetPosPar(vol1,pos);
	      AliDebug(1,Form(" %f %f %f", pos[0], pos[1], pos[2]));
	      interestingX[0] = pos[0];
	      interestingY[0] = pos[1];
	      interestingZ[0] = pos[2];

	      interestingTOF[1] = selectedDigit[adesso2][secondIndex]->GetTDC();
	      interestingTOT[1] = selectedDigit[adesso2][secondIndex]->GetTOT();
	      interestingADC[1] = selectedDigit[adesso2][secondIndex]->GetADC();
	      interestingWeight[1] = selectedDigit[adesso2][secondIndex]->GetWeight();
	      Int_t vol2[5]; for(jj=0; jj<5; jj++) vol2[jj] = selectedDigit[adesso2][secondIndex]->GetDetectorIndex(jj);
	      AliDebug(1,Form(" %2d %1d %2d %1d %2d", vol2[0], vol2[1], vol2[2], vol2[4], vol2[3]));
	      volDum = vol2[3];
	      vol2[3] = vol2[4];
	      vol2[4] = volDum;
	      fTOFGeometry->GetPosPar(vol2,pos);
	      AliDebug(1,Form(" %f %f %f", pos[0], pos[1], pos[2]));
	      interestingX[1] = pos[0];
	      interestingY[1] = pos[1];
	      interestingZ[1] = pos[2];


	      AverageCalculations(interestingCounter+1,
				  interestingX, interestingY, interestingZ,
				  interestingTOF, interestingTOT, interestingADC,
				  interestingWeight,
				  parTOF, posClus, check);

	      for (jj=0; jj<5; jj++) det[jj] = -1;
	      for (jj=0; jj<3; jj++) posF[jj] = posClus[jj];

	      AliDebug(1,Form(" %f %f %f", posF[0], posF[1], posF[2]));
	      fTOFGeometry->GetDetID(posF, det);
	      AliDebug(1,Form(" %2d %1d %2d %1d %2d", det[0], det[1], det[2], det[3], det[4]));

	      volIdClus = fTOFGeometry->GetAliSensVolIndex(det[0],det[1],det[2]);
	      //volIdClus = GetClusterVolIndex(det);

	      for (jj=3; jj<11; jj++) padsCluster[jj] = -1;
	      padsCluster[3] = selectedDigit[adesso1][firstIndex]->GetDetectorIndex(4);
	      padsCluster[4] = selectedDigit[adesso1][firstIndex]->GetDetectorIndex(3);
	      padsCluster[5] = selectedDigit[adesso2][secondIndex]->GetDetectorIndex(4);
	      padsCluster[6] = selectedDigit[adesso2][secondIndex]->GetDetectorIndex(3);

	      for (jj=0; jj<6; jj++) covClus[jj] = 0.;
	      Int_t ** indDet = new Int_t*[interestingCounter+1];
	      for (jj=0; jj<interestingCounter+1; jj++) indDet[jj] = new Int_t [5];
	      for (jj=0; jj<interestingCounter+1; jj++) indDet[jj][0] = nSector;
	      for (jj=0; jj<interestingCounter+1; jj++) indDet[jj][1] = nPlate;
	      for (jj=0; jj<interestingCounter+1; jj++) indDet[jj][2] = nStrip;
	      for (jj=0; jj<interestingCounter+1; jj++) indDet[jj][3] = padsCluster[2*jj+3];
	      for (jj=0; jj<interestingCounter+1; jj++) indDet[jj][4] = padsCluster[2*jj+1+3];
	      GetClusterPars(/*check,*/ interestingCounter+1, indDet, interestingWeight, posClus, covClus);
	      for (jj=0; jj<interestingCounter+1; jj++) delete [] indDet[jj];
	      delete [] indDet;

	      // To fill the track index array
	      dummyCounter=-1;
	      for (jj=0; jj<kMaxNumberOfTracksPerDigit; jj++) tracks[jj] = -1;
	      for (Int_t kk=0; kk<kMaxNumberOfTracksPerDigit; kk++) { // three is the max number of tracks associated to one digit
		if (selectedDigit[adesso1][firstIndex]->GetTrackLabel(kk)==-1) continue;
		else {
		  dummyCounter++;
		  tracks[dummyCounter] = selectedDigit[adesso1][firstIndex]->GetTrackLabel(kk);
		}
	      }
	      for (Int_t kk=0; kk<kMaxNumberOfTracksPerDigit; kk++) { // three is the max number of tracks associated to one digit
		if (selectedDigit[adesso2][secondIndex]->GetTrackLabel(kk)==-1) continue;
		else {

		  alreadyStored = kFALSE;
		  for (jj=0; jj<dummyCounter+1; jj++)
		    alreadyStored = alreadyStored || (tracks[jj]!=-1 && tracks[jj]==selectedDigit[adesso2][secondIndex]->GetTrackLabel(kk));

		  if (alreadyStored) continue;
		  if (dummyCounter==2) { // three is the max number of tracks associated to one cluster
		    AliWarning("  Siamo al limite!");
		    continue;
		  }

		  dummyCounter++;
		  tracks[dummyCounter] = selectedDigit[adesso2][secondIndex]->GetTrackLabel(kk);

		}

	      }


	      AliTOFcluster *tofCluster =
		new AliTOFcluster(volIdClus, posClus[0], posClus[1], posClus[2],
				  covClus[0], covClus[1], covClus[2], covClus[3], covClus[4], covClus[5],
				  tracks, det, parTOF, status, selectedDigit[adesso1][firstIndex]->GetIndex()); //to updated
	      InsertCluster(tofCluster);

	      AliDebug(2, Form("       %4d  %f %f %f  %f %f %f %f %f %f  %3d %3d %3d  %2d %1d %2d %1d %2d  %4d %3d %3d %4d %4d  %1d  %4d", 
			       volIdClus, posClus[0], posClus[1], posClus[2],
			       covClus[0], covClus[1], covClus[2], covClus[3], covClus[4], covClus[5],
			       tracks[0], tracks[1], tracks[2],
			       det[0], det[1], det[2], det[3], det[4],
			       parTOF[0], parTOF[1], parTOF[2], parTOF[3], parTOF[4],
			       status, selectedDigit[adesso1][firstIndex]->GetIndex()));

	      volDum = vol1[3];
	      vol1[3] = vol1[4];
	      vol1[4] = volDum;
	      fTOFdigitMap->ResetDigitNumber(vol1,selectedDigit[adesso1][firstIndex]->GetIndex());
	      volDum = vol2[3];
	      vol2[3] = vol2[4];
	      vol2[4] = volDum;
	      fTOFdigitMap->ResetDigitNumber(vol2,selectedDigit[adesso2][secondIndex]->GetIndex());


	    } // close loop on second digit
	    //} // close loop on adesso2

	} // close loop on first digit
	  //} // close loop on adesso1


      break;

    case 3:

      //for (adesso1=0; adesso1<interestingCounter+1; adesso1++) {
      adesso1 = 0;
	for (Int_t firstIndex=0; firstIndex<kMaxNumberOfDigitsPerVolume; firstIndex++) {
	  if (selectedDigit[adesso1][firstIndex]==0x0) continue;

	  //for (adesso2=adesso1+1; adesso2<interestingCounter+1; adesso2++) {
	  adesso2 = 1;
	    for (Int_t secondIndex=0; secondIndex<kMaxNumberOfDigitsPerVolume; secondIndex++) {
	      if (selectedDigit[adesso2][secondIndex]==0x0) continue;

	      //for (adesso3=adesso2+1; adesso3<interestingCounter+1; adesso3++) {
	      adesso3 = 2;
		for (Int_t thirdIndex=0; thirdIndex<kMaxNumberOfDigitsPerVolume; thirdIndex++) {
		  if (selectedDigit[adesso3][thirdIndex]==0x0) continue;


		  if (TMath::Abs(selectedDigit[adesso1][firstIndex]->GetTDC()-selectedDigit[adesso2][secondIndex]->GetTDC())>fMaxDeltaTime
		      ||
		      TMath::Abs(selectedDigit[adesso1][firstIndex]->GetTDC()-selectedDigit[adesso3][thirdIndex]->GetTDC())>fMaxDeltaTime
		      ||
		      TMath::Abs(selectedDigit[adesso2][secondIndex]->GetTDC()-selectedDigit[adesso3][thirdIndex]->GetTDC())>fMaxDeltaTime) continue;

		  interestingTOF[0] = selectedDigit[adesso1][firstIndex]->GetTDC();
		  interestingTOT[0] = selectedDigit[adesso1][firstIndex]->GetTOT();
		  interestingADC[0] = selectedDigit[adesso1][firstIndex]->GetADC();
		  interestingWeight[0] = selectedDigit[adesso1][firstIndex]->GetWeight();
		  Int_t vol1[5]; for(jj=0; jj<5; jj++) vol1[jj] = selectedDigit[adesso1][firstIndex]->GetDetectorIndex(jj);
		  AliDebug(1,Form(" %2d %1d %2d %1d %2d", vol1[0], vol1[1], vol1[2], vol1[4], vol1[3]));
		  Int_t volDum = vol1[3];
		  vol1[3] = vol1[4];
		  vol1[4] = volDum;
		  fTOFGeometry->GetPosPar(vol1,pos);
		  interestingX[0] = pos[0];
		  interestingY[0] = pos[1];
		  interestingZ[0] = pos[2];

		  interestingTOF[1] = selectedDigit[adesso2][secondIndex]->GetTDC();
		  interestingTOT[1] = selectedDigit[adesso2][secondIndex]->GetTOT();
		  interestingADC[1] = selectedDigit[adesso2][secondIndex]->GetADC();
		  interestingWeight[1] = selectedDigit[adesso2][secondIndex]->GetWeight();
		  Int_t vol2[5]; for(jj=0; jj<5; jj++) vol2[jj] = selectedDigit[adesso2][secondIndex]->GetDetectorIndex(jj);
		  AliDebug(1,Form(" %2d %1d %2d %1d %2d", vol2[0], vol2[1], vol2[2], vol2[4], vol2[3]));
		  volDum = vol2[3];
		  vol2[3] = vol2[4];
		  vol2[4] = volDum;
		  fTOFGeometry->GetPosPar(vol2,pos);
		  interestingX[1] = pos[0];
		  interestingY[1] = pos[1];
		  interestingZ[1] = pos[2];

		  interestingTOF[2] = selectedDigit[adesso3][thirdIndex]->GetTDC();
		  interestingTOT[2] = selectedDigit[adesso3][thirdIndex]->GetTOT();
		  interestingADC[2] = selectedDigit[adesso3][thirdIndex]->GetADC();
		  interestingWeight[2] = selectedDigit[adesso3][thirdIndex]->GetWeight();
		  Int_t vol3[5]; for(jj=0; jj<5; jj++) vol3[jj] = selectedDigit[adesso3][thirdIndex]->GetDetectorIndex(jj);
		  AliDebug(1,Form(" %2d %1d %2d %1d %2d", vol3[0], vol3[1], vol3[2], vol3[4], vol3[3]));
		  volDum = vol3[3];
		  vol3[3] = vol3[4];
		  vol3[4] = volDum;
		  fTOFGeometry->GetPosPar(vol3,pos);
		  interestingX[2] = pos[0];
		  interestingY[2] = pos[1];
		  interestingZ[2] = pos[2];


		  AverageCalculations(interestingCounter+1,
				      interestingX, interestingY, interestingZ,
				      interestingTOF, interestingTOT, interestingADC,
				      interestingWeight,
				      parTOF, posClus, check);

		  for (jj=0; jj<5; jj++) det[jj] = -1;
		  for (jj=0; jj<3; jj++) posF[jj] = posClus[jj];
		  fTOFGeometry->GetDetID(posF, det);

		  volIdClus = fTOFGeometry->GetAliSensVolIndex(det[0],det[1],det[2]);
		  //volIdClus = GetClusterVolIndex(det);

		  for (jj=3; jj<11; jj++) padsCluster[jj] = -1;
		  padsCluster[3] = selectedDigit[adesso1][firstIndex]->GetDetectorIndex(4);
		  padsCluster[4] = selectedDigit[adesso1][firstIndex]->GetDetectorIndex(3);
		  padsCluster[5] = selectedDigit[adesso2][secondIndex]->GetDetectorIndex(4);
		  padsCluster[6] = selectedDigit[adesso2][secondIndex]->GetDetectorIndex(3);
		  padsCluster[7] = selectedDigit[adesso3][thirdIndex]->GetDetectorIndex(4);
		  padsCluster[8] = selectedDigit[adesso3][thirdIndex]->GetDetectorIndex(3);

		  for (jj=0; jj<6; jj++) covClus[jj] = 0.;
		  Int_t ** indDet = new Int_t*[interestingCounter+1];
		  for (jj=0; jj<interestingCounter+1; jj++) indDet[jj] = new Int_t [5];
		  for (jj=0; jj<interestingCounter+1; jj++) indDet[jj][0] = nSector;
		  for (jj=0; jj<interestingCounter+1; jj++) indDet[jj][1] = nPlate;
		  for (jj=0; jj<interestingCounter+1; jj++) indDet[jj][2] = nStrip;
		  for (jj=0; jj<interestingCounter+1; jj++) indDet[jj][3] = padsCluster[2*jj+3];
		  for (jj=0; jj<interestingCounter+1; jj++) indDet[jj][4] = padsCluster[2*jj+1+3];
		  GetClusterPars(/*check,*/ interestingCounter+1, indDet, interestingWeight, posClus, covClus);
		  for (jj=0; jj<interestingCounter+1; jj++) delete [] indDet[jj];
		  delete [] indDet;


		  // To fill the track index array
		  dummyCounter=-1;
		  for (jj=0; jj<kMaxNumberOfTracksPerDigit; jj++) tracks[jj] = -1;
		  for (Int_t kk=0; kk<kMaxNumberOfTracksPerDigit; kk++) { // three is the max number of tracks associated to one digit
		    if (selectedDigit[adesso1][firstIndex]->GetTrackLabel(kk)==-1) continue;
		    else {
		      dummyCounter++;
		      tracks[dummyCounter] = selectedDigit[adesso1][firstIndex]->GetTrackLabel(kk);
		    }
		  }
		  for (Int_t kk=0; kk<kMaxNumberOfTracksPerDigit; kk++) { // three is the max number of tracks associated to one digit
		    if (selectedDigit[adesso2][secondIndex]->GetTrackLabel(kk)==-1) continue;
		    else {

		      alreadyStored = kFALSE;
		      for (jj=0; jj<dummyCounter+1; jj++)
			alreadyStored = alreadyStored || (tracks[jj]!=-1 && tracks[jj]==selectedDigit[adesso2][secondIndex]->GetTrackLabel(kk));

		      if (alreadyStored) continue;
		      if (dummyCounter==2) { // three is the max number of tracks associated to one cluster
			AliWarning("  Siamo al limite!");
			continue;
		      }

		      dummyCounter++;
		      tracks[dummyCounter] = selectedDigit[adesso2][secondIndex]->GetTrackLabel(kk);

		    }

		  }
		  for (Int_t kk=0; kk<kMaxNumberOfTracksPerDigit; kk++) { // three is the max number of tracks associated to one digit
		    if (selectedDigit[adesso3][thirdIndex]->GetTrackLabel(kk)==-1) continue;
		    else {

		      alreadyStored = kFALSE;
		      for (jj=0; jj<dummyCounter+1; jj++)
			alreadyStored = alreadyStored || (tracks[jj]!=-1 && tracks[jj]==selectedDigit[adesso3][thirdIndex]->GetTrackLabel(kk));

		      if (alreadyStored) continue;
		      if (dummyCounter==2) { // three is the max number of tracks associated to one cluster
			AliWarning("  Siamo al limite!");
			continue;
		      }

		      dummyCounter++;
		      tracks[dummyCounter] = selectedDigit[adesso3][thirdIndex]->GetTrackLabel(kk);

		    }

		  }


		  AliTOFcluster *tofCluster =
		    new AliTOFcluster(volIdClus, posClus[0], posClus[1], posClus[2],
				      covClus[0], covClus[1], covClus[2], covClus[3], covClus[4], covClus[5],
				      tracks, det, parTOF, status, selectedDigit[adesso1][firstIndex]->GetIndex()); // to be updated
		  InsertCluster(tofCluster);

		  AliDebug(2, Form("       %4d  %f %f %f  %f %f %f %f %f %f  %3d %3d %3d  %2d %1d %2d %1d %2d  %4d %3d %3d %4d %4d  %1d  %4d", 
				   volIdClus, posClus[0], posClus[1], posClus[2],
				   covClus[0], covClus[1], covClus[2], covClus[3], covClus[4], covClus[5],
				   tracks[0], tracks[1], tracks[2],
				   det[0], det[1], det[2], det[3], det[4],
				   parTOF[0], parTOF[1], parTOF[2], parTOF[3], parTOF[4],
				   status, selectedDigit[adesso1][firstIndex]->GetIndex()));

		  volDum = vol1[3];
		  vol1[3] = vol1[4];
		  vol1[4] = volDum;
		  fTOFdigitMap->ResetDigitNumber(vol1,selectedDigit[adesso1][firstIndex]->GetIndex());
		  volDum = vol2[3];
		  vol2[3] = vol2[4];
		  vol2[4] = volDum;
		  fTOFdigitMap->ResetDigitNumber(vol2,selectedDigit[adesso2][secondIndex]->GetIndex());
		  volDum = vol3[3];
		  vol3[3] = vol3[4];
		  vol3[4] = volDum;
		  fTOFdigitMap->ResetDigitNumber(vol3,selectedDigit[adesso3][thirdIndex]->GetIndex());


		} // close loop on third digit
		//} // close loop on adesso3

	    } // close loop on second digit
	    //} // close loop on adesso2

	} // close loop on first digit
	//} // close loop on adesso1


      break;

    case 4:

      adesso1 = 0;
      for (Int_t firstIndex=0; firstIndex<kMaxNumberOfDigitsPerVolume; firstIndex++) {
	if (selectedDigit[adesso1][firstIndex]==0x0) continue;

	adesso2 = 1;
	for (Int_t secondIndex=0; secondIndex<kMaxNumberOfDigitsPerVolume; secondIndex++) {
	  if (selectedDigit[adesso2][secondIndex]==0x0) continue;

	  adesso3 = 2;
	  for (Int_t thirdIndex=0; thirdIndex<kMaxNumberOfDigitsPerVolume; thirdIndex++) {
	    if (selectedDigit[adesso3][thirdIndex]==0x0) continue;

	    adesso4 = 3;
	    for (Int_t fourthIndex=0; fourthIndex<kMaxNumberOfDigitsPerVolume; fourthIndex++) {
	      if (selectedDigit[adesso4][fourthIndex]==0x0) continue;


	      if (TMath::Abs(selectedDigit[adesso1][firstIndex]->GetTDC()-selectedDigit[adesso2][secondIndex]->GetTDC())>fMaxDeltaTime
		  ||
		  TMath::Abs(selectedDigit[adesso1][firstIndex]->GetTDC()-selectedDigit[adesso3][thirdIndex]->GetTDC())>fMaxDeltaTime
		  ||
		  TMath::Abs(selectedDigit[adesso1][firstIndex]->GetTDC()-selectedDigit[adesso4][fourthIndex]->GetTDC())>fMaxDeltaTime
		  ||
		  TMath::Abs(selectedDigit[adesso2][secondIndex]->GetTDC()-selectedDigit[adesso3][thirdIndex]->GetTDC())>fMaxDeltaTime
		  ||
		  TMath::Abs(selectedDigit[adesso2][secondIndex]->GetTDC()-selectedDigit[adesso4][fourthIndex]->GetTDC())>fMaxDeltaTime
		  ||
		  TMath::Abs(selectedDigit[adesso3][thirdIndex]->GetTDC()-selectedDigit[adesso4][fourthIndex]->GetTDC())>fMaxDeltaTime) continue;

	      interestingTOF[0] = selectedDigit[adesso1][firstIndex]->GetTDC();
	      interestingTOT[0] = selectedDigit[adesso1][firstIndex]->GetTOT();
	      interestingADC[0] = selectedDigit[adesso1][firstIndex]->GetADC();
	      interestingWeight[0] = selectedDigit[adesso1][firstIndex]->GetWeight();
	      Int_t vol1[5]; for(jj=0; jj<5; jj++) vol1[jj] = selectedDigit[adesso1][firstIndex]->GetDetectorIndex(jj);
	      AliDebug(1,Form(" %2d %1d %2d %1d %2d", vol1[0], vol1[1], vol1[2], vol1[4], vol1[3]));
	      Int_t volDum = vol1[3];
	      vol1[3] = vol1[4];
	      vol1[4] = volDum;
	      fTOFGeometry->GetPosPar(vol1,pos);
	      interestingX[0] = pos[0];
	      interestingY[0] = pos[1];
	      interestingZ[0] = pos[2];

	      interestingTOF[1] = selectedDigit[adesso2][secondIndex]->GetTDC();
	      interestingTOT[1] = selectedDigit[adesso2][secondIndex]->GetTOT();
	      interestingADC[1] = selectedDigit[adesso2][secondIndex]->GetADC();
	      interestingWeight[1] = selectedDigit[adesso2][secondIndex]->GetWeight();
	      Int_t vol2[5]; for(jj=0; jj<5; jj++) vol2[jj] = selectedDigit[adesso2][secondIndex]->GetDetectorIndex(jj);
	      AliDebug(1,Form(" %2d %1d %2d %1d %2d", vol2[0], vol2[1], vol2[2], vol2[4], vol2[3]));
	      volDum = vol2[3];
	      vol2[3] = vol2[4];
	      vol2[4] = volDum;
	      fTOFGeometry->GetPosPar(vol2,pos);
	      interestingX[1] = pos[0];
	      interestingY[1] = pos[1];
	      interestingZ[1] = pos[2];

	      interestingTOF[2] = selectedDigit[adesso3][thirdIndex]->GetTDC();
	      interestingTOT[2] = selectedDigit[adesso3][thirdIndex]->GetTOT();
	      interestingADC[2] = selectedDigit[adesso3][thirdIndex]->GetADC();
	      interestingWeight[2] = selectedDigit[adesso3][thirdIndex]->GetWeight();
	      Int_t vol3[5]; for(jj=0; jj<5; jj++) vol3[jj] = selectedDigit[adesso3][thirdIndex]->GetDetectorIndex(jj);
	      AliDebug(1,Form(" %2d %1d %2d %1d %2d", vol3[0], vol3[1], vol3[2], vol3[4], vol3[3]));
	      volDum = vol3[3];
	      vol3[3] = vol3[4];
	      vol3[4] = volDum;
	      fTOFGeometry->GetPosPar(vol3,pos);
	      interestingX[2] = pos[0];
	      interestingY[2] = pos[1];
	      interestingZ[2] = pos[2];

	      interestingTOF[3] = selectedDigit[adesso4][fourthIndex]->GetTDC();
	      interestingTOT[3] = selectedDigit[adesso4][fourthIndex]->GetTOT();
	      interestingADC[3] = selectedDigit[adesso4][fourthIndex]->GetADC();
	      interestingWeight[3] = selectedDigit[adesso4][fourthIndex]->GetWeight();
	      Int_t vol4[5]; for(jj=0; jj<5; jj++) vol4[jj] = selectedDigit[adesso4][fourthIndex]->GetDetectorIndex(jj);
	      AliDebug(1,Form(" %2d %1d %2d %1d %2d", vol4[0], vol4[1], vol4[2], vol4[4], vol4[3]));
	      volDum = vol4[3];
	      vol4[3] = vol4[4];
	      vol4[4] = volDum;
	      fTOFGeometry->GetPosPar(vol4,pos);
	      interestingX[3] = pos[0];
	      interestingY[3] = pos[1];
	      interestingZ[3] = pos[2];


	      AverageCalculations(interestingCounter+1,
				  interestingX, interestingY, interestingZ,
				  interestingTOF, interestingTOT, interestingADC,
				  interestingWeight,
				  parTOF, posClus, check);

	      for (jj=0; jj<5; jj++) det[jj] = -1;
	      for (jj=0; jj<3; jj++) posF[jj] = posClus[jj];
	      fTOFGeometry->GetDetID(posF, det);

	      volIdClus = fTOFGeometry->GetAliSensVolIndex(det[0],det[1],det[2]);
	      //volIdClus = GetClusterVolIndex(det);

	      for (jj=3; jj<11; jj++) padsCluster[jj] = -1;
	      padsCluster[3] = selectedDigit[adesso1][firstIndex]->GetDetectorIndex(4);
	      padsCluster[4] = selectedDigit[adesso1][firstIndex]->GetDetectorIndex(3);
	      padsCluster[5] = selectedDigit[adesso2][secondIndex]->GetDetectorIndex(4);
	      padsCluster[6] = selectedDigit[adesso2][secondIndex]->GetDetectorIndex(3);
	      padsCluster[7] = selectedDigit[adesso3][thirdIndex]->GetDetectorIndex(4);
	      padsCluster[8] = selectedDigit[adesso3][thirdIndex]->GetDetectorIndex(3);
	      padsCluster[9] = selectedDigit[adesso4][fourthIndex]->GetDetectorIndex(4);
	      padsCluster[10] = selectedDigit[adesso4][fourthIndex]->GetDetectorIndex(3);

	      for (jj=0; jj<6; jj++) covClus[jj] = 0.;
	      Int_t ** indDet = new Int_t*[interestingCounter+1];
	      for (jj=0; jj<interestingCounter+1; jj++) indDet[jj] = new Int_t [5];
	      for (jj=0; jj<interestingCounter+1; jj++) indDet[jj][0] = nSector;
	      for (jj=0; jj<interestingCounter+1; jj++) indDet[jj][1] = nPlate;
	      for (jj=0; jj<interestingCounter+1; jj++) indDet[jj][2] = nStrip;
	      for (jj=0; jj<interestingCounter+1; jj++) indDet[jj][3] = padsCluster[2*jj+3];
	      for (jj=0; jj<interestingCounter+1; jj++) indDet[jj][4] = padsCluster[2*jj+1+3];
	      GetClusterPars(/*check,*/ interestingCounter+1, indDet, interestingWeight, posClus, covClus);
	      for (jj=0; jj<interestingCounter+1; jj++) delete [] indDet[jj];
	      delete [] indDet;

	      // To fill the track index array
	      dummyCounter=-1;
	      for (jj=0; jj<kMaxNumberOfTracksPerDigit; jj++) tracks[jj] = -1;
	      for (Int_t kk=0; kk<kMaxNumberOfTracksPerDigit; kk++) { // three is the max number of tracks associated to one digit
		if (selectedDigit[adesso1][firstIndex]->GetTrackLabel(kk)==-1) continue;
		else {
		  dummyCounter++;
		  tracks[dummyCounter] = selectedDigit[adesso1][firstIndex]->GetTrackLabel(kk);
		}
	      }
	      for (Int_t kk=0; kk<kMaxNumberOfTracksPerDigit; kk++) { // three is the max number of tracks associated to one digit
		if (selectedDigit[adesso2][secondIndex]->GetTrackLabel(kk)==-1) continue;
		else {

		  alreadyStored = kFALSE;
		  for (jj=0; jj<dummyCounter+1; jj++)
		    alreadyStored = alreadyStored || (tracks[jj]!=-1 && tracks[jj]==selectedDigit[adesso2][secondIndex]->GetTrackLabel(kk));

		  if (alreadyStored) continue;
		  if (dummyCounter==2) { // three is the max number of tracks associated to one cluster
		    AliWarning("  Siamo al limite!");
		    continue;
		  }

		  dummyCounter++;
		  tracks[dummyCounter] = selectedDigit[adesso2][secondIndex]->GetTrackLabel(kk);

		}

	      }
	      for (Int_t kk=0; kk<kMaxNumberOfTracksPerDigit; kk++) { // three is the max number of tracks associated to one digit
		if (selectedDigit[adesso3][thirdIndex]->GetTrackLabel(kk)==-1) continue;
		else {

		  alreadyStored = kFALSE;
		  for (jj=0; jj<dummyCounter+1; jj++)
		    alreadyStored = alreadyStored || (tracks[jj]!=-1 && tracks[jj]==selectedDigit[adesso3][thirdIndex]->GetTrackLabel(kk));

		  if (alreadyStored) continue;
		  if (dummyCounter==2) { // three is the max number of tracks associated to one cluster
		    AliWarning("  Siamo al limite!");
		    continue;
		  }

		  dummyCounter++;
		  tracks[dummyCounter] = selectedDigit[adesso3][thirdIndex]->GetTrackLabel(kk);

		}

	      }
	      for (Int_t kk=0; kk<kMaxNumberOfTracksPerDigit; kk++) { // three is the max number of tracks associated to one digit
		if (selectedDigit[adesso4][fourthIndex]->GetTrackLabel(kk)==-1) continue;
		else {

		  alreadyStored = kFALSE;
		  for (jj=0; jj<dummyCounter+1; jj++)
		    alreadyStored = alreadyStored || (tracks[jj]!=-1 && tracks[jj]==selectedDigit[adesso4][fourthIndex]->GetTrackLabel(kk));

		  if (alreadyStored) continue;
		  if (dummyCounter==2) { // three is the max number of tracks associated to one cluster
		    AliWarning("  Siamo al limite!");
		    continue;
		  }

		  dummyCounter++;
		  tracks[dummyCounter] = selectedDigit[adesso4][fourthIndex]->GetTrackLabel(kk);

		}

	      }


	      AliTOFcluster *tofCluster =
		new AliTOFcluster(volIdClus, posClus[0], posClus[1], posClus[2],
				  covClus[0], covClus[1], covClus[2], covClus[3], covClus[4], covClus[5],
				  tracks, det, parTOF, status, selectedDigit[adesso1][firstIndex]->GetIndex()); // to be updated
	      InsertCluster(tofCluster);

	      AliDebug(2, Form("       %4d  %f %f %f  %f %f %f %f %f %f  %3d %3d %3d  %2d %1d %2d %1d %2d  %4d %3d %3d %4d %4d  %1d  %4d", 
			       volIdClus, posClus[0], posClus[1], posClus[2],
			       covClus[0], covClus[1], covClus[2], covClus[3], covClus[4], covClus[5],
			       tracks[0], tracks[1], tracks[2],
			       det[0], det[1], det[2], det[3], det[4],
			       parTOF[0], parTOF[1], parTOF[2], parTOF[3], parTOF[4],
			       status, selectedDigit[adesso1][firstIndex]->GetIndex()));

	      volDum = vol1[3];
	      vol1[3] = vol1[4];
	      vol1[4] = volDum;
	      fTOFdigitMap->ResetDigitNumber(vol1,selectedDigit[adesso1][firstIndex]->GetIndex());
	      volDum = vol2[3];
	      vol2[3] = vol2[4];
	      vol2[4] = volDum;
	      fTOFdigitMap->ResetDigitNumber(vol2,selectedDigit[adesso2][secondIndex]->GetIndex());
	      volDum = vol3[3];
	      vol3[3] = vol3[4];
	      vol3[4] = volDum;
	      fTOFdigitMap->ResetDigitNumber(vol3,selectedDigit[adesso3][thirdIndex]->GetIndex());
	      volDum = vol4[3];
	      vol4[3] = vol4[4];
	      vol4[4] = volDum;
	      fTOFdigitMap->ResetDigitNumber(vol4,selectedDigit[adesso4][fourthIndex]->GetIndex());


	    } // close loop on fourth digit

	  } // close loop on third digit

	} // close loop on second digit

      } // close loop on first digit

      break;

    }

    for (ii=0; ii<kMaxNumberOfInterestingPads; ii++)
      for (jj=0; jj<kMaxNumberOfDigitsPerVolume; jj++)
	selectedDigit[ii][jj] = 0x0;

  } // loop on iPad

  for (ii=0; ii<kMaxNumberOfInterestingPads; ii++) {
    for (jj=0; jj<kMaxNumberOfDigitsPerVolume; jj++) {
      delete [] selectedDigit[ii][jj];
      selectedDigit[ii][jj] = 0x0;
    }
    delete [] selectedDigit[ii];
    selectedDigit[ii] = 0x0;
  }
  delete [] selectedDigit;
  selectedDigit = 0x0;

}
//_____________________________________________________________________________

Int_t AliTOFClusterFinderV1::InsertCluster(AliTOFcluster *tofCluster)
{
  //
  // This function adds a TOF cluster to the array of TOF clusters
  // sorted in Z, i.e. fTofClusters
  //

  if (fNumberOfTofClusters==kTofMaxCluster) {
    AliError("Too many clusters !");
    return 1;
  }

  if (fNumberOfTofClusters==0) {
    fTofClusters[fNumberOfTofClusters++] = tofCluster;
    return 0;
  }

  Int_t ii = FindClusterIndex(tofCluster->GetZ());
  memmove(fTofClusters+ii+1 ,fTofClusters+ii,(fNumberOfTofClusters-ii)*sizeof(AliTOFcluster*));
  fTofClusters[ii] = tofCluster;
  fNumberOfTofClusters++;
  
  return 0;

}
//_____________________________________________________________________________

Int_t AliTOFClusterFinderV1::FindClusterIndex(Double_t z) const
{
  //
  // This function returns the index of the nearest cluster in z
  //

  if (fNumberOfTofClusters==0) return 0;
  if (z <= fTofClusters[0]->GetZ()) return 0;
  if (z > fTofClusters[fNumberOfTofClusters-1]->GetZ()) return fNumberOfTofClusters;
  Int_t b = 0, e = fNumberOfTofClusters-1, m = (b+e)/2;
  for (; b<e; m=(b+e)/2) {
    if (z > fTofClusters[m]->GetZ()) b=m+1;
    else e=m;
  }

  return m;

}
//_____________________________________________________________________________

void AliTOFClusterFinderV1::ResetRecpoint()
{
  //
  // Clear the list of reconstructed points
  //

  fNumberOfTofClusters = 0;
  fNumberOfTofTrgPads = 0;
  if (fRecPoints) fRecPoints->Clear();

}
//_____________________________________________________________________________

void AliTOFClusterFinderV1::ResetDigits()
{
  //
  // Clear the list of digits
  //

  fNumberOfTofDigits = 0;
  fNumberOfTofTrgPads = 0;
  if (fDigits) fDigits->Clear();

}
//_____________________________________________________________________________
//UShort_t AliTOFClusterFinderV1::GetClusterVolIndex(Int_t *ind) const
//{
  //
  // Get the volume ID to retrieve the l2t transformation
  //

  // Detector numbering scheme
/*
  Int_t nSector = AliTOFGeometry::NSectors();
  Int_t nPlate  = AliTOFGeometry::NPlates();
  Int_t nStripA = AliTOFGeometry::NStripA();
  Int_t nStripB = AliTOFGeometry::NStripB();
  Int_t nStripC = AliTOFGeometry::NStripC();

  Int_t isector =ind[0];
  if (isector >= nSector)
    AliError(Form("Wrong sector number in TOF (%d) !", isector));
  Int_t iplate = ind[1];
  if (iplate >= nPlate)
    AliError(Form("Wrong plate number in TOF (%d) !", iplate));
  Int_t istrip = ind[2];

  Int_t stripOffset = 0;
  switch (iplate) {
  case 0:
    stripOffset = 0;
    break;
  case 1:
    stripOffset = nStripC;
    break;
  case 2:
    stripOffset = nStripC+nStripB;
    break;
  case 3:
    stripOffset = nStripC+nStripB+nStripA;
    break;
  case 4:
    stripOffset = nStripC+nStripB+nStripA+nStripB;
    break;
  default:
    AliError(Form("Wrong plate number in TOF (%d) !", iplate));
    break;
  };

  Int_t index= (2*(nStripC+nStripB)+nStripA)*isector +
               stripOffset +
               istrip;

  UShort_t volIndex = AliGeomManager::LayerToVolUID(AliGeomManager::kTOF, index);
  return volIndex;

}
*/
//_____________________________________________________________________________

void AliTOFClusterFinderV1::GetClusterPars(Int_t *ind, Double_t* pos, Double_t* cov) const
{
  //
  // Starting from the volume indices (ind[5]), for a cluster coming from
  // a isolated digits, this function returns:
  //   the cluster position (pos),
  //   the cluster covariance matrix elements (cov)
  // 

  //
  //we now go in the system of the strip: determine the local coordinates
  //
  //
  // 47---------------------------------------------------0  ^ z
  // | | | | | | | | | | | | | | | | | | | | | | | | | | | 1 |
  // -----------------------------------------------------   | y going outwards
  // | | | | | | | | | | | | | | | | | | | | | | | | | | | 0 |  par[0]=0;

  // -----------------------------------------------------   |
  // x <-----------------------------------------------------

  //move to the tracking ref system
  Double_t lpos[3] = { (ind[4]-23.5)*AliTOFGeometry::XPad(),
		       0.,
		       (ind[3]- 0.5)*AliTOFGeometry::ZPad() };   
  AliDebug(1, Form(" %f %f %f", lpos[0], lpos[1], lpos[2]));

  // Volume ID
  UShort_t volIndex = fTOFGeometry->GetAliSensVolIndex(ind[0],ind[1],ind[2]);
  //UShort_t volIndex = GetClusterVolIndex(ind);
  const TGeoHMatrix *l2t = AliGeomManager::GetTracking2LocalMatrix(volIndex);

  // Get the position in the track ref system
  Double_t tpos[3];
  l2t->MasterToLocal(lpos,tpos);
  pos[0] = tpos[0];
  pos[1] = tpos[1];
  pos[2] = tpos[2];

  //Get the cluster covariance in the track ref system
  Double_t lcov[9];
  for (Int_t ii=0; ii<9; ii++) lcov[ii] = 0.;

  //cluster covariance in the local system:
  // sx2   0   0
  // 0     0   0
  // 0     0 sz2
  /*
  lcov[4] = 0.42*0.42/3.;
                       // = ( 5*0.025 (gas gaps thikness)
                       //   + 4*0.040 (internal glasses thickness)
                       //   + 0.5*0.160 (internl PCB)
                       //   + 1*0.055 (external red glass))
  */

  lcov[0] = 0.499678;//AliTOFGeometry::XPad()*AliTOFGeometry::XPad()/12.;
  lcov[8] = 0.992429;//AliTOFGeometry::ZPad()*AliTOFGeometry::ZPad()/12.;

  //cluster covariance in the tracking system:
  TGeoHMatrix m;
  m.SetRotation(lcov);
  m.Multiply(l2t);
  m.MultiplyLeft(&l2t->Inverse());
  Double_t *tcov = m.GetRotationMatrix();
  cov[0] = tcov[0]; cov[1] = tcov[1]; cov[2] = tcov[2];
  cov[3] = tcov[4]; cov[4] = tcov[5]; cov[5] = tcov[8];

  return;

}
//_____________________________________________________________________________

void AliTOFClusterFinderV1::GetClusterPars(/*Bool_t check,*/ Int_t counter,
					   Int_t **ind, Double_t *weight,
					   Double_t *pos, Double_t *cov) const
{
  //
  // Starting from:
  //               the volumes indices (ind[counter][5]), for a
  //                  cluster coming from a collection of 'counter'
  //                  digits,
  //               the volumes weights (weight[counter]), -controlled
  //                  by the 'check' variable control-, for a cluster
  //                  coming from a collection of 'counter' digits,
  //               the cluster position (pos),
  // this function returns:
  //   the covariance matrix elements (cov) for the found cluster
  //

  //
  // we now go in the system of the strip: determine the local coordinates
  //
  // 47---------------------------------------------------0  ^ z
  // | | | | | | | | | | | | | | | | | | | | | | | | | | | 1 |
  // -----------------------------------------------------   | y going outwards
  // | | | | | | | | | | | | | | | | | | | | | | | | | | | 0 |  par[0]=0;

  // -----------------------------------------------------   |
  // x <-----------------------------------------------------

  for (Int_t ii=0; ii<counter; ii++)
    AliDebug(1, Form(" %2d  %2d %1d %2d %1d %2d ",
		     ii, ind[ii][0], ind[ii][1], ind[ii][2], ind[ii][3], ind[ii][4]));

  Float_t posF[3]; for (Int_t ii=0; ii<3; ii++) posF[ii] = (Float_t)pos[ii];
  AliDebug(1, Form(" %f %f %f", pos[0], pos[1], pos[2]));

  Int_t detClus[5] = {-1, -1, -1, -1, -1};
  fTOFGeometry->GetDetID(posF, detClus);

  // Volume ID
  UShort_t volIndex = fTOFGeometry->GetAliSensVolIndex(detClus[0],detClus[1],detClus[2]);
  //UShort_t volIndex = GetClusterVolIndex(detClus);
  AliDebug(1, Form(" %2d %1d %2d %1d %2d  %7i",
		   detClus[0], detClus[1], detClus[2], detClus[3], detClus[4], volIndex));

  // Get the position in the TOF strip ref system
  const TGeoHMatrix *alice2strip = AliGeomManager::GetOrigGlobalMatrix(volIndex);
  Double_t ppos[3] = {-1, -1, -1};
  alice2strip->MasterToLocal(pos,ppos);
  AliDebug(1, Form(" %f %f %f", ppos[0], ppos[1], ppos[2]));


  // Get the position in the tracking ref system
  const TGeoHMatrix *g2l = AliGeomManager::GetTracking2LocalMatrix(volIndex);
  Double_t lpos[3] = {-1, -1, -1};
  g2l->MasterToLocal(ppos,lpos);
  AliDebug(1, Form(" %f %f %f", lpos[0], lpos[1], lpos[2]));
  for (Int_t ii=0; ii<3; ii++) pos[ii] = lpos[ii];

  //Get the cluster covariance in the track ref system
  Double_t lcov[9];
  for (Int_t ii=0; ii<9; ii++) lcov[ii] = 0.;

  //cluster covariance in the local system:
  // sx2   0   0
  // 0     0   0
  // 0     0 sz2

  // Evaluation of the ovariance matrix elements
  TOFclusterError(/*check,*/ counter, ind, weight, ppos, lcov);

  AliDebug(1, Form("lcov[0] = %f, lcov[8] = %f", lcov[0], lcov[8]));

  //cluster covariance in the tracking system:
  TGeoHMatrix m;
  m.SetRotation(lcov);
  m.Multiply(g2l);
  m.MultiplyLeft(&g2l->Inverse());
  Double_t *tcov = m.GetRotationMatrix();
  cov[0] = tcov[0]; cov[1] = tcov[1]; cov[2] = tcov[2];
  cov[3] = tcov[4]; cov[4] = tcov[5]; cov[5] = tcov[8];

  return;

}
//_____________________________________________________________________________

void AliTOFClusterFinderV1::TOFclusterError(/*Bool_t check,*/ Int_t counter,
					    Int_t **ind, Double_t *weight,
					    Double_t ppos[], Double_t lcov[]) const
{
  //
  //
  //

  //lcov[4] = 0.42*0.42/3.; // cm2
                       // = ( 5*0.025 (gas gaps thikness)
                       //   + 4*0.040 (internal glasses thickness)
                       //   + 0.5*0.160 (internl PCB)
                       //   + 1*0.055 (external red glass))


  Float_t *delta2X = new Float_t[counter];
  for (Int_t ii=0; ii<counter; ii++)
    delta2X[ii] =
      ((ind[ii][4]-23.5)*AliTOFGeometry::XPad() - ppos[0])*((ind[ii][4]-23.5)*AliTOFGeometry::XPad() - ppos[0]);

  Float_t *delta2Z = new Float_t[counter];
  for (Int_t ii=0; ii<counter; ii++)
    delta2Z[ii] =
      ((ind[ii][3]- 0.5)*AliTOFGeometry::ZPad() - ppos[2])*((ind[ii][3]- 0.5)*AliTOFGeometry::ZPad() - ppos[2]);

  for (Int_t ii=0; ii<counter; ii++)
    AliDebug(1, Form("x[%d] = %f, z[%d] = %f, weight[%d] = %f",
		     ii, (ind[ii][4]-23.5)*AliTOFGeometry::XPad(),
		     ii, (ind[ii][3]- 0.5)*AliTOFGeometry::ZPad(),
		     ii, weight[ii]
		     ));
  AliDebug(1, Form("xMean = %f, zMean = %f",ppos[0], ppos[2]));


  switch (counter)
    {

    case 2:

      if (ind[0][3]==ind[1][3] && TMath::Abs(ind[0][4]-ind[1][4])==1) { //

	lcov[8] = 1.02039; // cm2
	lcov[0] = 0.0379409; // cm2
	/*
	if (check)
	  lcov[0] = 0.5*0.5; // cm2
	else {
	  if (weight[0]==weight[1])
	    lcov[0] = 0.0379409; // cm2
	  else
	    lcov[0] = TMath::Mean(counter, delta2X, weight); // cm2
	}
	*/

      }

      else if (ind[0][4]==ind[1][4] && TMath::Abs(ind[0][3]-ind[1][3])==1) {//

	lcov[0] = 0.505499; // cm2
	lcov[8] = 0.0422046; // cm2
	/*
	if (check)
	  lcov[8] = 0.5*0.5; // cm2
	else {
	  if (weight[0]==weight[1])
	    lcov[8] = 0.0422046; // cm2
	  else
	    lcov[8] = TMath::Mean(counter, delta2Z, weight); // cm2
	}
	*/

      }

      break;

    case 3:
      lcov[0] = 0.0290677; // cm2
      lcov[8] = 0.0569726; // cm2
      /*
      if (check) {
	lcov[0] = 0.5*0.5; // cm2
	lcov[8] = 0.5*0.5; // cm2
      }
      else {
      if (weight[0]==weight[1] && weight[0]==weight[2]) {
	  lcov[0] = 0.0290677; // cm2
	  lcov[8] = 0.0569726; // cm2
	  }
	else {
	  lcov[0] = TMath::Mean(counter, delta2X, weight); // cm2
	  lcov[8] = TMath::Mean(counter, delta2Z, weight); // cm2
	  }

	}
      */

      break;

    case 4:
      lcov[0] = 0.0223807; // cm2
      lcov[8] = 0.0438662; // cm2
      /*
      if (check) {
	lcov[0] = 0.5*0.5; // cm2
	lcov[8] = 0.5*0.5; // cm2
      }
      else {
      if (weight[0]==weight[1] && weight[0]==weight[2] && weight[0]==weight[3]) {
	  lcov[0] = 0.0223807; // cm2
	  lcov[8] = 0.0438662; // cm2
	  }
	else {
	  lcov[0] = TMath::Mean(counter, delta2X, weight); // cm2
	  lcov[8] = TMath::Mean(counter, delta2Z, weight); // cm2
	  }

	}
      */

      break;

    }

  delete [] delta2Z;
  delete [] delta2X;

}
//_____________________________________________________________________________

Bool_t AliTOFClusterFinderV1::MakeSlewingCorrection(Int_t *detectorIndex,
						    Int_t tofDigitToT,
						    Int_t tofDigitTdc,
						    Int_t &tdcCorr)
{
  //
  // This funtion makes the following:
  //
  //      - if at least one of the three status (Pulser/Noise/HW) is
  //        bad, is sets the status of electronic channel, corresponding to the
  //        volume identified by detectorIndex, as kFALSE;
  //      - if offline calibration is in the valid status, it performs the
  //        slewing correction. In particular, by taking into account:
  //          * the measured tot and tof values (tofDigitToT and tofDigitTdc,
  //            respectively);
  //          * the six parameters of 5th order polynomial used
  //            to fit the tofVStot scatter plot,
  //         it returns the corrected tof value, i.e. tdcCorr value.
  //

  Bool_t output = kTRUE;

  Double_t timeCorr;
  Int_t jj;

  //AliInfo(" Calibrating TOF Digits: ");
  
  AliTOFChannelOnlineArray *calDelay = fTOFcalib->GetTOFOnlineDelay();
  AliTOFChannelOnlineStatusArray *calStatus = fTOFcalib->GetTOFOnlineStatus();

  TObjArray *calTOFArrayOffline = fTOFcalib->GetTOFCalArrayOffline();

  Int_t index = AliTOFGeometry::GetIndex(detectorIndex);

  UChar_t statusPulser = calStatus->GetPulserStatus(index);
  UChar_t statusNoise  = calStatus->GetNoiseStatus(index);
  UChar_t statusHW     = calStatus->GetHWStatus(index);
  UChar_t status       = calStatus->GetStatus(index);

  //check the status, also unknown is fine!!!!!!!

  AliDebug(2, Form(" Status for channel %d = %d",index, (Int_t)status));
  if((statusPulser & AliTOFChannelOnlineStatusArray::kTOFPulserBad)==(AliTOFChannelOnlineStatusArray::kTOFPulserBad)||(statusNoise & AliTOFChannelOnlineStatusArray::kTOFNoiseBad)==(AliTOFChannelOnlineStatusArray::kTOFNoiseBad)||(statusHW & AliTOFChannelOnlineStatusArray::kTOFHWBad)==(AliTOFChannelOnlineStatusArray::kTOFHWBad)){
    AliDebug(2, Form(" Bad Status for channel %d",index));
    //fTofClusters[ii]->SetStatus(kFALSE); //odd convention, to avoid conflict with calibration objects currently in the db (temporary solution).
    output = kFALSE;
  }
  else
    AliDebug(2, Form(" Good Status for channel %d",index));


  if (fCalibrateTOFtimes) { // AdC

  // Get Rough channel online equalization 
  Double_t roughDelay = (Double_t)calDelay->GetDelay(index);  // in ns
  AliDebug(2,Form(" channel delay (ns) = %f", roughDelay));
  // Get Refined channel offline calibration parameters
  TString validity = (TString)fTOFcalib->GetOfflineValidity();
  if (validity.CompareTo("valid")==0) {
    AliTOFChannelOffline * calChannelOffline = (AliTOFChannelOffline*)calTOFArrayOffline->At(index);
    Double_t par[6];
    for (jj = 0; jj<6; jj++)
      par[jj] = (Double_t)calChannelOffline->GetSlewPar(jj);

    AliDebug(2,Form(" Calib Pars = %f, %f, %f, %f, %f, %f ",par[0],par[1],par[2],par[3],par[4],par[5]));
    AliDebug(2,Form(" The ToT and Time, uncorr (counts) = %d , %d", tofDigitToT, tofDigitTdc));
    Double_t tToT = (Double_t)(tofDigitToT*AliTOFGeometry::ToTBinWidth());    
    tToT*=1.E-3; //ToT in ns
    AliDebug(2,Form(" The ToT and Time, uncorr (ns)= %e, %e",tofDigitTdc*AliTOFGeometry::TdcBinWidth()*1.E-3,tToT));
    timeCorr = par[0] + tToT*(par[1] + tToT*(par[2] + tToT*(par[3] + tToT*(par[4] + tToT*par[5])))); // the time correction (ns)
  }
  else
    timeCorr = roughDelay; // correction in ns

  AliDebug(2,Form(" The ToT and Time, uncorr (ns)= %e, %e",tofDigitTdc*AliTOFGeometry::TdcBinWidth()*1.E-3,tofDigitToT*AliTOFGeometry::ToTBinWidth()));
  AliDebug(2,Form(" The time correction (ns) = %f", timeCorr));
  timeCorr = (Double_t)(tofDigitTdc)*AliTOFGeometry::TdcBinWidth()*1.E-3-timeCorr;//redefine the time
  timeCorr *= 1.E3;
  AliDebug(2,Form(" The channel time, corr (ps)= %e",timeCorr ));
  //tdcCorr = (Int_t)(timeCorr/AliTOFGeometry::TdcBinWidth()); //the corrected time (tdc counts)
  tdcCorr = TMath::Nint(timeCorr/AliTOFGeometry::TdcBinWidth()); //the corrected time (tdc counts)
  
  } // AdC

  return output;

}
//______________________________________________________________________________

void AliTOFClusterFinderV1::Digits2RecPoints(Int_t iEvent)
{
  //
  // Converts digits to recpoints for TOF
  //

  TStopwatch stopwatch;
  stopwatch.Start();

  fRunLoader->GetEvent(iEvent);

  AliLoader *localTOFLoader = (AliLoader*)fRunLoader->GetLoader("TOFLoader");

  TTree * localTreeD = (TTree*)localTOFLoader->TreeD();
  if (localTreeD == 0x0) {
    AliFatal("Can not get TreeD");
    return;
  }

  TBranch *branch = localTreeD->GetBranch("TOF");
  if (!branch) {
    AliError("Can't get the branch with the TOF digits !");
    return;
  }

  TTree *localTreeR = (TTree*)localTOFLoader->TreeR();
  if (localTreeR == 0x0)
    {
      localTOFLoader->MakeTree("R");
      localTreeR = localTOFLoader->TreeR();
    }

  Digits2RecPoints(localTreeD, localTreeR);

  //localTOFLoader = fRunLoader->GetLoader("TOFLoader");  
  localTOFLoader->WriteRecPoints("OVERWRITE");

  AliDebug(1, Form("Execution time to read TOF digits and to write TOF clusters for the event number %d: R:%.4fs C:%.4fs",
		   iEvent, stopwatch.RealTime(),stopwatch.CpuTime()));

}
//______________________________________________________________________________

void AliTOFClusterFinderV1::Digits2RecPoints(Int_t iEvent, AliRawReader *rawReader)
{
  //
  // Converts RAW data to recpoints for TOF
  //

  TStopwatch stopwatch;
  stopwatch.Start();

  fRunLoader->GetEvent(iEvent);

  AliDebug(2,Form(" Event number %2d ", iEvent));

  AliLoader *localTOFLoader = (AliLoader*)fRunLoader->GetLoader("TOFLoader");

  TTree *localTreeR = localTOFLoader->TreeR();

  if (localTreeR == 0x0){
    localTOFLoader->MakeTree("R");
    localTreeR = localTOFLoader->TreeR();
  }

  Digits2RecPoints(rawReader, localTreeR);

  AliDebug(1, Form("Execution time to read TOF raw data and to write TOF clusters for the event number %d: R:%.4fs C:%.4fs",
		   iEvent, stopwatch.RealTime(),stopwatch.CpuTime()));

}
//______________________________________________________________________________

void AliTOFClusterFinderV1::Raw2Digits(Int_t iEvent, AliRawReader *rawReader)
{
  //
  // Converts RAW data to MC digits for TOF
  //


  TStopwatch stopwatch;
  stopwatch.Start();

  fRunLoader->GetEvent(iEvent);

  AliDebug(2,Form(" Event number %2d ", iEvent));

  AliLoader *localTOFLoader = (AliLoader*)fRunLoader->GetLoader("TOFLoader");

  TTree *localTreeD = localTOFLoader->TreeD();

  if (localTreeD == 0x0){
    localTOFLoader->MakeTree("D");
    localTreeD = localTOFLoader->TreeD();
  }

  Raw2Digits(rawReader, localTreeD);

  AliDebug(1, Form("Execution time to read TOF raw data and to write TOF clusters for the event number %d: R:%.4fs C:%.4fs",
		   iEvent, stopwatch.RealTime(),stopwatch.CpuTime()));

}
//______________________________________________________________________________

void AliTOFClusterFinderV1::AverageCalculations(Int_t number, Float_t *interestingX,
						Float_t *interestingY, Float_t *interestingZ,
						Double_t *interestingTOF, Double_t *interestingTOT,
						Double_t *interestingADC, Double_t *interestingWeight,
						Int_t *parTOF, Double_t *posClus, Bool_t &check)
{
  //
  // Calculates the mean values for cluster position (x,y,z),
  //  TOF charge and time
  //

  Double_t tofAverage = 0.;
  Double_t totAverage = 0.;
  Double_t adcAverage = 0.;

  check = kFALSE;
  Int_t ii=-1;
  for (ii=number-1; ii>=0; ii--) check=check||(interestingWeight[ii]==0 || interestingWeight[ii]==-1);

  if (check) {
		  
    posClus[0] = TMath::Mean(number, interestingX);
    posClus[1] = TMath::Mean(number, interestingY);
    posClus[2] = TMath::Mean(number, interestingZ);
    tofAverage = TMath::Mean(number, interestingTOF);
    totAverage = TMath::Mean(number, interestingTOT);
    adcAverage = TMath::Mean(number, interestingADC);

  }
  else {

    posClus[0] = TMath::Mean(number, interestingX, interestingWeight);
    posClus[1] = TMath::Mean(number, interestingY, interestingWeight);
    posClus[2] = TMath::Mean(number, interestingZ, interestingWeight);
    tofAverage = TMath::Mean(number, interestingTOF, interestingWeight);
    totAverage = TMath::Mean(number, interestingTOT, interestingWeight);
    adcAverage = TMath::Mean(number, interestingADC, interestingWeight);

  }

  parTOF[0] = Int_t(tofAverage);
  parTOF[1] = Int_t(totAverage);
  parTOF[2] = Int_t(adcAverage);
  parTOF[3] = Int_t(tofAverage);//tofND
  parTOF[4] = Int_t(tofAverage);//tofRAW
  parTOF[5] = 0;
  parTOF[6] = 0;

}
 AliTOFClusterFinderV1.cxx:1
 AliTOFClusterFinderV1.cxx:2
 AliTOFClusterFinderV1.cxx:3
 AliTOFClusterFinderV1.cxx:4
 AliTOFClusterFinderV1.cxx:5
 AliTOFClusterFinderV1.cxx:6
 AliTOFClusterFinderV1.cxx:7
 AliTOFClusterFinderV1.cxx:8
 AliTOFClusterFinderV1.cxx:9
 AliTOFClusterFinderV1.cxx:10
 AliTOFClusterFinderV1.cxx:11
 AliTOFClusterFinderV1.cxx:12
 AliTOFClusterFinderV1.cxx:13
 AliTOFClusterFinderV1.cxx:14
 AliTOFClusterFinderV1.cxx:15
 AliTOFClusterFinderV1.cxx:16
 AliTOFClusterFinderV1.cxx:17
 AliTOFClusterFinderV1.cxx:18
 AliTOFClusterFinderV1.cxx:19
 AliTOFClusterFinderV1.cxx:20
 AliTOFClusterFinderV1.cxx:21
 AliTOFClusterFinderV1.cxx:22
 AliTOFClusterFinderV1.cxx:23
 AliTOFClusterFinderV1.cxx:24
 AliTOFClusterFinderV1.cxx:25
 AliTOFClusterFinderV1.cxx:26
 AliTOFClusterFinderV1.cxx:27
 AliTOFClusterFinderV1.cxx:28
 AliTOFClusterFinderV1.cxx:29
 AliTOFClusterFinderV1.cxx:30
 AliTOFClusterFinderV1.cxx:31
 AliTOFClusterFinderV1.cxx:32
 AliTOFClusterFinderV1.cxx:33
 AliTOFClusterFinderV1.cxx:34
 AliTOFClusterFinderV1.cxx:35
 AliTOFClusterFinderV1.cxx:36
 AliTOFClusterFinderV1.cxx:37
 AliTOFClusterFinderV1.cxx:38
 AliTOFClusterFinderV1.cxx:39
 AliTOFClusterFinderV1.cxx:40
 AliTOFClusterFinderV1.cxx:41
 AliTOFClusterFinderV1.cxx:42
 AliTOFClusterFinderV1.cxx:43
 AliTOFClusterFinderV1.cxx:44
 AliTOFClusterFinderV1.cxx:45
 AliTOFClusterFinderV1.cxx:46
 AliTOFClusterFinderV1.cxx:47
 AliTOFClusterFinderV1.cxx:48
 AliTOFClusterFinderV1.cxx:49
 AliTOFClusterFinderV1.cxx:50
 AliTOFClusterFinderV1.cxx:51
 AliTOFClusterFinderV1.cxx:52
 AliTOFClusterFinderV1.cxx:53
 AliTOFClusterFinderV1.cxx:54
 AliTOFClusterFinderV1.cxx:55
 AliTOFClusterFinderV1.cxx:56
 AliTOFClusterFinderV1.cxx:57
 AliTOFClusterFinderV1.cxx:58
 AliTOFClusterFinderV1.cxx:59
 AliTOFClusterFinderV1.cxx:60
 AliTOFClusterFinderV1.cxx:61
 AliTOFClusterFinderV1.cxx:62
 AliTOFClusterFinderV1.cxx:63
 AliTOFClusterFinderV1.cxx:64
 AliTOFClusterFinderV1.cxx:65
 AliTOFClusterFinderV1.cxx:66
 AliTOFClusterFinderV1.cxx:67
 AliTOFClusterFinderV1.cxx:68
 AliTOFClusterFinderV1.cxx:69
 AliTOFClusterFinderV1.cxx:70
 AliTOFClusterFinderV1.cxx:71
 AliTOFClusterFinderV1.cxx:72
 AliTOFClusterFinderV1.cxx:73
 AliTOFClusterFinderV1.cxx:74
 AliTOFClusterFinderV1.cxx:75
 AliTOFClusterFinderV1.cxx:76
 AliTOFClusterFinderV1.cxx:77
 AliTOFClusterFinderV1.cxx:78
 AliTOFClusterFinderV1.cxx:79
 AliTOFClusterFinderV1.cxx:80
 AliTOFClusterFinderV1.cxx:81
 AliTOFClusterFinderV1.cxx:82
 AliTOFClusterFinderV1.cxx:83
 AliTOFClusterFinderV1.cxx:84
 AliTOFClusterFinderV1.cxx:85
 AliTOFClusterFinderV1.cxx:86
 AliTOFClusterFinderV1.cxx:87
 AliTOFClusterFinderV1.cxx:88
 AliTOFClusterFinderV1.cxx:89
 AliTOFClusterFinderV1.cxx:90
 AliTOFClusterFinderV1.cxx:91
 AliTOFClusterFinderV1.cxx:92
 AliTOFClusterFinderV1.cxx:93
 AliTOFClusterFinderV1.cxx:94
 AliTOFClusterFinderV1.cxx:95
 AliTOFClusterFinderV1.cxx:96
 AliTOFClusterFinderV1.cxx:97
 AliTOFClusterFinderV1.cxx:98
 AliTOFClusterFinderV1.cxx:99
 AliTOFClusterFinderV1.cxx:100
 AliTOFClusterFinderV1.cxx:101
 AliTOFClusterFinderV1.cxx:102
 AliTOFClusterFinderV1.cxx:103
 AliTOFClusterFinderV1.cxx:104
 AliTOFClusterFinderV1.cxx:105
 AliTOFClusterFinderV1.cxx:106
 AliTOFClusterFinderV1.cxx:107
 AliTOFClusterFinderV1.cxx:108
 AliTOFClusterFinderV1.cxx:109
 AliTOFClusterFinderV1.cxx:110
 AliTOFClusterFinderV1.cxx:111
 AliTOFClusterFinderV1.cxx:112
 AliTOFClusterFinderV1.cxx:113
 AliTOFClusterFinderV1.cxx:114
 AliTOFClusterFinderV1.cxx:115
 AliTOFClusterFinderV1.cxx:116
 AliTOFClusterFinderV1.cxx:117
 AliTOFClusterFinderV1.cxx:118
 AliTOFClusterFinderV1.cxx:119
 AliTOFClusterFinderV1.cxx:120
 AliTOFClusterFinderV1.cxx:121
 AliTOFClusterFinderV1.cxx:122
 AliTOFClusterFinderV1.cxx:123
 AliTOFClusterFinderV1.cxx:124
 AliTOFClusterFinderV1.cxx:125
 AliTOFClusterFinderV1.cxx:126
 AliTOFClusterFinderV1.cxx:127
 AliTOFClusterFinderV1.cxx:128
 AliTOFClusterFinderV1.cxx:129
 AliTOFClusterFinderV1.cxx:130
 AliTOFClusterFinderV1.cxx:131
 AliTOFClusterFinderV1.cxx:132
 AliTOFClusterFinderV1.cxx:133
 AliTOFClusterFinderV1.cxx:134
 AliTOFClusterFinderV1.cxx:135
 AliTOFClusterFinderV1.cxx:136
 AliTOFClusterFinderV1.cxx:137
 AliTOFClusterFinderV1.cxx:138
 AliTOFClusterFinderV1.cxx:139
 AliTOFClusterFinderV1.cxx:140
 AliTOFClusterFinderV1.cxx:141
 AliTOFClusterFinderV1.cxx:142
 AliTOFClusterFinderV1.cxx:143
 AliTOFClusterFinderV1.cxx:144
 AliTOFClusterFinderV1.cxx:145
 AliTOFClusterFinderV1.cxx:146
 AliTOFClusterFinderV1.cxx:147
 AliTOFClusterFinderV1.cxx:148
 AliTOFClusterFinderV1.cxx:149
 AliTOFClusterFinderV1.cxx:150
 AliTOFClusterFinderV1.cxx:151
 AliTOFClusterFinderV1.cxx:152
 AliTOFClusterFinderV1.cxx:153
 AliTOFClusterFinderV1.cxx:154
 AliTOFClusterFinderV1.cxx:155
 AliTOFClusterFinderV1.cxx:156
 AliTOFClusterFinderV1.cxx:157
 AliTOFClusterFinderV1.cxx:158
 AliTOFClusterFinderV1.cxx:159
 AliTOFClusterFinderV1.cxx:160
 AliTOFClusterFinderV1.cxx:161
 AliTOFClusterFinderV1.cxx:162
 AliTOFClusterFinderV1.cxx:163
 AliTOFClusterFinderV1.cxx:164
 AliTOFClusterFinderV1.cxx:165
 AliTOFClusterFinderV1.cxx:166
 AliTOFClusterFinderV1.cxx:167
 AliTOFClusterFinderV1.cxx:168
 AliTOFClusterFinderV1.cxx:169
 AliTOFClusterFinderV1.cxx:170
 AliTOFClusterFinderV1.cxx:171
 AliTOFClusterFinderV1.cxx:172
 AliTOFClusterFinderV1.cxx:173
 AliTOFClusterFinderV1.cxx:174
 AliTOFClusterFinderV1.cxx:175
 AliTOFClusterFinderV1.cxx:176
 AliTOFClusterFinderV1.cxx:177
 AliTOFClusterFinderV1.cxx:178
 AliTOFClusterFinderV1.cxx:179
 AliTOFClusterFinderV1.cxx:180
 AliTOFClusterFinderV1.cxx:181
 AliTOFClusterFinderV1.cxx:182
 AliTOFClusterFinderV1.cxx:183
 AliTOFClusterFinderV1.cxx:184
 AliTOFClusterFinderV1.cxx:185
 AliTOFClusterFinderV1.cxx:186
 AliTOFClusterFinderV1.cxx:187
 AliTOFClusterFinderV1.cxx:188
 AliTOFClusterFinderV1.cxx:189
 AliTOFClusterFinderV1.cxx:190
 AliTOFClusterFinderV1.cxx:191
 AliTOFClusterFinderV1.cxx:192
 AliTOFClusterFinderV1.cxx:193
 AliTOFClusterFinderV1.cxx:194
 AliTOFClusterFinderV1.cxx:195
 AliTOFClusterFinderV1.cxx:196
 AliTOFClusterFinderV1.cxx:197
 AliTOFClusterFinderV1.cxx:198
 AliTOFClusterFinderV1.cxx:199
 AliTOFClusterFinderV1.cxx:200
 AliTOFClusterFinderV1.cxx:201
 AliTOFClusterFinderV1.cxx:202
 AliTOFClusterFinderV1.cxx:203
 AliTOFClusterFinderV1.cxx:204
 AliTOFClusterFinderV1.cxx:205
 AliTOFClusterFinderV1.cxx:206
 AliTOFClusterFinderV1.cxx:207
 AliTOFClusterFinderV1.cxx:208
 AliTOFClusterFinderV1.cxx:209
 AliTOFClusterFinderV1.cxx:210
 AliTOFClusterFinderV1.cxx:211
 AliTOFClusterFinderV1.cxx:212
 AliTOFClusterFinderV1.cxx:213
 AliTOFClusterFinderV1.cxx:214
 AliTOFClusterFinderV1.cxx:215
 AliTOFClusterFinderV1.cxx:216
 AliTOFClusterFinderV1.cxx:217
 AliTOFClusterFinderV1.cxx:218
 AliTOFClusterFinderV1.cxx:219
 AliTOFClusterFinderV1.cxx:220
 AliTOFClusterFinderV1.cxx:221
 AliTOFClusterFinderV1.cxx:222
 AliTOFClusterFinderV1.cxx:223
 AliTOFClusterFinderV1.cxx:224
 AliTOFClusterFinderV1.cxx:225
 AliTOFClusterFinderV1.cxx:226
 AliTOFClusterFinderV1.cxx:227
 AliTOFClusterFinderV1.cxx:228
 AliTOFClusterFinderV1.cxx:229
 AliTOFClusterFinderV1.cxx:230
 AliTOFClusterFinderV1.cxx:231
 AliTOFClusterFinderV1.cxx:232
 AliTOFClusterFinderV1.cxx:233
 AliTOFClusterFinderV1.cxx:234
 AliTOFClusterFinderV1.cxx:235
 AliTOFClusterFinderV1.cxx:236
 AliTOFClusterFinderV1.cxx:237
 AliTOFClusterFinderV1.cxx:238
 AliTOFClusterFinderV1.cxx:239
 AliTOFClusterFinderV1.cxx:240
 AliTOFClusterFinderV1.cxx:241
 AliTOFClusterFinderV1.cxx:242
 AliTOFClusterFinderV1.cxx:243
 AliTOFClusterFinderV1.cxx:244
 AliTOFClusterFinderV1.cxx:245
 AliTOFClusterFinderV1.cxx:246
 AliTOFClusterFinderV1.cxx:247
 AliTOFClusterFinderV1.cxx:248
 AliTOFClusterFinderV1.cxx:249
 AliTOFClusterFinderV1.cxx:250
 AliTOFClusterFinderV1.cxx:251
 AliTOFClusterFinderV1.cxx:252
 AliTOFClusterFinderV1.cxx:253
 AliTOFClusterFinderV1.cxx:254
 AliTOFClusterFinderV1.cxx:255
 AliTOFClusterFinderV1.cxx:256
 AliTOFClusterFinderV1.cxx:257
 AliTOFClusterFinderV1.cxx:258
 AliTOFClusterFinderV1.cxx:259
 AliTOFClusterFinderV1.cxx:260
 AliTOFClusterFinderV1.cxx:261
 AliTOFClusterFinderV1.cxx:262
 AliTOFClusterFinderV1.cxx:263
 AliTOFClusterFinderV1.cxx:264
 AliTOFClusterFinderV1.cxx:265
 AliTOFClusterFinderV1.cxx:266
 AliTOFClusterFinderV1.cxx:267
 AliTOFClusterFinderV1.cxx:268
 AliTOFClusterFinderV1.cxx:269
 AliTOFClusterFinderV1.cxx:270
 AliTOFClusterFinderV1.cxx:271
 AliTOFClusterFinderV1.cxx:272
 AliTOFClusterFinderV1.cxx:273
 AliTOFClusterFinderV1.cxx:274
 AliTOFClusterFinderV1.cxx:275
 AliTOFClusterFinderV1.cxx:276
 AliTOFClusterFinderV1.cxx:277
 AliTOFClusterFinderV1.cxx:278
 AliTOFClusterFinderV1.cxx:279
 AliTOFClusterFinderV1.cxx:280
 AliTOFClusterFinderV1.cxx:281
 AliTOFClusterFinderV1.cxx:282
 AliTOFClusterFinderV1.cxx:283
 AliTOFClusterFinderV1.cxx:284
 AliTOFClusterFinderV1.cxx:285
 AliTOFClusterFinderV1.cxx:286
 AliTOFClusterFinderV1.cxx:287
 AliTOFClusterFinderV1.cxx:288
 AliTOFClusterFinderV1.cxx:289
 AliTOFClusterFinderV1.cxx:290
 AliTOFClusterFinderV1.cxx:291
 AliTOFClusterFinderV1.cxx:292
 AliTOFClusterFinderV1.cxx:293
 AliTOFClusterFinderV1.cxx:294
 AliTOFClusterFinderV1.cxx:295
 AliTOFClusterFinderV1.cxx:296
 AliTOFClusterFinderV1.cxx:297
 AliTOFClusterFinderV1.cxx:298
 AliTOFClusterFinderV1.cxx:299
 AliTOFClusterFinderV1.cxx:300
 AliTOFClusterFinderV1.cxx:301
 AliTOFClusterFinderV1.cxx:302
 AliTOFClusterFinderV1.cxx:303
 AliTOFClusterFinderV1.cxx:304
 AliTOFClusterFinderV1.cxx:305
 AliTOFClusterFinderV1.cxx:306
 AliTOFClusterFinderV1.cxx:307
 AliTOFClusterFinderV1.cxx:308
 AliTOFClusterFinderV1.cxx:309
 AliTOFClusterFinderV1.cxx:310
 AliTOFClusterFinderV1.cxx:311
 AliTOFClusterFinderV1.cxx:312
 AliTOFClusterFinderV1.cxx:313
 AliTOFClusterFinderV1.cxx:314
 AliTOFClusterFinderV1.cxx:315
 AliTOFClusterFinderV1.cxx:316
 AliTOFClusterFinderV1.cxx:317
 AliTOFClusterFinderV1.cxx:318
 AliTOFClusterFinderV1.cxx:319
 AliTOFClusterFinderV1.cxx:320
 AliTOFClusterFinderV1.cxx:321
 AliTOFClusterFinderV1.cxx:322
 AliTOFClusterFinderV1.cxx:323
 AliTOFClusterFinderV1.cxx:324
 AliTOFClusterFinderV1.cxx:325
 AliTOFClusterFinderV1.cxx:326
 AliTOFClusterFinderV1.cxx:327
 AliTOFClusterFinderV1.cxx:328
 AliTOFClusterFinderV1.cxx:329
 AliTOFClusterFinderV1.cxx:330
 AliTOFClusterFinderV1.cxx:331
 AliTOFClusterFinderV1.cxx:332
 AliTOFClusterFinderV1.cxx:333
 AliTOFClusterFinderV1.cxx:334
 AliTOFClusterFinderV1.cxx:335
 AliTOFClusterFinderV1.cxx:336
 AliTOFClusterFinderV1.cxx:337
 AliTOFClusterFinderV1.cxx:338
 AliTOFClusterFinderV1.cxx:339
 AliTOFClusterFinderV1.cxx:340
 AliTOFClusterFinderV1.cxx:341
 AliTOFClusterFinderV1.cxx:342
 AliTOFClusterFinderV1.cxx:343
 AliTOFClusterFinderV1.cxx:344
 AliTOFClusterFinderV1.cxx:345
 AliTOFClusterFinderV1.cxx:346
 AliTOFClusterFinderV1.cxx:347
 AliTOFClusterFinderV1.cxx:348
 AliTOFClusterFinderV1.cxx:349
 AliTOFClusterFinderV1.cxx:350
 AliTOFClusterFinderV1.cxx:351
 AliTOFClusterFinderV1.cxx:352
 AliTOFClusterFinderV1.cxx:353
 AliTOFClusterFinderV1.cxx:354
 AliTOFClusterFinderV1.cxx:355
 AliTOFClusterFinderV1.cxx:356
 AliTOFClusterFinderV1.cxx:357
 AliTOFClusterFinderV1.cxx:358
 AliTOFClusterFinderV1.cxx:359
 AliTOFClusterFinderV1.cxx:360
 AliTOFClusterFinderV1.cxx:361
 AliTOFClusterFinderV1.cxx:362
 AliTOFClusterFinderV1.cxx:363
 AliTOFClusterFinderV1.cxx:364
 AliTOFClusterFinderV1.cxx:365
 AliTOFClusterFinderV1.cxx:366
 AliTOFClusterFinderV1.cxx:367
 AliTOFClusterFinderV1.cxx:368
 AliTOFClusterFinderV1.cxx:369
 AliTOFClusterFinderV1.cxx:370
 AliTOFClusterFinderV1.cxx:371
 AliTOFClusterFinderV1.cxx:372
 AliTOFClusterFinderV1.cxx:373
 AliTOFClusterFinderV1.cxx:374
 AliTOFClusterFinderV1.cxx:375
 AliTOFClusterFinderV1.cxx:376
 AliTOFClusterFinderV1.cxx:377
 AliTOFClusterFinderV1.cxx:378
 AliTOFClusterFinderV1.cxx:379
 AliTOFClusterFinderV1.cxx:380
 AliTOFClusterFinderV1.cxx:381
 AliTOFClusterFinderV1.cxx:382
 AliTOFClusterFinderV1.cxx:383
 AliTOFClusterFinderV1.cxx:384
 AliTOFClusterFinderV1.cxx:385
 AliTOFClusterFinderV1.cxx:386
 AliTOFClusterFinderV1.cxx:387
 AliTOFClusterFinderV1.cxx:388
 AliTOFClusterFinderV1.cxx:389
 AliTOFClusterFinderV1.cxx:390
 AliTOFClusterFinderV1.cxx:391
 AliTOFClusterFinderV1.cxx:392
 AliTOFClusterFinderV1.cxx:393
 AliTOFClusterFinderV1.cxx:394
 AliTOFClusterFinderV1.cxx:395
 AliTOFClusterFinderV1.cxx:396
 AliTOFClusterFinderV1.cxx:397
 AliTOFClusterFinderV1.cxx:398
 AliTOFClusterFinderV1.cxx:399
 AliTOFClusterFinderV1.cxx:400
 AliTOFClusterFinderV1.cxx:401
 AliTOFClusterFinderV1.cxx:402
 AliTOFClusterFinderV1.cxx:403
 AliTOFClusterFinderV1.cxx:404
 AliTOFClusterFinderV1.cxx:405
 AliTOFClusterFinderV1.cxx:406
 AliTOFClusterFinderV1.cxx:407
 AliTOFClusterFinderV1.cxx:408
 AliTOFClusterFinderV1.cxx:409
 AliTOFClusterFinderV1.cxx:410
 AliTOFClusterFinderV1.cxx:411
 AliTOFClusterFinderV1.cxx:412
 AliTOFClusterFinderV1.cxx:413
 AliTOFClusterFinderV1.cxx:414
 AliTOFClusterFinderV1.cxx:415
 AliTOFClusterFinderV1.cxx:416
 AliTOFClusterFinderV1.cxx:417
 AliTOFClusterFinderV1.cxx:418
 AliTOFClusterFinderV1.cxx:419
 AliTOFClusterFinderV1.cxx:420
 AliTOFClusterFinderV1.cxx:421
 AliTOFClusterFinderV1.cxx:422
 AliTOFClusterFinderV1.cxx:423
 AliTOFClusterFinderV1.cxx:424
 AliTOFClusterFinderV1.cxx:425
 AliTOFClusterFinderV1.cxx:426
 AliTOFClusterFinderV1.cxx:427
 AliTOFClusterFinderV1.cxx:428
 AliTOFClusterFinderV1.cxx:429
 AliTOFClusterFinderV1.cxx:430
 AliTOFClusterFinderV1.cxx:431
 AliTOFClusterFinderV1.cxx:432
 AliTOFClusterFinderV1.cxx:433
 AliTOFClusterFinderV1.cxx:434
 AliTOFClusterFinderV1.cxx:435
 AliTOFClusterFinderV1.cxx:436
 AliTOFClusterFinderV1.cxx:437
 AliTOFClusterFinderV1.cxx:438
 AliTOFClusterFinderV1.cxx:439
 AliTOFClusterFinderV1.cxx:440
 AliTOFClusterFinderV1.cxx:441
 AliTOFClusterFinderV1.cxx:442
 AliTOFClusterFinderV1.cxx:443
 AliTOFClusterFinderV1.cxx:444
 AliTOFClusterFinderV1.cxx:445
 AliTOFClusterFinderV1.cxx:446
 AliTOFClusterFinderV1.cxx:447
 AliTOFClusterFinderV1.cxx:448
 AliTOFClusterFinderV1.cxx:449
 AliTOFClusterFinderV1.cxx:450
 AliTOFClusterFinderV1.cxx:451
 AliTOFClusterFinderV1.cxx:452
 AliTOFClusterFinderV1.cxx:453
 AliTOFClusterFinderV1.cxx:454
 AliTOFClusterFinderV1.cxx:455
 AliTOFClusterFinderV1.cxx:456
 AliTOFClusterFinderV1.cxx:457
 AliTOFClusterFinderV1.cxx:458
 AliTOFClusterFinderV1.cxx:459
 AliTOFClusterFinderV1.cxx:460
 AliTOFClusterFinderV1.cxx:461
 AliTOFClusterFinderV1.cxx:462
 AliTOFClusterFinderV1.cxx:463
 AliTOFClusterFinderV1.cxx:464
 AliTOFClusterFinderV1.cxx:465
 AliTOFClusterFinderV1.cxx:466
 AliTOFClusterFinderV1.cxx:467
 AliTOFClusterFinderV1.cxx:468
 AliTOFClusterFinderV1.cxx:469
 AliTOFClusterFinderV1.cxx:470
 AliTOFClusterFinderV1.cxx:471
 AliTOFClusterFinderV1.cxx:472
 AliTOFClusterFinderV1.cxx:473
 AliTOFClusterFinderV1.cxx:474
 AliTOFClusterFinderV1.cxx:475
 AliTOFClusterFinderV1.cxx:476
 AliTOFClusterFinderV1.cxx:477
 AliTOFClusterFinderV1.cxx:478
 AliTOFClusterFinderV1.cxx:479
 AliTOFClusterFinderV1.cxx:480
 AliTOFClusterFinderV1.cxx:481
 AliTOFClusterFinderV1.cxx:482
 AliTOFClusterFinderV1.cxx:483
 AliTOFClusterFinderV1.cxx:484
 AliTOFClusterFinderV1.cxx:485
 AliTOFClusterFinderV1.cxx:486
 AliTOFClusterFinderV1.cxx:487
 AliTOFClusterFinderV1.cxx:488
 AliTOFClusterFinderV1.cxx:489
 AliTOFClusterFinderV1.cxx:490
 AliTOFClusterFinderV1.cxx:491
 AliTOFClusterFinderV1.cxx:492
 AliTOFClusterFinderV1.cxx:493
 AliTOFClusterFinderV1.cxx:494
 AliTOFClusterFinderV1.cxx:495
 AliTOFClusterFinderV1.cxx:496
 AliTOFClusterFinderV1.cxx:497
 AliTOFClusterFinderV1.cxx:498
 AliTOFClusterFinderV1.cxx:499
 AliTOFClusterFinderV1.cxx:500
 AliTOFClusterFinderV1.cxx:501
 AliTOFClusterFinderV1.cxx:502
 AliTOFClusterFinderV1.cxx:503
 AliTOFClusterFinderV1.cxx:504
 AliTOFClusterFinderV1.cxx:505
 AliTOFClusterFinderV1.cxx:506
 AliTOFClusterFinderV1.cxx:507
 AliTOFClusterFinderV1.cxx:508
 AliTOFClusterFinderV1.cxx:509
 AliTOFClusterFinderV1.cxx:510
 AliTOFClusterFinderV1.cxx:511
 AliTOFClusterFinderV1.cxx:512
 AliTOFClusterFinderV1.cxx:513
 AliTOFClusterFinderV1.cxx:514
 AliTOFClusterFinderV1.cxx:515
 AliTOFClusterFinderV1.cxx:516
 AliTOFClusterFinderV1.cxx:517
 AliTOFClusterFinderV1.cxx:518
 AliTOFClusterFinderV1.cxx:519
 AliTOFClusterFinderV1.cxx:520
 AliTOFClusterFinderV1.cxx:521
 AliTOFClusterFinderV1.cxx:522
 AliTOFClusterFinderV1.cxx:523
 AliTOFClusterFinderV1.cxx:524
 AliTOFClusterFinderV1.cxx:525
 AliTOFClusterFinderV1.cxx:526
 AliTOFClusterFinderV1.cxx:527
 AliTOFClusterFinderV1.cxx:528
 AliTOFClusterFinderV1.cxx:529
 AliTOFClusterFinderV1.cxx:530
 AliTOFClusterFinderV1.cxx:531
 AliTOFClusterFinderV1.cxx:532
 AliTOFClusterFinderV1.cxx:533
 AliTOFClusterFinderV1.cxx:534
 AliTOFClusterFinderV1.cxx:535
 AliTOFClusterFinderV1.cxx:536
 AliTOFClusterFinderV1.cxx:537
 AliTOFClusterFinderV1.cxx:538
 AliTOFClusterFinderV1.cxx:539
 AliTOFClusterFinderV1.cxx:540
 AliTOFClusterFinderV1.cxx:541
 AliTOFClusterFinderV1.cxx:542
 AliTOFClusterFinderV1.cxx:543
 AliTOFClusterFinderV1.cxx:544
 AliTOFClusterFinderV1.cxx:545
 AliTOFClusterFinderV1.cxx:546
 AliTOFClusterFinderV1.cxx:547
 AliTOFClusterFinderV1.cxx:548
 AliTOFClusterFinderV1.cxx:549
 AliTOFClusterFinderV1.cxx:550
 AliTOFClusterFinderV1.cxx:551
 AliTOFClusterFinderV1.cxx:552
 AliTOFClusterFinderV1.cxx:553
 AliTOFClusterFinderV1.cxx:554
 AliTOFClusterFinderV1.cxx:555
 AliTOFClusterFinderV1.cxx:556
 AliTOFClusterFinderV1.cxx:557
 AliTOFClusterFinderV1.cxx:558
 AliTOFClusterFinderV1.cxx:559
 AliTOFClusterFinderV1.cxx:560
 AliTOFClusterFinderV1.cxx:561
 AliTOFClusterFinderV1.cxx:562
 AliTOFClusterFinderV1.cxx:563
 AliTOFClusterFinderV1.cxx:564
 AliTOFClusterFinderV1.cxx:565
 AliTOFClusterFinderV1.cxx:566
 AliTOFClusterFinderV1.cxx:567
 AliTOFClusterFinderV1.cxx:568
 AliTOFClusterFinderV1.cxx:569
 AliTOFClusterFinderV1.cxx:570
 AliTOFClusterFinderV1.cxx:571
 AliTOFClusterFinderV1.cxx:572
 AliTOFClusterFinderV1.cxx:573
 AliTOFClusterFinderV1.cxx:574
 AliTOFClusterFinderV1.cxx:575
 AliTOFClusterFinderV1.cxx:576
 AliTOFClusterFinderV1.cxx:577
 AliTOFClusterFinderV1.cxx:578
 AliTOFClusterFinderV1.cxx:579
 AliTOFClusterFinderV1.cxx:580
 AliTOFClusterFinderV1.cxx:581
 AliTOFClusterFinderV1.cxx:582
 AliTOFClusterFinderV1.cxx:583
 AliTOFClusterFinderV1.cxx:584
 AliTOFClusterFinderV1.cxx:585
 AliTOFClusterFinderV1.cxx:586
 AliTOFClusterFinderV1.cxx:587
 AliTOFClusterFinderV1.cxx:588
 AliTOFClusterFinderV1.cxx:589
 AliTOFClusterFinderV1.cxx:590
 AliTOFClusterFinderV1.cxx:591
 AliTOFClusterFinderV1.cxx:592
 AliTOFClusterFinderV1.cxx:593
 AliTOFClusterFinderV1.cxx:594
 AliTOFClusterFinderV1.cxx:595
 AliTOFClusterFinderV1.cxx:596
 AliTOFClusterFinderV1.cxx:597
 AliTOFClusterFinderV1.cxx:598
 AliTOFClusterFinderV1.cxx:599
 AliTOFClusterFinderV1.cxx:600
 AliTOFClusterFinderV1.cxx:601
 AliTOFClusterFinderV1.cxx:602
 AliTOFClusterFinderV1.cxx:603
 AliTOFClusterFinderV1.cxx:604
 AliTOFClusterFinderV1.cxx:605
 AliTOFClusterFinderV1.cxx:606
 AliTOFClusterFinderV1.cxx:607
 AliTOFClusterFinderV1.cxx:608
 AliTOFClusterFinderV1.cxx:609
 AliTOFClusterFinderV1.cxx:610
 AliTOFClusterFinderV1.cxx:611
 AliTOFClusterFinderV1.cxx:612
 AliTOFClusterFinderV1.cxx:613
 AliTOFClusterFinderV1.cxx:614
 AliTOFClusterFinderV1.cxx:615
 AliTOFClusterFinderV1.cxx:616
 AliTOFClusterFinderV1.cxx:617
 AliTOFClusterFinderV1.cxx:618
 AliTOFClusterFinderV1.cxx:619
 AliTOFClusterFinderV1.cxx:620
 AliTOFClusterFinderV1.cxx:621
 AliTOFClusterFinderV1.cxx:622
 AliTOFClusterFinderV1.cxx:623
 AliTOFClusterFinderV1.cxx:624
 AliTOFClusterFinderV1.cxx:625
 AliTOFClusterFinderV1.cxx:626
 AliTOFClusterFinderV1.cxx:627
 AliTOFClusterFinderV1.cxx:628
 AliTOFClusterFinderV1.cxx:629
 AliTOFClusterFinderV1.cxx:630
 AliTOFClusterFinderV1.cxx:631
 AliTOFClusterFinderV1.cxx:632
 AliTOFClusterFinderV1.cxx:633
 AliTOFClusterFinderV1.cxx:634
 AliTOFClusterFinderV1.cxx:635
 AliTOFClusterFinderV1.cxx:636
 AliTOFClusterFinderV1.cxx:637
 AliTOFClusterFinderV1.cxx:638
 AliTOFClusterFinderV1.cxx:639
 AliTOFClusterFinderV1.cxx:640
 AliTOFClusterFinderV1.cxx:641
 AliTOFClusterFinderV1.cxx:642
 AliTOFClusterFinderV1.cxx:643
 AliTOFClusterFinderV1.cxx:644
 AliTOFClusterFinderV1.cxx:645
 AliTOFClusterFinderV1.cxx:646
 AliTOFClusterFinderV1.cxx:647
 AliTOFClusterFinderV1.cxx:648
 AliTOFClusterFinderV1.cxx:649
 AliTOFClusterFinderV1.cxx:650
 AliTOFClusterFinderV1.cxx:651
 AliTOFClusterFinderV1.cxx:652
 AliTOFClusterFinderV1.cxx:653
 AliTOFClusterFinderV1.cxx:654
 AliTOFClusterFinderV1.cxx:655
 AliTOFClusterFinderV1.cxx:656
 AliTOFClusterFinderV1.cxx:657
 AliTOFClusterFinderV1.cxx:658
 AliTOFClusterFinderV1.cxx:659
 AliTOFClusterFinderV1.cxx:660
 AliTOFClusterFinderV1.cxx:661
 AliTOFClusterFinderV1.cxx:662
 AliTOFClusterFinderV1.cxx:663
 AliTOFClusterFinderV1.cxx:664
 AliTOFClusterFinderV1.cxx:665
 AliTOFClusterFinderV1.cxx:666
 AliTOFClusterFinderV1.cxx:667
 AliTOFClusterFinderV1.cxx:668
 AliTOFClusterFinderV1.cxx:669
 AliTOFClusterFinderV1.cxx:670
 AliTOFClusterFinderV1.cxx:671
 AliTOFClusterFinderV1.cxx:672
 AliTOFClusterFinderV1.cxx:673
 AliTOFClusterFinderV1.cxx:674
 AliTOFClusterFinderV1.cxx:675
 AliTOFClusterFinderV1.cxx:676
 AliTOFClusterFinderV1.cxx:677
 AliTOFClusterFinderV1.cxx:678
 AliTOFClusterFinderV1.cxx:679
 AliTOFClusterFinderV1.cxx:680
 AliTOFClusterFinderV1.cxx:681
 AliTOFClusterFinderV1.cxx:682
 AliTOFClusterFinderV1.cxx:683
 AliTOFClusterFinderV1.cxx:684
 AliTOFClusterFinderV1.cxx:685
 AliTOFClusterFinderV1.cxx:686
 AliTOFClusterFinderV1.cxx:687
 AliTOFClusterFinderV1.cxx:688
 AliTOFClusterFinderV1.cxx:689
 AliTOFClusterFinderV1.cxx:690
 AliTOFClusterFinderV1.cxx:691
 AliTOFClusterFinderV1.cxx:692
 AliTOFClusterFinderV1.cxx:693
 AliTOFClusterFinderV1.cxx:694
 AliTOFClusterFinderV1.cxx:695
 AliTOFClusterFinderV1.cxx:696
 AliTOFClusterFinderV1.cxx:697
 AliTOFClusterFinderV1.cxx:698
 AliTOFClusterFinderV1.cxx:699
 AliTOFClusterFinderV1.cxx:700
 AliTOFClusterFinderV1.cxx:701
 AliTOFClusterFinderV1.cxx:702
 AliTOFClusterFinderV1.cxx:703
 AliTOFClusterFinderV1.cxx:704
 AliTOFClusterFinderV1.cxx:705
 AliTOFClusterFinderV1.cxx:706
 AliTOFClusterFinderV1.cxx:707
 AliTOFClusterFinderV1.cxx:708
 AliTOFClusterFinderV1.cxx:709
 AliTOFClusterFinderV1.cxx:710
 AliTOFClusterFinderV1.cxx:711
 AliTOFClusterFinderV1.cxx:712
 AliTOFClusterFinderV1.cxx:713
 AliTOFClusterFinderV1.cxx:714
 AliTOFClusterFinderV1.cxx:715
 AliTOFClusterFinderV1.cxx:716
 AliTOFClusterFinderV1.cxx:717
 AliTOFClusterFinderV1.cxx:718
 AliTOFClusterFinderV1.cxx:719
 AliTOFClusterFinderV1.cxx:720
 AliTOFClusterFinderV1.cxx:721
 AliTOFClusterFinderV1.cxx:722
 AliTOFClusterFinderV1.cxx:723
 AliTOFClusterFinderV1.cxx:724
 AliTOFClusterFinderV1.cxx:725
 AliTOFClusterFinderV1.cxx:726
 AliTOFClusterFinderV1.cxx:727
 AliTOFClusterFinderV1.cxx:728
 AliTOFClusterFinderV1.cxx:729
 AliTOFClusterFinderV1.cxx:730
 AliTOFClusterFinderV1.cxx:731
 AliTOFClusterFinderV1.cxx:732
 AliTOFClusterFinderV1.cxx:733
 AliTOFClusterFinderV1.cxx:734
 AliTOFClusterFinderV1.cxx:735
 AliTOFClusterFinderV1.cxx:736
 AliTOFClusterFinderV1.cxx:737
 AliTOFClusterFinderV1.cxx:738
 AliTOFClusterFinderV1.cxx:739
 AliTOFClusterFinderV1.cxx:740
 AliTOFClusterFinderV1.cxx:741
 AliTOFClusterFinderV1.cxx:742
 AliTOFClusterFinderV1.cxx:743
 AliTOFClusterFinderV1.cxx:744
 AliTOFClusterFinderV1.cxx:745
 AliTOFClusterFinderV1.cxx:746
 AliTOFClusterFinderV1.cxx:747
 AliTOFClusterFinderV1.cxx:748
 AliTOFClusterFinderV1.cxx:749
 AliTOFClusterFinderV1.cxx:750
 AliTOFClusterFinderV1.cxx:751
 AliTOFClusterFinderV1.cxx:752
 AliTOFClusterFinderV1.cxx:753
 AliTOFClusterFinderV1.cxx:754
 AliTOFClusterFinderV1.cxx:755
 AliTOFClusterFinderV1.cxx:756
 AliTOFClusterFinderV1.cxx:757
 AliTOFClusterFinderV1.cxx:758
 AliTOFClusterFinderV1.cxx:759
 AliTOFClusterFinderV1.cxx:760
 AliTOFClusterFinderV1.cxx:761
 AliTOFClusterFinderV1.cxx:762
 AliTOFClusterFinderV1.cxx:763
 AliTOFClusterFinderV1.cxx:764
 AliTOFClusterFinderV1.cxx:765
 AliTOFClusterFinderV1.cxx:766
 AliTOFClusterFinderV1.cxx:767
 AliTOFClusterFinderV1.cxx:768
 AliTOFClusterFinderV1.cxx:769
 AliTOFClusterFinderV1.cxx:770
 AliTOFClusterFinderV1.cxx:771
 AliTOFClusterFinderV1.cxx:772
 AliTOFClusterFinderV1.cxx:773
 AliTOFClusterFinderV1.cxx:774
 AliTOFClusterFinderV1.cxx:775
 AliTOFClusterFinderV1.cxx:776
 AliTOFClusterFinderV1.cxx:777
 AliTOFClusterFinderV1.cxx:778
 AliTOFClusterFinderV1.cxx:779
 AliTOFClusterFinderV1.cxx:780
 AliTOFClusterFinderV1.cxx:781
 AliTOFClusterFinderV1.cxx:782
 AliTOFClusterFinderV1.cxx:783
 AliTOFClusterFinderV1.cxx:784
 AliTOFClusterFinderV1.cxx:785
 AliTOFClusterFinderV1.cxx:786
 AliTOFClusterFinderV1.cxx:787
 AliTOFClusterFinderV1.cxx:788
 AliTOFClusterFinderV1.cxx:789
 AliTOFClusterFinderV1.cxx:790
 AliTOFClusterFinderV1.cxx:791
 AliTOFClusterFinderV1.cxx:792
 AliTOFClusterFinderV1.cxx:793
 AliTOFClusterFinderV1.cxx:794
 AliTOFClusterFinderV1.cxx:795
 AliTOFClusterFinderV1.cxx:796
 AliTOFClusterFinderV1.cxx:797
 AliTOFClusterFinderV1.cxx:798
 AliTOFClusterFinderV1.cxx:799
 AliTOFClusterFinderV1.cxx:800
 AliTOFClusterFinderV1.cxx:801
 AliTOFClusterFinderV1.cxx:802
 AliTOFClusterFinderV1.cxx:803
 AliTOFClusterFinderV1.cxx:804
 AliTOFClusterFinderV1.cxx:805
 AliTOFClusterFinderV1.cxx:806
 AliTOFClusterFinderV1.cxx:807
 AliTOFClusterFinderV1.cxx:808
 AliTOFClusterFinderV1.cxx:809
 AliTOFClusterFinderV1.cxx:810
 AliTOFClusterFinderV1.cxx:811
 AliTOFClusterFinderV1.cxx:812
 AliTOFClusterFinderV1.cxx:813
 AliTOFClusterFinderV1.cxx:814
 AliTOFClusterFinderV1.cxx:815
 AliTOFClusterFinderV1.cxx:816
 AliTOFClusterFinderV1.cxx:817
 AliTOFClusterFinderV1.cxx:818
 AliTOFClusterFinderV1.cxx:819
 AliTOFClusterFinderV1.cxx:820
 AliTOFClusterFinderV1.cxx:821
 AliTOFClusterFinderV1.cxx:822
 AliTOFClusterFinderV1.cxx:823
 AliTOFClusterFinderV1.cxx:824
 AliTOFClusterFinderV1.cxx:825
 AliTOFClusterFinderV1.cxx:826
 AliTOFClusterFinderV1.cxx:827
 AliTOFClusterFinderV1.cxx:828
 AliTOFClusterFinderV1.cxx:829
 AliTOFClusterFinderV1.cxx:830
 AliTOFClusterFinderV1.cxx:831
 AliTOFClusterFinderV1.cxx:832
 AliTOFClusterFinderV1.cxx:833
 AliTOFClusterFinderV1.cxx:834
 AliTOFClusterFinderV1.cxx:835
 AliTOFClusterFinderV1.cxx:836
 AliTOFClusterFinderV1.cxx:837
 AliTOFClusterFinderV1.cxx:838
 AliTOFClusterFinderV1.cxx:839
 AliTOFClusterFinderV1.cxx:840
 AliTOFClusterFinderV1.cxx:841
 AliTOFClusterFinderV1.cxx:842
 AliTOFClusterFinderV1.cxx:843
 AliTOFClusterFinderV1.cxx:844
 AliTOFClusterFinderV1.cxx:845
 AliTOFClusterFinderV1.cxx:846
 AliTOFClusterFinderV1.cxx:847
 AliTOFClusterFinderV1.cxx:848
 AliTOFClusterFinderV1.cxx:849
 AliTOFClusterFinderV1.cxx:850
 AliTOFClusterFinderV1.cxx:851
 AliTOFClusterFinderV1.cxx:852
 AliTOFClusterFinderV1.cxx:853
 AliTOFClusterFinderV1.cxx:854
 AliTOFClusterFinderV1.cxx:855
 AliTOFClusterFinderV1.cxx:856
 AliTOFClusterFinderV1.cxx:857
 AliTOFClusterFinderV1.cxx:858
 AliTOFClusterFinderV1.cxx:859
 AliTOFClusterFinderV1.cxx:860
 AliTOFClusterFinderV1.cxx:861
 AliTOFClusterFinderV1.cxx:862
 AliTOFClusterFinderV1.cxx:863
 AliTOFClusterFinderV1.cxx:864
 AliTOFClusterFinderV1.cxx:865
 AliTOFClusterFinderV1.cxx:866
 AliTOFClusterFinderV1.cxx:867
 AliTOFClusterFinderV1.cxx:868
 AliTOFClusterFinderV1.cxx:869
 AliTOFClusterFinderV1.cxx:870
 AliTOFClusterFinderV1.cxx:871
 AliTOFClusterFinderV1.cxx:872
 AliTOFClusterFinderV1.cxx:873
 AliTOFClusterFinderV1.cxx:874
 AliTOFClusterFinderV1.cxx:875
 AliTOFClusterFinderV1.cxx:876
 AliTOFClusterFinderV1.cxx:877
 AliTOFClusterFinderV1.cxx:878
 AliTOFClusterFinderV1.cxx:879
 AliTOFClusterFinderV1.cxx:880
 AliTOFClusterFinderV1.cxx:881
 AliTOFClusterFinderV1.cxx:882
 AliTOFClusterFinderV1.cxx:883
 AliTOFClusterFinderV1.cxx:884
 AliTOFClusterFinderV1.cxx:885
 AliTOFClusterFinderV1.cxx:886
 AliTOFClusterFinderV1.cxx:887
 AliTOFClusterFinderV1.cxx:888
 AliTOFClusterFinderV1.cxx:889
 AliTOFClusterFinderV1.cxx:890
 AliTOFClusterFinderV1.cxx:891
 AliTOFClusterFinderV1.cxx:892
 AliTOFClusterFinderV1.cxx:893
 AliTOFClusterFinderV1.cxx:894
 AliTOFClusterFinderV1.cxx:895
 AliTOFClusterFinderV1.cxx:896
 AliTOFClusterFinderV1.cxx:897
 AliTOFClusterFinderV1.cxx:898
 AliTOFClusterFinderV1.cxx:899
 AliTOFClusterFinderV1.cxx:900
 AliTOFClusterFinderV1.cxx:901
 AliTOFClusterFinderV1.cxx:902
 AliTOFClusterFinderV1.cxx:903
 AliTOFClusterFinderV1.cxx:904
 AliTOFClusterFinderV1.cxx:905
 AliTOFClusterFinderV1.cxx:906
 AliTOFClusterFinderV1.cxx:907
 AliTOFClusterFinderV1.cxx:908
 AliTOFClusterFinderV1.cxx:909
 AliTOFClusterFinderV1.cxx:910
 AliTOFClusterFinderV1.cxx:911
 AliTOFClusterFinderV1.cxx:912
 AliTOFClusterFinderV1.cxx:913
 AliTOFClusterFinderV1.cxx:914
 AliTOFClusterFinderV1.cxx:915
 AliTOFClusterFinderV1.cxx:916
 AliTOFClusterFinderV1.cxx:917
 AliTOFClusterFinderV1.cxx:918
 AliTOFClusterFinderV1.cxx:919
 AliTOFClusterFinderV1.cxx:920
 AliTOFClusterFinderV1.cxx:921
 AliTOFClusterFinderV1.cxx:922
 AliTOFClusterFinderV1.cxx:923
 AliTOFClusterFinderV1.cxx:924
 AliTOFClusterFinderV1.cxx:925
 AliTOFClusterFinderV1.cxx:926
 AliTOFClusterFinderV1.cxx:927
 AliTOFClusterFinderV1.cxx:928
 AliTOFClusterFinderV1.cxx:929
 AliTOFClusterFinderV1.cxx:930
 AliTOFClusterFinderV1.cxx:931
 AliTOFClusterFinderV1.cxx:932
 AliTOFClusterFinderV1.cxx:933
 AliTOFClusterFinderV1.cxx:934
 AliTOFClusterFinderV1.cxx:935
 AliTOFClusterFinderV1.cxx:936
 AliTOFClusterFinderV1.cxx:937
 AliTOFClusterFinderV1.cxx:938
 AliTOFClusterFinderV1.cxx:939
 AliTOFClusterFinderV1.cxx:940
 AliTOFClusterFinderV1.cxx:941
 AliTOFClusterFinderV1.cxx:942
 AliTOFClusterFinderV1.cxx:943
 AliTOFClusterFinderV1.cxx:944
 AliTOFClusterFinderV1.cxx:945
 AliTOFClusterFinderV1.cxx:946
 AliTOFClusterFinderV1.cxx:947
 AliTOFClusterFinderV1.cxx:948
 AliTOFClusterFinderV1.cxx:949
 AliTOFClusterFinderV1.cxx:950
 AliTOFClusterFinderV1.cxx:951
 AliTOFClusterFinderV1.cxx:952
 AliTOFClusterFinderV1.cxx:953
 AliTOFClusterFinderV1.cxx:954
 AliTOFClusterFinderV1.cxx:955
 AliTOFClusterFinderV1.cxx:956
 AliTOFClusterFinderV1.cxx:957
 AliTOFClusterFinderV1.cxx:958
 AliTOFClusterFinderV1.cxx:959
 AliTOFClusterFinderV1.cxx:960
 AliTOFClusterFinderV1.cxx:961
 AliTOFClusterFinderV1.cxx:962
 AliTOFClusterFinderV1.cxx:963
 AliTOFClusterFinderV1.cxx:964
 AliTOFClusterFinderV1.cxx:965
 AliTOFClusterFinderV1.cxx:966
 AliTOFClusterFinderV1.cxx:967
 AliTOFClusterFinderV1.cxx:968
 AliTOFClusterFinderV1.cxx:969
 AliTOFClusterFinderV1.cxx:970
 AliTOFClusterFinderV1.cxx:971
 AliTOFClusterFinderV1.cxx:972
 AliTOFClusterFinderV1.cxx:973
 AliTOFClusterFinderV1.cxx:974
 AliTOFClusterFinderV1.cxx:975
 AliTOFClusterFinderV1.cxx:976
 AliTOFClusterFinderV1.cxx:977
 AliTOFClusterFinderV1.cxx:978
 AliTOFClusterFinderV1.cxx:979
 AliTOFClusterFinderV1.cxx:980
 AliTOFClusterFinderV1.cxx:981
 AliTOFClusterFinderV1.cxx:982
 AliTOFClusterFinderV1.cxx:983
 AliTOFClusterFinderV1.cxx:984
 AliTOFClusterFinderV1.cxx:985
 AliTOFClusterFinderV1.cxx:986
 AliTOFClusterFinderV1.cxx:987
 AliTOFClusterFinderV1.cxx:988
 AliTOFClusterFinderV1.cxx:989
 AliTOFClusterFinderV1.cxx:990
 AliTOFClusterFinderV1.cxx:991
 AliTOFClusterFinderV1.cxx:992
 AliTOFClusterFinderV1.cxx:993
 AliTOFClusterFinderV1.cxx:994
 AliTOFClusterFinderV1.cxx:995
 AliTOFClusterFinderV1.cxx:996
 AliTOFClusterFinderV1.cxx:997
 AliTOFClusterFinderV1.cxx:998
 AliTOFClusterFinderV1.cxx:999
 AliTOFClusterFinderV1.cxx:1000
 AliTOFClusterFinderV1.cxx:1001
 AliTOFClusterFinderV1.cxx:1002
 AliTOFClusterFinderV1.cxx:1003
 AliTOFClusterFinderV1.cxx:1004
 AliTOFClusterFinderV1.cxx:1005
 AliTOFClusterFinderV1.cxx:1006
 AliTOFClusterFinderV1.cxx:1007
 AliTOFClusterFinderV1.cxx:1008
 AliTOFClusterFinderV1.cxx:1009
 AliTOFClusterFinderV1.cxx:1010
 AliTOFClusterFinderV1.cxx:1011
 AliTOFClusterFinderV1.cxx:1012
 AliTOFClusterFinderV1.cxx:1013
 AliTOFClusterFinderV1.cxx:1014
 AliTOFClusterFinderV1.cxx:1015
 AliTOFClusterFinderV1.cxx:1016
 AliTOFClusterFinderV1.cxx:1017
 AliTOFClusterFinderV1.cxx:1018
 AliTOFClusterFinderV1.cxx:1019
 AliTOFClusterFinderV1.cxx:1020
 AliTOFClusterFinderV1.cxx:1021
 AliTOFClusterFinderV1.cxx:1022
 AliTOFClusterFinderV1.cxx:1023
 AliTOFClusterFinderV1.cxx:1024
 AliTOFClusterFinderV1.cxx:1025
 AliTOFClusterFinderV1.cxx:1026
 AliTOFClusterFinderV1.cxx:1027
 AliTOFClusterFinderV1.cxx:1028
 AliTOFClusterFinderV1.cxx:1029
 AliTOFClusterFinderV1.cxx:1030
 AliTOFClusterFinderV1.cxx:1031
 AliTOFClusterFinderV1.cxx:1032
 AliTOFClusterFinderV1.cxx:1033
 AliTOFClusterFinderV1.cxx:1034
 AliTOFClusterFinderV1.cxx:1035
 AliTOFClusterFinderV1.cxx:1036
 AliTOFClusterFinderV1.cxx:1037
 AliTOFClusterFinderV1.cxx:1038
 AliTOFClusterFinderV1.cxx:1039
 AliTOFClusterFinderV1.cxx:1040
 AliTOFClusterFinderV1.cxx:1041
 AliTOFClusterFinderV1.cxx:1042
 AliTOFClusterFinderV1.cxx:1043
 AliTOFClusterFinderV1.cxx:1044
 AliTOFClusterFinderV1.cxx:1045
 AliTOFClusterFinderV1.cxx:1046
 AliTOFClusterFinderV1.cxx:1047
 AliTOFClusterFinderV1.cxx:1048
 AliTOFClusterFinderV1.cxx:1049
 AliTOFClusterFinderV1.cxx:1050
 AliTOFClusterFinderV1.cxx:1051
 AliTOFClusterFinderV1.cxx:1052
 AliTOFClusterFinderV1.cxx:1053
 AliTOFClusterFinderV1.cxx:1054
 AliTOFClusterFinderV1.cxx:1055
 AliTOFClusterFinderV1.cxx:1056
 AliTOFClusterFinderV1.cxx:1057
 AliTOFClusterFinderV1.cxx:1058
 AliTOFClusterFinderV1.cxx:1059
 AliTOFClusterFinderV1.cxx:1060
 AliTOFClusterFinderV1.cxx:1061
 AliTOFClusterFinderV1.cxx:1062
 AliTOFClusterFinderV1.cxx:1063
 AliTOFClusterFinderV1.cxx:1064
 AliTOFClusterFinderV1.cxx:1065
 AliTOFClusterFinderV1.cxx:1066
 AliTOFClusterFinderV1.cxx:1067
 AliTOFClusterFinderV1.cxx:1068
 AliTOFClusterFinderV1.cxx:1069
 AliTOFClusterFinderV1.cxx:1070
 AliTOFClusterFinderV1.cxx:1071
 AliTOFClusterFinderV1.cxx:1072
 AliTOFClusterFinderV1.cxx:1073
 AliTOFClusterFinderV1.cxx:1074
 AliTOFClusterFinderV1.cxx:1075
 AliTOFClusterFinderV1.cxx:1076
 AliTOFClusterFinderV1.cxx:1077
 AliTOFClusterFinderV1.cxx:1078
 AliTOFClusterFinderV1.cxx:1079
 AliTOFClusterFinderV1.cxx:1080
 AliTOFClusterFinderV1.cxx:1081
 AliTOFClusterFinderV1.cxx:1082
 AliTOFClusterFinderV1.cxx:1083
 AliTOFClusterFinderV1.cxx:1084
 AliTOFClusterFinderV1.cxx:1085
 AliTOFClusterFinderV1.cxx:1086
 AliTOFClusterFinderV1.cxx:1087
 AliTOFClusterFinderV1.cxx:1088
 AliTOFClusterFinderV1.cxx:1089
 AliTOFClusterFinderV1.cxx:1090
 AliTOFClusterFinderV1.cxx:1091
 AliTOFClusterFinderV1.cxx:1092
 AliTOFClusterFinderV1.cxx:1093
 AliTOFClusterFinderV1.cxx:1094
 AliTOFClusterFinderV1.cxx:1095
 AliTOFClusterFinderV1.cxx:1096
 AliTOFClusterFinderV1.cxx:1097
 AliTOFClusterFinderV1.cxx:1098
 AliTOFClusterFinderV1.cxx:1099
 AliTOFClusterFinderV1.cxx:1100
 AliTOFClusterFinderV1.cxx:1101
 AliTOFClusterFinderV1.cxx:1102
 AliTOFClusterFinderV1.cxx:1103
 AliTOFClusterFinderV1.cxx:1104
 AliTOFClusterFinderV1.cxx:1105
 AliTOFClusterFinderV1.cxx:1106
 AliTOFClusterFinderV1.cxx:1107
 AliTOFClusterFinderV1.cxx:1108
 AliTOFClusterFinderV1.cxx:1109
 AliTOFClusterFinderV1.cxx:1110
 AliTOFClusterFinderV1.cxx:1111
 AliTOFClusterFinderV1.cxx:1112
 AliTOFClusterFinderV1.cxx:1113
 AliTOFClusterFinderV1.cxx:1114
 AliTOFClusterFinderV1.cxx:1115
 AliTOFClusterFinderV1.cxx:1116
 AliTOFClusterFinderV1.cxx:1117
 AliTOFClusterFinderV1.cxx:1118
 AliTOFClusterFinderV1.cxx:1119
 AliTOFClusterFinderV1.cxx:1120
 AliTOFClusterFinderV1.cxx:1121
 AliTOFClusterFinderV1.cxx:1122
 AliTOFClusterFinderV1.cxx:1123
 AliTOFClusterFinderV1.cxx:1124
 AliTOFClusterFinderV1.cxx:1125
 AliTOFClusterFinderV1.cxx:1126
 AliTOFClusterFinderV1.cxx:1127
 AliTOFClusterFinderV1.cxx:1128
 AliTOFClusterFinderV1.cxx:1129
 AliTOFClusterFinderV1.cxx:1130
 AliTOFClusterFinderV1.cxx:1131
 AliTOFClusterFinderV1.cxx:1132
 AliTOFClusterFinderV1.cxx:1133
 AliTOFClusterFinderV1.cxx:1134
 AliTOFClusterFinderV1.cxx:1135
 AliTOFClusterFinderV1.cxx:1136
 AliTOFClusterFinderV1.cxx:1137
 AliTOFClusterFinderV1.cxx:1138
 AliTOFClusterFinderV1.cxx:1139
 AliTOFClusterFinderV1.cxx:1140
 AliTOFClusterFinderV1.cxx:1141
 AliTOFClusterFinderV1.cxx:1142
 AliTOFClusterFinderV1.cxx:1143
 AliTOFClusterFinderV1.cxx:1144
 AliTOFClusterFinderV1.cxx:1145
 AliTOFClusterFinderV1.cxx:1146
 AliTOFClusterFinderV1.cxx:1147
 AliTOFClusterFinderV1.cxx:1148
 AliTOFClusterFinderV1.cxx:1149
 AliTOFClusterFinderV1.cxx:1150
 AliTOFClusterFinderV1.cxx:1151
 AliTOFClusterFinderV1.cxx:1152
 AliTOFClusterFinderV1.cxx:1153
 AliTOFClusterFinderV1.cxx:1154
 AliTOFClusterFinderV1.cxx:1155
 AliTOFClusterFinderV1.cxx:1156
 AliTOFClusterFinderV1.cxx:1157
 AliTOFClusterFinderV1.cxx:1158
 AliTOFClusterFinderV1.cxx:1159
 AliTOFClusterFinderV1.cxx:1160
 AliTOFClusterFinderV1.cxx:1161
 AliTOFClusterFinderV1.cxx:1162
 AliTOFClusterFinderV1.cxx:1163
 AliTOFClusterFinderV1.cxx:1164
 AliTOFClusterFinderV1.cxx:1165
 AliTOFClusterFinderV1.cxx:1166
 AliTOFClusterFinderV1.cxx:1167
 AliTOFClusterFinderV1.cxx:1168
 AliTOFClusterFinderV1.cxx:1169
 AliTOFClusterFinderV1.cxx:1170
 AliTOFClusterFinderV1.cxx:1171
 AliTOFClusterFinderV1.cxx:1172
 AliTOFClusterFinderV1.cxx:1173
 AliTOFClusterFinderV1.cxx:1174
 AliTOFClusterFinderV1.cxx:1175
 AliTOFClusterFinderV1.cxx:1176
 AliTOFClusterFinderV1.cxx:1177
 AliTOFClusterFinderV1.cxx:1178
 AliTOFClusterFinderV1.cxx:1179
 AliTOFClusterFinderV1.cxx:1180
 AliTOFClusterFinderV1.cxx:1181
 AliTOFClusterFinderV1.cxx:1182
 AliTOFClusterFinderV1.cxx:1183
 AliTOFClusterFinderV1.cxx:1184
 AliTOFClusterFinderV1.cxx:1185
 AliTOFClusterFinderV1.cxx:1186
 AliTOFClusterFinderV1.cxx:1187
 AliTOFClusterFinderV1.cxx:1188
 AliTOFClusterFinderV1.cxx:1189
 AliTOFClusterFinderV1.cxx:1190
 AliTOFClusterFinderV1.cxx:1191
 AliTOFClusterFinderV1.cxx:1192
 AliTOFClusterFinderV1.cxx:1193
 AliTOFClusterFinderV1.cxx:1194
 AliTOFClusterFinderV1.cxx:1195
 AliTOFClusterFinderV1.cxx:1196
 AliTOFClusterFinderV1.cxx:1197
 AliTOFClusterFinderV1.cxx:1198
 AliTOFClusterFinderV1.cxx:1199
 AliTOFClusterFinderV1.cxx:1200
 AliTOFClusterFinderV1.cxx:1201
 AliTOFClusterFinderV1.cxx:1202
 AliTOFClusterFinderV1.cxx:1203
 AliTOFClusterFinderV1.cxx:1204
 AliTOFClusterFinderV1.cxx:1205
 AliTOFClusterFinderV1.cxx:1206
 AliTOFClusterFinderV1.cxx:1207
 AliTOFClusterFinderV1.cxx:1208
 AliTOFClusterFinderV1.cxx:1209
 AliTOFClusterFinderV1.cxx:1210
 AliTOFClusterFinderV1.cxx:1211
 AliTOFClusterFinderV1.cxx:1212
 AliTOFClusterFinderV1.cxx:1213
 AliTOFClusterFinderV1.cxx:1214
 AliTOFClusterFinderV1.cxx:1215
 AliTOFClusterFinderV1.cxx:1216
 AliTOFClusterFinderV1.cxx:1217
 AliTOFClusterFinderV1.cxx:1218
 AliTOFClusterFinderV1.cxx:1219
 AliTOFClusterFinderV1.cxx:1220
 AliTOFClusterFinderV1.cxx:1221
 AliTOFClusterFinderV1.cxx:1222
 AliTOFClusterFinderV1.cxx:1223
 AliTOFClusterFinderV1.cxx:1224
 AliTOFClusterFinderV1.cxx:1225
 AliTOFClusterFinderV1.cxx:1226
 AliTOFClusterFinderV1.cxx:1227
 AliTOFClusterFinderV1.cxx:1228
 AliTOFClusterFinderV1.cxx:1229
 AliTOFClusterFinderV1.cxx:1230
 AliTOFClusterFinderV1.cxx:1231
 AliTOFClusterFinderV1.cxx:1232
 AliTOFClusterFinderV1.cxx:1233
 AliTOFClusterFinderV1.cxx:1234
 AliTOFClusterFinderV1.cxx:1235
 AliTOFClusterFinderV1.cxx:1236
 AliTOFClusterFinderV1.cxx:1237
 AliTOFClusterFinderV1.cxx:1238
 AliTOFClusterFinderV1.cxx:1239
 AliTOFClusterFinderV1.cxx:1240
 AliTOFClusterFinderV1.cxx:1241
 AliTOFClusterFinderV1.cxx:1242
 AliTOFClusterFinderV1.cxx:1243
 AliTOFClusterFinderV1.cxx:1244
 AliTOFClusterFinderV1.cxx:1245
 AliTOFClusterFinderV1.cxx:1246
 AliTOFClusterFinderV1.cxx:1247
 AliTOFClusterFinderV1.cxx:1248
 AliTOFClusterFinderV1.cxx:1249
 AliTOFClusterFinderV1.cxx:1250
 AliTOFClusterFinderV1.cxx:1251
 AliTOFClusterFinderV1.cxx:1252
 AliTOFClusterFinderV1.cxx:1253
 AliTOFClusterFinderV1.cxx:1254
 AliTOFClusterFinderV1.cxx:1255
 AliTOFClusterFinderV1.cxx:1256
 AliTOFClusterFinderV1.cxx:1257
 AliTOFClusterFinderV1.cxx:1258
 AliTOFClusterFinderV1.cxx:1259
 AliTOFClusterFinderV1.cxx:1260
 AliTOFClusterFinderV1.cxx:1261
 AliTOFClusterFinderV1.cxx:1262
 AliTOFClusterFinderV1.cxx:1263
 AliTOFClusterFinderV1.cxx:1264
 AliTOFClusterFinderV1.cxx:1265
 AliTOFClusterFinderV1.cxx:1266
 AliTOFClusterFinderV1.cxx:1267
 AliTOFClusterFinderV1.cxx:1268
 AliTOFClusterFinderV1.cxx:1269
 AliTOFClusterFinderV1.cxx:1270
 AliTOFClusterFinderV1.cxx:1271
 AliTOFClusterFinderV1.cxx:1272
 AliTOFClusterFinderV1.cxx:1273
 AliTOFClusterFinderV1.cxx:1274
 AliTOFClusterFinderV1.cxx:1275
 AliTOFClusterFinderV1.cxx:1276
 AliTOFClusterFinderV1.cxx:1277
 AliTOFClusterFinderV1.cxx:1278
 AliTOFClusterFinderV1.cxx:1279
 AliTOFClusterFinderV1.cxx:1280
 AliTOFClusterFinderV1.cxx:1281
 AliTOFClusterFinderV1.cxx:1282
 AliTOFClusterFinderV1.cxx:1283
 AliTOFClusterFinderV1.cxx:1284
 AliTOFClusterFinderV1.cxx:1285
 AliTOFClusterFinderV1.cxx:1286
 AliTOFClusterFinderV1.cxx:1287
 AliTOFClusterFinderV1.cxx:1288
 AliTOFClusterFinderV1.cxx:1289
 AliTOFClusterFinderV1.cxx:1290
 AliTOFClusterFinderV1.cxx:1291
 AliTOFClusterFinderV1.cxx:1292
 AliTOFClusterFinderV1.cxx:1293
 AliTOFClusterFinderV1.cxx:1294
 AliTOFClusterFinderV1.cxx:1295
 AliTOFClusterFinderV1.cxx:1296
 AliTOFClusterFinderV1.cxx:1297
 AliTOFClusterFinderV1.cxx:1298
 AliTOFClusterFinderV1.cxx:1299
 AliTOFClusterFinderV1.cxx:1300
 AliTOFClusterFinderV1.cxx:1301
 AliTOFClusterFinderV1.cxx:1302
 AliTOFClusterFinderV1.cxx:1303
 AliTOFClusterFinderV1.cxx:1304
 AliTOFClusterFinderV1.cxx:1305
 AliTOFClusterFinderV1.cxx:1306
 AliTOFClusterFinderV1.cxx:1307
 AliTOFClusterFinderV1.cxx:1308
 AliTOFClusterFinderV1.cxx:1309
 AliTOFClusterFinderV1.cxx:1310
 AliTOFClusterFinderV1.cxx:1311
 AliTOFClusterFinderV1.cxx:1312
 AliTOFClusterFinderV1.cxx:1313
 AliTOFClusterFinderV1.cxx:1314
 AliTOFClusterFinderV1.cxx:1315
 AliTOFClusterFinderV1.cxx:1316
 AliTOFClusterFinderV1.cxx:1317
 AliTOFClusterFinderV1.cxx:1318
 AliTOFClusterFinderV1.cxx:1319
 AliTOFClusterFinderV1.cxx:1320
 AliTOFClusterFinderV1.cxx:1321
 AliTOFClusterFinderV1.cxx:1322
 AliTOFClusterFinderV1.cxx:1323
 AliTOFClusterFinderV1.cxx:1324
 AliTOFClusterFinderV1.cxx:1325
 AliTOFClusterFinderV1.cxx:1326
 AliTOFClusterFinderV1.cxx:1327
 AliTOFClusterFinderV1.cxx:1328
 AliTOFClusterFinderV1.cxx:1329
 AliTOFClusterFinderV1.cxx:1330
 AliTOFClusterFinderV1.cxx:1331
 AliTOFClusterFinderV1.cxx:1332
 AliTOFClusterFinderV1.cxx:1333
 AliTOFClusterFinderV1.cxx:1334
 AliTOFClusterFinderV1.cxx:1335
 AliTOFClusterFinderV1.cxx:1336
 AliTOFClusterFinderV1.cxx:1337
 AliTOFClusterFinderV1.cxx:1338
 AliTOFClusterFinderV1.cxx:1339
 AliTOFClusterFinderV1.cxx:1340
 AliTOFClusterFinderV1.cxx:1341
 AliTOFClusterFinderV1.cxx:1342
 AliTOFClusterFinderV1.cxx:1343
 AliTOFClusterFinderV1.cxx:1344
 AliTOFClusterFinderV1.cxx:1345
 AliTOFClusterFinderV1.cxx:1346
 AliTOFClusterFinderV1.cxx:1347
 AliTOFClusterFinderV1.cxx:1348
 AliTOFClusterFinderV1.cxx:1349
 AliTOFClusterFinderV1.cxx:1350
 AliTOFClusterFinderV1.cxx:1351
 AliTOFClusterFinderV1.cxx:1352
 AliTOFClusterFinderV1.cxx:1353
 AliTOFClusterFinderV1.cxx:1354
 AliTOFClusterFinderV1.cxx:1355
 AliTOFClusterFinderV1.cxx:1356
 AliTOFClusterFinderV1.cxx:1357
 AliTOFClusterFinderV1.cxx:1358
 AliTOFClusterFinderV1.cxx:1359
 AliTOFClusterFinderV1.cxx:1360
 AliTOFClusterFinderV1.cxx:1361
 AliTOFClusterFinderV1.cxx:1362
 AliTOFClusterFinderV1.cxx:1363
 AliTOFClusterFinderV1.cxx:1364
 AliTOFClusterFinderV1.cxx:1365
 AliTOFClusterFinderV1.cxx:1366
 AliTOFClusterFinderV1.cxx:1367
 AliTOFClusterFinderV1.cxx:1368
 AliTOFClusterFinderV1.cxx:1369
 AliTOFClusterFinderV1.cxx:1370
 AliTOFClusterFinderV1.cxx:1371
 AliTOFClusterFinderV1.cxx:1372
 AliTOFClusterFinderV1.cxx:1373
 AliTOFClusterFinderV1.cxx:1374
 AliTOFClusterFinderV1.cxx:1375
 AliTOFClusterFinderV1.cxx:1376
 AliTOFClusterFinderV1.cxx:1377
 AliTOFClusterFinderV1.cxx:1378
 AliTOFClusterFinderV1.cxx:1379
 AliTOFClusterFinderV1.cxx:1380
 AliTOFClusterFinderV1.cxx:1381
 AliTOFClusterFinderV1.cxx:1382
 AliTOFClusterFinderV1.cxx:1383
 AliTOFClusterFinderV1.cxx:1384
 AliTOFClusterFinderV1.cxx:1385
 AliTOFClusterFinderV1.cxx:1386
 AliTOFClusterFinderV1.cxx:1387
 AliTOFClusterFinderV1.cxx:1388
 AliTOFClusterFinderV1.cxx:1389
 AliTOFClusterFinderV1.cxx:1390
 AliTOFClusterFinderV1.cxx:1391
 AliTOFClusterFinderV1.cxx:1392
 AliTOFClusterFinderV1.cxx:1393
 AliTOFClusterFinderV1.cxx:1394
 AliTOFClusterFinderV1.cxx:1395
 AliTOFClusterFinderV1.cxx:1396
 AliTOFClusterFinderV1.cxx:1397
 AliTOFClusterFinderV1.cxx:1398
 AliTOFClusterFinderV1.cxx:1399
 AliTOFClusterFinderV1.cxx:1400
 AliTOFClusterFinderV1.cxx:1401
 AliTOFClusterFinderV1.cxx:1402
 AliTOFClusterFinderV1.cxx:1403
 AliTOFClusterFinderV1.cxx:1404
 AliTOFClusterFinderV1.cxx:1405
 AliTOFClusterFinderV1.cxx:1406
 AliTOFClusterFinderV1.cxx:1407
 AliTOFClusterFinderV1.cxx:1408
 AliTOFClusterFinderV1.cxx:1409
 AliTOFClusterFinderV1.cxx:1410
 AliTOFClusterFinderV1.cxx:1411
 AliTOFClusterFinderV1.cxx:1412
 AliTOFClusterFinderV1.cxx:1413
 AliTOFClusterFinderV1.cxx:1414
 AliTOFClusterFinderV1.cxx:1415
 AliTOFClusterFinderV1.cxx:1416
 AliTOFClusterFinderV1.cxx:1417
 AliTOFClusterFinderV1.cxx:1418
 AliTOFClusterFinderV1.cxx:1419
 AliTOFClusterFinderV1.cxx:1420
 AliTOFClusterFinderV1.cxx:1421
 AliTOFClusterFinderV1.cxx:1422
 AliTOFClusterFinderV1.cxx:1423
 AliTOFClusterFinderV1.cxx:1424
 AliTOFClusterFinderV1.cxx:1425
 AliTOFClusterFinderV1.cxx:1426
 AliTOFClusterFinderV1.cxx:1427
 AliTOFClusterFinderV1.cxx:1428
 AliTOFClusterFinderV1.cxx:1429
 AliTOFClusterFinderV1.cxx:1430
 AliTOFClusterFinderV1.cxx:1431
 AliTOFClusterFinderV1.cxx:1432
 AliTOFClusterFinderV1.cxx:1433
 AliTOFClusterFinderV1.cxx:1434
 AliTOFClusterFinderV1.cxx:1435
 AliTOFClusterFinderV1.cxx:1436
 AliTOFClusterFinderV1.cxx:1437
 AliTOFClusterFinderV1.cxx:1438
 AliTOFClusterFinderV1.cxx:1439
 AliTOFClusterFinderV1.cxx:1440
 AliTOFClusterFinderV1.cxx:1441
 AliTOFClusterFinderV1.cxx:1442
 AliTOFClusterFinderV1.cxx:1443
 AliTOFClusterFinderV1.cxx:1444
 AliTOFClusterFinderV1.cxx:1445
 AliTOFClusterFinderV1.cxx:1446
 AliTOFClusterFinderV1.cxx:1447
 AliTOFClusterFinderV1.cxx:1448
 AliTOFClusterFinderV1.cxx:1449
 AliTOFClusterFinderV1.cxx:1450
 AliTOFClusterFinderV1.cxx:1451
 AliTOFClusterFinderV1.cxx:1452
 AliTOFClusterFinderV1.cxx:1453
 AliTOFClusterFinderV1.cxx:1454
 AliTOFClusterFinderV1.cxx:1455
 AliTOFClusterFinderV1.cxx:1456
 AliTOFClusterFinderV1.cxx:1457
 AliTOFClusterFinderV1.cxx:1458
 AliTOFClusterFinderV1.cxx:1459
 AliTOFClusterFinderV1.cxx:1460
 AliTOFClusterFinderV1.cxx:1461
 AliTOFClusterFinderV1.cxx:1462
 AliTOFClusterFinderV1.cxx:1463
 AliTOFClusterFinderV1.cxx:1464
 AliTOFClusterFinderV1.cxx:1465
 AliTOFClusterFinderV1.cxx:1466
 AliTOFClusterFinderV1.cxx:1467
 AliTOFClusterFinderV1.cxx:1468
 AliTOFClusterFinderV1.cxx:1469
 AliTOFClusterFinderV1.cxx:1470
 AliTOFClusterFinderV1.cxx:1471
 AliTOFClusterFinderV1.cxx:1472
 AliTOFClusterFinderV1.cxx:1473
 AliTOFClusterFinderV1.cxx:1474
 AliTOFClusterFinderV1.cxx:1475
 AliTOFClusterFinderV1.cxx:1476
 AliTOFClusterFinderV1.cxx:1477
 AliTOFClusterFinderV1.cxx:1478
 AliTOFClusterFinderV1.cxx:1479
 AliTOFClusterFinderV1.cxx:1480
 AliTOFClusterFinderV1.cxx:1481
 AliTOFClusterFinderV1.cxx:1482
 AliTOFClusterFinderV1.cxx:1483
 AliTOFClusterFinderV1.cxx:1484
 AliTOFClusterFinderV1.cxx:1485
 AliTOFClusterFinderV1.cxx:1486
 AliTOFClusterFinderV1.cxx:1487
 AliTOFClusterFinderV1.cxx:1488
 AliTOFClusterFinderV1.cxx:1489
 AliTOFClusterFinderV1.cxx:1490
 AliTOFClusterFinderV1.cxx:1491
 AliTOFClusterFinderV1.cxx:1492
 AliTOFClusterFinderV1.cxx:1493
 AliTOFClusterFinderV1.cxx:1494
 AliTOFClusterFinderV1.cxx:1495
 AliTOFClusterFinderV1.cxx:1496
 AliTOFClusterFinderV1.cxx:1497
 AliTOFClusterFinderV1.cxx:1498
 AliTOFClusterFinderV1.cxx:1499
 AliTOFClusterFinderV1.cxx:1500
 AliTOFClusterFinderV1.cxx:1501
 AliTOFClusterFinderV1.cxx:1502
 AliTOFClusterFinderV1.cxx:1503
 AliTOFClusterFinderV1.cxx:1504
 AliTOFClusterFinderV1.cxx:1505
 AliTOFClusterFinderV1.cxx:1506
 AliTOFClusterFinderV1.cxx:1507
 AliTOFClusterFinderV1.cxx:1508
 AliTOFClusterFinderV1.cxx:1509
 AliTOFClusterFinderV1.cxx:1510
 AliTOFClusterFinderV1.cxx:1511
 AliTOFClusterFinderV1.cxx:1512
 AliTOFClusterFinderV1.cxx:1513
 AliTOFClusterFinderV1.cxx:1514
 AliTOFClusterFinderV1.cxx:1515
 AliTOFClusterFinderV1.cxx:1516
 AliTOFClusterFinderV1.cxx:1517
 AliTOFClusterFinderV1.cxx:1518
 AliTOFClusterFinderV1.cxx:1519
 AliTOFClusterFinderV1.cxx:1520
 AliTOFClusterFinderV1.cxx:1521
 AliTOFClusterFinderV1.cxx:1522
 AliTOFClusterFinderV1.cxx:1523
 AliTOFClusterFinderV1.cxx:1524
 AliTOFClusterFinderV1.cxx:1525
 AliTOFClusterFinderV1.cxx:1526
 AliTOFClusterFinderV1.cxx:1527
 AliTOFClusterFinderV1.cxx:1528
 AliTOFClusterFinderV1.cxx:1529
 AliTOFClusterFinderV1.cxx:1530
 AliTOFClusterFinderV1.cxx:1531
 AliTOFClusterFinderV1.cxx:1532
 AliTOFClusterFinderV1.cxx:1533
 AliTOFClusterFinderV1.cxx:1534
 AliTOFClusterFinderV1.cxx:1535
 AliTOFClusterFinderV1.cxx:1536
 AliTOFClusterFinderV1.cxx:1537
 AliTOFClusterFinderV1.cxx:1538
 AliTOFClusterFinderV1.cxx:1539
 AliTOFClusterFinderV1.cxx:1540
 AliTOFClusterFinderV1.cxx:1541
 AliTOFClusterFinderV1.cxx:1542
 AliTOFClusterFinderV1.cxx:1543
 AliTOFClusterFinderV1.cxx:1544
 AliTOFClusterFinderV1.cxx:1545
 AliTOFClusterFinderV1.cxx:1546
 AliTOFClusterFinderV1.cxx:1547
 AliTOFClusterFinderV1.cxx:1548
 AliTOFClusterFinderV1.cxx:1549
 AliTOFClusterFinderV1.cxx:1550
 AliTOFClusterFinderV1.cxx:1551
 AliTOFClusterFinderV1.cxx:1552
 AliTOFClusterFinderV1.cxx:1553
 AliTOFClusterFinderV1.cxx:1554
 AliTOFClusterFinderV1.cxx:1555
 AliTOFClusterFinderV1.cxx:1556
 AliTOFClusterFinderV1.cxx:1557
 AliTOFClusterFinderV1.cxx:1558
 AliTOFClusterFinderV1.cxx:1559
 AliTOFClusterFinderV1.cxx:1560
 AliTOFClusterFinderV1.cxx:1561
 AliTOFClusterFinderV1.cxx:1562
 AliTOFClusterFinderV1.cxx:1563
 AliTOFClusterFinderV1.cxx:1564
 AliTOFClusterFinderV1.cxx:1565
 AliTOFClusterFinderV1.cxx:1566
 AliTOFClusterFinderV1.cxx:1567
 AliTOFClusterFinderV1.cxx:1568
 AliTOFClusterFinderV1.cxx:1569
 AliTOFClusterFinderV1.cxx:1570
 AliTOFClusterFinderV1.cxx:1571
 AliTOFClusterFinderV1.cxx:1572
 AliTOFClusterFinderV1.cxx:1573
 AliTOFClusterFinderV1.cxx:1574
 AliTOFClusterFinderV1.cxx:1575
 AliTOFClusterFinderV1.cxx:1576
 AliTOFClusterFinderV1.cxx:1577
 AliTOFClusterFinderV1.cxx:1578
 AliTOFClusterFinderV1.cxx:1579
 AliTOFClusterFinderV1.cxx:1580
 AliTOFClusterFinderV1.cxx:1581
 AliTOFClusterFinderV1.cxx:1582
 AliTOFClusterFinderV1.cxx:1583
 AliTOFClusterFinderV1.cxx:1584
 AliTOFClusterFinderV1.cxx:1585
 AliTOFClusterFinderV1.cxx:1586
 AliTOFClusterFinderV1.cxx:1587
 AliTOFClusterFinderV1.cxx:1588
 AliTOFClusterFinderV1.cxx:1589
 AliTOFClusterFinderV1.cxx:1590
 AliTOFClusterFinderV1.cxx:1591
 AliTOFClusterFinderV1.cxx:1592
 AliTOFClusterFinderV1.cxx:1593
 AliTOFClusterFinderV1.cxx:1594
 AliTOFClusterFinderV1.cxx:1595
 AliTOFClusterFinderV1.cxx:1596
 AliTOFClusterFinderV1.cxx:1597
 AliTOFClusterFinderV1.cxx:1598
 AliTOFClusterFinderV1.cxx:1599
 AliTOFClusterFinderV1.cxx:1600
 AliTOFClusterFinderV1.cxx:1601
 AliTOFClusterFinderV1.cxx:1602
 AliTOFClusterFinderV1.cxx:1603
 AliTOFClusterFinderV1.cxx:1604
 AliTOFClusterFinderV1.cxx:1605
 AliTOFClusterFinderV1.cxx:1606
 AliTOFClusterFinderV1.cxx:1607
 AliTOFClusterFinderV1.cxx:1608
 AliTOFClusterFinderV1.cxx:1609
 AliTOFClusterFinderV1.cxx:1610
 AliTOFClusterFinderV1.cxx:1611
 AliTOFClusterFinderV1.cxx:1612
 AliTOFClusterFinderV1.cxx:1613
 AliTOFClusterFinderV1.cxx:1614
 AliTOFClusterFinderV1.cxx:1615
 AliTOFClusterFinderV1.cxx:1616
 AliTOFClusterFinderV1.cxx:1617
 AliTOFClusterFinderV1.cxx:1618
 AliTOFClusterFinderV1.cxx:1619
 AliTOFClusterFinderV1.cxx:1620
 AliTOFClusterFinderV1.cxx:1621
 AliTOFClusterFinderV1.cxx:1622
 AliTOFClusterFinderV1.cxx:1623
 AliTOFClusterFinderV1.cxx:1624
 AliTOFClusterFinderV1.cxx:1625
 AliTOFClusterFinderV1.cxx:1626
 AliTOFClusterFinderV1.cxx:1627
 AliTOFClusterFinderV1.cxx:1628
 AliTOFClusterFinderV1.cxx:1629
 AliTOFClusterFinderV1.cxx:1630
 AliTOFClusterFinderV1.cxx:1631
 AliTOFClusterFinderV1.cxx:1632
 AliTOFClusterFinderV1.cxx:1633
 AliTOFClusterFinderV1.cxx:1634
 AliTOFClusterFinderV1.cxx:1635
 AliTOFClusterFinderV1.cxx:1636
 AliTOFClusterFinderV1.cxx:1637
 AliTOFClusterFinderV1.cxx:1638
 AliTOFClusterFinderV1.cxx:1639
 AliTOFClusterFinderV1.cxx:1640
 AliTOFClusterFinderV1.cxx:1641
 AliTOFClusterFinderV1.cxx:1642
 AliTOFClusterFinderV1.cxx:1643
 AliTOFClusterFinderV1.cxx:1644
 AliTOFClusterFinderV1.cxx:1645
 AliTOFClusterFinderV1.cxx:1646
 AliTOFClusterFinderV1.cxx:1647
 AliTOFClusterFinderV1.cxx:1648
 AliTOFClusterFinderV1.cxx:1649
 AliTOFClusterFinderV1.cxx:1650
 AliTOFClusterFinderV1.cxx:1651
 AliTOFClusterFinderV1.cxx:1652
 AliTOFClusterFinderV1.cxx:1653
 AliTOFClusterFinderV1.cxx:1654
 AliTOFClusterFinderV1.cxx:1655
 AliTOFClusterFinderV1.cxx:1656
 AliTOFClusterFinderV1.cxx:1657
 AliTOFClusterFinderV1.cxx:1658
 AliTOFClusterFinderV1.cxx:1659
 AliTOFClusterFinderV1.cxx:1660
 AliTOFClusterFinderV1.cxx:1661
 AliTOFClusterFinderV1.cxx:1662
 AliTOFClusterFinderV1.cxx:1663
 AliTOFClusterFinderV1.cxx:1664
 AliTOFClusterFinderV1.cxx:1665
 AliTOFClusterFinderV1.cxx:1666
 AliTOFClusterFinderV1.cxx:1667
 AliTOFClusterFinderV1.cxx:1668
 AliTOFClusterFinderV1.cxx:1669
 AliTOFClusterFinderV1.cxx:1670
 AliTOFClusterFinderV1.cxx:1671
 AliTOFClusterFinderV1.cxx:1672
 AliTOFClusterFinderV1.cxx:1673
 AliTOFClusterFinderV1.cxx:1674
 AliTOFClusterFinderV1.cxx:1675
 AliTOFClusterFinderV1.cxx:1676
 AliTOFClusterFinderV1.cxx:1677
 AliTOFClusterFinderV1.cxx:1678
 AliTOFClusterFinderV1.cxx:1679
 AliTOFClusterFinderV1.cxx:1680
 AliTOFClusterFinderV1.cxx:1681
 AliTOFClusterFinderV1.cxx:1682
 AliTOFClusterFinderV1.cxx:1683
 AliTOFClusterFinderV1.cxx:1684
 AliTOFClusterFinderV1.cxx:1685
 AliTOFClusterFinderV1.cxx:1686
 AliTOFClusterFinderV1.cxx:1687
 AliTOFClusterFinderV1.cxx:1688
 AliTOFClusterFinderV1.cxx:1689
 AliTOFClusterFinderV1.cxx:1690
 AliTOFClusterFinderV1.cxx:1691
 AliTOFClusterFinderV1.cxx:1692
 AliTOFClusterFinderV1.cxx:1693
 AliTOFClusterFinderV1.cxx:1694
 AliTOFClusterFinderV1.cxx:1695
 AliTOFClusterFinderV1.cxx:1696
 AliTOFClusterFinderV1.cxx:1697
 AliTOFClusterFinderV1.cxx:1698
 AliTOFClusterFinderV1.cxx:1699
 AliTOFClusterFinderV1.cxx:1700
 AliTOFClusterFinderV1.cxx:1701
 AliTOFClusterFinderV1.cxx:1702
 AliTOFClusterFinderV1.cxx:1703
 AliTOFClusterFinderV1.cxx:1704
 AliTOFClusterFinderV1.cxx:1705
 AliTOFClusterFinderV1.cxx:1706
 AliTOFClusterFinderV1.cxx:1707
 AliTOFClusterFinderV1.cxx:1708
 AliTOFClusterFinderV1.cxx:1709
 AliTOFClusterFinderV1.cxx:1710
 AliTOFClusterFinderV1.cxx:1711
 AliTOFClusterFinderV1.cxx:1712
 AliTOFClusterFinderV1.cxx:1713
 AliTOFClusterFinderV1.cxx:1714
 AliTOFClusterFinderV1.cxx:1715
 AliTOFClusterFinderV1.cxx:1716
 AliTOFClusterFinderV1.cxx:1717
 AliTOFClusterFinderV1.cxx:1718
 AliTOFClusterFinderV1.cxx:1719
 AliTOFClusterFinderV1.cxx:1720
 AliTOFClusterFinderV1.cxx:1721
 AliTOFClusterFinderV1.cxx:1722
 AliTOFClusterFinderV1.cxx:1723
 AliTOFClusterFinderV1.cxx:1724
 AliTOFClusterFinderV1.cxx:1725
 AliTOFClusterFinderV1.cxx:1726
 AliTOFClusterFinderV1.cxx:1727
 AliTOFClusterFinderV1.cxx:1728
 AliTOFClusterFinderV1.cxx:1729
 AliTOFClusterFinderV1.cxx:1730
 AliTOFClusterFinderV1.cxx:1731
 AliTOFClusterFinderV1.cxx:1732
 AliTOFClusterFinderV1.cxx:1733
 AliTOFClusterFinderV1.cxx:1734
 AliTOFClusterFinderV1.cxx:1735
 AliTOFClusterFinderV1.cxx:1736
 AliTOFClusterFinderV1.cxx:1737
 AliTOFClusterFinderV1.cxx:1738
 AliTOFClusterFinderV1.cxx:1739
 AliTOFClusterFinderV1.cxx:1740
 AliTOFClusterFinderV1.cxx:1741
 AliTOFClusterFinderV1.cxx:1742
 AliTOFClusterFinderV1.cxx:1743
 AliTOFClusterFinderV1.cxx:1744
 AliTOFClusterFinderV1.cxx:1745
 AliTOFClusterFinderV1.cxx:1746
 AliTOFClusterFinderV1.cxx:1747
 AliTOFClusterFinderV1.cxx:1748
 AliTOFClusterFinderV1.cxx:1749
 AliTOFClusterFinderV1.cxx:1750
 AliTOFClusterFinderV1.cxx:1751
 AliTOFClusterFinderV1.cxx:1752
 AliTOFClusterFinderV1.cxx:1753
 AliTOFClusterFinderV1.cxx:1754
 AliTOFClusterFinderV1.cxx:1755
 AliTOFClusterFinderV1.cxx:1756
 AliTOFClusterFinderV1.cxx:1757
 AliTOFClusterFinderV1.cxx:1758
 AliTOFClusterFinderV1.cxx:1759
 AliTOFClusterFinderV1.cxx:1760
 AliTOFClusterFinderV1.cxx:1761
 AliTOFClusterFinderV1.cxx:1762
 AliTOFClusterFinderV1.cxx:1763
 AliTOFClusterFinderV1.cxx:1764
 AliTOFClusterFinderV1.cxx:1765
 AliTOFClusterFinderV1.cxx:1766
 AliTOFClusterFinderV1.cxx:1767
 AliTOFClusterFinderV1.cxx:1768
 AliTOFClusterFinderV1.cxx:1769
 AliTOFClusterFinderV1.cxx:1770
 AliTOFClusterFinderV1.cxx:1771
 AliTOFClusterFinderV1.cxx:1772
 AliTOFClusterFinderV1.cxx:1773
 AliTOFClusterFinderV1.cxx:1774
 AliTOFClusterFinderV1.cxx:1775
 AliTOFClusterFinderV1.cxx:1776
 AliTOFClusterFinderV1.cxx:1777
 AliTOFClusterFinderV1.cxx:1778
 AliTOFClusterFinderV1.cxx:1779
 AliTOFClusterFinderV1.cxx:1780
 AliTOFClusterFinderV1.cxx:1781
 AliTOFClusterFinderV1.cxx:1782
 AliTOFClusterFinderV1.cxx:1783
 AliTOFClusterFinderV1.cxx:1784
 AliTOFClusterFinderV1.cxx:1785
 AliTOFClusterFinderV1.cxx:1786
 AliTOFClusterFinderV1.cxx:1787
 AliTOFClusterFinderV1.cxx:1788
 AliTOFClusterFinderV1.cxx:1789
 AliTOFClusterFinderV1.cxx:1790
 AliTOFClusterFinderV1.cxx:1791
 AliTOFClusterFinderV1.cxx:1792
 AliTOFClusterFinderV1.cxx:1793
 AliTOFClusterFinderV1.cxx:1794
 AliTOFClusterFinderV1.cxx:1795
 AliTOFClusterFinderV1.cxx:1796
 AliTOFClusterFinderV1.cxx:1797
 AliTOFClusterFinderV1.cxx:1798
 AliTOFClusterFinderV1.cxx:1799
 AliTOFClusterFinderV1.cxx:1800
 AliTOFClusterFinderV1.cxx:1801
 AliTOFClusterFinderV1.cxx:1802
 AliTOFClusterFinderV1.cxx:1803
 AliTOFClusterFinderV1.cxx:1804
 AliTOFClusterFinderV1.cxx:1805
 AliTOFClusterFinderV1.cxx:1806
 AliTOFClusterFinderV1.cxx:1807
 AliTOFClusterFinderV1.cxx:1808
 AliTOFClusterFinderV1.cxx:1809
 AliTOFClusterFinderV1.cxx:1810
 AliTOFClusterFinderV1.cxx:1811
 AliTOFClusterFinderV1.cxx:1812
 AliTOFClusterFinderV1.cxx:1813
 AliTOFClusterFinderV1.cxx:1814
 AliTOFClusterFinderV1.cxx:1815
 AliTOFClusterFinderV1.cxx:1816
 AliTOFClusterFinderV1.cxx:1817
 AliTOFClusterFinderV1.cxx:1818
 AliTOFClusterFinderV1.cxx:1819
 AliTOFClusterFinderV1.cxx:1820
 AliTOFClusterFinderV1.cxx:1821
 AliTOFClusterFinderV1.cxx:1822
 AliTOFClusterFinderV1.cxx:1823
 AliTOFClusterFinderV1.cxx:1824
 AliTOFClusterFinderV1.cxx:1825
 AliTOFClusterFinderV1.cxx:1826
 AliTOFClusterFinderV1.cxx:1827
 AliTOFClusterFinderV1.cxx:1828
 AliTOFClusterFinderV1.cxx:1829
 AliTOFClusterFinderV1.cxx:1830
 AliTOFClusterFinderV1.cxx:1831
 AliTOFClusterFinderV1.cxx:1832
 AliTOFClusterFinderV1.cxx:1833
 AliTOFClusterFinderV1.cxx:1834
 AliTOFClusterFinderV1.cxx:1835
 AliTOFClusterFinderV1.cxx:1836
 AliTOFClusterFinderV1.cxx:1837
 AliTOFClusterFinderV1.cxx:1838
 AliTOFClusterFinderV1.cxx:1839
 AliTOFClusterFinderV1.cxx:1840
 AliTOFClusterFinderV1.cxx:1841
 AliTOFClusterFinderV1.cxx:1842
 AliTOFClusterFinderV1.cxx:1843
 AliTOFClusterFinderV1.cxx:1844
 AliTOFClusterFinderV1.cxx:1845
 AliTOFClusterFinderV1.cxx:1846
 AliTOFClusterFinderV1.cxx:1847
 AliTOFClusterFinderV1.cxx:1848
 AliTOFClusterFinderV1.cxx:1849
 AliTOFClusterFinderV1.cxx:1850
 AliTOFClusterFinderV1.cxx:1851
 AliTOFClusterFinderV1.cxx:1852
 AliTOFClusterFinderV1.cxx:1853
 AliTOFClusterFinderV1.cxx:1854
 AliTOFClusterFinderV1.cxx:1855
 AliTOFClusterFinderV1.cxx:1856
 AliTOFClusterFinderV1.cxx:1857
 AliTOFClusterFinderV1.cxx:1858
 AliTOFClusterFinderV1.cxx:1859
 AliTOFClusterFinderV1.cxx:1860
 AliTOFClusterFinderV1.cxx:1861
 AliTOFClusterFinderV1.cxx:1862
 AliTOFClusterFinderV1.cxx:1863
 AliTOFClusterFinderV1.cxx:1864
 AliTOFClusterFinderV1.cxx:1865
 AliTOFClusterFinderV1.cxx:1866
 AliTOFClusterFinderV1.cxx:1867
 AliTOFClusterFinderV1.cxx:1868
 AliTOFClusterFinderV1.cxx:1869
 AliTOFClusterFinderV1.cxx:1870
 AliTOFClusterFinderV1.cxx:1871
 AliTOFClusterFinderV1.cxx:1872
 AliTOFClusterFinderV1.cxx:1873
 AliTOFClusterFinderV1.cxx:1874
 AliTOFClusterFinderV1.cxx:1875
 AliTOFClusterFinderV1.cxx:1876
 AliTOFClusterFinderV1.cxx:1877
 AliTOFClusterFinderV1.cxx:1878
 AliTOFClusterFinderV1.cxx:1879
 AliTOFClusterFinderV1.cxx:1880
 AliTOFClusterFinderV1.cxx:1881
 AliTOFClusterFinderV1.cxx:1882
 AliTOFClusterFinderV1.cxx:1883
 AliTOFClusterFinderV1.cxx:1884
 AliTOFClusterFinderV1.cxx:1885
 AliTOFClusterFinderV1.cxx:1886
 AliTOFClusterFinderV1.cxx:1887
 AliTOFClusterFinderV1.cxx:1888
 AliTOFClusterFinderV1.cxx:1889
 AliTOFClusterFinderV1.cxx:1890
 AliTOFClusterFinderV1.cxx:1891
 AliTOFClusterFinderV1.cxx:1892
 AliTOFClusterFinderV1.cxx:1893
 AliTOFClusterFinderV1.cxx:1894
 AliTOFClusterFinderV1.cxx:1895
 AliTOFClusterFinderV1.cxx:1896
 AliTOFClusterFinderV1.cxx:1897
 AliTOFClusterFinderV1.cxx:1898
 AliTOFClusterFinderV1.cxx:1899
 AliTOFClusterFinderV1.cxx:1900
 AliTOFClusterFinderV1.cxx:1901
 AliTOFClusterFinderV1.cxx:1902
 AliTOFClusterFinderV1.cxx:1903
 AliTOFClusterFinderV1.cxx:1904
 AliTOFClusterFinderV1.cxx:1905
 AliTOFClusterFinderV1.cxx:1906
 AliTOFClusterFinderV1.cxx:1907
 AliTOFClusterFinderV1.cxx:1908
 AliTOFClusterFinderV1.cxx:1909
 AliTOFClusterFinderV1.cxx:1910
 AliTOFClusterFinderV1.cxx:1911
 AliTOFClusterFinderV1.cxx:1912
 AliTOFClusterFinderV1.cxx:1913
 AliTOFClusterFinderV1.cxx:1914
 AliTOFClusterFinderV1.cxx:1915
 AliTOFClusterFinderV1.cxx:1916
 AliTOFClusterFinderV1.cxx:1917
 AliTOFClusterFinderV1.cxx:1918
 AliTOFClusterFinderV1.cxx:1919
 AliTOFClusterFinderV1.cxx:1920
 AliTOFClusterFinderV1.cxx:1921
 AliTOFClusterFinderV1.cxx:1922
 AliTOFClusterFinderV1.cxx:1923
 AliTOFClusterFinderV1.cxx:1924
 AliTOFClusterFinderV1.cxx:1925
 AliTOFClusterFinderV1.cxx:1926
 AliTOFClusterFinderV1.cxx:1927
 AliTOFClusterFinderV1.cxx:1928
 AliTOFClusterFinderV1.cxx:1929
 AliTOFClusterFinderV1.cxx:1930
 AliTOFClusterFinderV1.cxx:1931
 AliTOFClusterFinderV1.cxx:1932
 AliTOFClusterFinderV1.cxx:1933
 AliTOFClusterFinderV1.cxx:1934
 AliTOFClusterFinderV1.cxx:1935
 AliTOFClusterFinderV1.cxx:1936
 AliTOFClusterFinderV1.cxx:1937
 AliTOFClusterFinderV1.cxx:1938
 AliTOFClusterFinderV1.cxx:1939
 AliTOFClusterFinderV1.cxx:1940
 AliTOFClusterFinderV1.cxx:1941
 AliTOFClusterFinderV1.cxx:1942
 AliTOFClusterFinderV1.cxx:1943
 AliTOFClusterFinderV1.cxx:1944
 AliTOFClusterFinderV1.cxx:1945
 AliTOFClusterFinderV1.cxx:1946
 AliTOFClusterFinderV1.cxx:1947
 AliTOFClusterFinderV1.cxx:1948
 AliTOFClusterFinderV1.cxx:1949
 AliTOFClusterFinderV1.cxx:1950
 AliTOFClusterFinderV1.cxx:1951
 AliTOFClusterFinderV1.cxx:1952
 AliTOFClusterFinderV1.cxx:1953
 AliTOFClusterFinderV1.cxx:1954
 AliTOFClusterFinderV1.cxx:1955
 AliTOFClusterFinderV1.cxx:1956
 AliTOFClusterFinderV1.cxx:1957
 AliTOFClusterFinderV1.cxx:1958
 AliTOFClusterFinderV1.cxx:1959
 AliTOFClusterFinderV1.cxx:1960
 AliTOFClusterFinderV1.cxx:1961
 AliTOFClusterFinderV1.cxx:1962
 AliTOFClusterFinderV1.cxx:1963
 AliTOFClusterFinderV1.cxx:1964
 AliTOFClusterFinderV1.cxx:1965
 AliTOFClusterFinderV1.cxx:1966
 AliTOFClusterFinderV1.cxx:1967
 AliTOFClusterFinderV1.cxx:1968
 AliTOFClusterFinderV1.cxx:1969
 AliTOFClusterFinderV1.cxx:1970
 AliTOFClusterFinderV1.cxx:1971
 AliTOFClusterFinderV1.cxx:1972
 AliTOFClusterFinderV1.cxx:1973
 AliTOFClusterFinderV1.cxx:1974
 AliTOFClusterFinderV1.cxx:1975
 AliTOFClusterFinderV1.cxx:1976
 AliTOFClusterFinderV1.cxx:1977
 AliTOFClusterFinderV1.cxx:1978
 AliTOFClusterFinderV1.cxx:1979
 AliTOFClusterFinderV1.cxx:1980
 AliTOFClusterFinderV1.cxx:1981
 AliTOFClusterFinderV1.cxx:1982
 AliTOFClusterFinderV1.cxx:1983
 AliTOFClusterFinderV1.cxx:1984
 AliTOFClusterFinderV1.cxx:1985
 AliTOFClusterFinderV1.cxx:1986
 AliTOFClusterFinderV1.cxx:1987
 AliTOFClusterFinderV1.cxx:1988
 AliTOFClusterFinderV1.cxx:1989
 AliTOFClusterFinderV1.cxx:1990
 AliTOFClusterFinderV1.cxx:1991
 AliTOFClusterFinderV1.cxx:1992
 AliTOFClusterFinderV1.cxx:1993
 AliTOFClusterFinderV1.cxx:1994
 AliTOFClusterFinderV1.cxx:1995
 AliTOFClusterFinderV1.cxx:1996
 AliTOFClusterFinderV1.cxx:1997
 AliTOFClusterFinderV1.cxx:1998
 AliTOFClusterFinderV1.cxx:1999
 AliTOFClusterFinderV1.cxx:2000
 AliTOFClusterFinderV1.cxx:2001
 AliTOFClusterFinderV1.cxx:2002
 AliTOFClusterFinderV1.cxx:2003
 AliTOFClusterFinderV1.cxx:2004
 AliTOFClusterFinderV1.cxx:2005
 AliTOFClusterFinderV1.cxx:2006
 AliTOFClusterFinderV1.cxx:2007
 AliTOFClusterFinderV1.cxx:2008
 AliTOFClusterFinderV1.cxx:2009
 AliTOFClusterFinderV1.cxx:2010
 AliTOFClusterFinderV1.cxx:2011
 AliTOFClusterFinderV1.cxx:2012
 AliTOFClusterFinderV1.cxx:2013
 AliTOFClusterFinderV1.cxx:2014
 AliTOFClusterFinderV1.cxx:2015
 AliTOFClusterFinderV1.cxx:2016
 AliTOFClusterFinderV1.cxx:2017
 AliTOFClusterFinderV1.cxx:2018
 AliTOFClusterFinderV1.cxx:2019
 AliTOFClusterFinderV1.cxx:2020
 AliTOFClusterFinderV1.cxx:2021
 AliTOFClusterFinderV1.cxx:2022
 AliTOFClusterFinderV1.cxx:2023
 AliTOFClusterFinderV1.cxx:2024
 AliTOFClusterFinderV1.cxx:2025
 AliTOFClusterFinderV1.cxx:2026
 AliTOFClusterFinderV1.cxx:2027
 AliTOFClusterFinderV1.cxx:2028
 AliTOFClusterFinderV1.cxx:2029
 AliTOFClusterFinderV1.cxx:2030
 AliTOFClusterFinderV1.cxx:2031
 AliTOFClusterFinderV1.cxx:2032
 AliTOFClusterFinderV1.cxx:2033
 AliTOFClusterFinderV1.cxx:2034
 AliTOFClusterFinderV1.cxx:2035
 AliTOFClusterFinderV1.cxx:2036
 AliTOFClusterFinderV1.cxx:2037
 AliTOFClusterFinderV1.cxx:2038
 AliTOFClusterFinderV1.cxx:2039
 AliTOFClusterFinderV1.cxx:2040
 AliTOFClusterFinderV1.cxx:2041
 AliTOFClusterFinderV1.cxx:2042
 AliTOFClusterFinderV1.cxx:2043
 AliTOFClusterFinderV1.cxx:2044
 AliTOFClusterFinderV1.cxx:2045
 AliTOFClusterFinderV1.cxx:2046
 AliTOFClusterFinderV1.cxx:2047
 AliTOFClusterFinderV1.cxx:2048
 AliTOFClusterFinderV1.cxx:2049
 AliTOFClusterFinderV1.cxx:2050
 AliTOFClusterFinderV1.cxx:2051
 AliTOFClusterFinderV1.cxx:2052
 AliTOFClusterFinderV1.cxx:2053
 AliTOFClusterFinderV1.cxx:2054
 AliTOFClusterFinderV1.cxx:2055
 AliTOFClusterFinderV1.cxx:2056
 AliTOFClusterFinderV1.cxx:2057
 AliTOFClusterFinderV1.cxx:2058
 AliTOFClusterFinderV1.cxx:2059
 AliTOFClusterFinderV1.cxx:2060
 AliTOFClusterFinderV1.cxx:2061
 AliTOFClusterFinderV1.cxx:2062
 AliTOFClusterFinderV1.cxx:2063
 AliTOFClusterFinderV1.cxx:2064
 AliTOFClusterFinderV1.cxx:2065
 AliTOFClusterFinderV1.cxx:2066
 AliTOFClusterFinderV1.cxx:2067
 AliTOFClusterFinderV1.cxx:2068
 AliTOFClusterFinderV1.cxx:2069
 AliTOFClusterFinderV1.cxx:2070
 AliTOFClusterFinderV1.cxx:2071
 AliTOFClusterFinderV1.cxx:2072
 AliTOFClusterFinderV1.cxx:2073
 AliTOFClusterFinderV1.cxx:2074
 AliTOFClusterFinderV1.cxx:2075
 AliTOFClusterFinderV1.cxx:2076
 AliTOFClusterFinderV1.cxx:2077
 AliTOFClusterFinderV1.cxx:2078
 AliTOFClusterFinderV1.cxx:2079
 AliTOFClusterFinderV1.cxx:2080
 AliTOFClusterFinderV1.cxx:2081
 AliTOFClusterFinderV1.cxx:2082
 AliTOFClusterFinderV1.cxx:2083
 AliTOFClusterFinderV1.cxx:2084
 AliTOFClusterFinderV1.cxx:2085
 AliTOFClusterFinderV1.cxx:2086
 AliTOFClusterFinderV1.cxx:2087
 AliTOFClusterFinderV1.cxx:2088
 AliTOFClusterFinderV1.cxx:2089
 AliTOFClusterFinderV1.cxx:2090
 AliTOFClusterFinderV1.cxx:2091
 AliTOFClusterFinderV1.cxx:2092
 AliTOFClusterFinderV1.cxx:2093
 AliTOFClusterFinderV1.cxx:2094
 AliTOFClusterFinderV1.cxx:2095
 AliTOFClusterFinderV1.cxx:2096
 AliTOFClusterFinderV1.cxx:2097
 AliTOFClusterFinderV1.cxx:2098
 AliTOFClusterFinderV1.cxx:2099
 AliTOFClusterFinderV1.cxx:2100
 AliTOFClusterFinderV1.cxx:2101
 AliTOFClusterFinderV1.cxx:2102
 AliTOFClusterFinderV1.cxx:2103
 AliTOFClusterFinderV1.cxx:2104
 AliTOFClusterFinderV1.cxx:2105
 AliTOFClusterFinderV1.cxx:2106
 AliTOFClusterFinderV1.cxx:2107
 AliTOFClusterFinderV1.cxx:2108
 AliTOFClusterFinderV1.cxx:2109
 AliTOFClusterFinderV1.cxx:2110
 AliTOFClusterFinderV1.cxx:2111
 AliTOFClusterFinderV1.cxx:2112
 AliTOFClusterFinderV1.cxx:2113
 AliTOFClusterFinderV1.cxx:2114
 AliTOFClusterFinderV1.cxx:2115
 AliTOFClusterFinderV1.cxx:2116
 AliTOFClusterFinderV1.cxx:2117
 AliTOFClusterFinderV1.cxx:2118
 AliTOFClusterFinderV1.cxx:2119
 AliTOFClusterFinderV1.cxx:2120
 AliTOFClusterFinderV1.cxx:2121
 AliTOFClusterFinderV1.cxx:2122
 AliTOFClusterFinderV1.cxx:2123
 AliTOFClusterFinderV1.cxx:2124
 AliTOFClusterFinderV1.cxx:2125
 AliTOFClusterFinderV1.cxx:2126
 AliTOFClusterFinderV1.cxx:2127
 AliTOFClusterFinderV1.cxx:2128
 AliTOFClusterFinderV1.cxx:2129
 AliTOFClusterFinderV1.cxx:2130
 AliTOFClusterFinderV1.cxx:2131
 AliTOFClusterFinderV1.cxx:2132
 AliTOFClusterFinderV1.cxx:2133
 AliTOFClusterFinderV1.cxx:2134
 AliTOFClusterFinderV1.cxx:2135
 AliTOFClusterFinderV1.cxx:2136
 AliTOFClusterFinderV1.cxx:2137
 AliTOFClusterFinderV1.cxx:2138
 AliTOFClusterFinderV1.cxx:2139
 AliTOFClusterFinderV1.cxx:2140
 AliTOFClusterFinderV1.cxx:2141
 AliTOFClusterFinderV1.cxx:2142
 AliTOFClusterFinderV1.cxx:2143
 AliTOFClusterFinderV1.cxx:2144
 AliTOFClusterFinderV1.cxx:2145
 AliTOFClusterFinderV1.cxx:2146
 AliTOFClusterFinderV1.cxx:2147
 AliTOFClusterFinderV1.cxx:2148
 AliTOFClusterFinderV1.cxx:2149
 AliTOFClusterFinderV1.cxx:2150
 AliTOFClusterFinderV1.cxx:2151
 AliTOFClusterFinderV1.cxx:2152
 AliTOFClusterFinderV1.cxx:2153
 AliTOFClusterFinderV1.cxx:2154
 AliTOFClusterFinderV1.cxx:2155
 AliTOFClusterFinderV1.cxx:2156
 AliTOFClusterFinderV1.cxx:2157
 AliTOFClusterFinderV1.cxx:2158
 AliTOFClusterFinderV1.cxx:2159
 AliTOFClusterFinderV1.cxx:2160
 AliTOFClusterFinderV1.cxx:2161
 AliTOFClusterFinderV1.cxx:2162
 AliTOFClusterFinderV1.cxx:2163
 AliTOFClusterFinderV1.cxx:2164
 AliTOFClusterFinderV1.cxx:2165
 AliTOFClusterFinderV1.cxx:2166
 AliTOFClusterFinderV1.cxx:2167
 AliTOFClusterFinderV1.cxx:2168
 AliTOFClusterFinderV1.cxx:2169
 AliTOFClusterFinderV1.cxx:2170
 AliTOFClusterFinderV1.cxx:2171
 AliTOFClusterFinderV1.cxx:2172
 AliTOFClusterFinderV1.cxx:2173
 AliTOFClusterFinderV1.cxx:2174
 AliTOFClusterFinderV1.cxx:2175
 AliTOFClusterFinderV1.cxx:2176
 AliTOFClusterFinderV1.cxx:2177
 AliTOFClusterFinderV1.cxx:2178
 AliTOFClusterFinderV1.cxx:2179
 AliTOFClusterFinderV1.cxx:2180
 AliTOFClusterFinderV1.cxx:2181
 AliTOFClusterFinderV1.cxx:2182
 AliTOFClusterFinderV1.cxx:2183
 AliTOFClusterFinderV1.cxx:2184
 AliTOFClusterFinderV1.cxx:2185
 AliTOFClusterFinderV1.cxx:2186
 AliTOFClusterFinderV1.cxx:2187
 AliTOFClusterFinderV1.cxx:2188
 AliTOFClusterFinderV1.cxx:2189
 AliTOFClusterFinderV1.cxx:2190
 AliTOFClusterFinderV1.cxx:2191
 AliTOFClusterFinderV1.cxx:2192
 AliTOFClusterFinderV1.cxx:2193
 AliTOFClusterFinderV1.cxx:2194
 AliTOFClusterFinderV1.cxx:2195
 AliTOFClusterFinderV1.cxx:2196
 AliTOFClusterFinderV1.cxx:2197
 AliTOFClusterFinderV1.cxx:2198
 AliTOFClusterFinderV1.cxx:2199
 AliTOFClusterFinderV1.cxx:2200
 AliTOFClusterFinderV1.cxx:2201
 AliTOFClusterFinderV1.cxx:2202
 AliTOFClusterFinderV1.cxx:2203
 AliTOFClusterFinderV1.cxx:2204
 AliTOFClusterFinderV1.cxx:2205
 AliTOFClusterFinderV1.cxx:2206
 AliTOFClusterFinderV1.cxx:2207
 AliTOFClusterFinderV1.cxx:2208
 AliTOFClusterFinderV1.cxx:2209
 AliTOFClusterFinderV1.cxx:2210
 AliTOFClusterFinderV1.cxx:2211
 AliTOFClusterFinderV1.cxx:2212
 AliTOFClusterFinderV1.cxx:2213
 AliTOFClusterFinderV1.cxx:2214
 AliTOFClusterFinderV1.cxx:2215
 AliTOFClusterFinderV1.cxx:2216
 AliTOFClusterFinderV1.cxx:2217
 AliTOFClusterFinderV1.cxx:2218
 AliTOFClusterFinderV1.cxx:2219
 AliTOFClusterFinderV1.cxx:2220
 AliTOFClusterFinderV1.cxx:2221
 AliTOFClusterFinderV1.cxx:2222
 AliTOFClusterFinderV1.cxx:2223
 AliTOFClusterFinderV1.cxx:2224
 AliTOFClusterFinderV1.cxx:2225
 AliTOFClusterFinderV1.cxx:2226
 AliTOFClusterFinderV1.cxx:2227
 AliTOFClusterFinderV1.cxx:2228
 AliTOFClusterFinderV1.cxx:2229
 AliTOFClusterFinderV1.cxx:2230
 AliTOFClusterFinderV1.cxx:2231
 AliTOFClusterFinderV1.cxx:2232
 AliTOFClusterFinderV1.cxx:2233
 AliTOFClusterFinderV1.cxx:2234
 AliTOFClusterFinderV1.cxx:2235
 AliTOFClusterFinderV1.cxx:2236
 AliTOFClusterFinderV1.cxx:2237
 AliTOFClusterFinderV1.cxx:2238
 AliTOFClusterFinderV1.cxx:2239
 AliTOFClusterFinderV1.cxx:2240
 AliTOFClusterFinderV1.cxx:2241
 AliTOFClusterFinderV1.cxx:2242
 AliTOFClusterFinderV1.cxx:2243
 AliTOFClusterFinderV1.cxx:2244
 AliTOFClusterFinderV1.cxx:2245
 AliTOFClusterFinderV1.cxx:2246
 AliTOFClusterFinderV1.cxx:2247
 AliTOFClusterFinderV1.cxx:2248
 AliTOFClusterFinderV1.cxx:2249
 AliTOFClusterFinderV1.cxx:2250
 AliTOFClusterFinderV1.cxx:2251
 AliTOFClusterFinderV1.cxx:2252
 AliTOFClusterFinderV1.cxx:2253
 AliTOFClusterFinderV1.cxx:2254
 AliTOFClusterFinderV1.cxx:2255
 AliTOFClusterFinderV1.cxx:2256
 AliTOFClusterFinderV1.cxx:2257
 AliTOFClusterFinderV1.cxx:2258
 AliTOFClusterFinderV1.cxx:2259
 AliTOFClusterFinderV1.cxx:2260
 AliTOFClusterFinderV1.cxx:2261
 AliTOFClusterFinderV1.cxx:2262
 AliTOFClusterFinderV1.cxx:2263
 AliTOFClusterFinderV1.cxx:2264
 AliTOFClusterFinderV1.cxx:2265
 AliTOFClusterFinderV1.cxx:2266
 AliTOFClusterFinderV1.cxx:2267
 AliTOFClusterFinderV1.cxx:2268
 AliTOFClusterFinderV1.cxx:2269
 AliTOFClusterFinderV1.cxx:2270
 AliTOFClusterFinderV1.cxx:2271
 AliTOFClusterFinderV1.cxx:2272
 AliTOFClusterFinderV1.cxx:2273
 AliTOFClusterFinderV1.cxx:2274
 AliTOFClusterFinderV1.cxx:2275
 AliTOFClusterFinderV1.cxx:2276
 AliTOFClusterFinderV1.cxx:2277
 AliTOFClusterFinderV1.cxx:2278
 AliTOFClusterFinderV1.cxx:2279
 AliTOFClusterFinderV1.cxx:2280
 AliTOFClusterFinderV1.cxx:2281
 AliTOFClusterFinderV1.cxx:2282
 AliTOFClusterFinderV1.cxx:2283
 AliTOFClusterFinderV1.cxx:2284
 AliTOFClusterFinderV1.cxx:2285
 AliTOFClusterFinderV1.cxx:2286
 AliTOFClusterFinderV1.cxx:2287
 AliTOFClusterFinderV1.cxx:2288
 AliTOFClusterFinderV1.cxx:2289
 AliTOFClusterFinderV1.cxx:2290
 AliTOFClusterFinderV1.cxx:2291
 AliTOFClusterFinderV1.cxx:2292
 AliTOFClusterFinderV1.cxx:2293
 AliTOFClusterFinderV1.cxx:2294
 AliTOFClusterFinderV1.cxx:2295
 AliTOFClusterFinderV1.cxx:2296
 AliTOFClusterFinderV1.cxx:2297
 AliTOFClusterFinderV1.cxx:2298
 AliTOFClusterFinderV1.cxx:2299
 AliTOFClusterFinderV1.cxx:2300
 AliTOFClusterFinderV1.cxx:2301
 AliTOFClusterFinderV1.cxx:2302
 AliTOFClusterFinderV1.cxx:2303
 AliTOFClusterFinderV1.cxx:2304
 AliTOFClusterFinderV1.cxx:2305
 AliTOFClusterFinderV1.cxx:2306
 AliTOFClusterFinderV1.cxx:2307
 AliTOFClusterFinderV1.cxx:2308
 AliTOFClusterFinderV1.cxx:2309
 AliTOFClusterFinderV1.cxx:2310
 AliTOFClusterFinderV1.cxx:2311
 AliTOFClusterFinderV1.cxx:2312
 AliTOFClusterFinderV1.cxx:2313
 AliTOFClusterFinderV1.cxx:2314
 AliTOFClusterFinderV1.cxx:2315
 AliTOFClusterFinderV1.cxx:2316
 AliTOFClusterFinderV1.cxx:2317
 AliTOFClusterFinderV1.cxx:2318
 AliTOFClusterFinderV1.cxx:2319
 AliTOFClusterFinderV1.cxx:2320
 AliTOFClusterFinderV1.cxx:2321
 AliTOFClusterFinderV1.cxx:2322
 AliTOFClusterFinderV1.cxx:2323
 AliTOFClusterFinderV1.cxx:2324
 AliTOFClusterFinderV1.cxx:2325
 AliTOFClusterFinderV1.cxx:2326
 AliTOFClusterFinderV1.cxx:2327
 AliTOFClusterFinderV1.cxx:2328
 AliTOFClusterFinderV1.cxx:2329
 AliTOFClusterFinderV1.cxx:2330
 AliTOFClusterFinderV1.cxx:2331
 AliTOFClusterFinderV1.cxx:2332
 AliTOFClusterFinderV1.cxx:2333
 AliTOFClusterFinderV1.cxx:2334
 AliTOFClusterFinderV1.cxx:2335
 AliTOFClusterFinderV1.cxx:2336
 AliTOFClusterFinderV1.cxx:2337
 AliTOFClusterFinderV1.cxx:2338
 AliTOFClusterFinderV1.cxx:2339
 AliTOFClusterFinderV1.cxx:2340
 AliTOFClusterFinderV1.cxx:2341
 AliTOFClusterFinderV1.cxx:2342
 AliTOFClusterFinderV1.cxx:2343
 AliTOFClusterFinderV1.cxx:2344
 AliTOFClusterFinderV1.cxx:2345
 AliTOFClusterFinderV1.cxx:2346
 AliTOFClusterFinderV1.cxx:2347
 AliTOFClusterFinderV1.cxx:2348
 AliTOFClusterFinderV1.cxx:2349
 AliTOFClusterFinderV1.cxx:2350
 AliTOFClusterFinderV1.cxx:2351
 AliTOFClusterFinderV1.cxx:2352
 AliTOFClusterFinderV1.cxx:2353
 AliTOFClusterFinderV1.cxx:2354
 AliTOFClusterFinderV1.cxx:2355
 AliTOFClusterFinderV1.cxx:2356
 AliTOFClusterFinderV1.cxx:2357
 AliTOFClusterFinderV1.cxx:2358
 AliTOFClusterFinderV1.cxx:2359
 AliTOFClusterFinderV1.cxx:2360
 AliTOFClusterFinderV1.cxx:2361
 AliTOFClusterFinderV1.cxx:2362
 AliTOFClusterFinderV1.cxx:2363
 AliTOFClusterFinderV1.cxx:2364
 AliTOFClusterFinderV1.cxx:2365
 AliTOFClusterFinderV1.cxx:2366
 AliTOFClusterFinderV1.cxx:2367
 AliTOFClusterFinderV1.cxx:2368
 AliTOFClusterFinderV1.cxx:2369
 AliTOFClusterFinderV1.cxx:2370
 AliTOFClusterFinderV1.cxx:2371
 AliTOFClusterFinderV1.cxx:2372
 AliTOFClusterFinderV1.cxx:2373
 AliTOFClusterFinderV1.cxx:2374
 AliTOFClusterFinderV1.cxx:2375
 AliTOFClusterFinderV1.cxx:2376
 AliTOFClusterFinderV1.cxx:2377
 AliTOFClusterFinderV1.cxx:2378
 AliTOFClusterFinderV1.cxx:2379
 AliTOFClusterFinderV1.cxx:2380
 AliTOFClusterFinderV1.cxx:2381
 AliTOFClusterFinderV1.cxx:2382
 AliTOFClusterFinderV1.cxx:2383
 AliTOFClusterFinderV1.cxx:2384
 AliTOFClusterFinderV1.cxx:2385
 AliTOFClusterFinderV1.cxx:2386
 AliTOFClusterFinderV1.cxx:2387
 AliTOFClusterFinderV1.cxx:2388
 AliTOFClusterFinderV1.cxx:2389
 AliTOFClusterFinderV1.cxx:2390
 AliTOFClusterFinderV1.cxx:2391
 AliTOFClusterFinderV1.cxx:2392
 AliTOFClusterFinderV1.cxx:2393
 AliTOFClusterFinderV1.cxx:2394
 AliTOFClusterFinderV1.cxx:2395
 AliTOFClusterFinderV1.cxx:2396
 AliTOFClusterFinderV1.cxx:2397
 AliTOFClusterFinderV1.cxx:2398
 AliTOFClusterFinderV1.cxx:2399
 AliTOFClusterFinderV1.cxx:2400
 AliTOFClusterFinderV1.cxx:2401
 AliTOFClusterFinderV1.cxx:2402
 AliTOFClusterFinderV1.cxx:2403
 AliTOFClusterFinderV1.cxx:2404
 AliTOFClusterFinderV1.cxx:2405
 AliTOFClusterFinderV1.cxx:2406
 AliTOFClusterFinderV1.cxx:2407
 AliTOFClusterFinderV1.cxx:2408
 AliTOFClusterFinderV1.cxx:2409
 AliTOFClusterFinderV1.cxx:2410
 AliTOFClusterFinderV1.cxx:2411
 AliTOFClusterFinderV1.cxx:2412
 AliTOFClusterFinderV1.cxx:2413
 AliTOFClusterFinderV1.cxx:2414
 AliTOFClusterFinderV1.cxx:2415
 AliTOFClusterFinderV1.cxx:2416
 AliTOFClusterFinderV1.cxx:2417
 AliTOFClusterFinderV1.cxx:2418
 AliTOFClusterFinderV1.cxx:2419
 AliTOFClusterFinderV1.cxx:2420
 AliTOFClusterFinderV1.cxx:2421
 AliTOFClusterFinderV1.cxx:2422
 AliTOFClusterFinderV1.cxx:2423
 AliTOFClusterFinderV1.cxx:2424
 AliTOFClusterFinderV1.cxx:2425
 AliTOFClusterFinderV1.cxx:2426
 AliTOFClusterFinderV1.cxx:2427
 AliTOFClusterFinderV1.cxx:2428
 AliTOFClusterFinderV1.cxx:2429
 AliTOFClusterFinderV1.cxx:2430
 AliTOFClusterFinderV1.cxx:2431
 AliTOFClusterFinderV1.cxx:2432
 AliTOFClusterFinderV1.cxx:2433
 AliTOFClusterFinderV1.cxx:2434
 AliTOFClusterFinderV1.cxx:2435
 AliTOFClusterFinderV1.cxx:2436
 AliTOFClusterFinderV1.cxx:2437
 AliTOFClusterFinderV1.cxx:2438
 AliTOFClusterFinderV1.cxx:2439
 AliTOFClusterFinderV1.cxx:2440
 AliTOFClusterFinderV1.cxx:2441
 AliTOFClusterFinderV1.cxx:2442
 AliTOFClusterFinderV1.cxx:2443
 AliTOFClusterFinderV1.cxx:2444
 AliTOFClusterFinderV1.cxx:2445
 AliTOFClusterFinderV1.cxx:2446
 AliTOFClusterFinderV1.cxx:2447
 AliTOFClusterFinderV1.cxx:2448
 AliTOFClusterFinderV1.cxx:2449
 AliTOFClusterFinderV1.cxx:2450
 AliTOFClusterFinderV1.cxx:2451
 AliTOFClusterFinderV1.cxx:2452
 AliTOFClusterFinderV1.cxx:2453
 AliTOFClusterFinderV1.cxx:2454
 AliTOFClusterFinderV1.cxx:2455
 AliTOFClusterFinderV1.cxx:2456
 AliTOFClusterFinderV1.cxx:2457
 AliTOFClusterFinderV1.cxx:2458
 AliTOFClusterFinderV1.cxx:2459
 AliTOFClusterFinderV1.cxx:2460
 AliTOFClusterFinderV1.cxx:2461
 AliTOFClusterFinderV1.cxx:2462
 AliTOFClusterFinderV1.cxx:2463
 AliTOFClusterFinderV1.cxx:2464
 AliTOFClusterFinderV1.cxx:2465
 AliTOFClusterFinderV1.cxx:2466
 AliTOFClusterFinderV1.cxx:2467
 AliTOFClusterFinderV1.cxx:2468
 AliTOFClusterFinderV1.cxx:2469
 AliTOFClusterFinderV1.cxx:2470
 AliTOFClusterFinderV1.cxx:2471
 AliTOFClusterFinderV1.cxx:2472
 AliTOFClusterFinderV1.cxx:2473
 AliTOFClusterFinderV1.cxx:2474
 AliTOFClusterFinderV1.cxx:2475
 AliTOFClusterFinderV1.cxx:2476
 AliTOFClusterFinderV1.cxx:2477
 AliTOFClusterFinderV1.cxx:2478
 AliTOFClusterFinderV1.cxx:2479
 AliTOFClusterFinderV1.cxx:2480
 AliTOFClusterFinderV1.cxx:2481
 AliTOFClusterFinderV1.cxx:2482
 AliTOFClusterFinderV1.cxx:2483
 AliTOFClusterFinderV1.cxx:2484
 AliTOFClusterFinderV1.cxx:2485
 AliTOFClusterFinderV1.cxx:2486
 AliTOFClusterFinderV1.cxx:2487
 AliTOFClusterFinderV1.cxx:2488
 AliTOFClusterFinderV1.cxx:2489
 AliTOFClusterFinderV1.cxx:2490
 AliTOFClusterFinderV1.cxx:2491
 AliTOFClusterFinderV1.cxx:2492
 AliTOFClusterFinderV1.cxx:2493
 AliTOFClusterFinderV1.cxx:2494
 AliTOFClusterFinderV1.cxx:2495
 AliTOFClusterFinderV1.cxx:2496
 AliTOFClusterFinderV1.cxx:2497
 AliTOFClusterFinderV1.cxx:2498
 AliTOFClusterFinderV1.cxx:2499
 AliTOFClusterFinderV1.cxx:2500
 AliTOFClusterFinderV1.cxx:2501
 AliTOFClusterFinderV1.cxx:2502
 AliTOFClusterFinderV1.cxx:2503
 AliTOFClusterFinderV1.cxx:2504
 AliTOFClusterFinderV1.cxx:2505
 AliTOFClusterFinderV1.cxx:2506
 AliTOFClusterFinderV1.cxx:2507
 AliTOFClusterFinderV1.cxx:2508
 AliTOFClusterFinderV1.cxx:2509
 AliTOFClusterFinderV1.cxx:2510
 AliTOFClusterFinderV1.cxx:2511
 AliTOFClusterFinderV1.cxx:2512
 AliTOFClusterFinderV1.cxx:2513
 AliTOFClusterFinderV1.cxx:2514
 AliTOFClusterFinderV1.cxx:2515
 AliTOFClusterFinderV1.cxx:2516
 AliTOFClusterFinderV1.cxx:2517
 AliTOFClusterFinderV1.cxx:2518
 AliTOFClusterFinderV1.cxx:2519
 AliTOFClusterFinderV1.cxx:2520
 AliTOFClusterFinderV1.cxx:2521
 AliTOFClusterFinderV1.cxx:2522
 AliTOFClusterFinderV1.cxx:2523
 AliTOFClusterFinderV1.cxx:2524
 AliTOFClusterFinderV1.cxx:2525
 AliTOFClusterFinderV1.cxx:2526
 AliTOFClusterFinderV1.cxx:2527
 AliTOFClusterFinderV1.cxx:2528
 AliTOFClusterFinderV1.cxx:2529
 AliTOFClusterFinderV1.cxx:2530
 AliTOFClusterFinderV1.cxx:2531
 AliTOFClusterFinderV1.cxx:2532
 AliTOFClusterFinderV1.cxx:2533
 AliTOFClusterFinderV1.cxx:2534
 AliTOFClusterFinderV1.cxx:2535
 AliTOFClusterFinderV1.cxx:2536
 AliTOFClusterFinderV1.cxx:2537
 AliTOFClusterFinderV1.cxx:2538
 AliTOFClusterFinderV1.cxx:2539
 AliTOFClusterFinderV1.cxx:2540
 AliTOFClusterFinderV1.cxx:2541
 AliTOFClusterFinderV1.cxx:2542
 AliTOFClusterFinderV1.cxx:2543
 AliTOFClusterFinderV1.cxx:2544
 AliTOFClusterFinderV1.cxx:2545
 AliTOFClusterFinderV1.cxx:2546
 AliTOFClusterFinderV1.cxx:2547
 AliTOFClusterFinderV1.cxx:2548
 AliTOFClusterFinderV1.cxx:2549
 AliTOFClusterFinderV1.cxx:2550
 AliTOFClusterFinderV1.cxx:2551
 AliTOFClusterFinderV1.cxx:2552
 AliTOFClusterFinderV1.cxx:2553
 AliTOFClusterFinderV1.cxx:2554
 AliTOFClusterFinderV1.cxx:2555
 AliTOFClusterFinderV1.cxx:2556
 AliTOFClusterFinderV1.cxx:2557
 AliTOFClusterFinderV1.cxx:2558
 AliTOFClusterFinderV1.cxx:2559
 AliTOFClusterFinderV1.cxx:2560
 AliTOFClusterFinderV1.cxx:2561
 AliTOFClusterFinderV1.cxx:2562
 AliTOFClusterFinderV1.cxx:2563
 AliTOFClusterFinderV1.cxx:2564
 AliTOFClusterFinderV1.cxx:2565
 AliTOFClusterFinderV1.cxx:2566
 AliTOFClusterFinderV1.cxx:2567
 AliTOFClusterFinderV1.cxx:2568
 AliTOFClusterFinderV1.cxx:2569
 AliTOFClusterFinderV1.cxx:2570
 AliTOFClusterFinderV1.cxx:2571
 AliTOFClusterFinderV1.cxx:2572
 AliTOFClusterFinderV1.cxx:2573
 AliTOFClusterFinderV1.cxx:2574
 AliTOFClusterFinderV1.cxx:2575
 AliTOFClusterFinderV1.cxx:2576
 AliTOFClusterFinderV1.cxx:2577
 AliTOFClusterFinderV1.cxx:2578
 AliTOFClusterFinderV1.cxx:2579
 AliTOFClusterFinderV1.cxx:2580
 AliTOFClusterFinderV1.cxx:2581
 AliTOFClusterFinderV1.cxx:2582
 AliTOFClusterFinderV1.cxx:2583
 AliTOFClusterFinderV1.cxx:2584
 AliTOFClusterFinderV1.cxx:2585
 AliTOFClusterFinderV1.cxx:2586
 AliTOFClusterFinderV1.cxx:2587
 AliTOFClusterFinderV1.cxx:2588
 AliTOFClusterFinderV1.cxx:2589
 AliTOFClusterFinderV1.cxx:2590
 AliTOFClusterFinderV1.cxx:2591
 AliTOFClusterFinderV1.cxx:2592
 AliTOFClusterFinderV1.cxx:2593
 AliTOFClusterFinderV1.cxx:2594
 AliTOFClusterFinderV1.cxx:2595
 AliTOFClusterFinderV1.cxx:2596
 AliTOFClusterFinderV1.cxx:2597
 AliTOFClusterFinderV1.cxx:2598
 AliTOFClusterFinderV1.cxx:2599
 AliTOFClusterFinderV1.cxx:2600
 AliTOFClusterFinderV1.cxx:2601
 AliTOFClusterFinderV1.cxx:2602
 AliTOFClusterFinderV1.cxx:2603
 AliTOFClusterFinderV1.cxx:2604
 AliTOFClusterFinderV1.cxx:2605
 AliTOFClusterFinderV1.cxx:2606
 AliTOFClusterFinderV1.cxx:2607
 AliTOFClusterFinderV1.cxx:2608
 AliTOFClusterFinderV1.cxx:2609
 AliTOFClusterFinderV1.cxx:2610
 AliTOFClusterFinderV1.cxx:2611
 AliTOFClusterFinderV1.cxx:2612
 AliTOFClusterFinderV1.cxx:2613
 AliTOFClusterFinderV1.cxx:2614
 AliTOFClusterFinderV1.cxx:2615
 AliTOFClusterFinderV1.cxx:2616
 AliTOFClusterFinderV1.cxx:2617
 AliTOFClusterFinderV1.cxx:2618
 AliTOFClusterFinderV1.cxx:2619
 AliTOFClusterFinderV1.cxx:2620
 AliTOFClusterFinderV1.cxx:2621
 AliTOFClusterFinderV1.cxx:2622
 AliTOFClusterFinderV1.cxx:2623
 AliTOFClusterFinderV1.cxx:2624
 AliTOFClusterFinderV1.cxx:2625
 AliTOFClusterFinderV1.cxx:2626
 AliTOFClusterFinderV1.cxx:2627
 AliTOFClusterFinderV1.cxx:2628
 AliTOFClusterFinderV1.cxx:2629
 AliTOFClusterFinderV1.cxx:2630
 AliTOFClusterFinderV1.cxx:2631
 AliTOFClusterFinderV1.cxx:2632
 AliTOFClusterFinderV1.cxx:2633
 AliTOFClusterFinderV1.cxx:2634
 AliTOFClusterFinderV1.cxx:2635
 AliTOFClusterFinderV1.cxx:2636
 AliTOFClusterFinderV1.cxx:2637
 AliTOFClusterFinderV1.cxx:2638
 AliTOFClusterFinderV1.cxx:2639
 AliTOFClusterFinderV1.cxx:2640
 AliTOFClusterFinderV1.cxx:2641
 AliTOFClusterFinderV1.cxx:2642
 AliTOFClusterFinderV1.cxx:2643
 AliTOFClusterFinderV1.cxx:2644
 AliTOFClusterFinderV1.cxx:2645
 AliTOFClusterFinderV1.cxx:2646
 AliTOFClusterFinderV1.cxx:2647
 AliTOFClusterFinderV1.cxx:2648
 AliTOFClusterFinderV1.cxx:2649
 AliTOFClusterFinderV1.cxx:2650
 AliTOFClusterFinderV1.cxx:2651
 AliTOFClusterFinderV1.cxx:2652
 AliTOFClusterFinderV1.cxx:2653
 AliTOFClusterFinderV1.cxx:2654
 AliTOFClusterFinderV1.cxx:2655
 AliTOFClusterFinderV1.cxx:2656
 AliTOFClusterFinderV1.cxx:2657
 AliTOFClusterFinderV1.cxx:2658
 AliTOFClusterFinderV1.cxx:2659
 AliTOFClusterFinderV1.cxx:2660
 AliTOFClusterFinderV1.cxx:2661
 AliTOFClusterFinderV1.cxx:2662
 AliTOFClusterFinderV1.cxx:2663
 AliTOFClusterFinderV1.cxx:2664
 AliTOFClusterFinderV1.cxx:2665
 AliTOFClusterFinderV1.cxx:2666
 AliTOFClusterFinderV1.cxx:2667
 AliTOFClusterFinderV1.cxx:2668
 AliTOFClusterFinderV1.cxx:2669
 AliTOFClusterFinderV1.cxx:2670
 AliTOFClusterFinderV1.cxx:2671
 AliTOFClusterFinderV1.cxx:2672
 AliTOFClusterFinderV1.cxx:2673
 AliTOFClusterFinderV1.cxx:2674
 AliTOFClusterFinderV1.cxx:2675
 AliTOFClusterFinderV1.cxx:2676
 AliTOFClusterFinderV1.cxx:2677
 AliTOFClusterFinderV1.cxx:2678
 AliTOFClusterFinderV1.cxx:2679
 AliTOFClusterFinderV1.cxx:2680
 AliTOFClusterFinderV1.cxx:2681
 AliTOFClusterFinderV1.cxx:2682
 AliTOFClusterFinderV1.cxx:2683
 AliTOFClusterFinderV1.cxx:2684
 AliTOFClusterFinderV1.cxx:2685
 AliTOFClusterFinderV1.cxx:2686
 AliTOFClusterFinderV1.cxx:2687
 AliTOFClusterFinderV1.cxx:2688
 AliTOFClusterFinderV1.cxx:2689
 AliTOFClusterFinderV1.cxx:2690
 AliTOFClusterFinderV1.cxx:2691
 AliTOFClusterFinderV1.cxx:2692
 AliTOFClusterFinderV1.cxx:2693
 AliTOFClusterFinderV1.cxx:2694
 AliTOFClusterFinderV1.cxx:2695
 AliTOFClusterFinderV1.cxx:2696
 AliTOFClusterFinderV1.cxx:2697
 AliTOFClusterFinderV1.cxx:2698
 AliTOFClusterFinderV1.cxx:2699
 AliTOFClusterFinderV1.cxx:2700
 AliTOFClusterFinderV1.cxx:2701
 AliTOFClusterFinderV1.cxx:2702
 AliTOFClusterFinderV1.cxx:2703
 AliTOFClusterFinderV1.cxx:2704
 AliTOFClusterFinderV1.cxx:2705
 AliTOFClusterFinderV1.cxx:2706
 AliTOFClusterFinderV1.cxx:2707
 AliTOFClusterFinderV1.cxx:2708
 AliTOFClusterFinderV1.cxx:2709
 AliTOFClusterFinderV1.cxx:2710
 AliTOFClusterFinderV1.cxx:2711
 AliTOFClusterFinderV1.cxx:2712
 AliTOFClusterFinderV1.cxx:2713
 AliTOFClusterFinderV1.cxx:2714
 AliTOFClusterFinderV1.cxx:2715
 AliTOFClusterFinderV1.cxx:2716
 AliTOFClusterFinderV1.cxx:2717
 AliTOFClusterFinderV1.cxx:2718
 AliTOFClusterFinderV1.cxx:2719
 AliTOFClusterFinderV1.cxx:2720
 AliTOFClusterFinderV1.cxx:2721
 AliTOFClusterFinderV1.cxx:2722
 AliTOFClusterFinderV1.cxx:2723
 AliTOFClusterFinderV1.cxx:2724
 AliTOFClusterFinderV1.cxx:2725
 AliTOFClusterFinderV1.cxx:2726
 AliTOFClusterFinderV1.cxx:2727
 AliTOFClusterFinderV1.cxx:2728
 AliTOFClusterFinderV1.cxx:2729
 AliTOFClusterFinderV1.cxx:2730
 AliTOFClusterFinderV1.cxx:2731
 AliTOFClusterFinderV1.cxx:2732
 AliTOFClusterFinderV1.cxx:2733
 AliTOFClusterFinderV1.cxx:2734
 AliTOFClusterFinderV1.cxx:2735
 AliTOFClusterFinderV1.cxx:2736
 AliTOFClusterFinderV1.cxx:2737
 AliTOFClusterFinderV1.cxx:2738
 AliTOFClusterFinderV1.cxx:2739
 AliTOFClusterFinderV1.cxx:2740
 AliTOFClusterFinderV1.cxx:2741
 AliTOFClusterFinderV1.cxx:2742
 AliTOFClusterFinderV1.cxx:2743
 AliTOFClusterFinderV1.cxx:2744
 AliTOFClusterFinderV1.cxx:2745
 AliTOFClusterFinderV1.cxx:2746
 AliTOFClusterFinderV1.cxx:2747
 AliTOFClusterFinderV1.cxx:2748
 AliTOFClusterFinderV1.cxx:2749
 AliTOFClusterFinderV1.cxx:2750
 AliTOFClusterFinderV1.cxx:2751
 AliTOFClusterFinderV1.cxx:2752
 AliTOFClusterFinderV1.cxx:2753
 AliTOFClusterFinderV1.cxx:2754
 AliTOFClusterFinderV1.cxx:2755
 AliTOFClusterFinderV1.cxx:2756
 AliTOFClusterFinderV1.cxx:2757
 AliTOFClusterFinderV1.cxx:2758
 AliTOFClusterFinderV1.cxx:2759
 AliTOFClusterFinderV1.cxx:2760
 AliTOFClusterFinderV1.cxx:2761
 AliTOFClusterFinderV1.cxx:2762
 AliTOFClusterFinderV1.cxx:2763
 AliTOFClusterFinderV1.cxx:2764
 AliTOFClusterFinderV1.cxx:2765
 AliTOFClusterFinderV1.cxx:2766
 AliTOFClusterFinderV1.cxx:2767
 AliTOFClusterFinderV1.cxx:2768
 AliTOFClusterFinderV1.cxx:2769
 AliTOFClusterFinderV1.cxx:2770
 AliTOFClusterFinderV1.cxx:2771
 AliTOFClusterFinderV1.cxx:2772
 AliTOFClusterFinderV1.cxx:2773
 AliTOFClusterFinderV1.cxx:2774
 AliTOFClusterFinderV1.cxx:2775
 AliTOFClusterFinderV1.cxx:2776
 AliTOFClusterFinderV1.cxx:2777
 AliTOFClusterFinderV1.cxx:2778
 AliTOFClusterFinderV1.cxx:2779
 AliTOFClusterFinderV1.cxx:2780
 AliTOFClusterFinderV1.cxx:2781
 AliTOFClusterFinderV1.cxx:2782
 AliTOFClusterFinderV1.cxx:2783
 AliTOFClusterFinderV1.cxx:2784
 AliTOFClusterFinderV1.cxx:2785
 AliTOFClusterFinderV1.cxx:2786
 AliTOFClusterFinderV1.cxx:2787
 AliTOFClusterFinderV1.cxx:2788
 AliTOFClusterFinderV1.cxx:2789
 AliTOFClusterFinderV1.cxx:2790
 AliTOFClusterFinderV1.cxx:2791
 AliTOFClusterFinderV1.cxx:2792
 AliTOFClusterFinderV1.cxx:2793
 AliTOFClusterFinderV1.cxx:2794
 AliTOFClusterFinderV1.cxx:2795
 AliTOFClusterFinderV1.cxx:2796
 AliTOFClusterFinderV1.cxx:2797
 AliTOFClusterFinderV1.cxx:2798
 AliTOFClusterFinderV1.cxx:2799
 AliTOFClusterFinderV1.cxx:2800
 AliTOFClusterFinderV1.cxx:2801
 AliTOFClusterFinderV1.cxx:2802
 AliTOFClusterFinderV1.cxx:2803
 AliTOFClusterFinderV1.cxx:2804
 AliTOFClusterFinderV1.cxx:2805
 AliTOFClusterFinderV1.cxx:2806
 AliTOFClusterFinderV1.cxx:2807
 AliTOFClusterFinderV1.cxx:2808
 AliTOFClusterFinderV1.cxx:2809
 AliTOFClusterFinderV1.cxx:2810
 AliTOFClusterFinderV1.cxx:2811
 AliTOFClusterFinderV1.cxx:2812
 AliTOFClusterFinderV1.cxx:2813
 AliTOFClusterFinderV1.cxx:2814
 AliTOFClusterFinderV1.cxx:2815
 AliTOFClusterFinderV1.cxx:2816
 AliTOFClusterFinderV1.cxx:2817
 AliTOFClusterFinderV1.cxx:2818
 AliTOFClusterFinderV1.cxx:2819
 AliTOFClusterFinderV1.cxx:2820
 AliTOFClusterFinderV1.cxx:2821
 AliTOFClusterFinderV1.cxx:2822
 AliTOFClusterFinderV1.cxx:2823
 AliTOFClusterFinderV1.cxx:2824
 AliTOFClusterFinderV1.cxx:2825
 AliTOFClusterFinderV1.cxx:2826
 AliTOFClusterFinderV1.cxx:2827
 AliTOFClusterFinderV1.cxx:2828
 AliTOFClusterFinderV1.cxx:2829
 AliTOFClusterFinderV1.cxx:2830
 AliTOFClusterFinderV1.cxx:2831
 AliTOFClusterFinderV1.cxx:2832
 AliTOFClusterFinderV1.cxx:2833
 AliTOFClusterFinderV1.cxx:2834
 AliTOFClusterFinderV1.cxx:2835
 AliTOFClusterFinderV1.cxx:2836
 AliTOFClusterFinderV1.cxx:2837
 AliTOFClusterFinderV1.cxx:2838
 AliTOFClusterFinderV1.cxx:2839
 AliTOFClusterFinderV1.cxx:2840
 AliTOFClusterFinderV1.cxx:2841
 AliTOFClusterFinderV1.cxx:2842
 AliTOFClusterFinderV1.cxx:2843
 AliTOFClusterFinderV1.cxx:2844
 AliTOFClusterFinderV1.cxx:2845
 AliTOFClusterFinderV1.cxx:2846
 AliTOFClusterFinderV1.cxx:2847
 AliTOFClusterFinderV1.cxx:2848
 AliTOFClusterFinderV1.cxx:2849
 AliTOFClusterFinderV1.cxx:2850
 AliTOFClusterFinderV1.cxx:2851
 AliTOFClusterFinderV1.cxx:2852
 AliTOFClusterFinderV1.cxx:2853
 AliTOFClusterFinderV1.cxx:2854
 AliTOFClusterFinderV1.cxx:2855
 AliTOFClusterFinderV1.cxx:2856
 AliTOFClusterFinderV1.cxx:2857
 AliTOFClusterFinderV1.cxx:2858
 AliTOFClusterFinderV1.cxx:2859
 AliTOFClusterFinderV1.cxx:2860
 AliTOFClusterFinderV1.cxx:2861
 AliTOFClusterFinderV1.cxx:2862
 AliTOFClusterFinderV1.cxx:2863
 AliTOFClusterFinderV1.cxx:2864
 AliTOFClusterFinderV1.cxx:2865
 AliTOFClusterFinderV1.cxx:2866
 AliTOFClusterFinderV1.cxx:2867
 AliTOFClusterFinderV1.cxx:2868
 AliTOFClusterFinderV1.cxx:2869
 AliTOFClusterFinderV1.cxx:2870
 AliTOFClusterFinderV1.cxx:2871
 AliTOFClusterFinderV1.cxx:2872
 AliTOFClusterFinderV1.cxx:2873
 AliTOFClusterFinderV1.cxx:2874
 AliTOFClusterFinderV1.cxx:2875
 AliTOFClusterFinderV1.cxx:2876
 AliTOFClusterFinderV1.cxx:2877
 AliTOFClusterFinderV1.cxx:2878
 AliTOFClusterFinderV1.cxx:2879
 AliTOFClusterFinderV1.cxx:2880
 AliTOFClusterFinderV1.cxx:2881
 AliTOFClusterFinderV1.cxx:2882
 AliTOFClusterFinderV1.cxx:2883
 AliTOFClusterFinderV1.cxx:2884
 AliTOFClusterFinderV1.cxx:2885
 AliTOFClusterFinderV1.cxx:2886
 AliTOFClusterFinderV1.cxx:2887
 AliTOFClusterFinderV1.cxx:2888
 AliTOFClusterFinderV1.cxx:2889
 AliTOFClusterFinderV1.cxx:2890
 AliTOFClusterFinderV1.cxx:2891
 AliTOFClusterFinderV1.cxx:2892
 AliTOFClusterFinderV1.cxx:2893
 AliTOFClusterFinderV1.cxx:2894
 AliTOFClusterFinderV1.cxx:2895
 AliTOFClusterFinderV1.cxx:2896
 AliTOFClusterFinderV1.cxx:2897
 AliTOFClusterFinderV1.cxx:2898
 AliTOFClusterFinderV1.cxx:2899
 AliTOFClusterFinderV1.cxx:2900
 AliTOFClusterFinderV1.cxx:2901
 AliTOFClusterFinderV1.cxx:2902
 AliTOFClusterFinderV1.cxx:2903
 AliTOFClusterFinderV1.cxx:2904
 AliTOFClusterFinderV1.cxx:2905
 AliTOFClusterFinderV1.cxx:2906
 AliTOFClusterFinderV1.cxx:2907
 AliTOFClusterFinderV1.cxx:2908
 AliTOFClusterFinderV1.cxx:2909
 AliTOFClusterFinderV1.cxx:2910
 AliTOFClusterFinderV1.cxx:2911
 AliTOFClusterFinderV1.cxx:2912
 AliTOFClusterFinderV1.cxx:2913
 AliTOFClusterFinderV1.cxx:2914
 AliTOFClusterFinderV1.cxx:2915
 AliTOFClusterFinderV1.cxx:2916
 AliTOFClusterFinderV1.cxx:2917
 AliTOFClusterFinderV1.cxx:2918
 AliTOFClusterFinderV1.cxx:2919
 AliTOFClusterFinderV1.cxx:2920
 AliTOFClusterFinderV1.cxx:2921
 AliTOFClusterFinderV1.cxx:2922
 AliTOFClusterFinderV1.cxx:2923
 AliTOFClusterFinderV1.cxx:2924
 AliTOFClusterFinderV1.cxx:2925
 AliTOFClusterFinderV1.cxx:2926
 AliTOFClusterFinderV1.cxx:2927
 AliTOFClusterFinderV1.cxx:2928
 AliTOFClusterFinderV1.cxx:2929
 AliTOFClusterFinderV1.cxx:2930
 AliTOFClusterFinderV1.cxx:2931
 AliTOFClusterFinderV1.cxx:2932
 AliTOFClusterFinderV1.cxx:2933
 AliTOFClusterFinderV1.cxx:2934
 AliTOFClusterFinderV1.cxx:2935
 AliTOFClusterFinderV1.cxx:2936
 AliTOFClusterFinderV1.cxx:2937
 AliTOFClusterFinderV1.cxx:2938
 AliTOFClusterFinderV1.cxx:2939
 AliTOFClusterFinderV1.cxx:2940
 AliTOFClusterFinderV1.cxx:2941
 AliTOFClusterFinderV1.cxx:2942
 AliTOFClusterFinderV1.cxx:2943
 AliTOFClusterFinderV1.cxx:2944
 AliTOFClusterFinderV1.cxx:2945
 AliTOFClusterFinderV1.cxx:2946
 AliTOFClusterFinderV1.cxx:2947
 AliTOFClusterFinderV1.cxx:2948
 AliTOFClusterFinderV1.cxx:2949
 AliTOFClusterFinderV1.cxx:2950
 AliTOFClusterFinderV1.cxx:2951
 AliTOFClusterFinderV1.cxx:2952
 AliTOFClusterFinderV1.cxx:2953
 AliTOFClusterFinderV1.cxx:2954
 AliTOFClusterFinderV1.cxx:2955
 AliTOFClusterFinderV1.cxx:2956
 AliTOFClusterFinderV1.cxx:2957
 AliTOFClusterFinderV1.cxx:2958
 AliTOFClusterFinderV1.cxx:2959
 AliTOFClusterFinderV1.cxx:2960
 AliTOFClusterFinderV1.cxx:2961
 AliTOFClusterFinderV1.cxx:2962
 AliTOFClusterFinderV1.cxx:2963
 AliTOFClusterFinderV1.cxx:2964
 AliTOFClusterFinderV1.cxx:2965
 AliTOFClusterFinderV1.cxx:2966
 AliTOFClusterFinderV1.cxx:2967
 AliTOFClusterFinderV1.cxx:2968
 AliTOFClusterFinderV1.cxx:2969
 AliTOFClusterFinderV1.cxx:2970
 AliTOFClusterFinderV1.cxx:2971
 AliTOFClusterFinderV1.cxx:2972
 AliTOFClusterFinderV1.cxx:2973
 AliTOFClusterFinderV1.cxx:2974
 AliTOFClusterFinderV1.cxx:2975
 AliTOFClusterFinderV1.cxx:2976
 AliTOFClusterFinderV1.cxx:2977
 AliTOFClusterFinderV1.cxx:2978
 AliTOFClusterFinderV1.cxx:2979
 AliTOFClusterFinderV1.cxx:2980
 AliTOFClusterFinderV1.cxx:2981
 AliTOFClusterFinderV1.cxx:2982
 AliTOFClusterFinderV1.cxx:2983
 AliTOFClusterFinderV1.cxx:2984
 AliTOFClusterFinderV1.cxx:2985
 AliTOFClusterFinderV1.cxx:2986
 AliTOFClusterFinderV1.cxx:2987
 AliTOFClusterFinderV1.cxx:2988
 AliTOFClusterFinderV1.cxx:2989
 AliTOFClusterFinderV1.cxx:2990
 AliTOFClusterFinderV1.cxx:2991
 AliTOFClusterFinderV1.cxx:2992
 AliTOFClusterFinderV1.cxx:2993
 AliTOFClusterFinderV1.cxx:2994
 AliTOFClusterFinderV1.cxx:2995
 AliTOFClusterFinderV1.cxx:2996
 AliTOFClusterFinderV1.cxx:2997
 AliTOFClusterFinderV1.cxx:2998
 AliTOFClusterFinderV1.cxx:2999
 AliTOFClusterFinderV1.cxx:3000
 AliTOFClusterFinderV1.cxx:3001
 AliTOFClusterFinderV1.cxx:3002
 AliTOFClusterFinderV1.cxx:3003
 AliTOFClusterFinderV1.cxx:3004
 AliTOFClusterFinderV1.cxx:3005
 AliTOFClusterFinderV1.cxx:3006
 AliTOFClusterFinderV1.cxx:3007
 AliTOFClusterFinderV1.cxx:3008
 AliTOFClusterFinderV1.cxx:3009
 AliTOFClusterFinderV1.cxx:3010
 AliTOFClusterFinderV1.cxx:3011
 AliTOFClusterFinderV1.cxx:3012
 AliTOFClusterFinderV1.cxx:3013
 AliTOFClusterFinderV1.cxx:3014
 AliTOFClusterFinderV1.cxx:3015
 AliTOFClusterFinderV1.cxx:3016
 AliTOFClusterFinderV1.cxx:3017
 AliTOFClusterFinderV1.cxx:3018
 AliTOFClusterFinderV1.cxx:3019
 AliTOFClusterFinderV1.cxx:3020
 AliTOFClusterFinderV1.cxx:3021
 AliTOFClusterFinderV1.cxx:3022
 AliTOFClusterFinderV1.cxx:3023
 AliTOFClusterFinderV1.cxx:3024
 AliTOFClusterFinderV1.cxx:3025
 AliTOFClusterFinderV1.cxx:3026
 AliTOFClusterFinderV1.cxx:3027
 AliTOFClusterFinderV1.cxx:3028
 AliTOFClusterFinderV1.cxx:3029
 AliTOFClusterFinderV1.cxx:3030
 AliTOFClusterFinderV1.cxx:3031
 AliTOFClusterFinderV1.cxx:3032
 AliTOFClusterFinderV1.cxx:3033
 AliTOFClusterFinderV1.cxx:3034
 AliTOFClusterFinderV1.cxx:3035
 AliTOFClusterFinderV1.cxx:3036
 AliTOFClusterFinderV1.cxx:3037
 AliTOFClusterFinderV1.cxx:3038
 AliTOFClusterFinderV1.cxx:3039
 AliTOFClusterFinderV1.cxx:3040
 AliTOFClusterFinderV1.cxx:3041
 AliTOFClusterFinderV1.cxx:3042
 AliTOFClusterFinderV1.cxx:3043
 AliTOFClusterFinderV1.cxx:3044
 AliTOFClusterFinderV1.cxx:3045
 AliTOFClusterFinderV1.cxx:3046
 AliTOFClusterFinderV1.cxx:3047
 AliTOFClusterFinderV1.cxx:3048
 AliTOFClusterFinderV1.cxx:3049
 AliTOFClusterFinderV1.cxx:3050
 AliTOFClusterFinderV1.cxx:3051
 AliTOFClusterFinderV1.cxx:3052
 AliTOFClusterFinderV1.cxx:3053
 AliTOFClusterFinderV1.cxx:3054
 AliTOFClusterFinderV1.cxx:3055
 AliTOFClusterFinderV1.cxx:3056
 AliTOFClusterFinderV1.cxx:3057
 AliTOFClusterFinderV1.cxx:3058
 AliTOFClusterFinderV1.cxx:3059
 AliTOFClusterFinderV1.cxx:3060
 AliTOFClusterFinderV1.cxx:3061
 AliTOFClusterFinderV1.cxx:3062
 AliTOFClusterFinderV1.cxx:3063
 AliTOFClusterFinderV1.cxx:3064
 AliTOFClusterFinderV1.cxx:3065
 AliTOFClusterFinderV1.cxx:3066
 AliTOFClusterFinderV1.cxx:3067
 AliTOFClusterFinderV1.cxx:3068
 AliTOFClusterFinderV1.cxx:3069
 AliTOFClusterFinderV1.cxx:3070
 AliTOFClusterFinderV1.cxx:3071
 AliTOFClusterFinderV1.cxx:3072
 AliTOFClusterFinderV1.cxx:3073
 AliTOFClusterFinderV1.cxx:3074
 AliTOFClusterFinderV1.cxx:3075
 AliTOFClusterFinderV1.cxx:3076
 AliTOFClusterFinderV1.cxx:3077
 AliTOFClusterFinderV1.cxx:3078
 AliTOFClusterFinderV1.cxx:3079
 AliTOFClusterFinderV1.cxx:3080
 AliTOFClusterFinderV1.cxx:3081
 AliTOFClusterFinderV1.cxx:3082
 AliTOFClusterFinderV1.cxx:3083
 AliTOFClusterFinderV1.cxx:3084
 AliTOFClusterFinderV1.cxx:3085
 AliTOFClusterFinderV1.cxx:3086
 AliTOFClusterFinderV1.cxx:3087
 AliTOFClusterFinderV1.cxx:3088
 AliTOFClusterFinderV1.cxx:3089
 AliTOFClusterFinderV1.cxx:3090
 AliTOFClusterFinderV1.cxx:3091
 AliTOFClusterFinderV1.cxx:3092
 AliTOFClusterFinderV1.cxx:3093
 AliTOFClusterFinderV1.cxx:3094
 AliTOFClusterFinderV1.cxx:3095
 AliTOFClusterFinderV1.cxx:3096
 AliTOFClusterFinderV1.cxx:3097
 AliTOFClusterFinderV1.cxx:3098
 AliTOFClusterFinderV1.cxx:3099
 AliTOFClusterFinderV1.cxx:3100
 AliTOFClusterFinderV1.cxx:3101
 AliTOFClusterFinderV1.cxx:3102
 AliTOFClusterFinderV1.cxx:3103
 AliTOFClusterFinderV1.cxx:3104
 AliTOFClusterFinderV1.cxx:3105
 AliTOFClusterFinderV1.cxx:3106
 AliTOFClusterFinderV1.cxx:3107
 AliTOFClusterFinderV1.cxx:3108
 AliTOFClusterFinderV1.cxx:3109
 AliTOFClusterFinderV1.cxx:3110
 AliTOFClusterFinderV1.cxx:3111
 AliTOFClusterFinderV1.cxx:3112
 AliTOFClusterFinderV1.cxx:3113
 AliTOFClusterFinderV1.cxx:3114
 AliTOFClusterFinderV1.cxx:3115
 AliTOFClusterFinderV1.cxx:3116
 AliTOFClusterFinderV1.cxx:3117
 AliTOFClusterFinderV1.cxx:3118
 AliTOFClusterFinderV1.cxx:3119
 AliTOFClusterFinderV1.cxx:3120
 AliTOFClusterFinderV1.cxx:3121
 AliTOFClusterFinderV1.cxx:3122
 AliTOFClusterFinderV1.cxx:3123
 AliTOFClusterFinderV1.cxx:3124
 AliTOFClusterFinderV1.cxx:3125
 AliTOFClusterFinderV1.cxx:3126
 AliTOFClusterFinderV1.cxx:3127
 AliTOFClusterFinderV1.cxx:3128
 AliTOFClusterFinderV1.cxx:3129
 AliTOFClusterFinderV1.cxx:3130
 AliTOFClusterFinderV1.cxx:3131
 AliTOFClusterFinderV1.cxx:3132
 AliTOFClusterFinderV1.cxx:3133
 AliTOFClusterFinderV1.cxx:3134
 AliTOFClusterFinderV1.cxx:3135
 AliTOFClusterFinderV1.cxx:3136
 AliTOFClusterFinderV1.cxx:3137
 AliTOFClusterFinderV1.cxx:3138
 AliTOFClusterFinderV1.cxx:3139
 AliTOFClusterFinderV1.cxx:3140
 AliTOFClusterFinderV1.cxx:3141
 AliTOFClusterFinderV1.cxx:3142
 AliTOFClusterFinderV1.cxx:3143
 AliTOFClusterFinderV1.cxx:3144
 AliTOFClusterFinderV1.cxx:3145
 AliTOFClusterFinderV1.cxx:3146
 AliTOFClusterFinderV1.cxx:3147
 AliTOFClusterFinderV1.cxx:3148
 AliTOFClusterFinderV1.cxx:3149
 AliTOFClusterFinderV1.cxx:3150
 AliTOFClusterFinderV1.cxx:3151
 AliTOFClusterFinderV1.cxx:3152
 AliTOFClusterFinderV1.cxx:3153
 AliTOFClusterFinderV1.cxx:3154
 AliTOFClusterFinderV1.cxx:3155
 AliTOFClusterFinderV1.cxx:3156
 AliTOFClusterFinderV1.cxx:3157
 AliTOFClusterFinderV1.cxx:3158
 AliTOFClusterFinderV1.cxx:3159
 AliTOFClusterFinderV1.cxx:3160
 AliTOFClusterFinderV1.cxx:3161
 AliTOFClusterFinderV1.cxx:3162
 AliTOFClusterFinderV1.cxx:3163
 AliTOFClusterFinderV1.cxx:3164
 AliTOFClusterFinderV1.cxx:3165
 AliTOFClusterFinderV1.cxx:3166
 AliTOFClusterFinderV1.cxx:3167
 AliTOFClusterFinderV1.cxx:3168
 AliTOFClusterFinderV1.cxx:3169
 AliTOFClusterFinderV1.cxx:3170
 AliTOFClusterFinderV1.cxx:3171
 AliTOFClusterFinderV1.cxx:3172
 AliTOFClusterFinderV1.cxx:3173
 AliTOFClusterFinderV1.cxx:3174
 AliTOFClusterFinderV1.cxx:3175
 AliTOFClusterFinderV1.cxx:3176
 AliTOFClusterFinderV1.cxx:3177
 AliTOFClusterFinderV1.cxx:3178
 AliTOFClusterFinderV1.cxx:3179
 AliTOFClusterFinderV1.cxx:3180
 AliTOFClusterFinderV1.cxx:3181
 AliTOFClusterFinderV1.cxx:3182
 AliTOFClusterFinderV1.cxx:3183
 AliTOFClusterFinderV1.cxx:3184
 AliTOFClusterFinderV1.cxx:3185
 AliTOFClusterFinderV1.cxx:3186
 AliTOFClusterFinderV1.cxx:3187
 AliTOFClusterFinderV1.cxx:3188
 AliTOFClusterFinderV1.cxx:3189
 AliTOFClusterFinderV1.cxx:3190
 AliTOFClusterFinderV1.cxx:3191
 AliTOFClusterFinderV1.cxx:3192
 AliTOFClusterFinderV1.cxx:3193
 AliTOFClusterFinderV1.cxx:3194
 AliTOFClusterFinderV1.cxx:3195
 AliTOFClusterFinderV1.cxx:3196
 AliTOFClusterFinderV1.cxx:3197
 AliTOFClusterFinderV1.cxx:3198
 AliTOFClusterFinderV1.cxx:3199
 AliTOFClusterFinderV1.cxx:3200
 AliTOFClusterFinderV1.cxx:3201
 AliTOFClusterFinderV1.cxx:3202
 AliTOFClusterFinderV1.cxx:3203
 AliTOFClusterFinderV1.cxx:3204
 AliTOFClusterFinderV1.cxx:3205
 AliTOFClusterFinderV1.cxx:3206
 AliTOFClusterFinderV1.cxx:3207
 AliTOFClusterFinderV1.cxx:3208
 AliTOFClusterFinderV1.cxx:3209
 AliTOFClusterFinderV1.cxx:3210
 AliTOFClusterFinderV1.cxx:3211
 AliTOFClusterFinderV1.cxx:3212
 AliTOFClusterFinderV1.cxx:3213
 AliTOFClusterFinderV1.cxx:3214
 AliTOFClusterFinderV1.cxx:3215
 AliTOFClusterFinderV1.cxx:3216
 AliTOFClusterFinderV1.cxx:3217
 AliTOFClusterFinderV1.cxx:3218
 AliTOFClusterFinderV1.cxx:3219
 AliTOFClusterFinderV1.cxx:3220
 AliTOFClusterFinderV1.cxx:3221
 AliTOFClusterFinderV1.cxx:3222
 AliTOFClusterFinderV1.cxx:3223
 AliTOFClusterFinderV1.cxx:3224
 AliTOFClusterFinderV1.cxx:3225
 AliTOFClusterFinderV1.cxx:3226
 AliTOFClusterFinderV1.cxx:3227
 AliTOFClusterFinderV1.cxx:3228
 AliTOFClusterFinderV1.cxx:3229
 AliTOFClusterFinderV1.cxx:3230
 AliTOFClusterFinderV1.cxx:3231
 AliTOFClusterFinderV1.cxx:3232
 AliTOFClusterFinderV1.cxx:3233
 AliTOFClusterFinderV1.cxx:3234
 AliTOFClusterFinderV1.cxx:3235
 AliTOFClusterFinderV1.cxx:3236
 AliTOFClusterFinderV1.cxx:3237
 AliTOFClusterFinderV1.cxx:3238
 AliTOFClusterFinderV1.cxx:3239
 AliTOFClusterFinderV1.cxx:3240
 AliTOFClusterFinderV1.cxx:3241
 AliTOFClusterFinderV1.cxx:3242
 AliTOFClusterFinderV1.cxx:3243
 AliTOFClusterFinderV1.cxx:3244
 AliTOFClusterFinderV1.cxx:3245
 AliTOFClusterFinderV1.cxx:3246
 AliTOFClusterFinderV1.cxx:3247
 AliTOFClusterFinderV1.cxx:3248
 AliTOFClusterFinderV1.cxx:3249
 AliTOFClusterFinderV1.cxx:3250
 AliTOFClusterFinderV1.cxx:3251
 AliTOFClusterFinderV1.cxx:3252
 AliTOFClusterFinderV1.cxx:3253
 AliTOFClusterFinderV1.cxx:3254
 AliTOFClusterFinderV1.cxx:3255
 AliTOFClusterFinderV1.cxx:3256
 AliTOFClusterFinderV1.cxx:3257
 AliTOFClusterFinderV1.cxx:3258
 AliTOFClusterFinderV1.cxx:3259
 AliTOFClusterFinderV1.cxx:3260
 AliTOFClusterFinderV1.cxx:3261
 AliTOFClusterFinderV1.cxx:3262
 AliTOFClusterFinderV1.cxx:3263
 AliTOFClusterFinderV1.cxx:3264
 AliTOFClusterFinderV1.cxx:3265
 AliTOFClusterFinderV1.cxx:3266
 AliTOFClusterFinderV1.cxx:3267
 AliTOFClusterFinderV1.cxx:3268
 AliTOFClusterFinderV1.cxx:3269
 AliTOFClusterFinderV1.cxx:3270
 AliTOFClusterFinderV1.cxx:3271
 AliTOFClusterFinderV1.cxx:3272
 AliTOFClusterFinderV1.cxx:3273
 AliTOFClusterFinderV1.cxx:3274
 AliTOFClusterFinderV1.cxx:3275
 AliTOFClusterFinderV1.cxx:3276
 AliTOFClusterFinderV1.cxx:3277
 AliTOFClusterFinderV1.cxx:3278
 AliTOFClusterFinderV1.cxx:3279
 AliTOFClusterFinderV1.cxx:3280
 AliTOFClusterFinderV1.cxx:3281
 AliTOFClusterFinderV1.cxx:3282
 AliTOFClusterFinderV1.cxx:3283
 AliTOFClusterFinderV1.cxx:3284
 AliTOFClusterFinderV1.cxx:3285
 AliTOFClusterFinderV1.cxx:3286
 AliTOFClusterFinderV1.cxx:3287
 AliTOFClusterFinderV1.cxx:3288
 AliTOFClusterFinderV1.cxx:3289
 AliTOFClusterFinderV1.cxx:3290
 AliTOFClusterFinderV1.cxx:3291
 AliTOFClusterFinderV1.cxx:3292
 AliTOFClusterFinderV1.cxx:3293
 AliTOFClusterFinderV1.cxx:3294
 AliTOFClusterFinderV1.cxx:3295
 AliTOFClusterFinderV1.cxx:3296
 AliTOFClusterFinderV1.cxx:3297
 AliTOFClusterFinderV1.cxx:3298
 AliTOFClusterFinderV1.cxx:3299
 AliTOFClusterFinderV1.cxx:3300
 AliTOFClusterFinderV1.cxx:3301
 AliTOFClusterFinderV1.cxx:3302
 AliTOFClusterFinderV1.cxx:3303
 AliTOFClusterFinderV1.cxx:3304
 AliTOFClusterFinderV1.cxx:3305
 AliTOFClusterFinderV1.cxx:3306
 AliTOFClusterFinderV1.cxx:3307
 AliTOFClusterFinderV1.cxx:3308
 AliTOFClusterFinderV1.cxx:3309
 AliTOFClusterFinderV1.cxx:3310
 AliTOFClusterFinderV1.cxx:3311
 AliTOFClusterFinderV1.cxx:3312
 AliTOFClusterFinderV1.cxx:3313
 AliTOFClusterFinderV1.cxx:3314
 AliTOFClusterFinderV1.cxx:3315
 AliTOFClusterFinderV1.cxx:3316
 AliTOFClusterFinderV1.cxx:3317
 AliTOFClusterFinderV1.cxx:3318
 AliTOFClusterFinderV1.cxx:3319
 AliTOFClusterFinderV1.cxx:3320
 AliTOFClusterFinderV1.cxx:3321
 AliTOFClusterFinderV1.cxx:3322
 AliTOFClusterFinderV1.cxx:3323
 AliTOFClusterFinderV1.cxx:3324
 AliTOFClusterFinderV1.cxx:3325
 AliTOFClusterFinderV1.cxx:3326
 AliTOFClusterFinderV1.cxx:3327
 AliTOFClusterFinderV1.cxx:3328
 AliTOFClusterFinderV1.cxx:3329
 AliTOFClusterFinderV1.cxx:3330
 AliTOFClusterFinderV1.cxx:3331
 AliTOFClusterFinderV1.cxx:3332
 AliTOFClusterFinderV1.cxx:3333
 AliTOFClusterFinderV1.cxx:3334
 AliTOFClusterFinderV1.cxx:3335
 AliTOFClusterFinderV1.cxx:3336
 AliTOFClusterFinderV1.cxx:3337
 AliTOFClusterFinderV1.cxx:3338
 AliTOFClusterFinderV1.cxx:3339
 AliTOFClusterFinderV1.cxx:3340
 AliTOFClusterFinderV1.cxx:3341
 AliTOFClusterFinderV1.cxx:3342
 AliTOFClusterFinderV1.cxx:3343
 AliTOFClusterFinderV1.cxx:3344
 AliTOFClusterFinderV1.cxx:3345
 AliTOFClusterFinderV1.cxx:3346
 AliTOFClusterFinderV1.cxx:3347
 AliTOFClusterFinderV1.cxx:3348
 AliTOFClusterFinderV1.cxx:3349
 AliTOFClusterFinderV1.cxx:3350
 AliTOFClusterFinderV1.cxx:3351
 AliTOFClusterFinderV1.cxx:3352
 AliTOFClusterFinderV1.cxx:3353
 AliTOFClusterFinderV1.cxx:3354
 AliTOFClusterFinderV1.cxx:3355
 AliTOFClusterFinderV1.cxx:3356
 AliTOFClusterFinderV1.cxx:3357
 AliTOFClusterFinderV1.cxx:3358
 AliTOFClusterFinderV1.cxx:3359
 AliTOFClusterFinderV1.cxx:3360
 AliTOFClusterFinderV1.cxx:3361
 AliTOFClusterFinderV1.cxx:3362
 AliTOFClusterFinderV1.cxx:3363
 AliTOFClusterFinderV1.cxx:3364
 AliTOFClusterFinderV1.cxx:3365
 AliTOFClusterFinderV1.cxx:3366
 AliTOFClusterFinderV1.cxx:3367
 AliTOFClusterFinderV1.cxx:3368
 AliTOFClusterFinderV1.cxx:3369
 AliTOFClusterFinderV1.cxx:3370
 AliTOFClusterFinderV1.cxx:3371
 AliTOFClusterFinderV1.cxx:3372
 AliTOFClusterFinderV1.cxx:3373
 AliTOFClusterFinderV1.cxx:3374
 AliTOFClusterFinderV1.cxx:3375
 AliTOFClusterFinderV1.cxx:3376
 AliTOFClusterFinderV1.cxx:3377
 AliTOFClusterFinderV1.cxx:3378
 AliTOFClusterFinderV1.cxx:3379
 AliTOFClusterFinderV1.cxx:3380
 AliTOFClusterFinderV1.cxx:3381
 AliTOFClusterFinderV1.cxx:3382
 AliTOFClusterFinderV1.cxx:3383
 AliTOFClusterFinderV1.cxx:3384
 AliTOFClusterFinderV1.cxx:3385
 AliTOFClusterFinderV1.cxx:3386
 AliTOFClusterFinderV1.cxx:3387
 AliTOFClusterFinderV1.cxx:3388
 AliTOFClusterFinderV1.cxx:3389
 AliTOFClusterFinderV1.cxx:3390
 AliTOFClusterFinderV1.cxx:3391
 AliTOFClusterFinderV1.cxx:3392
 AliTOFClusterFinderV1.cxx:3393
 AliTOFClusterFinderV1.cxx:3394
 AliTOFClusterFinderV1.cxx:3395
 AliTOFClusterFinderV1.cxx:3396
 AliTOFClusterFinderV1.cxx:3397
 AliTOFClusterFinderV1.cxx:3398
 AliTOFClusterFinderV1.cxx:3399
 AliTOFClusterFinderV1.cxx:3400
 AliTOFClusterFinderV1.cxx:3401
 AliTOFClusterFinderV1.cxx:3402
 AliTOFClusterFinderV1.cxx:3403
 AliTOFClusterFinderV1.cxx:3404
 AliTOFClusterFinderV1.cxx:3405
 AliTOFClusterFinderV1.cxx:3406
 AliTOFClusterFinderV1.cxx:3407
 AliTOFClusterFinderV1.cxx:3408
 AliTOFClusterFinderV1.cxx:3409
 AliTOFClusterFinderV1.cxx:3410
 AliTOFClusterFinderV1.cxx:3411
 AliTOFClusterFinderV1.cxx:3412
 AliTOFClusterFinderV1.cxx:3413
 AliTOFClusterFinderV1.cxx:3414
 AliTOFClusterFinderV1.cxx:3415
 AliTOFClusterFinderV1.cxx:3416
 AliTOFClusterFinderV1.cxx:3417
 AliTOFClusterFinderV1.cxx:3418
 AliTOFClusterFinderV1.cxx:3419
 AliTOFClusterFinderV1.cxx:3420
 AliTOFClusterFinderV1.cxx:3421
 AliTOFClusterFinderV1.cxx:3422
 AliTOFClusterFinderV1.cxx:3423
 AliTOFClusterFinderV1.cxx:3424
 AliTOFClusterFinderV1.cxx:3425
 AliTOFClusterFinderV1.cxx:3426
 AliTOFClusterFinderV1.cxx:3427
 AliTOFClusterFinderV1.cxx:3428
 AliTOFClusterFinderV1.cxx:3429
 AliTOFClusterFinderV1.cxx:3430
 AliTOFClusterFinderV1.cxx:3431
 AliTOFClusterFinderV1.cxx:3432
 AliTOFClusterFinderV1.cxx:3433
 AliTOFClusterFinderV1.cxx:3434
 AliTOFClusterFinderV1.cxx:3435
 AliTOFClusterFinderV1.cxx:3436
 AliTOFClusterFinderV1.cxx:3437
 AliTOFClusterFinderV1.cxx:3438
 AliTOFClusterFinderV1.cxx:3439
 AliTOFClusterFinderV1.cxx:3440
 AliTOFClusterFinderV1.cxx:3441
 AliTOFClusterFinderV1.cxx:3442
 AliTOFClusterFinderV1.cxx:3443
 AliTOFClusterFinderV1.cxx:3444
 AliTOFClusterFinderV1.cxx:3445
 AliTOFClusterFinderV1.cxx:3446
 AliTOFClusterFinderV1.cxx:3447
 AliTOFClusterFinderV1.cxx:3448
 AliTOFClusterFinderV1.cxx:3449
 AliTOFClusterFinderV1.cxx:3450
 AliTOFClusterFinderV1.cxx:3451
 AliTOFClusterFinderV1.cxx:3452
 AliTOFClusterFinderV1.cxx:3453
 AliTOFClusterFinderV1.cxx:3454
 AliTOFClusterFinderV1.cxx:3455
 AliTOFClusterFinderV1.cxx:3456
 AliTOFClusterFinderV1.cxx:3457
 AliTOFClusterFinderV1.cxx:3458
 AliTOFClusterFinderV1.cxx:3459
 AliTOFClusterFinderV1.cxx:3460
 AliTOFClusterFinderV1.cxx:3461
 AliTOFClusterFinderV1.cxx:3462
 AliTOFClusterFinderV1.cxx:3463
 AliTOFClusterFinderV1.cxx:3464
 AliTOFClusterFinderV1.cxx:3465
 AliTOFClusterFinderV1.cxx:3466
 AliTOFClusterFinderV1.cxx:3467
 AliTOFClusterFinderV1.cxx:3468
 AliTOFClusterFinderV1.cxx:3469
 AliTOFClusterFinderV1.cxx:3470
 AliTOFClusterFinderV1.cxx:3471
 AliTOFClusterFinderV1.cxx:3472
 AliTOFClusterFinderV1.cxx:3473
 AliTOFClusterFinderV1.cxx:3474
 AliTOFClusterFinderV1.cxx:3475
 AliTOFClusterFinderV1.cxx:3476
 AliTOFClusterFinderV1.cxx:3477
 AliTOFClusterFinderV1.cxx:3478
 AliTOFClusterFinderV1.cxx:3479
 AliTOFClusterFinderV1.cxx:3480
 AliTOFClusterFinderV1.cxx:3481
 AliTOFClusterFinderV1.cxx:3482
 AliTOFClusterFinderV1.cxx:3483
 AliTOFClusterFinderV1.cxx:3484
 AliTOFClusterFinderV1.cxx:3485
 AliTOFClusterFinderV1.cxx:3486
 AliTOFClusterFinderV1.cxx:3487
 AliTOFClusterFinderV1.cxx:3488
 AliTOFClusterFinderV1.cxx:3489
 AliTOFClusterFinderV1.cxx:3490
 AliTOFClusterFinderV1.cxx:3491
 AliTOFClusterFinderV1.cxx:3492
 AliTOFClusterFinderV1.cxx:3493
 AliTOFClusterFinderV1.cxx:3494
 AliTOFClusterFinderV1.cxx:3495
 AliTOFClusterFinderV1.cxx:3496
 AliTOFClusterFinderV1.cxx:3497
 AliTOFClusterFinderV1.cxx:3498
 AliTOFClusterFinderV1.cxx:3499
 AliTOFClusterFinderV1.cxx:3500
 AliTOFClusterFinderV1.cxx:3501
 AliTOFClusterFinderV1.cxx:3502
 AliTOFClusterFinderV1.cxx:3503
 AliTOFClusterFinderV1.cxx:3504
 AliTOFClusterFinderV1.cxx:3505
 AliTOFClusterFinderV1.cxx:3506
 AliTOFClusterFinderV1.cxx:3507
 AliTOFClusterFinderV1.cxx:3508
 AliTOFClusterFinderV1.cxx:3509
 AliTOFClusterFinderV1.cxx:3510
 AliTOFClusterFinderV1.cxx:3511
 AliTOFClusterFinderV1.cxx:3512
 AliTOFClusterFinderV1.cxx:3513
 AliTOFClusterFinderV1.cxx:3514
 AliTOFClusterFinderV1.cxx:3515
 AliTOFClusterFinderV1.cxx:3516
 AliTOFClusterFinderV1.cxx:3517
 AliTOFClusterFinderV1.cxx:3518
 AliTOFClusterFinderV1.cxx:3519
 AliTOFClusterFinderV1.cxx:3520
 AliTOFClusterFinderV1.cxx:3521
 AliTOFClusterFinderV1.cxx:3522
 AliTOFClusterFinderV1.cxx:3523
 AliTOFClusterFinderV1.cxx:3524
 AliTOFClusterFinderV1.cxx:3525
 AliTOFClusterFinderV1.cxx:3526
 AliTOFClusterFinderV1.cxx:3527
 AliTOFClusterFinderV1.cxx:3528
 AliTOFClusterFinderV1.cxx:3529
 AliTOFClusterFinderV1.cxx:3530
 AliTOFClusterFinderV1.cxx:3531
 AliTOFClusterFinderV1.cxx:3532
 AliTOFClusterFinderV1.cxx:3533
 AliTOFClusterFinderV1.cxx:3534
 AliTOFClusterFinderV1.cxx:3535
 AliTOFClusterFinderV1.cxx:3536
 AliTOFClusterFinderV1.cxx:3537
 AliTOFClusterFinderV1.cxx:3538
 AliTOFClusterFinderV1.cxx:3539
 AliTOFClusterFinderV1.cxx:3540
 AliTOFClusterFinderV1.cxx:3541
 AliTOFClusterFinderV1.cxx:3542
 AliTOFClusterFinderV1.cxx:3543
 AliTOFClusterFinderV1.cxx:3544
 AliTOFClusterFinderV1.cxx:3545
 AliTOFClusterFinderV1.cxx:3546
 AliTOFClusterFinderV1.cxx:3547
 AliTOFClusterFinderV1.cxx:3548
 AliTOFClusterFinderV1.cxx:3549
 AliTOFClusterFinderV1.cxx:3550
 AliTOFClusterFinderV1.cxx:3551
 AliTOFClusterFinderV1.cxx:3552
 AliTOFClusterFinderV1.cxx:3553
 AliTOFClusterFinderV1.cxx:3554
 AliTOFClusterFinderV1.cxx:3555
 AliTOFClusterFinderV1.cxx:3556
 AliTOFClusterFinderV1.cxx:3557
 AliTOFClusterFinderV1.cxx:3558
 AliTOFClusterFinderV1.cxx:3559
 AliTOFClusterFinderV1.cxx:3560
 AliTOFClusterFinderV1.cxx:3561
 AliTOFClusterFinderV1.cxx:3562
 AliTOFClusterFinderV1.cxx:3563
 AliTOFClusterFinderV1.cxx:3564
 AliTOFClusterFinderV1.cxx:3565
 AliTOFClusterFinderV1.cxx:3566
 AliTOFClusterFinderV1.cxx:3567
 AliTOFClusterFinderV1.cxx:3568
 AliTOFClusterFinderV1.cxx:3569
 AliTOFClusterFinderV1.cxx:3570
 AliTOFClusterFinderV1.cxx:3571
 AliTOFClusterFinderV1.cxx:3572
 AliTOFClusterFinderV1.cxx:3573
 AliTOFClusterFinderV1.cxx:3574
 AliTOFClusterFinderV1.cxx:3575
 AliTOFClusterFinderV1.cxx:3576
 AliTOFClusterFinderV1.cxx:3577
 AliTOFClusterFinderV1.cxx:3578
 AliTOFClusterFinderV1.cxx:3579
 AliTOFClusterFinderV1.cxx:3580
 AliTOFClusterFinderV1.cxx:3581
 AliTOFClusterFinderV1.cxx:3582
 AliTOFClusterFinderV1.cxx:3583
 AliTOFClusterFinderV1.cxx:3584
 AliTOFClusterFinderV1.cxx:3585
 AliTOFClusterFinderV1.cxx:3586
 AliTOFClusterFinderV1.cxx:3587
 AliTOFClusterFinderV1.cxx:3588
 AliTOFClusterFinderV1.cxx:3589
 AliTOFClusterFinderV1.cxx:3590
 AliTOFClusterFinderV1.cxx:3591
 AliTOFClusterFinderV1.cxx:3592
 AliTOFClusterFinderV1.cxx:3593
 AliTOFClusterFinderV1.cxx:3594
 AliTOFClusterFinderV1.cxx:3595
 AliTOFClusterFinderV1.cxx:3596
 AliTOFClusterFinderV1.cxx:3597
 AliTOFClusterFinderV1.cxx:3598
 AliTOFClusterFinderV1.cxx:3599
 AliTOFClusterFinderV1.cxx:3600
 AliTOFClusterFinderV1.cxx:3601
 AliTOFClusterFinderV1.cxx:3602
 AliTOFClusterFinderV1.cxx:3603
 AliTOFClusterFinderV1.cxx:3604
 AliTOFClusterFinderV1.cxx:3605
 AliTOFClusterFinderV1.cxx:3606
 AliTOFClusterFinderV1.cxx:3607
 AliTOFClusterFinderV1.cxx:3608
 AliTOFClusterFinderV1.cxx:3609
 AliTOFClusterFinderV1.cxx:3610
 AliTOFClusterFinderV1.cxx:3611
 AliTOFClusterFinderV1.cxx:3612
 AliTOFClusterFinderV1.cxx:3613
 AliTOFClusterFinderV1.cxx:3614
 AliTOFClusterFinderV1.cxx:3615
 AliTOFClusterFinderV1.cxx:3616
 AliTOFClusterFinderV1.cxx:3617
 AliTOFClusterFinderV1.cxx:3618
 AliTOFClusterFinderV1.cxx:3619
 AliTOFClusterFinderV1.cxx:3620
 AliTOFClusterFinderV1.cxx:3621
 AliTOFClusterFinderV1.cxx:3622
 AliTOFClusterFinderV1.cxx:3623
 AliTOFClusterFinderV1.cxx:3624
 AliTOFClusterFinderV1.cxx:3625
 AliTOFClusterFinderV1.cxx:3626
 AliTOFClusterFinderV1.cxx:3627
 AliTOFClusterFinderV1.cxx:3628
 AliTOFClusterFinderV1.cxx:3629
 AliTOFClusterFinderV1.cxx:3630
 AliTOFClusterFinderV1.cxx:3631
 AliTOFClusterFinderV1.cxx:3632
 AliTOFClusterFinderV1.cxx:3633
 AliTOFClusterFinderV1.cxx:3634
 AliTOFClusterFinderV1.cxx:3635
 AliTOFClusterFinderV1.cxx:3636
 AliTOFClusterFinderV1.cxx:3637
 AliTOFClusterFinderV1.cxx:3638
 AliTOFClusterFinderV1.cxx:3639
 AliTOFClusterFinderV1.cxx:3640
 AliTOFClusterFinderV1.cxx:3641
 AliTOFClusterFinderV1.cxx:3642
 AliTOFClusterFinderV1.cxx:3643
 AliTOFClusterFinderV1.cxx:3644
 AliTOFClusterFinderV1.cxx:3645
 AliTOFClusterFinderV1.cxx:3646
 AliTOFClusterFinderV1.cxx:3647
 AliTOFClusterFinderV1.cxx:3648
 AliTOFClusterFinderV1.cxx:3649
 AliTOFClusterFinderV1.cxx:3650
 AliTOFClusterFinderV1.cxx:3651
 AliTOFClusterFinderV1.cxx:3652
 AliTOFClusterFinderV1.cxx:3653
 AliTOFClusterFinderV1.cxx:3654
 AliTOFClusterFinderV1.cxx:3655
 AliTOFClusterFinderV1.cxx:3656
 AliTOFClusterFinderV1.cxx:3657
 AliTOFClusterFinderV1.cxx:3658
 AliTOFClusterFinderV1.cxx:3659
 AliTOFClusterFinderV1.cxx:3660
 AliTOFClusterFinderV1.cxx:3661
 AliTOFClusterFinderV1.cxx:3662
 AliTOFClusterFinderV1.cxx:3663
 AliTOFClusterFinderV1.cxx:3664
 AliTOFClusterFinderV1.cxx:3665
 AliTOFClusterFinderV1.cxx:3666
 AliTOFClusterFinderV1.cxx:3667
 AliTOFClusterFinderV1.cxx:3668
 AliTOFClusterFinderV1.cxx:3669
 AliTOFClusterFinderV1.cxx:3670
 AliTOFClusterFinderV1.cxx:3671
 AliTOFClusterFinderV1.cxx:3672
 AliTOFClusterFinderV1.cxx:3673
 AliTOFClusterFinderV1.cxx:3674
 AliTOFClusterFinderV1.cxx:3675
 AliTOFClusterFinderV1.cxx:3676
 AliTOFClusterFinderV1.cxx:3677
 AliTOFClusterFinderV1.cxx:3678
 AliTOFClusterFinderV1.cxx:3679
 AliTOFClusterFinderV1.cxx:3680
 AliTOFClusterFinderV1.cxx:3681
 AliTOFClusterFinderV1.cxx:3682
 AliTOFClusterFinderV1.cxx:3683
 AliTOFClusterFinderV1.cxx:3684
 AliTOFClusterFinderV1.cxx:3685
 AliTOFClusterFinderV1.cxx:3686
 AliTOFClusterFinderV1.cxx:3687
 AliTOFClusterFinderV1.cxx:3688
 AliTOFClusterFinderV1.cxx:3689
 AliTOFClusterFinderV1.cxx:3690
 AliTOFClusterFinderV1.cxx:3691
 AliTOFClusterFinderV1.cxx:3692
 AliTOFClusterFinderV1.cxx:3693
 AliTOFClusterFinderV1.cxx:3694
 AliTOFClusterFinderV1.cxx:3695
 AliTOFClusterFinderV1.cxx:3696
 AliTOFClusterFinderV1.cxx:3697
 AliTOFClusterFinderV1.cxx:3698
 AliTOFClusterFinderV1.cxx:3699
 AliTOFClusterFinderV1.cxx:3700
 AliTOFClusterFinderV1.cxx:3701
 AliTOFClusterFinderV1.cxx:3702
 AliTOFClusterFinderV1.cxx:3703
 AliTOFClusterFinderV1.cxx:3704
 AliTOFClusterFinderV1.cxx:3705
 AliTOFClusterFinderV1.cxx:3706
 AliTOFClusterFinderV1.cxx:3707
 AliTOFClusterFinderV1.cxx:3708
 AliTOFClusterFinderV1.cxx:3709
 AliTOFClusterFinderV1.cxx:3710
 AliTOFClusterFinderV1.cxx:3711
 AliTOFClusterFinderV1.cxx:3712
 AliTOFClusterFinderV1.cxx:3713
 AliTOFClusterFinderV1.cxx:3714
 AliTOFClusterFinderV1.cxx:3715
 AliTOFClusterFinderV1.cxx:3716
 AliTOFClusterFinderV1.cxx:3717
 AliTOFClusterFinderV1.cxx:3718
 AliTOFClusterFinderV1.cxx:3719
 AliTOFClusterFinderV1.cxx:3720
 AliTOFClusterFinderV1.cxx:3721
 AliTOFClusterFinderV1.cxx:3722
 AliTOFClusterFinderV1.cxx:3723
 AliTOFClusterFinderV1.cxx:3724
 AliTOFClusterFinderV1.cxx:3725
 AliTOFClusterFinderV1.cxx:3726
 AliTOFClusterFinderV1.cxx:3727
 AliTOFClusterFinderV1.cxx:3728
 AliTOFClusterFinderV1.cxx:3729
 AliTOFClusterFinderV1.cxx:3730
 AliTOFClusterFinderV1.cxx:3731
 AliTOFClusterFinderV1.cxx:3732
 AliTOFClusterFinderV1.cxx:3733
 AliTOFClusterFinderV1.cxx:3734
 AliTOFClusterFinderV1.cxx:3735
 AliTOFClusterFinderV1.cxx:3736
 AliTOFClusterFinderV1.cxx:3737
 AliTOFClusterFinderV1.cxx:3738
 AliTOFClusterFinderV1.cxx:3739
 AliTOFClusterFinderV1.cxx:3740
 AliTOFClusterFinderV1.cxx:3741
 AliTOFClusterFinderV1.cxx:3742
 AliTOFClusterFinderV1.cxx:3743
 AliTOFClusterFinderV1.cxx:3744
 AliTOFClusterFinderV1.cxx:3745
 AliTOFClusterFinderV1.cxx:3746
 AliTOFClusterFinderV1.cxx:3747
 AliTOFClusterFinderV1.cxx:3748
 AliTOFClusterFinderV1.cxx:3749
 AliTOFClusterFinderV1.cxx:3750
 AliTOFClusterFinderV1.cxx:3751
 AliTOFClusterFinderV1.cxx:3752
 AliTOFClusterFinderV1.cxx:3753
 AliTOFClusterFinderV1.cxx:3754
 AliTOFClusterFinderV1.cxx:3755
 AliTOFClusterFinderV1.cxx:3756
 AliTOFClusterFinderV1.cxx:3757
 AliTOFClusterFinderV1.cxx:3758
 AliTOFClusterFinderV1.cxx:3759
 AliTOFClusterFinderV1.cxx:3760
 AliTOFClusterFinderV1.cxx:3761
 AliTOFClusterFinderV1.cxx:3762
 AliTOFClusterFinderV1.cxx:3763
 AliTOFClusterFinderV1.cxx:3764
 AliTOFClusterFinderV1.cxx:3765
 AliTOFClusterFinderV1.cxx:3766
 AliTOFClusterFinderV1.cxx:3767
 AliTOFClusterFinderV1.cxx:3768
 AliTOFClusterFinderV1.cxx:3769
 AliTOFClusterFinderV1.cxx:3770
 AliTOFClusterFinderV1.cxx:3771
 AliTOFClusterFinderV1.cxx:3772
 AliTOFClusterFinderV1.cxx:3773
 AliTOFClusterFinderV1.cxx:3774
 AliTOFClusterFinderV1.cxx:3775
 AliTOFClusterFinderV1.cxx:3776
 AliTOFClusterFinderV1.cxx:3777
 AliTOFClusterFinderV1.cxx:3778
 AliTOFClusterFinderV1.cxx:3779
 AliTOFClusterFinderV1.cxx:3780
 AliTOFClusterFinderV1.cxx:3781
 AliTOFClusterFinderV1.cxx:3782
 AliTOFClusterFinderV1.cxx:3783
 AliTOFClusterFinderV1.cxx:3784
 AliTOFClusterFinderV1.cxx:3785
 AliTOFClusterFinderV1.cxx:3786
 AliTOFClusterFinderV1.cxx:3787
 AliTOFClusterFinderV1.cxx:3788
 AliTOFClusterFinderV1.cxx:3789
 AliTOFClusterFinderV1.cxx:3790
 AliTOFClusterFinderV1.cxx:3791
 AliTOFClusterFinderV1.cxx:3792
 AliTOFClusterFinderV1.cxx:3793
 AliTOFClusterFinderV1.cxx:3794
 AliTOFClusterFinderV1.cxx:3795
 AliTOFClusterFinderV1.cxx:3796
 AliTOFClusterFinderV1.cxx:3797
 AliTOFClusterFinderV1.cxx:3798
 AliTOFClusterFinderV1.cxx:3799
 AliTOFClusterFinderV1.cxx:3800
 AliTOFClusterFinderV1.cxx:3801
 AliTOFClusterFinderV1.cxx:3802
 AliTOFClusterFinderV1.cxx:3803
 AliTOFClusterFinderV1.cxx:3804
 AliTOFClusterFinderV1.cxx:3805
 AliTOFClusterFinderV1.cxx:3806
 AliTOFClusterFinderV1.cxx:3807
 AliTOFClusterFinderV1.cxx:3808
 AliTOFClusterFinderV1.cxx:3809
 AliTOFClusterFinderV1.cxx:3810
 AliTOFClusterFinderV1.cxx:3811
 AliTOFClusterFinderV1.cxx:3812
 AliTOFClusterFinderV1.cxx:3813
 AliTOFClusterFinderV1.cxx:3814
 AliTOFClusterFinderV1.cxx:3815
 AliTOFClusterFinderV1.cxx:3816
 AliTOFClusterFinderV1.cxx:3817
 AliTOFClusterFinderV1.cxx:3818
 AliTOFClusterFinderV1.cxx:3819
 AliTOFClusterFinderV1.cxx:3820
 AliTOFClusterFinderV1.cxx:3821
 AliTOFClusterFinderV1.cxx:3822
 AliTOFClusterFinderV1.cxx:3823
 AliTOFClusterFinderV1.cxx:3824
 AliTOFClusterFinderV1.cxx:3825
 AliTOFClusterFinderV1.cxx:3826
 AliTOFClusterFinderV1.cxx:3827
 AliTOFClusterFinderV1.cxx:3828
 AliTOFClusterFinderV1.cxx:3829
 AliTOFClusterFinderV1.cxx:3830
 AliTOFClusterFinderV1.cxx:3831
 AliTOFClusterFinderV1.cxx:3832
 AliTOFClusterFinderV1.cxx:3833
 AliTOFClusterFinderV1.cxx:3834
 AliTOFClusterFinderV1.cxx:3835
 AliTOFClusterFinderV1.cxx:3836
 AliTOFClusterFinderV1.cxx:3837
 AliTOFClusterFinderV1.cxx:3838
 AliTOFClusterFinderV1.cxx:3839