ROOT logo
/**************************************************************************
 * Copyright(c) 2007-2009, ALICE Experiment at CERN, All rights reserved. *
 *                                                                        *
 * Author: The ALICE Off-line Project.                                    *
 * Contributors are mentioned in the code where appropriate.              *
 *                                                                        *
 * Permission to use, copy, modify and distribute this software and its   *
 * documentation strictly for non-commercial purposes is hereby granted   *
 * without fee, provided that the above copyright notice appears in all   *
 * copies and that both the copyright notice and this permission notice   *
 * appear in the supporting documentation. The authors make no claims     *
 * about the suitability of this software for any purpose. It is          *
 * provided "as is" without express or implied warranty.                  *
 **************************************************************************/

/* $Id$ */

////////////////////////////////////////////////////////////////////////////
//            Implementation of the ITS clusterer V2 class                //
//                                                                        //
//          Origin: Iouri Belikov, CERN, Jouri.Belikov@cern.ch            //
//          Last revision: 13-05-09 Enrico Fragiacomo                     //
//                                  enrico.fragiacomo@ts.infn.it          //
//                                                                        //
///////////////////////////////////////////////////////////////////////////

#include "AliITSClusterFinderV2SSD.h"

#include <Riostream.h>
#include <TGeoGlobalMagField.h>

#include "AliLog.h"
#include "AliMagF.h"
#include "AliITSRecPoint.h"
#include "AliITSRecPointContainer.h"
#include "AliITSgeomTGeo.h"
#include "AliRawReader.h"
#include "AliITSRawStreamSSD.h"
#include <TClonesArray.h>
#include <TCollection.h>
#include "AliITSdigitSSD.h"
#include "AliITSReconstructor.h"
#include "AliITSCalibrationSSD.h"
#include "AliITSsegmentationSSD.h"

Short_t *AliITSClusterFinderV2SSD::fgPairs = 0x0;
Int_t    AliITSClusterFinderV2SSD::fgPairsSize = 0;
const Float_t  AliITSClusterFinderV2SSD::fgkThreshold = 5.;

const Float_t AliITSClusterFinderV2SSD::fgkCosmic2008StripShifts[16][9] = 
  {{-0.35,-0.35,-0.35,-0.35,-0.35,-0.35,-0.35,-0.35,-0.35},  // DDL 512
   {-0.35,-0.35,-0.35,-0.35,-0.35,-0.35,-0.35,-0.35,-0.35},  // DDL 513
   {-0.15,-0.15,-0.15,-0.15,-0.15,-0.15,-0.15,-0.15,-0.15},  // DDL 514
   {-0.15,-0.15,-0.15,-0.15,-0.15,-0.15,-0.15,-0.15,-0.15},  // DDL 515
   { 0.00, 0.00, 0.00, 0.00, 0.00, 0.00, 0.00, 0.00, 0.00},  // DDL 516
   { 0.00, 0.00, 0.00, 0.00, 0.00, 0.00, 0.00, 0.00, 0.00},  // DDL 517
   {-0.15,-0.15,-0.15,-0.15,-0.15,-0.15,-0.15,-0.15,-0.15},  // DDL 518
   {-0.15,-0.15,-0.15,-0.15,-0.15,-0.15,-0.15,-0.15,-0.15},  // DDL 519
   {-0.15,-0.15,-0.15,-0.15,-0.15,-0.15,-0.15,-0.25,-0.15},  // DDL 520
   {-0.15,-0.15,-0.15,-0.15,-0.15,-0.15,-0.15,-0.15,-0.15},  // DDL 521
   {-0.10,-0.10,-0.10,-0.40,-0.40,-0.40,-0.10,-0.10,-0.45},  // DDL 522
   {-0.10,-0.10,-0.10,-0.35,-0.35,-0.35,-0.10,-0.35,-0.50},  // DDL 523
   { 0.00, 0.00, 0.00, 0.00, 0.00, 0.00, 0.00, 0.00, 0.00},  // DDL 524
   { 0.00, 0.00, 0.00, 0.00, 0.00, 0.00, 0.00, 0.00, 0.00},  // DDL 525
   { 0.35, 0.35, 0.35, 0.35, 0.35, 0.35, 0.35, 0.35, 0.35},  // DDL 526
   { 0.45, 0.45, 0.45, 0.45, 0.45, 0.45, 0.45, 0.45, 0.45}}; // DDL 527

ClassImp(AliITSClusterFinderV2SSD)


  AliITSClusterFinderV2SSD::AliITSClusterFinderV2SSD(AliITSDetTypeRec* dettyp):AliITSClusterFinder(dettyp),fLastSSD1(AliITSgeomTGeo::GetModuleIndex(6,1,1)-1), fLorentzShiftP(0), fLorentzShiftN(0)
{
//Default constructor
  static AliITSRecoParam *repa = NULL;  
  if(!repa){
    repa = (AliITSRecoParam*) AliITSReconstructor::GetRecoParam();
    if(!repa){
      repa = AliITSRecoParam::GetHighFluxParam();
      AliWarning("Using default AliITSRecoParam class");
    }
  }

  if (repa->GetCorrectLorentzAngleSSD()) {
    AliMagF* field = dynamic_cast<AliMagF*>(TGeoGlobalMagField::Instance()->GetField()); 
    if (field == 0) {
      AliError("Cannot get magnetic field from TGeoGlobalMagField");
    }
    else {
      Float_t bField = field->SolenoidField();
      // NB: spatial shift has opposite sign for lay 5 and 6, but strip numbering also changes direction, so no sign-change 
      // Shift due to ExB on drift N-side, units: strip width 
      fLorentzShiftP = -repa->GetTanLorentzAngleElectronsSSD() * 150.e-4/95.e-4 * bField / 5.0;
      // Shift due to ExB on drift P-side, units: strip width 
      fLorentzShiftN = -repa->GetTanLorentzAngleHolesSSD() * 150.e-4/95.e-4 * bField / 5.0;
      AliDebug(1,Form("bField %f Lorentz Shift P-side %f N-side %f",bField,fLorentzShiftN,fLorentzShiftP));
    }
  }
}
 
//______________________________________________________________________
AliITSClusterFinderV2SSD::AliITSClusterFinderV2SSD(const AliITSClusterFinderV2SSD &cf) : AliITSClusterFinder(cf), fLastSSD1(cf.fLastSSD1), fLorentzShiftP(cf.fLorentzShiftP), fLorentzShiftN(cf.fLorentzShiftN)
{
  // Copy constructor
}

//______________________________________________________________________
AliITSClusterFinderV2SSD& AliITSClusterFinderV2SSD::operator=(const AliITSClusterFinderV2SSD&  cf ){
  // Assignment operator

  this->~AliITSClusterFinderV2SSD();
  new(this) AliITSClusterFinderV2SSD(cf);
  return *this;
}


void AliITSClusterFinderV2SSD::FindRawClusters(Int_t mod){

  //Find clusters V2
  SetModule(mod);
  FindClustersSSD(fDigits);

}

void AliITSClusterFinderV2SSD::FindClustersSSD(TClonesArray *alldigits) {
  //------------------------------------------------------------
  // Actual SSD cluster finder
  //------------------------------------------------------------
  Int_t smaxall=alldigits->GetEntriesFast();
  if (smaxall==0) return;


  //---------------------------------------
  // load recoparam and calibration
  // 
  static AliITSRecoParam *repa = NULL;  
  if(!repa){
    repa = (AliITSRecoParam*) AliITSReconstructor::GetRecoParam();
    if(!repa){
      repa = AliITSRecoParam::GetHighFluxParam();
      AliWarning("Using default AliITSRecoParam class");
    }
  }

  AliITSCalibrationSSD* cal = (AliITSCalibrationSSD*)GetResp(fModule);
  Float_t gain=0;
  Float_t noise=0;
  //---------------------------------------


  //------------------------------------
  // fill the digits array with zero-suppression condition
  // Signal is converted in KeV
  //
  TObjArray digits;
  for (Int_t i=0;i<smaxall; i++){
    AliITSdigitSSD *d=(AliITSdigitSSD*)alldigits->UncheckedAt(i);

    if(d->IsSideP()) noise = cal->GetNoiseP(d->GetStripNumber());  
    else noise = cal->GetNoiseN(d->GetStripNumber());
    if (d->GetSignal()<3.*noise) continue;

    if(d->IsSideP()) gain = cal->GetGainP(d->GetStripNumber());  
    else gain = cal->GetGainN(d->GetStripNumber());

    Float_t q=gain*d->GetSignal(); //
    q=cal->ADCToKeV(q); // converts the charge in KeV from ADC units
    d->SetSignal(Int_t(q));

    digits.AddLast(d);
  }
  Int_t smax = digits.GetEntriesFast();
  if (smax==0) return;
  //------------------------------------

  
  const Int_t kMax=1000;
  Int_t np=0, nn=0; 
  Ali1Dcluster pos[kMax], neg[kMax];
  Float_t y=0., q=0., qmax=0.; 
  Int_t lab[4]={-2,-2,-2,-2};  
  Bool_t flag5 = 0;
  
  /*
  cout<<"-----------------------------"<<endl;
  cout<<"this is module "<<fModule;
  cout<<endl;
  cout<<endl;
 
  Int_t layer = 4;
  if (fModule>fLastSSD1) 
    layer = 5;
  */
  //--------------------------------------------------------
  // start 1D-clustering from the first digit in the digits array
  //
  AliITSdigitSSD *d=(AliITSdigitSSD*)digits.UncheckedAt(0);
  q += d->GetSignal();
  y += d->GetCoord2()*d->GetSignal();
  qmax=d->GetSignal();
  lab[0]=d->GetTrack(0); lab[1]=d->GetTrack(1); lab[2]=d->GetTrack(2);
  
  if(d->IsSideP()) {
    noise = cal->GetNoiseP(d->GetStripNumber());  
    gain = cal->GetGainP(d->GetStripNumber());
  }
  else {
    noise = cal->GetNoiseN(d->GetStripNumber());
    gain = cal->GetGainN(d->GetStripNumber());
  }  
  noise*=gain;
  noise=cal->ADCToKeV(noise); // converts noise in KeV from ADC units

  if(qmax>fgkThreshold*noise) flag5=1; // seed for the cluster

  /*
  cout<<d->GetSignal()<<" "<<noise<<" "<<flag5<<" "<<
    d->GetCoord1()<<" "<<d->GetCoord2()<<endl;
  */

  Int_t curr=d->GetCoord2();
  Int_t flag=d->GetCoord1();

  // Note: the first side which will be processed is supposed to be the 
  // P-side which is neg
  Int_t *n=&nn;
  Ali1Dcluster *c=neg;
  if(flag) {n=&np; c=pos;} // in case we have only Nstrips (P was bad!)

  Int_t nd=1;
  Int_t milab[10];
  for (Int_t ilab=0;ilab<10;ilab++){
    milab[ilab]=-2;
  }
  milab[0]=d->GetTrack(0); milab[1]=d->GetTrack(1); milab[2]=d->GetTrack(2);


  //----------------------------------------------------------
  // search for neighboring digits
  //
  for (Int_t s=1; s<smax; s++) {
      d=(AliITSdigitSSD*)digits.UncheckedAt(s);      
      Int_t strip=d->GetCoord2();

      // if digits is not a neighbour or side did not change 
      // and at least one of the previous digits met the seed condition
      // then creates a new 1D cluster
      if ( ( ((strip-curr) > 1) || (flag!=d->GetCoord1()) ) ) {

	if(flag5) {
	  //cout<<"here1"<<endl;
	  Float_t dLorentz = 0;
	  if (!flag) { // P-side is neg clust
	    dLorentz = fLorentzShiftN;
	  }
	  else { // N-side is p clust
	    dLorentz = fLorentzShiftP;
	  }
         c[*n].SetY(y/q+dLorentz);
         c[*n].SetQ(q);
         c[*n].SetNd(nd);
	 CheckLabels2(milab);
         c[*n].SetLabels(milab);

	 if(repa->GetUseUnfoldingInClusterFinderSSD()==kTRUE) {
	   // Note: fUseUnfoldingInClusterFinderSSD=kFALSE by default in RecoParam

	   //Split suspiciously big cluster
	   if (nd>4&&nd<25) {
	     c[*n].SetY(y/q-0.25*nd+dLorentz);
	     c[*n].SetQ(0.5*q);
	     (*n)++;
	     if (*n==kMax) {
	       Error("FindClustersSSD","Too many 1D clusters !");
	       return;
	     }
	     c[*n].SetY(y/q+0.25*nd+dLorentz);
	     c[*n].SetQ(0.5*q);
	     c[*n].SetNd(nd);
	     c[*n].SetLabels(milab);
	   }	 
	   
	 } // unfolding is on

         (*n)++;
         if (*n==kMax) {
          Error("FindClustersSSD","Too many 1D clusters !");
          return;
         }

	} // flag5 set

	 // reset everything
         y=q=qmax=0.;
         nd=0;
	 flag5=0;
         lab[0]=lab[1]=lab[2]=-2;
	 for (Int_t ilab=0;ilab<10;ilab++) milab[ilab]=-2;

	 // if side changed from P to N, switch to pos 1D clusters
	 // (if for some reason the side changed from N to P then do the opposite)
         if (flag!=d->GetCoord1()) 
	   { if(!flag) {n=&np; c=pos;} else {n=&nn; c=neg;} }

      } // end create new 1D cluster from previous neighboring digits

      // continues adding digits to the previous cluster 
      // or start a new one 
      flag=d->GetCoord1();
      q += d->GetSignal();
      y += d->GetCoord2()*d->GetSignal();
      nd++;

      if(d->IsSideP()) {
	noise = cal->GetNoiseP(d->GetStripNumber());  
	gain = cal->GetGainP(d->GetStripNumber());
      }
      else {
	noise = cal->GetNoiseN(d->GetStripNumber());
	gain = cal->GetGainN(d->GetStripNumber());
      }
      noise*=gain;
      noise=cal->ADCToKeV(noise); // converts the charge in KeV from ADC units

      if(d->GetSignal()>fgkThreshold*noise) flag5=1;

      /*
  cout<<d->GetSignal()<<" "<<noise<<" "<<flag5<<" "<<
    d->GetCoord1()<<" "<<d->GetCoord2()<<endl;
      */

      if (d->GetSignal()>qmax) {
         qmax=d->GetSignal();
         lab[0]=d->GetTrack(0); lab[1]=d->GetTrack(1); lab[2]=d->GetTrack(2);
      }
      for (Int_t ilab=0;ilab<10;ilab++) {
	if (d->GetTrack(ilab)>=0) AddLabel(milab, (d->GetTrack(ilab))); 
      }
      curr=strip;


  } // loop over digits, no more digits in the digits array


  // add the last 1D cluster 
  if(flag5) {

    //	cout<<"here2"<<endl;
    Float_t dLorentz = 0;
    if (!flag) { // P-side is neg clust
      dLorentz = fLorentzShiftN;
    }
    else { // N-side is p clust
      dLorentz = fLorentzShiftP;
    }
    
    c[*n].SetY(y/q + dLorentz);
    c[*n].SetQ(q);
    c[*n].SetNd(nd);
    c[*n].SetLabels(lab);
    
    if(repa->GetUseUnfoldingInClusterFinderSSD()==kTRUE) {
      
      //Split suspiciously big cluster
      if (nd>4 && nd<25) {
	c[*n].SetY(y/q-0.25*nd + dLorentz);
	c[*n].SetQ(0.5*q);
	(*n)++;
	if (*n==kMax) {
	  Error("FindClustersSSD","Too many 1D clusters !");
	  return;
	}
	c[*n].SetY(y/q+0.25*nd + dLorentz);
	c[*n].SetQ(0.5*q);
	c[*n].SetNd(nd);
	c[*n].SetLabels(lab);
      }
    } // unfolding is on
    
    (*n)++;
    if (*n==kMax) {
      Error("FindClustersSSD","Too many 1D clusters !");
      return;
    }

  } // if flag5 last 1D cluster added


  //------------------------------------------------------
  // call FindClustersSSD to pair neg and pos 1D clusters 
  // and create recpoints from the crosses
  // Note1: neg are Pside and pos are Nside!!
  // Note2: if there are no Pside digits nn=0 (bad strips!!) (same for Nside)
  //
  //  cout<<nn<<" Pside and "<<np<<" Nside clusters"<<endl;
  
  AliITSRecPointContainer* rpc = AliITSRecPointContainer::Instance();   
  if (nn*np > 0) { 
    TClonesArray* clusters = rpc->UncheckedGetClusters(fModule);
    clusters->Clear();
    FindClustersSSD(neg, nn, pos, np, clusters);
    TIter itr(clusters);
    AliITSRecPoint *irp;
    while ((irp = (AliITSRecPoint*)itr.Next()))  fDetTypeRec->AddRecPoint(*irp);
  }
  //-----------------------------------------------------
}


void AliITSClusterFinderV2SSD::RawdataToClusters(AliRawReader* rawReader){

  //------------------------------------------------------------
  // This function creates ITS clusters from raw data
  //------------------------------------------------------------
  fNClusters = 0;
  rawReader->Reset();
  AliITSRawStreamSSD inputSSD(rawReader);
  FindClustersSSD(&inputSSD);
  
}


void AliITSClusterFinderV2SSD::FindClustersSSD(AliITSRawStreamSSD* input) 
{
  //------------------------------------------------------------
  // Actual SSD cluster finder for raw data
  //------------------------------------------------------------

  AliITSRecPointContainer* rpc = AliITSRecPointContainer::Instance();
  static AliITSRecoParam *repa = NULL;
  if(!repa){
    repa = (AliITSRecoParam*) AliITSReconstructor::GetRecoParam();
    if(!repa){
      repa = AliITSRecoParam::GetHighFluxParam();
      AliWarning("Using default AliITSRecoParam class");
    }
  }
  if (fRawID2ClusID) { // RS: reset references from 1D clusters to rawID's
    fRawIDRef[0].Reset();
    fRawIDRef[1].Reset();
  }
  Int_t nClustersSSD = 0;
  const Int_t kNADC = 12;
  const Int_t kMaxADCClusters = 1000;

  Int_t strips[kNADC][2][kMaxADCClusters][3]; // [ADC],[side],[istrip], [0]=istrip [1]=signal [2]=rawID (for embedding, RS)
  Int_t nStrips[kNADC][2];

  for( int i=0; i<kNADC; i++ ){
    nStrips[i][0] = 0;
    nStrips[i][1] = 0;
  }

  Int_t ddl = -1;
  Int_t ad = -1;
  
  //*
  //* Loop over modules DDL+AD
  //*
  int countRW = 0; //RS
  if (fRawID2ClusID) fRawID2ClusID->Reset(); //RS if array was provided, we shall store the rawID -> ClusterID

  while (kTRUE) {

    bool next = input->Next();
    
    //* 
    //* Continue if corrupted input
    //*

    if( (!next)&&(input->flag) ){
     AliWarning(Form("ITSClustersFinderSSD: Corrupted data: warning from RawReader"));
      continue; 
    }

    Int_t newDDL = input->GetDDL(); 
    Int_t newAD = input->GetAD();

    if( next ){
      if( newDDL<0 || newDDL>15 ){
	AliWarning(Form("ITSClustersFinderSSD: Corrupted data: wrong DDL number (%d)",newDDL));
	continue;
      }
      
      if( newAD<1 || newAD>9 ){
	AliWarning(Form("ITSClustersFinderSSD: Corrupted data: wrong AD number (%d)",newAD));
	continue;
      }
    }

    bool newModule = ( !next || ddl!= newDDL || ad!=newAD );

    if( newModule && ddl>=0 && ad>=0 ){ 

      //*
      //* Reconstruct the previous block of 12 modules --- actual clusterfinder
      //* 
      //cout<<endl;
      for( int adc = 0; adc<kNADC; adc++ ){
	
	//* 1D clusterfinder

	Ali1Dcluster clusters1D[2][kMaxADCClusters]; // per ADC, per side
	Int_t nClusters1D[2] = {0,0};
	//int nstat[2] = {0,0};
	fModule = AliITSRawStreamSSD::GetModuleNumber(ddl, (ad - 1)  * 12 + adc );
	
	if( fModule<0 ){
//	  AliWarning(Form("ITSClustersFinderSSD: Corrupted data: module (ddl %d ad %d adc %d) not found in the map",ddl,ad,adc));
//CM channels are always present even everything is suppressed 
	  continue;
	}
	
	/*	Int_t layer = 4;
	if (fModule>fLastSSD1) 
	  layer = 5;
	*/

	AliITSCalibrationSSD* cal = (AliITSCalibrationSSD*)fDetTypeRec->GetCalibrationModel(fModule);
	if( !cal ){
	  AliWarning(Form("ITSClustersFinderSSD: No calibration found for module (ddl %d ad %d adc %d)",ddl,ad,adc));	    
	  continue;
	}

	Float_t dStrip = 0;

	if( repa->GetUseCosmicRunShiftsSSD()) {  // Special condition for 2007/2008 cosmic data
	  dStrip = fgkCosmic2008StripShifts[ddl][ad-1];
	  if (TMath::Abs(dStrip) > 1.5){
	    AliWarning(Form("Indexing error in Cosmic calibration: ddl = %d, dStrip %f\n",ddl,dStrip));
	    dStrip = 0;
	  }	
	}
	
	for( int side=0; side<=1; side++ ){

	  Int_t lab[3]={-2,-2,-2};
	  Float_t q = 0.;
	  Float_t y = 0.;
	  Int_t nDigits = 0;
	  Int_t ostrip = -2;
	  Bool_t snFlag = 0;

	  Float_t dLorentz = 0;
	  if (side==0) { // P-side is neg clust
	    dLorentz = fLorentzShiftN;
	  }
	  else { // N-side is pos clust
	    dLorentz = fLorentzShiftP;
	  }
	  
	  Int_t n = nStrips[adc][side];
	  for( int istr = 0; istr<n+1; istr++ ){
	    
	    bool stripOK = 1;
	    Int_t strip=0, rwID = 0;
	    Float_t signal=0.0, noise=0.0, gain=0.0;
	    
	    if( istr<n ){
	      strip = strips[adc][side][istr][0];
	      signal = strips[adc][side][istr][1];
	      rwID   = strips[adc][side][istr][2]; // RS
	      //cout<<"strip "<<adc<<" / "<<side<<": "<<strip<<endl;

	      if( cal ){
		noise = side ?cal->GetNoiseN(strip) :cal->GetNoiseP(strip); 
		gain = side ?cal->GetGainN(strip) :cal->GetGainP(strip);	 
		stripOK = ( noise>=1. && signal>=3.0*noise 
			    //&& !cal->IsPChannelBad(strip) 
			    );
	      }
	    } else stripOK = 0; // end of data

	    bool newCluster = ( (abs(strip-ostrip)!=1) || !stripOK );	  
	        
	    if( newCluster ){

	      //* Store the previous cluster

	      if( nDigits>0 && q>0 && snFlag ){

		if (nClusters1D[side] >= kMaxADCClusters-1 ) {
		  AliWarning("HLT ClustersFinderSSD: Too many 1D clusters !");
		}else {
		  
		  Ali1Dcluster &cluster = clusters1D[side][nClusters1D[side]++];
		  cluster.SetY( y / q + dStrip + dLorentz);
		  cluster.SetQ(q);
		  cluster.SetNd(nDigits);
		  cluster.SetLabels(lab);
		  //cout<<"cluster 1D side "<<side<<": y= "<<y<<" q= "<<q<<" d="<<dStrip<<" Y="<<cluster.GetY()<<endl;
		  //Split suspiciously big cluster

		  if( repa->GetUseUnfoldingInClusterFinderSSD()
		      && nDigits > 4 && nDigits < 25 
		      ){
		    cluster.SetY(y/q + dStrip - 0.25*nDigits + dLorentz);	    
		    cluster.SetQ(0.5*q);	  
		    Ali1Dcluster& cluster2 = clusters1D[side][nClusters1D[side]++];
		    cluster2.SetY(y/q + dStrip + 0.25*nDigits + dLorentz);	    
		    cluster2.SetQ(0.5*q);
		    cluster2.SetNd(nDigits);
		    cluster2.SetLabels(lab);	  
		  } // unfolding is on	  	
		}
	      }
	      y = q = 0.;
	      nDigits = 0;
	      snFlag = 0;

	    } //* End store the previous cluster

	    if( stripOK ){ // add new signal to the cluster
//	      signal = (Int_t) (signal * gain); // signal is corrected for gain
	      if( signal>fgkThreshold*noise) snFlag = 1;
	      signal = signal * gain; // signal is corrected for gain
//	      if( cal ) signal = (Int_t) cal->ADCToKeV( signal ); // signal is  converted in KeV  	  
	      if( cal ) signal = cal->ADCToKeV( signal ); // signal is  converted in KeV  	  
	      q += signal;	  // add digit to current cluster
	      y += strip * signal;	  
	      nDigits++;
	      //nstat[side]++;
	      ostrip = strip;
	      if (fRawID2ClusID) fRawIDRef[side].AddReference(nClusters1D[side],rwID);

	    }
	  } //* end loop over strips

	} //* end loop over ADC sides
	

  	//* 2D clusterfinder
      	if( nClusters1D[0] && nClusters1D[1] && fModule>=0 ){
           TClonesArray* clusters = rpc->UncheckedGetClusters(fModule);
	       FindClustersSSD( clusters1D[0], nClusters1D[0], clusters1D[1], nClusters1D[1], clusters); 
           Int_t nClustersn = clusters->GetEntriesFast();
	       nClustersSSD += nClustersn;
	}

	//cout<<"SG: "<<ddl<<" "<<ad<<" "<<adc<<": strips "<<nstat[0]<<"+"<<nstat[1]<<", clusters 1D= "<<nClusters1D[0]<<" + "<<nClusters1D[1]<<", 2D= "<<clusters.size()<<endl;

      }//* end loop over adc
      
    }//* end of reconstruction of previous block of 12 modules
    
    if( newModule ){
      
      //*
      //* Clean up arrays and set new module
      //* 
      
      for( int i=0; i<kNADC; i++ ){
	nStrips[i][0] = 0;
	nStrips[i][1] = 0;
      }     
      ddl = newDDL;
      ad = newAD;
    } 
    

    //*
    //* Exit main loop when there is no more input
    //* 

    if( !next ) break;
    
    //* 
    //* Fill the current strip information
    //* 

    Int_t adc = input->GetADC(); 
    if( adc<0 || adc>=kNADC+2 || (adc>5&&adc<8) ){
      AliWarning(Form("HLT ClustersFinderSSD: Corrupted data: wrong adc number (%d)", adc));
      continue;
    }

    if( adc>7 ) adc-= 2; // shift ADC numbers 8-13 to 6-11
    
    Bool_t side = input->GetSideFlag();
    Int_t strip = input->GetStrip();
    Int_t signal = input->GetSignal();
    

    //cout<<"SSD: "<<ddl<<" "<<ad<<" "<<adc<<" "<<side<<" "<<strip<<" : "<<signal<<endl;

    if( strip>767 ){    
      AliWarning(Form("HLT ClustersFinderSSD: Corrupted data: wrong strip number (ddl %d ad %d adc %d side %d, strip %d", 
		      ddl, ad, adc, side,strip) );
      continue;
    }
    if (strip < 0) continue;
    
    int &n = nStrips[adc][side];
    if( n >0 ){
      Int_t oldStrip = strips[adc][side][n-1][0];

      if( strip==oldStrip ){
	AliWarning(Form("HLT ClustersFinderSSD: Corrupted data: duplicated signal: ddl %d ad %d adc %d, side %d, strip %d", 
			ddl, ad, adc, side, strip ));
	continue;
      }
    }
    strips[adc][side][n][0] = strip;
    strips[adc][side][n][1] = signal;    
    strips[adc][side][n][2] = countRW;    
    n++;

    //cout<<"SSD: "<<input->GetDDL()<<" "<<input->GetAD()<<" "
    //<<input->GetADC()<<" "<<input->GetSideFlag()<<" "<<((int)input->GetStrip())<<" "<<strip<<" : "<<input->GetSignal()<<endl;
    //
    countRW++; //RS
  } //* End main loop over the input
  
  AliDebug(1,Form("found clusters in ITS SSD: %d", nClustersSSD));
}


void AliITSClusterFinderV2SSD::
FindClustersSSD(const Ali1Dcluster* neg, Int_t nn, 
		const Ali1Dcluster* pos, Int_t np,
		TClonesArray *clusters) {
  //------------------------------------------------------------
  // Actual SSD cluster finder
  //------------------------------------------------------------

  const TGeoHMatrix *mT2L=AliITSgeomTGeo::GetTracking2LocalMatrix(fModule);

  //---------------------------------------
  // load recoparam
  // 
  static AliITSRecoParam *repa = NULL;  
  if(!repa){
    repa = (AliITSRecoParam*) AliITSReconstructor::GetRecoParam();
    if(!repa){
      repa = AliITSRecoParam::GetHighFluxParam();
      AliWarning("Using default AliITSRecoParam class");
    }
  }

//  TClonesArray &cl=*clusters;
  
  AliITSsegmentationSSD *seg = static_cast<AliITSsegmentationSSD*>(fDetTypeRec->GetSegmentationModel(2));
  if (fModule>fLastSSD1) 
    seg->SetLayer(6);
  else 
    seg->SetLayer(5);

  Float_t hwSSD = seg->Dx()*1e-4/2;
  Float_t hlSSD = seg->Dz()*1e-4/2;

  Int_t idet=fNdet[fModule];
  Int_t ncl=0;

  //
  Int_t *cnegative = new Int_t[np];  
  Int_t *cused1 = new Int_t[np];
  Int_t *negativepair = new Int_t[10*np];
  Int_t *cpositive = new Int_t[nn];  
  Int_t *cused2 = new Int_t[nn];  
  Int_t *positivepair = new Int_t[10*nn];  
  for (Int_t i=0;i<np;i++) {cnegative[i]=0; cused1[i]=0;}
  for (Int_t i=0;i<nn;i++) {cpositive[i]=0; cused2[i]=0;}
  for (Int_t i=0;i<10*np;i++) {negativepair[i]=0;}
  for (Int_t i=0;i<10*nn;i++) {positivepair[i]=0;}

  if ((np*nn) > fgPairsSize) {

    delete [] fgPairs;
    fgPairsSize = 2*np*nn;
    fgPairs = new Short_t[fgPairsSize];
  }
  memset(fgPairs,0,sizeof(Short_t)*np*nn);

  //
  // find available pairs
  //
  Int_t ncross = 0;
  for (Int_t i=0; i<np; i++) {
    Float_t yp=pos[i].GetY(); 
    if ( (pos[i].GetQ()>0) && (pos[i].GetQ()<3) ) continue;
    for (Int_t j=0; j<nn; j++) {
      if ( (neg[j].GetQ()>0) && (neg[j].GetQ()<3) ) continue;
      Float_t yn=neg[j].GetY();

      Float_t xt, zt;
      seg->GetPadCxz(yn, yp, xt, zt);
      //cout<<yn<<" "<<yp<<" "<<xt<<" "<<zt<<endl;
      
      if (TMath::Abs(xt)<hwSSD)
      if (TMath::Abs(zt)<hlSSD) {
	Int_t in = i*10+cnegative[i];
	Int_t ip = j*10+cpositive[j];
	if ((in < 10*np) && (ip < 10*nn)) {
	  negativepair[in] =j;  //index
	  positivepair[ip] =i;
	  cnegative[i]++;  //counters
	  cpositive[j]++;
	  ncross++;	
	  fgPairs[i*nn+j]=100;
	}
	else
	  AliError(Form("Index out of range: ip=%d, in=%d",ip,in));
      }
    }
  }

  if (!ncross) {
    delete [] cnegative;
    delete [] cused1;
    delete [] negativepair;
    delete [] cpositive;
    delete [] cused2;
    delete [] positivepair;
    return;
  }
//why not to allocate memorey here?  if(!clusters) clusters = new TClonesArray("AliITSRecPoint", ncross);
  
  /* //
  // try to recover points out of but close to the module boundaries 
  //
  for (Int_t i=0; i<np; i++) {
    Float_t yp=pos[i].GetY(); 
    if ( (pos[i].GetQ()>0) && (pos[i].GetQ()<3) ) continue;
    for (Int_t j=0; j<nn; j++) {
      if ( (neg[j].GetQ()>0) && (neg[j].GetQ()<3) ) continue;
      // if both 1Dclusters have an other cross continue
      if (cpositive[j]&&cnegative[i]) continue;
      Float_t yn=neg[j].GetY();
      
      Float_t xt, zt;
      seg->GetPadCxz(yn, yp, xt, zt);
      
      if (TMath::Abs(xt)<hwSSD+0.1)
      if (TMath::Abs(zt)<hlSSD+0.15) {
	// tag 1Dcluster (eventually will produce low quality recpoint)
	if (cnegative[i]==0) pos[i].SetNd(100);  // not available pair
	if (cpositive[j]==0) neg[j].SetNd(100);  // not available pair
	Int_t in = i*10+cnegative[i];
	Int_t ip = j*10+cpositive[j];
	if ((in < 10*np) && (ip < 10*nn)) {
	  negativepair[in] =j;  //index
	  positivepair[ip] =i;
	  cnegative[i]++;  //counters
	  cpositive[j]++;	
	  fgPairs[i*nn+j]=100;
	}
	else
	  AliError(Form("Index out of range: ip=%d, in=%d",ip,in));
      }
    }
  }
  */

  //
  Float_t lp[6];
  Int_t milab[10];
  Double_t ratio;
  

  if(repa->GetUseChargeMatchingInClusterFinderSSD()==kTRUE) {


    //
    // sign gold tracks
    //
    for (Int_t ip=0;ip<np;ip++){
      Float_t xbest=1000,zbest=1000,qbest=0;
      //
      // select gold clusters
      if ( (cnegative[ip]==1) && cpositive[negativepair[10*ip]]==1){ 
	Float_t yp=pos[ip].GetY(); 
	Int_t j = negativepair[10*ip];      

	if( (pos[ip].GetQ()==0) && (neg[j].GetQ() ==0) ) { 
	  // both bad, hence continue;	  
	  // mark both as used (to avoid recover at the end)
	  cused1[ip]++; 
	  cused2[j]++;
	  continue;
	}

	ratio = (pos[ip].GetQ()-neg[j].GetQ())/(pos[ip].GetQ()+neg[j].GetQ());
	//cout<<"ratio="<<ratio<<endl;

	// charge matching (note that if posQ or negQ is 0 -> ratio=1 and the following condition is met
	if (TMath::Abs(ratio)>0.2) continue; // note: 0.2=3xsigma_ratio calculated in cosmics tests

	//
	Float_t yn=neg[j].GetY();
	
	Float_t xt, zt;
	seg->GetPadCxz(yn, yp, xt, zt);
	
	xbest=xt; zbest=zt; 

	
	qbest=0.5*(pos[ip].GetQ()+neg[j].GetQ());
	if( (pos[ip].GetQ()==0)||(neg[j].GetQ()==0)) qbest*=2; // in case of bad strips on one side keep all charge from the other one
	
	{
	  Double_t loc[3]={xbest,0.,zbest},trk[3]={0.,0.,0.};
	  mT2L->MasterToLocal(loc,trk);
	  lp[0]=trk[1];
	  lp[1]=trk[2];
	}
	lp[4]=qbest;        //Q
	for (Int_t ilab=0;ilab<10;ilab++) milab[ilab]=-2;
	for (Int_t ilab=0;ilab<3;ilab++){
	  milab[ilab] = pos[ip].GetLabel(ilab);
	  milab[ilab+3] = neg[j].GetLabel(ilab);
	}
	//
	CheckLabels2(milab);
	milab[3]=(((ip<<10) + j)<<10) + idet; // pos|neg|det
	Int_t info[3] = {pos[ip].GetNd(),neg[j].GetNd(),fNlayer[fModule]};

	lp[2]=4.968e-06;     // 0.00223*0.00223;  //SigmaY2
	lp[3]=0.012;         // 0.110*0.110;  //SigmaZ2
	// out-of-diagonal element of covariance matrix
 	if( (info[0]==1) && (info[1]==1) ) lp[5]=-0.00012;
	else if ( (info[0]>1) && (info[1]>1) ) { 
	  lp[2]=2.63e-06;    // 0.0016*0.0016;  //SigmaY2
	  lp[3]=0.0065;      // 0.08*0.08;   //SigmaZ2
	  lp[5]=-6.48e-05;
	}
	else {
	  lp[2]=4.80e-06;      // 0.00219*0.00219
	  lp[3]=0.0093;        // 0.0964*0.0964;
	  if (info[0]==1) {
	    lp[5]=-0.00014;
	  }
	  else { 
	    lp[2]=2.79e-06;    // 0.0017*0.0017; 
	    lp[3]=0.00935;     // 0.967*0.967;
	    lp[5]=-4.32e-05;
	  }
	}

	AliITSRecPoint * cl2;
	cl2 = new ((*clusters)[ncl]) AliITSRecPoint(milab,lp,info);
	  
    cl2->SetChargeRatio(ratio);    	
    cl2->SetType(1);
    fgPairs[ip*nn+j]=1;

    if ((pos[ip].GetNd()+neg[j].GetNd())>6){ //multi cluster
      cl2->SetType(2);
      fgPairs[ip*nn+j]=2;
    }

    if(pos[ip].GetQ()==0) cl2->SetType(3);
    if(neg[j].GetQ()==0) cl2->SetType(4);

    cused1[ip]++;
    cused2[j]++;

  	ncl++;
      }
    }
    
    for (Int_t ip=0;ip<np;ip++){
      Float_t xbest=1000,zbest=1000,qbest=0;
      //
      //
      // select "silber" cluster
      if ( cnegative[ip]==1 && cpositive[negativepair[10*ip]]==2){
	Int_t in  = negativepair[10*ip];
	Int_t ip2 = positivepair[10*in];
	if (ip2==ip) ip2 =  positivepair[10*in+1];
	Float_t pcharge = pos[ip].GetQ()+pos[ip2].GetQ();
	


	ratio = (pcharge-neg[in].GetQ())/(pcharge+neg[in].GetQ());
	if ( (TMath::Abs(ratio)<0.2) && (pcharge!=0) ) {
	  //if ( (TMath::Abs(pcharge-neg[in].GetQ())<30) && (pcharge!=0) ) { // 
	  
	  //
	  // add first pair
	  if ( (fgPairs[ip*nn+in]==100)&&(pos[ip].GetQ() ) ) {  //
	    
	    Float_t yp=pos[ip].GetY(); 
	    Float_t yn=neg[in].GetY();
	    
	    Float_t xt, zt;
	    seg->GetPadCxz(yn, yp, xt, zt);
	    
	    xbest=xt; zbest=zt; 

	    qbest =pos[ip].GetQ();
	    Double_t loc[3]={xbest,0.,zbest},trk[3]={0.,0.,0.};
	    mT2L->MasterToLocal(loc,trk);
	    lp[0]=trk[1];
	    lp[1]=trk[2];
	    
	    lp[4]=qbest;        //Q
	    for (Int_t ilab=0;ilab<10;ilab++) milab[ilab]=-2;
	    for (Int_t ilab=0;ilab<3;ilab++){
	      milab[ilab] = pos[ip].GetLabel(ilab);
	      milab[ilab+3] = neg[in].GetLabel(ilab);
	    }
	    //
	    CheckLabels2(milab);
	    ratio = (pos[ip].GetQ()-neg[in].GetQ())/(pos[ip].GetQ()+neg[in].GetQ());
	    milab[3]=(((ip<<10) + in)<<10) + idet; // pos|neg|det
	    Int_t info[3] = {pos[ip].GetNd(),neg[in].GetNd(),fNlayer[fModule]};
	    
	lp[2]=4.968e-06;     // 0.00223*0.00223;  //SigmaY2
	lp[3]=0.012;         // 0.110*0.110;  //SigmaZ2
	// out-of-diagonal element of covariance matrix
 	if( (info[0]==1) && (info[1]==1) ) lp[5]=-0.00012;
	else if ( (info[0]>1) && (info[1]>1) ) { 
	  lp[2]=2.63e-06;    // 0.0016*0.0016;  //SigmaY2
	  lp[3]=0.0065;      // 0.08*0.08;   //SigmaZ2
	  lp[5]=-6.48e-05;
	}
	else {
	  lp[2]=4.80e-06;      // 0.00219*0.00219
	  lp[3]=0.0093;        // 0.0964*0.0964;
	  if (info[0]==1) {
	    lp[5]=-0.00014;
	  }
	  else { 
	    lp[2]=2.79e-06;    // 0.0017*0.0017; 
	    lp[3]=0.00935;     // 0.967*0.967;
	    lp[5]=-4.32e-05;
	  }
	}

	AliITSRecPoint * cl2;
	      cl2 = new ((*clusters)[ncl]) AliITSRecPoint(milab,lp,info);
	      cl2->SetChargeRatio(ratio);    	
	      cl2->SetType(5);
	      fgPairs[ip*nn+in] = 5;
	      if ((pos[ip].GetNd()+neg[in].GetNd())>6){ //multi cluster
		cl2->SetType(6);
		fgPairs[ip*nn+in] = 6;
	      }	    
	    ncl++;
	  }
	  
	  
	  //
	  // add second pair
	  
	  //	if (!(cused1[ip2] || cused2[in])){  //
	  if ( (fgPairs[ip2*nn+in]==100) && (pos[ip2].GetQ()) ) {
	    
	    Float_t yp=pos[ip2].GetY();
	    Float_t yn=neg[in].GetY();
	    
	    Float_t xt, zt;
	    seg->GetPadCxz(yn, yp, xt, zt);
	    
	    xbest=xt; zbest=zt; 

	    qbest =pos[ip2].GetQ();
	    
	    Double_t loc[3]={xbest,0.,zbest},trk[3]={0.,0.,0.};
	    mT2L->MasterToLocal(loc,trk);
	    lp[0]=trk[1];
	    lp[1]=trk[2];
	    
	    lp[4]=qbest;        //Q
	    for (Int_t ilab=0;ilab<10;ilab++) milab[ilab]=-2;
	    for (Int_t ilab=0;ilab<3;ilab++){
	      milab[ilab] = pos[ip2].GetLabel(ilab);
	      milab[ilab+3] = neg[in].GetLabel(ilab);
	    }
	    //
	    CheckLabels2(milab);
	    ratio = (pos[ip2].GetQ()-neg[in].GetQ())/(pos[ip2].GetQ()+neg[in].GetQ());
	    milab[3]=(((ip2<<10) + in)<<10) + idet; // pos|neg|det
	    Int_t info[3] = {pos[ip2].GetNd(),neg[in].GetNd(),fNlayer[fModule]};
	    
	lp[2]=4.968e-06;     // 0.00223*0.00223;  //SigmaY2
	lp[3]=0.012;         // 0.110*0.110;  //SigmaZ2
	// out-of-diagonal element of covariance matrix
 	if( (info[0]==1) && (info[1]==1) ) lp[5]=-0.00012;
	else if ( (info[0]>1) && (info[1]>1) ) { 
	  lp[2]=2.63e-06;    // 0.0016*0.0016;  //SigmaY2
	  lp[3]=0.0065;      // 0.08*0.08;   //SigmaZ2
	  lp[5]=-6.48e-05;
	}
	else {
	  lp[2]=4.80e-06;      // 0.00219*0.00219
	  lp[3]=0.0093;        // 0.0964*0.0964;
	  if (info[0]==1) {
	    lp[5]=-0.00014;
	  }
	  else { 
	    lp[2]=2.79e-06;    // 0.0017*0.0017; 
	    lp[3]=0.00935;     // 0.967*0.967;
	    lp[5]=-4.32e-05;
	  }
	}

	    AliITSRecPoint * cl2;
	      cl2 = new ((*clusters)[ncl]) AliITSRecPoint(milab,lp,info);
	      
	      cl2->SetChargeRatio(ratio);    	
	      cl2->SetType(5);
	      fgPairs[ip2*nn+in] =5;
	      if ((pos[ip2].GetNd()+neg[in].GetNd())>6){ //multi cluster
		cl2->SetType(6);
		fgPairs[ip2*nn+in] =6;
	      }
	    ncl++;
	  }
	  
	  cused1[ip]++;
	  cused1[ip2]++;
	  cused2[in]++;

	} // charge matching condition

      } // 2 Pside cross 1 Nside
    } // loop over Pside clusters
    
    
      
      //  
    for (Int_t jn=0;jn<nn;jn++){
      if (cused2[jn]) continue;
      Float_t xbest=1000,zbest=1000,qbest=0;
      // select "silber" cluster
      if ( cpositive[jn]==1 && cnegative[positivepair[10*jn]]==2){
	Int_t ip  = positivepair[10*jn];
	Int_t jn2 = negativepair[10*ip];
	if (jn2==jn) jn2 =  negativepair[10*ip+1];
	Float_t pcharge = neg[jn].GetQ()+neg[jn2].GetQ();
	//
	

	ratio = (pcharge-pos[ip].GetQ())/(pcharge+pos[ip].GetQ());
	if ( (TMath::Abs(ratio)<0.2) && (pcharge!=0) ) {

	  /*
	if ( (TMath::Abs(pcharge-pos[ip].GetQ())<30) &&  // charge matching 
	     (pcharge!=0) ) { // reject combinations of bad strips
	  */


	  //
	  // add first pair
	  //	if (!(cused1[ip]||cused2[jn])){
	  if ( (fgPairs[ip*nn+jn]==100) && (neg[jn].GetQ()) ) {  //
	    
	    Float_t yn=neg[jn].GetY(); 
	    Float_t yp=pos[ip].GetY();

	    Float_t xt, zt;
	    seg->GetPadCxz(yn, yp, xt, zt);
	    
	    xbest=xt; zbest=zt; 

	    qbest =neg[jn].GetQ();

	    {
	      Double_t loc[3]={xbest,0.,zbest},trk[3]={0.,0.,0.};
	      mT2L->MasterToLocal(loc,trk);
	      lp[0]=trk[1];
	      lp[1]=trk[2];
          }
	  
	  lp[4]=qbest;        //Q
	  for (Int_t ilab=0;ilab<10;ilab++) milab[ilab]=-2;
	  for (Int_t ilab=0;ilab<3;ilab++){
	    milab[ilab] = pos[ip].GetLabel(ilab);
	    milab[ilab+3] = neg[jn].GetLabel(ilab);
	  }
	  //
	  CheckLabels2(milab);
	  ratio = (pos[ip].GetQ()-neg[jn].GetQ())/(pos[ip].GetQ()+neg[jn].GetQ());
	  milab[3]=(((ip<<10) + jn)<<10) + idet; // pos|neg|det
	  Int_t info[3] = {pos[ip].GetNd(),neg[jn].GetNd(),fNlayer[fModule]};

	lp[2]=4.968e-06;     // 0.00223*0.00223;  //SigmaY2
	lp[3]=0.012;         // 0.110*0.110;  //SigmaZ2
	// out-of-diagonal element of covariance matrix
 	if( (info[0]==1) && (info[1]==1) ) lp[5]=-0.00012;
	else if ( (info[0]>1) && (info[1]>1) ) { 
	  lp[2]=2.63e-06;    // 0.0016*0.0016;  //SigmaY2
	  lp[3]=0.0065;      // 0.08*0.08;   //SigmaZ2
	  lp[5]=-6.48e-05;
	}
	else {
	  lp[2]=4.80e-06;      // 0.00219*0.00219
	  lp[3]=0.0093;        // 0.0964*0.0964;
	  if (info[0]==1) {
	    lp[5]=-0.00014;
	  }
	  else { 
	    lp[2]=2.79e-06;    // 0.0017*0.0017; 
	    lp[3]=0.00935;     // 0.967*0.967;
	    lp[5]=-4.32e-05;
	  }
	}

	  AliITSRecPoint * cl2;
	    cl2 = new ((*clusters)[ncl]) AliITSRecPoint(milab,lp,info);

	    cl2->SetChargeRatio(ratio);    	
	    cl2->SetType(7);
	    fgPairs[ip*nn+jn] =7;
	    if ((pos[ip].GetNd()+neg[jn].GetNd())>6){ //multi cluster
	      cl2->SetType(8);
	      fgPairs[ip*nn+jn]=8;
	    }
	  ncl++;
	}
	//
	// add second pair
	//	if (!(cused1[ip]||cused2[jn2])){
	if ( (fgPairs[ip*nn+jn2]==100)&&(neg[jn2].GetQ() ) ) {  //

	  Float_t yn=neg[jn2].GetY(); 
	  Double_t yp=pos[ip].GetY(); 

	  Float_t xt, zt;
	  seg->GetPadCxz(yn, yp, xt, zt);
	  
	  xbest=xt; zbest=zt; 

	  qbest =neg[jn2].GetQ();

          {
          Double_t loc[3]={xbest,0.,zbest},trk[3]={0.,0.,0.};
          mT2L->MasterToLocal(loc,trk);
          lp[0]=trk[1];
          lp[1]=trk[2];
          }

	  lp[4]=qbest;        //Q
	  for (Int_t ilab=0;ilab<10;ilab++) milab[ilab]=-2;
	  for (Int_t ilab=0;ilab<3;ilab++){
	    milab[ilab] = pos[ip].GetLabel(ilab);
	    milab[ilab+3] = neg[jn2].GetLabel(ilab);
	  }
	  //
	  CheckLabels2(milab);
	  ratio = (pos[ip].GetQ()-neg[jn2].GetQ())/(pos[ip].GetQ()+neg[jn2].GetQ());
	  milab[3]=(((ip<<10) + jn2)<<10) + idet; // pos|neg|det
	  Int_t info[3] = {pos[ip].GetNd(),neg[jn2].GetNd(),fNlayer[fModule]};

	lp[2]=4.968e-06;     // 0.00223*0.00223;  //SigmaY2
	lp[3]=0.012;         // 0.110*0.110;  //SigmaZ2
	// out-of-diagonal element of covariance matrix
 	if( (info[0]==1) && (info[1]==1) ) lp[5]=-0.00012;
	else if ( (info[0]>1) && (info[1]>1) ) { 
	  lp[2]=2.63e-06;    // 0.0016*0.0016;  //SigmaY2
	  lp[3]=0.0065;      // 0.08*0.08;   //SigmaZ2
	  lp[5]=-6.48e-05;
	}
	else {
	  lp[2]=4.80e-06;      // 0.00219*0.00219
	  lp[3]=0.0093;        // 0.0964*0.0964;
	  if (info[0]==1) {
	    lp[5]=-0.00014;
	  }
	  else { 
	    lp[2]=2.79e-06;    // 0.0017*0.0017; 
	    lp[3]=0.00935;     // 0.967*0.967;
	    lp[5]=-4.32e-05;
	  }
	}

	  AliITSRecPoint * cl2;
	    cl2 = new ((*clusters)[ncl]) AliITSRecPoint(milab,lp,info);


	    cl2->SetChargeRatio(ratio);    	
	    fgPairs[ip*nn+jn2]=7;
	    cl2->SetType(7);
	    if ((pos[ip].GetNd()+neg[jn2].GetNd())>6){ //multi cluster
	      cl2->SetType(8);
	      fgPairs[ip*nn+jn2]=8;
	    }
	  ncl++;
	}
	cused1[ip]++;
	cused2[jn]++;
	cused2[jn2]++;

	} // charge matching condition

      } // 2 Nside cross 1 Pside
    } // loop over Pside clusters

  
    
    for (Int_t ip=0;ip<np;ip++){

      if(cused1[ip]) continue;


      Float_t xbest=1000,zbest=1000,qbest=0;
      //
      // 2x2 clusters
      //
      if ( (cnegative[ip]==2) && cpositive[negativepair[10*ip]]==2){ 
	Float_t minchargediff =4.;
	//	Float_t minchargeratio =0.2;

	Int_t j=-1;
	for (Int_t di=0;di<cnegative[ip];di++){
	  Int_t   jc = negativepair[ip*10+di];
	  Float_t chargedif = pos[ip].GetQ()-neg[jc].GetQ();
	  ratio = (pos[ip].GetQ()-neg[jc].GetQ())/(pos[ip].GetQ()+neg[jc].GetQ()); 
	  //if (TMath::Abs(chargedif)<minchargediff){
	  if (TMath::Abs(ratio)<0.2){
	    j =jc;
	    minchargediff = TMath::Abs(chargedif);
	    //	    minchargeratio = TMath::Abs(ratio);
	  }
	}
	if (j<0) continue;  // not proper cluster      
	

	Int_t count =0;
	for (Int_t di=0;di<cnegative[ip];di++){
	  Int_t   jc = negativepair[ip*10+di];
	  Float_t chargedif = pos[ip].GetQ()-neg[jc].GetQ();
	  if (TMath::Abs(chargedif)<minchargediff+3.) count++;
	}
	if (count>1) continue;  // more than one "proper" cluster for positive
	//
	
	count =0;
	for (Int_t dj=0;dj<cpositive[j];dj++){
	  Int_t   ic  = positivepair[j*10+dj];
	  Float_t chargedif = pos[ic].GetQ()-neg[j].GetQ();
	  if (TMath::Abs(chargedif)<minchargediff+3.) count++;
	}
	if (count>1) continue;  // more than one "proper" cluster for negative
	
	Int_t jp = 0;
	
	count =0;
	for (Int_t dj=0;dj<cnegative[jp];dj++){
	  Int_t   ic = positivepair[jp*10+dj];
	  Float_t chargedif = pos[ic].GetQ()-neg[jp].GetQ();
	  if (TMath::Abs(chargedif)<minchargediff+4.) count++;
	}
	if (count>1) continue;   
	if (fgPairs[ip*nn+j]<100) continue;
	//
	


	//almost gold clusters
	Float_t yp=pos[ip].GetY(); 
	Float_t yn=neg[j].GetY();      
	Float_t xt, zt;
	seg->GetPadCxz(yn, yp, xt, zt);	
	xbest=xt; zbest=zt; 
	qbest=0.5*(pos[ip].GetQ()+neg[j].GetQ());
	{
	  Double_t loc[3]={xbest,0.,zbest},trk[3]={0.,0.,0.};
	  mT2L->MasterToLocal(loc,trk);
	  lp[0]=trk[1];
	  lp[1]=trk[2];
	}
	lp[4]=qbest;        //Q
	for (Int_t ilab=0;ilab<10;ilab++) milab[ilab]=-2;
	for (Int_t ilab=0;ilab<3;ilab++){
	  milab[ilab] = pos[ip].GetLabel(ilab);
	  milab[ilab+3] = neg[j].GetLabel(ilab);
	}
	//
	CheckLabels2(milab);
        if ((neg[j].GetQ()==0)&&(pos[ip].GetQ()==0)) continue; // reject crosses of bad strips!!
	ratio = (pos[ip].GetQ()-neg[j].GetQ())/(pos[ip].GetQ()+neg[j].GetQ());
	milab[3]=(((ip<<10) + j)<<10) + idet; // pos|neg|det
	Int_t info[3] = {pos[ip].GetNd(),neg[j].GetNd(),fNlayer[fModule]};

	lp[2]=4.968e-06;     // 0.00223*0.00223;  //SigmaY2
	lp[3]=0.012;         // 0.110*0.110;  //SigmaZ2
	// out-of-diagonal element of covariance matrix
 	if( (info[0]==1) && (info[1]==1) ) lp[5]=-0.00012;
	else if ( (info[0]>1) && (info[1]>1) ) { 
	  lp[2]=2.63e-06;    // 0.0016*0.0016;  //SigmaY2
	  lp[3]=0.0065;      // 0.08*0.08;   //SigmaZ2
	  lp[5]=-6.48e-05;
	}
	else {
	  lp[2]=4.80e-06;      // 0.00219*0.00219
	  lp[3]=0.0093;        // 0.0964*0.0964;
	  if (info[0]==1) {
	    lp[5]=-0.00014;
	  }
	  else { 
	    lp[2]=2.79e-06;    // 0.0017*0.0017; 
	    lp[3]=0.00935;     // 0.967*0.967;
	    lp[5]=-4.32e-05;
	  }
	}

	AliITSRecPoint * cl2;
	  cl2 = new ((*clusters)[ncl]) AliITSRecPoint(milab,lp,info);
	  	  
	  cl2->SetChargeRatio(ratio);    	
	  cl2->SetType(10);
	  fgPairs[ip*nn+j]=10;
	  if ((pos[ip].GetNd()+neg[j].GetNd())>6){ //multi cluster
	    cl2->SetType(11);
	    fgPairs[ip*nn+j]=11;
	  }
	  cused1[ip]++;
	  cused2[j]++;      
	ncl++;
	
      } // 2X2
    } // loop over Pside 1Dclusters



    for (Int_t ip=0;ip<np;ip++){

      if(cused1[ip]) continue;


      Float_t xbest=1000,zbest=1000,qbest=0;
      //
      // manyxmany clusters
      //
      if ( (cnegative[ip]<5) && cpositive[negativepair[10*ip]]<5){ 
	Float_t minchargediff =4.;
	Int_t j=-1;
	for (Int_t di=0;di<cnegative[ip];di++){
	  Int_t   jc = negativepair[ip*10+di];
	  Float_t chargedif = pos[ip].GetQ()-neg[jc].GetQ();
	  if (TMath::Abs(chargedif)<minchargediff){
	    j =jc;
	    minchargediff = TMath::Abs(chargedif);
	  }
	}
	if (j<0) continue;  // not proper cluster      
	
	Int_t count =0;
	for (Int_t di=0;di<cnegative[ip];di++){
	  Int_t   jc = negativepair[ip*10+di];
	  Float_t chargedif = pos[ip].GetQ()-neg[jc].GetQ();
	  if (TMath::Abs(chargedif)<minchargediff+3.) count++;
	}
	if (count>1) continue;  // more than one "proper" cluster for positive
	//
	
	count =0;
	for (Int_t dj=0;dj<cpositive[j];dj++){
	  Int_t   ic  = positivepair[j*10+dj];
	  Float_t chargedif = pos[ic].GetQ()-neg[j].GetQ();
	  if (TMath::Abs(chargedif)<minchargediff+3.) count++;
	}
	if (count>1) continue;  // more than one "proper" cluster for negative
	
	Int_t jp = 0;
	
	count =0;
	for (Int_t dj=0;dj<cnegative[jp];dj++){
	  Int_t   ic = positivepair[jp*10+dj];
	  Float_t chargedif = pos[ic].GetQ()-neg[jp].GetQ();
	  if (TMath::Abs(chargedif)<minchargediff+4.) count++;
	}
	if (count>1) continue;   
	if (fgPairs[ip*nn+j]<100) continue;
	//
	
	//almost gold clusters
	Float_t yp=pos[ip].GetY(); 
	Float_t yn=neg[j].GetY();
      

	Float_t xt, zt;
	seg->GetPadCxz(yn, yp, xt, zt);
	
	xbest=xt; zbest=zt; 

	qbest=0.5*(pos[ip].GetQ()+neg[j].GetQ());

	{
	  Double_t loc[3]={xbest,0.,zbest},trk[3]={0.,0.,0.};
	  mT2L->MasterToLocal(loc,trk);
	  lp[0]=trk[1];
	  lp[1]=trk[2];
	}
	lp[4]=qbest;        //Q
	for (Int_t ilab=0;ilab<10;ilab++) milab[ilab]=-2;
	for (Int_t ilab=0;ilab<3;ilab++){
	  milab[ilab] = pos[ip].GetLabel(ilab);
	  milab[ilab+3] = neg[j].GetLabel(ilab);
	}
	//
	CheckLabels2(milab);
        if ((neg[j].GetQ()==0)&&(pos[ip].GetQ()==0)) continue; // reject crosses of bad strips!!
	ratio = (pos[ip].GetQ()-neg[j].GetQ())/(pos[ip].GetQ()+neg[j].GetQ());
	milab[3]=(((ip<<10) + j)<<10) + idet; // pos|neg|det
	Int_t info[3] = {pos[ip].GetNd(),neg[j].GetNd(),fNlayer[fModule]};

	lp[2]=4.968e-06;     // 0.00223*0.00223;  //SigmaY2
	lp[3]=0.012;         // 0.110*0.110;  //SigmaZ2
	// out-of-diagonal element of covariance matrix
 	if( (info[0]==1) && (info[1]==1) ) lp[5]=-0.00012;
	else if ( (info[0]>1) && (info[1]>1) ) { 
	  lp[2]=2.63e-06;    // 0.0016*0.0016;  //SigmaY2
	  lp[3]=0.0065;      // 0.08*0.08;   //SigmaZ2
	  lp[5]=-6.48e-05;
	}
	else {
	  lp[2]=4.80e-06;      // 0.00219*0.00219
	  lp[3]=0.0093;        // 0.0964*0.0964;
	  if (info[0]==1) {
	    lp[5]=-0.00014;
	  }
	  else { 
	    lp[2]=2.79e-06;    // 0.0017*0.0017; 
	    lp[3]=0.00935;     // 0.967*0.967;
	    lp[5]=-4.32e-05;
	  }
	}
	// 
	if (fRawID2ClusID) { // set rawID <-> clusterID correspondence for embedding
	  const int kMaxRefRW = 200;
	  UInt_t nrefsRW,refsRW[kMaxRefRW];
	  nrefsRW = fRawIDRef[0].GetReferences(j,refsRW,kMaxRefRW); // n-side
	  for (int ir=nrefsRW;ir--;) {
	    int rwid = (int)refsRW[ir];
	    if (fRawID2ClusID->GetSize()<=rwid) fRawID2ClusID->Set( (rwid+10)<<1 );
	    (*fRawID2ClusID)[rwid] = fNClusters+1; // RS: store clID+1 as a reference to the cluster
	  }
	  //
	  nrefsRW = fRawIDRef[1].GetReferences(ip,refsRW,kMaxRefRW); // p-side
	  for (int ir=nrefsRW;ir--;) {
	    int rwid = (int)refsRW[ir];
	    if (fRawID2ClusID->GetSize()<=rwid) fRawID2ClusID->Set( (rwid+10)<<1 );
	    (*fRawID2ClusID)[rwid] = fNClusters+1; // RS: store clID+1 as a reference to the cluster
	  }
	  //
	  milab[0] = fNClusters+1;  // RS: assign id as cluster label
	}

	AliITSRecPoint * cl2;
	  cl2 = new ((*clusters)[ncl]) AliITSRecPoint(milab,lp,info);
	  	  
	  cl2->SetChargeRatio(ratio);    	
	  cl2->SetType(12);
	  fgPairs[ip*nn+j]=12;
	  if ((pos[ip].GetNd()+neg[j].GetNd())>6){ //multi cluster
	    cl2->SetType(13);
	    fgPairs[ip*nn+j]=13;
	  }
	  cused1[ip]++;
	  cused2[j]++;      
	  ncl++;
	  fNClusters++;
	
      } // manyXmany
    } // loop over Pside 1Dclusters
    
  } // use charge matching
  
  
  // recover all the other crosses
  //  
  for (Int_t i=0; i<np; i++) {
    Float_t xbest=1000,zbest=1000,qbest=0;
    Float_t yp=pos[i].GetY(); 
    if ((pos[i].GetQ()>0)&&(pos[i].GetQ()<3)) continue;
    for (Int_t j=0; j<nn; j++) {
    //    for (Int_t di = 0;di<cpositive[i];di++){
    //  Int_t j = negativepair[10*i+di];
      if ((neg[j].GetQ()>0)&&(neg[j].GetQ()<3)) continue;

      if ((neg[j].GetQ()==0)&&(pos[i].GetQ()==0)) continue; // reject crosses of bad strips!!

      if (cused2[j]||cused1[i]) continue;      
      if (fgPairs[i*nn+j]>0 &&fgPairs[i*nn+j]<100) continue;
      ratio = (pos[i].GetQ()-neg[j].GetQ())/(pos[i].GetQ()+neg[j].GetQ());      
      Float_t yn=neg[j].GetY();
      
      Float_t xt, zt;
      seg->GetPadCxz(yn, yp, xt, zt);
      
      if (TMath::Abs(xt)<hwSSD)
      if (TMath::Abs(zt)<hlSSD) {
	xbest=xt; zbest=zt; 

        qbest=0.5*(pos[i].GetQ()+neg[j].GetQ());

        {
        Double_t loc[3]={xbest,0.,zbest},trk[3]={0.,0.,0.};
        mT2L->MasterToLocal(loc,trk);
        lp[0]=trk[1];
        lp[1]=trk[2];
        }
        lp[4]=qbest;        //Q
	for (Int_t ilab=0;ilab<10;ilab++) milab[ilab]=-2;
	for (Int_t ilab=0;ilab<3;ilab++){
	  milab[ilab] = pos[i].GetLabel(ilab);
	  milab[ilab+3] = neg[j].GetLabel(ilab);
	}
	//
	CheckLabels2(milab);
	milab[3]=(((i<<10) + j)<<10) + idet; // pos|neg|det
	Int_t info[3] = {pos[i].GetNd(),neg[j].GetNd(),fNlayer[fModule]};

	lp[2]=4.968e-06;     // 0.00223*0.00223;  //SigmaY2
	lp[3]=0.012;         // 0.110*0.110;  //SigmaZ2
	// out-of-diagonal element of covariance matrix
 	if( (info[0]==1) && (info[1]==1) ) lp[5]=-0.00012;
	else if ( (info[0]>1) && (info[1]>1) ) { 
	  lp[2]=2.63e-06;    // 0.0016*0.0016;  //SigmaY2
	  lp[3]=0.0065;      // 0.08*0.08;   //SigmaZ2
	  lp[5]=-6.48e-05;
	}
	else {
	  lp[2]=4.80e-06;      // 0.00219*0.00219
	  lp[3]=0.0093;        // 0.0964*0.0964;
	  if (info[0]==1) {
	    lp[5]=-0.00014;
	  }
	  else { 
	    lp[2]=2.79e-06;    // 0.0017*0.0017; 
	    lp[3]=0.00935;     // 0.967*0.967;
	    lp[5]=-4.32e-05;
	  }
	}

	AliITSRecPoint * cl2;
	  cl2 = new ((*clusters)[ncl]) AliITSRecPoint(milab,lp,info);

	  cl2->SetChargeRatio(ratio);
	  cl2->SetType(100+cpositive[j]+cnegative[i]);	  

	  if(pos[i].GetQ()==0) cl2->SetType(200+cpositive[j]+cnegative[i]);
	  if(neg[j].GetQ()==0) cl2->SetType(300+cpositive[j]+cnegative[i]);
      	ncl++;
      }
    }
  }



  if(repa->GetUseBadChannelsInClusterFinderSSD()==kTRUE) {
    
    //---------------------------------------------------------
    // recover crosses of good 1D clusters with bad strips on the other side
    // Note1: at first iteration skip modules with a bad side (or almost), (would produce too many fake!) 
    // Note2: for modules with a bad side see below 
    
    AliITSCalibrationSSD* cal = (AliITSCalibrationSSD*)GetResp(fModule);
    Int_t countPbad=0, countNbad=0;
    for(Int_t ib=0; ib<768; ib++) {
      if(cal->IsPChannelBad(ib)) countPbad++;
      if(cal->IsNChannelBad(ib)) countNbad++;
    }
    //  AliInfo(Form("module %d has %d P- and %d N-bad strips",fModule,countPbad,countNbad));
    
    if( (countPbad<100) && (countNbad<100) ) { // no bad side!!
      
      for (Int_t i=0; i<np; i++) { // loop over Nside 1Dclusters with no crosses
	if(cnegative[i]) continue; // if intersecting Pside clusters continue;
	
	//      for(Int_t ib=0; ib<768; ib++) { // loop over all Pstrips
	for(Int_t ib=15; ib<753; ib++) { // loop over all Pstrips
	  
	  if(cal->IsPChannelBad(ib)) { // check if strips is bad
	    Float_t yN=pos[i].GetY();	
	    Float_t xt, zt;
	    seg->GetPadCxz(1.*ib, yN, xt, zt);	
	    
	    //----------
	    // bad Pstrip is crossing the Nside 1Dcluster -> create recpoint
	    // 
	    if ( (TMath::Abs(xt)<hwSSD) && (TMath::Abs(zt)<hlSSD) ) {
	      Double_t loc[3]={xt,0.,zt},trk[3]={0.,0.,0.};
	      mT2L->MasterToLocal(loc,trk);
	      lp[0]=trk[1];
	      lp[1]=trk[2];        
	      lp[4]=pos[i].GetQ(); //Q
	      for (Int_t ilab=0;ilab<10;ilab++) milab[ilab]=-2;
	      for (Int_t ilab=0;ilab<3;ilab++) milab[ilab] = pos[i].GetLabel(ilab);	  
	      CheckLabels2(milab);
	      milab[3]=( (i<<10) << 10 ) + idet; // pos|neg|det
	      Int_t info[3] = {pos[i].GetNd(),0,fNlayer[fModule]};
	      
	      lp[2]=4.968e-06;     // 0.00223*0.00223;  //SigmaY2
	      lp[3]=0.012;         // 0.110*0.110;  //SigmaZ2
	      lp[5]=-0.00012; // out-of-diagonal element of covariance matrix
	      if (info[0]>1) {
		lp[2]=4.80e-06;
		lp[3]=0.0093;
		lp[5]=0.00014;
	      }
	      	      
	      AliITSRecPoint * cl2;
		cl2 = new ((*clusters)[ncl]) AliITSRecPoint(milab,lp,info);	    
		cl2->SetChargeRatio(1.);
	      cl2->SetType(50);	  
	      ncl++;
	    } // cross is within the detector
	    //
	    //--------------
	    
	  } // bad Pstrip
	  
	} // end loop over Pstrips
	
      } // end loop over Nside 1D clusters
      
      for (Int_t j=0; j<nn; j++) { // loop over Pside 1D clusters with no crosses
	if(cpositive[j]) continue;
	
	//      for(Int_t ib=0; ib<768; ib++) { // loop over all Nside strips
	for(Int_t ib=15; ib<753; ib++) { // loop over all Nside strips
	  
	  if(cal->IsNChannelBad(ib)) { // check if strip is bad
	    Float_t yP=neg[j].GetY();	
	    Float_t xt, zt;
	    seg->GetPadCxz(yP, 1.*ib, xt, zt);	
	    
	    //----------
	    // bad Nstrip is crossing the Pside 1Dcluster -> create recpoint
	    // 
	    if ( (TMath::Abs(xt)<hwSSD) && (TMath::Abs(zt)<hlSSD) ) {
	      Double_t loc[3]={xt,0.,zt},trk[3]={0.,0.,0.};
	      mT2L->MasterToLocal(loc,trk);
	      lp[0]=trk[1];
	      lp[1]=trk[2];        
	      lp[4]=neg[j].GetQ(); //Q
	      for (Int_t ilab=0;ilab<10;ilab++) milab[ilab]=-2;
	      for (Int_t ilab=0;ilab<3;ilab++) milab[ilab] = neg[j].GetLabel(ilab);	  
	      CheckLabels2(milab);
	      milab[3]=( j << 10 ) + idet; // pos|neg|det
	      Int_t info[3]={0,(Int_t)neg[j].GetNd(),fNlayer[fModule]};
	      
	      lp[2]=4.968e-06;     // 0.00223*0.00223;  //SigmaY2
	      lp[3]=0.012;         // 0.110*0.110;  //SigmaZ2
	      lp[5]=-0.00012; // out-of-diagonal element of covariance matrix
	      if (info[0]>1) {
		lp[2]=2.79e-06;
		lp[3]=0.00935;
		lp[5]=-4.32e-05;
	      }
	      
	      AliITSRecPoint * cl2;
		cl2 = new ((*clusters)[ncl]) AliITSRecPoint(milab,lp,info);	    
		cl2->SetChargeRatio(1.);
		cl2->SetType(60);	  
	      ncl++;
	    } // cross is within the detector
	    //
	    //--------------
	    
	  } // bad Nstrip
	} // end loop over Nstrips
      } // end loop over Pside 1D clusters
      
    } // no bad sides 
    
    //---------------------------------------------------------
    
    else if( (countPbad>700) && (countNbad<100) ) { // bad Pside!!
      
      for (Int_t i=0; i<np; i++) { // loop over Nside 1Dclusters with no crosses
	if(cnegative[i]) continue; // if intersecting Pside clusters continue;
	
	Float_t xt, zt;
	Float_t yN=pos[i].GetY();	
	Float_t yP=0.;
	if (seg->GetLayer()==5) yP = yN + (7.6/1.9);
	else yP = yN - (7.6/1.9);
	seg->GetPadCxz(yP, yN, xt, zt);	
	
	if ( (TMath::Abs(xt)<hwSSD) && (TMath::Abs(zt)<hlSSD) ) {
	  Double_t loc[3]={xt,0.,zt},trk[3]={0.,0.,0.};
	  mT2L->MasterToLocal(loc,trk);
	  lp[0]=trk[1];
	  lp[1]=trk[2];        
	  lp[4]=pos[i].GetQ(); //Q
	  for (Int_t ilab=0;ilab<10;ilab++) milab[ilab]=-2;
	  for (Int_t ilab=0;ilab<3;ilab++) milab[ilab] = pos[i].GetLabel(ilab);	  
	  CheckLabels2(milab);
	  milab[3]=( (i<<10) << 10 ) + idet; // pos|neg|det
	  Int_t info[3] = {(Int_t)pos[i].GetNd(),0,fNlayer[fModule]};
	  
	  lp[2]=0.00098;    // 0.031*0.031;  //SigmaY2
	  lp[3]=1.329;      // 1.15*1.15;  //SigmaZ2
	  lp[5]=-0.0359;
	  if(info[0]>1) lp[2]=0.00097;

	  AliITSRecPoint * cl2;
	    cl2 = new ((*clusters)[ncl]) AliITSRecPoint(milab,lp,info);	    
	    cl2->SetChargeRatio(1.);
	    cl2->SetType(70);	  
	  ncl++;
	} // cross is within the detector
	//
	//--------------
	
      } // end loop over Nside 1D clusters
      
    } // bad Pside module
    
    else if( (countNbad>700) && (countPbad<100) ) { // bad Nside!!
      
      for (Int_t j=0; j<nn; j++) { // loop over Pside 1D clusters with no crosses
	if(cpositive[j]) continue;
	
	Float_t xt, zt;
	Float_t yP=neg[j].GetY();	
	Float_t yN=0.;
	if (seg->GetLayer()==5) yN = yP - (7.6/1.9);
	else yN = yP + (7.6/1.9);
	seg->GetPadCxz(yP, yN, xt, zt);	
	
	if ( (TMath::Abs(xt)<hwSSD) && (TMath::Abs(zt)<hlSSD) ) {
	  Double_t loc[3]={xt,0.,zt},trk[3]={0.,0.,0.};
	  mT2L->MasterToLocal(loc,trk);
	  lp[0]=trk[1];
	  lp[1]=trk[2];        
	  lp[4]=neg[j].GetQ(); //Q
	  for (Int_t ilab=0;ilab<10;ilab++) milab[ilab]=-2;
	  for (Int_t ilab=0;ilab<3;ilab++) milab[ilab] = neg[j].GetLabel(ilab);	  
	  CheckLabels2(milab);
	  milab[3]=( j << 10 ) + idet; // pos|neg|det
	  Int_t info[3] = {0,(Int_t)neg[j].GetNd(),fNlayer[fModule]};
	  
	  lp[2]=7.27e-05;   // 0.0085*0.0085;  //SigmaY2
	  lp[3]=1.33;       // 1.15*1.15;  //SigmaZ2
	  lp[5]=0.00931;
	  if(info[1]>1) lp[2]=6.91e-05;
	  
	  AliITSRecPoint * cl2;
	    cl2 = new ((*clusters)[ncl]) AliITSRecPoint(milab,lp,info);	    
	    cl2->SetChargeRatio(1.);
	    cl2->SetType(80);	  
	  ncl++;
	} // cross is within the detector
	//
	//--------------
	
      } // end loop over Pside 1D clusters
      
    } // bad Nside module
    
    //---------------------------------------------------------
    
  } // use bad channels
    
  //cout<<ncl<<" clusters for this module"<<endl;

  delete [] cnegative;
  delete [] cused1;
  delete [] negativepair;
  delete [] cpositive;
  delete [] cused2;
  delete [] positivepair;

}
 AliITSClusterFinderV2SSD.cxx:1
 AliITSClusterFinderV2SSD.cxx:2
 AliITSClusterFinderV2SSD.cxx:3
 AliITSClusterFinderV2SSD.cxx:4
 AliITSClusterFinderV2SSD.cxx:5
 AliITSClusterFinderV2SSD.cxx:6
 AliITSClusterFinderV2SSD.cxx:7
 AliITSClusterFinderV2SSD.cxx:8
 AliITSClusterFinderV2SSD.cxx:9
 AliITSClusterFinderV2SSD.cxx:10
 AliITSClusterFinderV2SSD.cxx:11
 AliITSClusterFinderV2SSD.cxx:12
 AliITSClusterFinderV2SSD.cxx:13
 AliITSClusterFinderV2SSD.cxx:14
 AliITSClusterFinderV2SSD.cxx:15
 AliITSClusterFinderV2SSD.cxx:16
 AliITSClusterFinderV2SSD.cxx:17
 AliITSClusterFinderV2SSD.cxx:18
 AliITSClusterFinderV2SSD.cxx:19
 AliITSClusterFinderV2SSD.cxx:20
 AliITSClusterFinderV2SSD.cxx:21
 AliITSClusterFinderV2SSD.cxx:22
 AliITSClusterFinderV2SSD.cxx:23
 AliITSClusterFinderV2SSD.cxx:24
 AliITSClusterFinderV2SSD.cxx:25
 AliITSClusterFinderV2SSD.cxx:26
 AliITSClusterFinderV2SSD.cxx:27
 AliITSClusterFinderV2SSD.cxx:28
 AliITSClusterFinderV2SSD.cxx:29
 AliITSClusterFinderV2SSD.cxx:30
 AliITSClusterFinderV2SSD.cxx:31
 AliITSClusterFinderV2SSD.cxx:32
 AliITSClusterFinderV2SSD.cxx:33
 AliITSClusterFinderV2SSD.cxx:34
 AliITSClusterFinderV2SSD.cxx:35
 AliITSClusterFinderV2SSD.cxx:36
 AliITSClusterFinderV2SSD.cxx:37
 AliITSClusterFinderV2SSD.cxx:38
 AliITSClusterFinderV2SSD.cxx:39
 AliITSClusterFinderV2SSD.cxx:40
 AliITSClusterFinderV2SSD.cxx:41
 AliITSClusterFinderV2SSD.cxx:42
 AliITSClusterFinderV2SSD.cxx:43
 AliITSClusterFinderV2SSD.cxx:44
 AliITSClusterFinderV2SSD.cxx:45
 AliITSClusterFinderV2SSD.cxx:46
 AliITSClusterFinderV2SSD.cxx:47
 AliITSClusterFinderV2SSD.cxx:48
 AliITSClusterFinderV2SSD.cxx:49
 AliITSClusterFinderV2SSD.cxx:50
 AliITSClusterFinderV2SSD.cxx:51
 AliITSClusterFinderV2SSD.cxx:52
 AliITSClusterFinderV2SSD.cxx:53
 AliITSClusterFinderV2SSD.cxx:54
 AliITSClusterFinderV2SSD.cxx:55
 AliITSClusterFinderV2SSD.cxx:56
 AliITSClusterFinderV2SSD.cxx:57
 AliITSClusterFinderV2SSD.cxx:58
 AliITSClusterFinderV2SSD.cxx:59
 AliITSClusterFinderV2SSD.cxx:60
 AliITSClusterFinderV2SSD.cxx:61
 AliITSClusterFinderV2SSD.cxx:62
 AliITSClusterFinderV2SSD.cxx:63
 AliITSClusterFinderV2SSD.cxx:64
 AliITSClusterFinderV2SSD.cxx:65
 AliITSClusterFinderV2SSD.cxx:66
 AliITSClusterFinderV2SSD.cxx:67
 AliITSClusterFinderV2SSD.cxx:68
 AliITSClusterFinderV2SSD.cxx:69
 AliITSClusterFinderV2SSD.cxx:70
 AliITSClusterFinderV2SSD.cxx:71
 AliITSClusterFinderV2SSD.cxx:72
 AliITSClusterFinderV2SSD.cxx:73
 AliITSClusterFinderV2SSD.cxx:74
 AliITSClusterFinderV2SSD.cxx:75
 AliITSClusterFinderV2SSD.cxx:76
 AliITSClusterFinderV2SSD.cxx:77
 AliITSClusterFinderV2SSD.cxx:78
 AliITSClusterFinderV2SSD.cxx:79
 AliITSClusterFinderV2SSD.cxx:80
 AliITSClusterFinderV2SSD.cxx:81
 AliITSClusterFinderV2SSD.cxx:82
 AliITSClusterFinderV2SSD.cxx:83
 AliITSClusterFinderV2SSD.cxx:84
 AliITSClusterFinderV2SSD.cxx:85
 AliITSClusterFinderV2SSD.cxx:86
 AliITSClusterFinderV2SSD.cxx:87
 AliITSClusterFinderV2SSD.cxx:88
 AliITSClusterFinderV2SSD.cxx:89
 AliITSClusterFinderV2SSD.cxx:90
 AliITSClusterFinderV2SSD.cxx:91
 AliITSClusterFinderV2SSD.cxx:92
 AliITSClusterFinderV2SSD.cxx:93
 AliITSClusterFinderV2SSD.cxx:94
 AliITSClusterFinderV2SSD.cxx:95
 AliITSClusterFinderV2SSD.cxx:96
 AliITSClusterFinderV2SSD.cxx:97
 AliITSClusterFinderV2SSD.cxx:98
 AliITSClusterFinderV2SSD.cxx:99
 AliITSClusterFinderV2SSD.cxx:100
 AliITSClusterFinderV2SSD.cxx:101
 AliITSClusterFinderV2SSD.cxx:102
 AliITSClusterFinderV2SSD.cxx:103
 AliITSClusterFinderV2SSD.cxx:104
 AliITSClusterFinderV2SSD.cxx:105
 AliITSClusterFinderV2SSD.cxx:106
 AliITSClusterFinderV2SSD.cxx:107
 AliITSClusterFinderV2SSD.cxx:108
 AliITSClusterFinderV2SSD.cxx:109
 AliITSClusterFinderV2SSD.cxx:110
 AliITSClusterFinderV2SSD.cxx:111
 AliITSClusterFinderV2SSD.cxx:112
 AliITSClusterFinderV2SSD.cxx:113
 AliITSClusterFinderV2SSD.cxx:114
 AliITSClusterFinderV2SSD.cxx:115
 AliITSClusterFinderV2SSD.cxx:116
 AliITSClusterFinderV2SSD.cxx:117
 AliITSClusterFinderV2SSD.cxx:118
 AliITSClusterFinderV2SSD.cxx:119
 AliITSClusterFinderV2SSD.cxx:120
 AliITSClusterFinderV2SSD.cxx:121
 AliITSClusterFinderV2SSD.cxx:122
 AliITSClusterFinderV2SSD.cxx:123
 AliITSClusterFinderV2SSD.cxx:124
 AliITSClusterFinderV2SSD.cxx:125
 AliITSClusterFinderV2SSD.cxx:126
 AliITSClusterFinderV2SSD.cxx:127
 AliITSClusterFinderV2SSD.cxx:128
 AliITSClusterFinderV2SSD.cxx:129
 AliITSClusterFinderV2SSD.cxx:130
 AliITSClusterFinderV2SSD.cxx:131
 AliITSClusterFinderV2SSD.cxx:132
 AliITSClusterFinderV2SSD.cxx:133
 AliITSClusterFinderV2SSD.cxx:134
 AliITSClusterFinderV2SSD.cxx:135
 AliITSClusterFinderV2SSD.cxx:136
 AliITSClusterFinderV2SSD.cxx:137
 AliITSClusterFinderV2SSD.cxx:138
 AliITSClusterFinderV2SSD.cxx:139
 AliITSClusterFinderV2SSD.cxx:140
 AliITSClusterFinderV2SSD.cxx:141
 AliITSClusterFinderV2SSD.cxx:142
 AliITSClusterFinderV2SSD.cxx:143
 AliITSClusterFinderV2SSD.cxx:144
 AliITSClusterFinderV2SSD.cxx:145
 AliITSClusterFinderV2SSD.cxx:146
 AliITSClusterFinderV2SSD.cxx:147
 AliITSClusterFinderV2SSD.cxx:148
 AliITSClusterFinderV2SSD.cxx:149
 AliITSClusterFinderV2SSD.cxx:150
 AliITSClusterFinderV2SSD.cxx:151
 AliITSClusterFinderV2SSD.cxx:152
 AliITSClusterFinderV2SSD.cxx:153
 AliITSClusterFinderV2SSD.cxx:154
 AliITSClusterFinderV2SSD.cxx:155
 AliITSClusterFinderV2SSD.cxx:156
 AliITSClusterFinderV2SSD.cxx:157
 AliITSClusterFinderV2SSD.cxx:158
 AliITSClusterFinderV2SSD.cxx:159
 AliITSClusterFinderV2SSD.cxx:160
 AliITSClusterFinderV2SSD.cxx:161
 AliITSClusterFinderV2SSD.cxx:162
 AliITSClusterFinderV2SSD.cxx:163
 AliITSClusterFinderV2SSD.cxx:164
 AliITSClusterFinderV2SSD.cxx:165
 AliITSClusterFinderV2SSD.cxx:166
 AliITSClusterFinderV2SSD.cxx:167
 AliITSClusterFinderV2SSD.cxx:168
 AliITSClusterFinderV2SSD.cxx:169
 AliITSClusterFinderV2SSD.cxx:170
 AliITSClusterFinderV2SSD.cxx:171
 AliITSClusterFinderV2SSD.cxx:172
 AliITSClusterFinderV2SSD.cxx:173
 AliITSClusterFinderV2SSD.cxx:174
 AliITSClusterFinderV2SSD.cxx:175
 AliITSClusterFinderV2SSD.cxx:176
 AliITSClusterFinderV2SSD.cxx:177
 AliITSClusterFinderV2SSD.cxx:178
 AliITSClusterFinderV2SSD.cxx:179
 AliITSClusterFinderV2SSD.cxx:180
 AliITSClusterFinderV2SSD.cxx:181
 AliITSClusterFinderV2SSD.cxx:182
 AliITSClusterFinderV2SSD.cxx:183
 AliITSClusterFinderV2SSD.cxx:184
 AliITSClusterFinderV2SSD.cxx:185
 AliITSClusterFinderV2SSD.cxx:186
 AliITSClusterFinderV2SSD.cxx:187
 AliITSClusterFinderV2SSD.cxx:188
 AliITSClusterFinderV2SSD.cxx:189
 AliITSClusterFinderV2SSD.cxx:190
 AliITSClusterFinderV2SSD.cxx:191
 AliITSClusterFinderV2SSD.cxx:192
 AliITSClusterFinderV2SSD.cxx:193
 AliITSClusterFinderV2SSD.cxx:194
 AliITSClusterFinderV2SSD.cxx:195
 AliITSClusterFinderV2SSD.cxx:196
 AliITSClusterFinderV2SSD.cxx:197
 AliITSClusterFinderV2SSD.cxx:198
 AliITSClusterFinderV2SSD.cxx:199
 AliITSClusterFinderV2SSD.cxx:200
 AliITSClusterFinderV2SSD.cxx:201
 AliITSClusterFinderV2SSD.cxx:202
 AliITSClusterFinderV2SSD.cxx:203
 AliITSClusterFinderV2SSD.cxx:204
 AliITSClusterFinderV2SSD.cxx:205
 AliITSClusterFinderV2SSD.cxx:206
 AliITSClusterFinderV2SSD.cxx:207
 AliITSClusterFinderV2SSD.cxx:208
 AliITSClusterFinderV2SSD.cxx:209
 AliITSClusterFinderV2SSD.cxx:210
 AliITSClusterFinderV2SSD.cxx:211
 AliITSClusterFinderV2SSD.cxx:212
 AliITSClusterFinderV2SSD.cxx:213
 AliITSClusterFinderV2SSD.cxx:214
 AliITSClusterFinderV2SSD.cxx:215
 AliITSClusterFinderV2SSD.cxx:216
 AliITSClusterFinderV2SSD.cxx:217
 AliITSClusterFinderV2SSD.cxx:218
 AliITSClusterFinderV2SSD.cxx:219
 AliITSClusterFinderV2SSD.cxx:220
 AliITSClusterFinderV2SSD.cxx:221
 AliITSClusterFinderV2SSD.cxx:222
 AliITSClusterFinderV2SSD.cxx:223
 AliITSClusterFinderV2SSD.cxx:224
 AliITSClusterFinderV2SSD.cxx:225
 AliITSClusterFinderV2SSD.cxx:226
 AliITSClusterFinderV2SSD.cxx:227
 AliITSClusterFinderV2SSD.cxx:228
 AliITSClusterFinderV2SSD.cxx:229
 AliITSClusterFinderV2SSD.cxx:230
 AliITSClusterFinderV2SSD.cxx:231
 AliITSClusterFinderV2SSD.cxx:232
 AliITSClusterFinderV2SSD.cxx:233
 AliITSClusterFinderV2SSD.cxx:234
 AliITSClusterFinderV2SSD.cxx:235
 AliITSClusterFinderV2SSD.cxx:236
 AliITSClusterFinderV2SSD.cxx:237
 AliITSClusterFinderV2SSD.cxx:238
 AliITSClusterFinderV2SSD.cxx:239
 AliITSClusterFinderV2SSD.cxx:240
 AliITSClusterFinderV2SSD.cxx:241
 AliITSClusterFinderV2SSD.cxx:242
 AliITSClusterFinderV2SSD.cxx:243
 AliITSClusterFinderV2SSD.cxx:244
 AliITSClusterFinderV2SSD.cxx:245
 AliITSClusterFinderV2SSD.cxx:246
 AliITSClusterFinderV2SSD.cxx:247
 AliITSClusterFinderV2SSD.cxx:248
 AliITSClusterFinderV2SSD.cxx:249
 AliITSClusterFinderV2SSD.cxx:250
 AliITSClusterFinderV2SSD.cxx:251
 AliITSClusterFinderV2SSD.cxx:252
 AliITSClusterFinderV2SSD.cxx:253
 AliITSClusterFinderV2SSD.cxx:254
 AliITSClusterFinderV2SSD.cxx:255
 AliITSClusterFinderV2SSD.cxx:256
 AliITSClusterFinderV2SSD.cxx:257
 AliITSClusterFinderV2SSD.cxx:258
 AliITSClusterFinderV2SSD.cxx:259
 AliITSClusterFinderV2SSD.cxx:260
 AliITSClusterFinderV2SSD.cxx:261
 AliITSClusterFinderV2SSD.cxx:262
 AliITSClusterFinderV2SSD.cxx:263
 AliITSClusterFinderV2SSD.cxx:264
 AliITSClusterFinderV2SSD.cxx:265
 AliITSClusterFinderV2SSD.cxx:266
 AliITSClusterFinderV2SSD.cxx:267
 AliITSClusterFinderV2SSD.cxx:268
 AliITSClusterFinderV2SSD.cxx:269
 AliITSClusterFinderV2SSD.cxx:270
 AliITSClusterFinderV2SSD.cxx:271
 AliITSClusterFinderV2SSD.cxx:272
 AliITSClusterFinderV2SSD.cxx:273
 AliITSClusterFinderV2SSD.cxx:274
 AliITSClusterFinderV2SSD.cxx:275
 AliITSClusterFinderV2SSD.cxx:276
 AliITSClusterFinderV2SSD.cxx:277
 AliITSClusterFinderV2SSD.cxx:278
 AliITSClusterFinderV2SSD.cxx:279
 AliITSClusterFinderV2SSD.cxx:280
 AliITSClusterFinderV2SSD.cxx:281
 AliITSClusterFinderV2SSD.cxx:282
 AliITSClusterFinderV2SSD.cxx:283
 AliITSClusterFinderV2SSD.cxx:284
 AliITSClusterFinderV2SSD.cxx:285
 AliITSClusterFinderV2SSD.cxx:286
 AliITSClusterFinderV2SSD.cxx:287
 AliITSClusterFinderV2SSD.cxx:288
 AliITSClusterFinderV2SSD.cxx:289
 AliITSClusterFinderV2SSD.cxx:290
 AliITSClusterFinderV2SSD.cxx:291
 AliITSClusterFinderV2SSD.cxx:292
 AliITSClusterFinderV2SSD.cxx:293
 AliITSClusterFinderV2SSD.cxx:294
 AliITSClusterFinderV2SSD.cxx:295
 AliITSClusterFinderV2SSD.cxx:296
 AliITSClusterFinderV2SSD.cxx:297
 AliITSClusterFinderV2SSD.cxx:298
 AliITSClusterFinderV2SSD.cxx:299
 AliITSClusterFinderV2SSD.cxx:300
 AliITSClusterFinderV2SSD.cxx:301
 AliITSClusterFinderV2SSD.cxx:302
 AliITSClusterFinderV2SSD.cxx:303
 AliITSClusterFinderV2SSD.cxx:304
 AliITSClusterFinderV2SSD.cxx:305
 AliITSClusterFinderV2SSD.cxx:306
 AliITSClusterFinderV2SSD.cxx:307
 AliITSClusterFinderV2SSD.cxx:308
 AliITSClusterFinderV2SSD.cxx:309
 AliITSClusterFinderV2SSD.cxx:310
 AliITSClusterFinderV2SSD.cxx:311
 AliITSClusterFinderV2SSD.cxx:312
 AliITSClusterFinderV2SSD.cxx:313
 AliITSClusterFinderV2SSD.cxx:314
 AliITSClusterFinderV2SSD.cxx:315
 AliITSClusterFinderV2SSD.cxx:316
 AliITSClusterFinderV2SSD.cxx:317
 AliITSClusterFinderV2SSD.cxx:318
 AliITSClusterFinderV2SSD.cxx:319
 AliITSClusterFinderV2SSD.cxx:320
 AliITSClusterFinderV2SSD.cxx:321
 AliITSClusterFinderV2SSD.cxx:322
 AliITSClusterFinderV2SSD.cxx:323
 AliITSClusterFinderV2SSD.cxx:324
 AliITSClusterFinderV2SSD.cxx:325
 AliITSClusterFinderV2SSD.cxx:326
 AliITSClusterFinderV2SSD.cxx:327
 AliITSClusterFinderV2SSD.cxx:328
 AliITSClusterFinderV2SSD.cxx:329
 AliITSClusterFinderV2SSD.cxx:330
 AliITSClusterFinderV2SSD.cxx:331
 AliITSClusterFinderV2SSD.cxx:332
 AliITSClusterFinderV2SSD.cxx:333
 AliITSClusterFinderV2SSD.cxx:334
 AliITSClusterFinderV2SSD.cxx:335
 AliITSClusterFinderV2SSD.cxx:336
 AliITSClusterFinderV2SSD.cxx:337
 AliITSClusterFinderV2SSD.cxx:338
 AliITSClusterFinderV2SSD.cxx:339
 AliITSClusterFinderV2SSD.cxx:340
 AliITSClusterFinderV2SSD.cxx:341
 AliITSClusterFinderV2SSD.cxx:342
 AliITSClusterFinderV2SSD.cxx:343
 AliITSClusterFinderV2SSD.cxx:344
 AliITSClusterFinderV2SSD.cxx:345
 AliITSClusterFinderV2SSD.cxx:346
 AliITSClusterFinderV2SSD.cxx:347
 AliITSClusterFinderV2SSD.cxx:348
 AliITSClusterFinderV2SSD.cxx:349
 AliITSClusterFinderV2SSD.cxx:350
 AliITSClusterFinderV2SSD.cxx:351
 AliITSClusterFinderV2SSD.cxx:352
 AliITSClusterFinderV2SSD.cxx:353
 AliITSClusterFinderV2SSD.cxx:354
 AliITSClusterFinderV2SSD.cxx:355
 AliITSClusterFinderV2SSD.cxx:356
 AliITSClusterFinderV2SSD.cxx:357
 AliITSClusterFinderV2SSD.cxx:358
 AliITSClusterFinderV2SSD.cxx:359
 AliITSClusterFinderV2SSD.cxx:360
 AliITSClusterFinderV2SSD.cxx:361
 AliITSClusterFinderV2SSD.cxx:362
 AliITSClusterFinderV2SSD.cxx:363
 AliITSClusterFinderV2SSD.cxx:364
 AliITSClusterFinderV2SSD.cxx:365
 AliITSClusterFinderV2SSD.cxx:366
 AliITSClusterFinderV2SSD.cxx:367
 AliITSClusterFinderV2SSD.cxx:368
 AliITSClusterFinderV2SSD.cxx:369
 AliITSClusterFinderV2SSD.cxx:370
 AliITSClusterFinderV2SSD.cxx:371
 AliITSClusterFinderV2SSD.cxx:372
 AliITSClusterFinderV2SSD.cxx:373
 AliITSClusterFinderV2SSD.cxx:374
 AliITSClusterFinderV2SSD.cxx:375
 AliITSClusterFinderV2SSD.cxx:376
 AliITSClusterFinderV2SSD.cxx:377
 AliITSClusterFinderV2SSD.cxx:378
 AliITSClusterFinderV2SSD.cxx:379
 AliITSClusterFinderV2SSD.cxx:380
 AliITSClusterFinderV2SSD.cxx:381
 AliITSClusterFinderV2SSD.cxx:382
 AliITSClusterFinderV2SSD.cxx:383
 AliITSClusterFinderV2SSD.cxx:384
 AliITSClusterFinderV2SSD.cxx:385
 AliITSClusterFinderV2SSD.cxx:386
 AliITSClusterFinderV2SSD.cxx:387
 AliITSClusterFinderV2SSD.cxx:388
 AliITSClusterFinderV2SSD.cxx:389
 AliITSClusterFinderV2SSD.cxx:390
 AliITSClusterFinderV2SSD.cxx:391
 AliITSClusterFinderV2SSD.cxx:392
 AliITSClusterFinderV2SSD.cxx:393
 AliITSClusterFinderV2SSD.cxx:394
 AliITSClusterFinderV2SSD.cxx:395
 AliITSClusterFinderV2SSD.cxx:396
 AliITSClusterFinderV2SSD.cxx:397
 AliITSClusterFinderV2SSD.cxx:398
 AliITSClusterFinderV2SSD.cxx:399
 AliITSClusterFinderV2SSD.cxx:400
 AliITSClusterFinderV2SSD.cxx:401
 AliITSClusterFinderV2SSD.cxx:402
 AliITSClusterFinderV2SSD.cxx:403
 AliITSClusterFinderV2SSD.cxx:404
 AliITSClusterFinderV2SSD.cxx:405
 AliITSClusterFinderV2SSD.cxx:406
 AliITSClusterFinderV2SSD.cxx:407
 AliITSClusterFinderV2SSD.cxx:408
 AliITSClusterFinderV2SSD.cxx:409
 AliITSClusterFinderV2SSD.cxx:410
 AliITSClusterFinderV2SSD.cxx:411
 AliITSClusterFinderV2SSD.cxx:412
 AliITSClusterFinderV2SSD.cxx:413
 AliITSClusterFinderV2SSD.cxx:414
 AliITSClusterFinderV2SSD.cxx:415
 AliITSClusterFinderV2SSD.cxx:416
 AliITSClusterFinderV2SSD.cxx:417
 AliITSClusterFinderV2SSD.cxx:418
 AliITSClusterFinderV2SSD.cxx:419
 AliITSClusterFinderV2SSD.cxx:420
 AliITSClusterFinderV2SSD.cxx:421
 AliITSClusterFinderV2SSD.cxx:422
 AliITSClusterFinderV2SSD.cxx:423
 AliITSClusterFinderV2SSD.cxx:424
 AliITSClusterFinderV2SSD.cxx:425
 AliITSClusterFinderV2SSD.cxx:426
 AliITSClusterFinderV2SSD.cxx:427
 AliITSClusterFinderV2SSD.cxx:428
 AliITSClusterFinderV2SSD.cxx:429
 AliITSClusterFinderV2SSD.cxx:430
 AliITSClusterFinderV2SSD.cxx:431
 AliITSClusterFinderV2SSD.cxx:432
 AliITSClusterFinderV2SSD.cxx:433
 AliITSClusterFinderV2SSD.cxx:434
 AliITSClusterFinderV2SSD.cxx:435
 AliITSClusterFinderV2SSD.cxx:436
 AliITSClusterFinderV2SSD.cxx:437
 AliITSClusterFinderV2SSD.cxx:438
 AliITSClusterFinderV2SSD.cxx:439
 AliITSClusterFinderV2SSD.cxx:440
 AliITSClusterFinderV2SSD.cxx:441
 AliITSClusterFinderV2SSD.cxx:442
 AliITSClusterFinderV2SSD.cxx:443
 AliITSClusterFinderV2SSD.cxx:444
 AliITSClusterFinderV2SSD.cxx:445
 AliITSClusterFinderV2SSD.cxx:446
 AliITSClusterFinderV2SSD.cxx:447
 AliITSClusterFinderV2SSD.cxx:448
 AliITSClusterFinderV2SSD.cxx:449
 AliITSClusterFinderV2SSD.cxx:450
 AliITSClusterFinderV2SSD.cxx:451
 AliITSClusterFinderV2SSD.cxx:452
 AliITSClusterFinderV2SSD.cxx:453
 AliITSClusterFinderV2SSD.cxx:454
 AliITSClusterFinderV2SSD.cxx:455
 AliITSClusterFinderV2SSD.cxx:456
 AliITSClusterFinderV2SSD.cxx:457
 AliITSClusterFinderV2SSD.cxx:458
 AliITSClusterFinderV2SSD.cxx:459
 AliITSClusterFinderV2SSD.cxx:460
 AliITSClusterFinderV2SSD.cxx:461
 AliITSClusterFinderV2SSD.cxx:462
 AliITSClusterFinderV2SSD.cxx:463
 AliITSClusterFinderV2SSD.cxx:464
 AliITSClusterFinderV2SSD.cxx:465
 AliITSClusterFinderV2SSD.cxx:466
 AliITSClusterFinderV2SSD.cxx:467
 AliITSClusterFinderV2SSD.cxx:468
 AliITSClusterFinderV2SSD.cxx:469
 AliITSClusterFinderV2SSD.cxx:470
 AliITSClusterFinderV2SSD.cxx:471
 AliITSClusterFinderV2SSD.cxx:472
 AliITSClusterFinderV2SSD.cxx:473
 AliITSClusterFinderV2SSD.cxx:474
 AliITSClusterFinderV2SSD.cxx:475
 AliITSClusterFinderV2SSD.cxx:476
 AliITSClusterFinderV2SSD.cxx:477
 AliITSClusterFinderV2SSD.cxx:478
 AliITSClusterFinderV2SSD.cxx:479
 AliITSClusterFinderV2SSD.cxx:480
 AliITSClusterFinderV2SSD.cxx:481
 AliITSClusterFinderV2SSD.cxx:482
 AliITSClusterFinderV2SSD.cxx:483
 AliITSClusterFinderV2SSD.cxx:484
 AliITSClusterFinderV2SSD.cxx:485
 AliITSClusterFinderV2SSD.cxx:486
 AliITSClusterFinderV2SSD.cxx:487
 AliITSClusterFinderV2SSD.cxx:488
 AliITSClusterFinderV2SSD.cxx:489
 AliITSClusterFinderV2SSD.cxx:490
 AliITSClusterFinderV2SSD.cxx:491
 AliITSClusterFinderV2SSD.cxx:492
 AliITSClusterFinderV2SSD.cxx:493
 AliITSClusterFinderV2SSD.cxx:494
 AliITSClusterFinderV2SSD.cxx:495
 AliITSClusterFinderV2SSD.cxx:496
 AliITSClusterFinderV2SSD.cxx:497
 AliITSClusterFinderV2SSD.cxx:498
 AliITSClusterFinderV2SSD.cxx:499
 AliITSClusterFinderV2SSD.cxx:500
 AliITSClusterFinderV2SSD.cxx:501
 AliITSClusterFinderV2SSD.cxx:502
 AliITSClusterFinderV2SSD.cxx:503
 AliITSClusterFinderV2SSD.cxx:504
 AliITSClusterFinderV2SSD.cxx:505
 AliITSClusterFinderV2SSD.cxx:506
 AliITSClusterFinderV2SSD.cxx:507
 AliITSClusterFinderV2SSD.cxx:508
 AliITSClusterFinderV2SSD.cxx:509
 AliITSClusterFinderV2SSD.cxx:510
 AliITSClusterFinderV2SSD.cxx:511
 AliITSClusterFinderV2SSD.cxx:512
 AliITSClusterFinderV2SSD.cxx:513
 AliITSClusterFinderV2SSD.cxx:514
 AliITSClusterFinderV2SSD.cxx:515
 AliITSClusterFinderV2SSD.cxx:516
 AliITSClusterFinderV2SSD.cxx:517
 AliITSClusterFinderV2SSD.cxx:518
 AliITSClusterFinderV2SSD.cxx:519
 AliITSClusterFinderV2SSD.cxx:520
 AliITSClusterFinderV2SSD.cxx:521
 AliITSClusterFinderV2SSD.cxx:522
 AliITSClusterFinderV2SSD.cxx:523
 AliITSClusterFinderV2SSD.cxx:524
 AliITSClusterFinderV2SSD.cxx:525
 AliITSClusterFinderV2SSD.cxx:526
 AliITSClusterFinderV2SSD.cxx:527
 AliITSClusterFinderV2SSD.cxx:528
 AliITSClusterFinderV2SSD.cxx:529
 AliITSClusterFinderV2SSD.cxx:530
 AliITSClusterFinderV2SSD.cxx:531
 AliITSClusterFinderV2SSD.cxx:532
 AliITSClusterFinderV2SSD.cxx:533
 AliITSClusterFinderV2SSD.cxx:534
 AliITSClusterFinderV2SSD.cxx:535
 AliITSClusterFinderV2SSD.cxx:536
 AliITSClusterFinderV2SSD.cxx:537
 AliITSClusterFinderV2SSD.cxx:538
 AliITSClusterFinderV2SSD.cxx:539
 AliITSClusterFinderV2SSD.cxx:540
 AliITSClusterFinderV2SSD.cxx:541
 AliITSClusterFinderV2SSD.cxx:542
 AliITSClusterFinderV2SSD.cxx:543
 AliITSClusterFinderV2SSD.cxx:544
 AliITSClusterFinderV2SSD.cxx:545
 AliITSClusterFinderV2SSD.cxx:546
 AliITSClusterFinderV2SSD.cxx:547
 AliITSClusterFinderV2SSD.cxx:548
 AliITSClusterFinderV2SSD.cxx:549
 AliITSClusterFinderV2SSD.cxx:550
 AliITSClusterFinderV2SSD.cxx:551
 AliITSClusterFinderV2SSD.cxx:552
 AliITSClusterFinderV2SSD.cxx:553
 AliITSClusterFinderV2SSD.cxx:554
 AliITSClusterFinderV2SSD.cxx:555
 AliITSClusterFinderV2SSD.cxx:556
 AliITSClusterFinderV2SSD.cxx:557
 AliITSClusterFinderV2SSD.cxx:558
 AliITSClusterFinderV2SSD.cxx:559
 AliITSClusterFinderV2SSD.cxx:560
 AliITSClusterFinderV2SSD.cxx:561
 AliITSClusterFinderV2SSD.cxx:562
 AliITSClusterFinderV2SSD.cxx:563
 AliITSClusterFinderV2SSD.cxx:564
 AliITSClusterFinderV2SSD.cxx:565
 AliITSClusterFinderV2SSD.cxx:566
 AliITSClusterFinderV2SSD.cxx:567
 AliITSClusterFinderV2SSD.cxx:568
 AliITSClusterFinderV2SSD.cxx:569
 AliITSClusterFinderV2SSD.cxx:570
 AliITSClusterFinderV2SSD.cxx:571
 AliITSClusterFinderV2SSD.cxx:572
 AliITSClusterFinderV2SSD.cxx:573
 AliITSClusterFinderV2SSD.cxx:574
 AliITSClusterFinderV2SSD.cxx:575
 AliITSClusterFinderV2SSD.cxx:576
 AliITSClusterFinderV2SSD.cxx:577
 AliITSClusterFinderV2SSD.cxx:578
 AliITSClusterFinderV2SSD.cxx:579
 AliITSClusterFinderV2SSD.cxx:580
 AliITSClusterFinderV2SSD.cxx:581
 AliITSClusterFinderV2SSD.cxx:582
 AliITSClusterFinderV2SSD.cxx:583
 AliITSClusterFinderV2SSD.cxx:584
 AliITSClusterFinderV2SSD.cxx:585
 AliITSClusterFinderV2SSD.cxx:586
 AliITSClusterFinderV2SSD.cxx:587
 AliITSClusterFinderV2SSD.cxx:588
 AliITSClusterFinderV2SSD.cxx:589
 AliITSClusterFinderV2SSD.cxx:590
 AliITSClusterFinderV2SSD.cxx:591
 AliITSClusterFinderV2SSD.cxx:592
 AliITSClusterFinderV2SSD.cxx:593
 AliITSClusterFinderV2SSD.cxx:594
 AliITSClusterFinderV2SSD.cxx:595
 AliITSClusterFinderV2SSD.cxx:596
 AliITSClusterFinderV2SSD.cxx:597
 AliITSClusterFinderV2SSD.cxx:598
 AliITSClusterFinderV2SSD.cxx:599
 AliITSClusterFinderV2SSD.cxx:600
 AliITSClusterFinderV2SSD.cxx:601
 AliITSClusterFinderV2SSD.cxx:602
 AliITSClusterFinderV2SSD.cxx:603
 AliITSClusterFinderV2SSD.cxx:604
 AliITSClusterFinderV2SSD.cxx:605
 AliITSClusterFinderV2SSD.cxx:606
 AliITSClusterFinderV2SSD.cxx:607
 AliITSClusterFinderV2SSD.cxx:608
 AliITSClusterFinderV2SSD.cxx:609
 AliITSClusterFinderV2SSD.cxx:610
 AliITSClusterFinderV2SSD.cxx:611
 AliITSClusterFinderV2SSD.cxx:612
 AliITSClusterFinderV2SSD.cxx:613
 AliITSClusterFinderV2SSD.cxx:614
 AliITSClusterFinderV2SSD.cxx:615
 AliITSClusterFinderV2SSD.cxx:616
 AliITSClusterFinderV2SSD.cxx:617
 AliITSClusterFinderV2SSD.cxx:618
 AliITSClusterFinderV2SSD.cxx:619
 AliITSClusterFinderV2SSD.cxx:620
 AliITSClusterFinderV2SSD.cxx:621
 AliITSClusterFinderV2SSD.cxx:622
 AliITSClusterFinderV2SSD.cxx:623
 AliITSClusterFinderV2SSD.cxx:624
 AliITSClusterFinderV2SSD.cxx:625
 AliITSClusterFinderV2SSD.cxx:626
 AliITSClusterFinderV2SSD.cxx:627
 AliITSClusterFinderV2SSD.cxx:628
 AliITSClusterFinderV2SSD.cxx:629
 AliITSClusterFinderV2SSD.cxx:630
 AliITSClusterFinderV2SSD.cxx:631
 AliITSClusterFinderV2SSD.cxx:632
 AliITSClusterFinderV2SSD.cxx:633
 AliITSClusterFinderV2SSD.cxx:634
 AliITSClusterFinderV2SSD.cxx:635
 AliITSClusterFinderV2SSD.cxx:636
 AliITSClusterFinderV2SSD.cxx:637
 AliITSClusterFinderV2SSD.cxx:638
 AliITSClusterFinderV2SSD.cxx:639
 AliITSClusterFinderV2SSD.cxx:640
 AliITSClusterFinderV2SSD.cxx:641
 AliITSClusterFinderV2SSD.cxx:642
 AliITSClusterFinderV2SSD.cxx:643
 AliITSClusterFinderV2SSD.cxx:644
 AliITSClusterFinderV2SSD.cxx:645
 AliITSClusterFinderV2SSD.cxx:646
 AliITSClusterFinderV2SSD.cxx:647
 AliITSClusterFinderV2SSD.cxx:648
 AliITSClusterFinderV2SSD.cxx:649
 AliITSClusterFinderV2SSD.cxx:650
 AliITSClusterFinderV2SSD.cxx:651
 AliITSClusterFinderV2SSD.cxx:652
 AliITSClusterFinderV2SSD.cxx:653
 AliITSClusterFinderV2SSD.cxx:654
 AliITSClusterFinderV2SSD.cxx:655
 AliITSClusterFinderV2SSD.cxx:656
 AliITSClusterFinderV2SSD.cxx:657
 AliITSClusterFinderV2SSD.cxx:658
 AliITSClusterFinderV2SSD.cxx:659
 AliITSClusterFinderV2SSD.cxx:660
 AliITSClusterFinderV2SSD.cxx:661
 AliITSClusterFinderV2SSD.cxx:662
 AliITSClusterFinderV2SSD.cxx:663
 AliITSClusterFinderV2SSD.cxx:664
 AliITSClusterFinderV2SSD.cxx:665
 AliITSClusterFinderV2SSD.cxx:666
 AliITSClusterFinderV2SSD.cxx:667
 AliITSClusterFinderV2SSD.cxx:668
 AliITSClusterFinderV2SSD.cxx:669
 AliITSClusterFinderV2SSD.cxx:670
 AliITSClusterFinderV2SSD.cxx:671
 AliITSClusterFinderV2SSD.cxx:672
 AliITSClusterFinderV2SSD.cxx:673
 AliITSClusterFinderV2SSD.cxx:674
 AliITSClusterFinderV2SSD.cxx:675
 AliITSClusterFinderV2SSD.cxx:676
 AliITSClusterFinderV2SSD.cxx:677
 AliITSClusterFinderV2SSD.cxx:678
 AliITSClusterFinderV2SSD.cxx:679
 AliITSClusterFinderV2SSD.cxx:680
 AliITSClusterFinderV2SSD.cxx:681
 AliITSClusterFinderV2SSD.cxx:682
 AliITSClusterFinderV2SSD.cxx:683
 AliITSClusterFinderV2SSD.cxx:684
 AliITSClusterFinderV2SSD.cxx:685
 AliITSClusterFinderV2SSD.cxx:686
 AliITSClusterFinderV2SSD.cxx:687
 AliITSClusterFinderV2SSD.cxx:688
 AliITSClusterFinderV2SSD.cxx:689
 AliITSClusterFinderV2SSD.cxx:690
 AliITSClusterFinderV2SSD.cxx:691
 AliITSClusterFinderV2SSD.cxx:692
 AliITSClusterFinderV2SSD.cxx:693
 AliITSClusterFinderV2SSD.cxx:694
 AliITSClusterFinderV2SSD.cxx:695
 AliITSClusterFinderV2SSD.cxx:696
 AliITSClusterFinderV2SSD.cxx:697
 AliITSClusterFinderV2SSD.cxx:698
 AliITSClusterFinderV2SSD.cxx:699
 AliITSClusterFinderV2SSD.cxx:700
 AliITSClusterFinderV2SSD.cxx:701
 AliITSClusterFinderV2SSD.cxx:702
 AliITSClusterFinderV2SSD.cxx:703
 AliITSClusterFinderV2SSD.cxx:704
 AliITSClusterFinderV2SSD.cxx:705
 AliITSClusterFinderV2SSD.cxx:706
 AliITSClusterFinderV2SSD.cxx:707
 AliITSClusterFinderV2SSD.cxx:708
 AliITSClusterFinderV2SSD.cxx:709
 AliITSClusterFinderV2SSD.cxx:710
 AliITSClusterFinderV2SSD.cxx:711
 AliITSClusterFinderV2SSD.cxx:712
 AliITSClusterFinderV2SSD.cxx:713
 AliITSClusterFinderV2SSD.cxx:714
 AliITSClusterFinderV2SSD.cxx:715
 AliITSClusterFinderV2SSD.cxx:716
 AliITSClusterFinderV2SSD.cxx:717
 AliITSClusterFinderV2SSD.cxx:718
 AliITSClusterFinderV2SSD.cxx:719
 AliITSClusterFinderV2SSD.cxx:720
 AliITSClusterFinderV2SSD.cxx:721
 AliITSClusterFinderV2SSD.cxx:722
 AliITSClusterFinderV2SSD.cxx:723
 AliITSClusterFinderV2SSD.cxx:724
 AliITSClusterFinderV2SSD.cxx:725
 AliITSClusterFinderV2SSD.cxx:726
 AliITSClusterFinderV2SSD.cxx:727
 AliITSClusterFinderV2SSD.cxx:728
 AliITSClusterFinderV2SSD.cxx:729
 AliITSClusterFinderV2SSD.cxx:730
 AliITSClusterFinderV2SSD.cxx:731
 AliITSClusterFinderV2SSD.cxx:732
 AliITSClusterFinderV2SSD.cxx:733
 AliITSClusterFinderV2SSD.cxx:734
 AliITSClusterFinderV2SSD.cxx:735
 AliITSClusterFinderV2SSD.cxx:736
 AliITSClusterFinderV2SSD.cxx:737
 AliITSClusterFinderV2SSD.cxx:738
 AliITSClusterFinderV2SSD.cxx:739
 AliITSClusterFinderV2SSD.cxx:740
 AliITSClusterFinderV2SSD.cxx:741
 AliITSClusterFinderV2SSD.cxx:742
 AliITSClusterFinderV2SSD.cxx:743
 AliITSClusterFinderV2SSD.cxx:744
 AliITSClusterFinderV2SSD.cxx:745
 AliITSClusterFinderV2SSD.cxx:746
 AliITSClusterFinderV2SSD.cxx:747
 AliITSClusterFinderV2SSD.cxx:748
 AliITSClusterFinderV2SSD.cxx:749
 AliITSClusterFinderV2SSD.cxx:750
 AliITSClusterFinderV2SSD.cxx:751
 AliITSClusterFinderV2SSD.cxx:752
 AliITSClusterFinderV2SSD.cxx:753
 AliITSClusterFinderV2SSD.cxx:754
 AliITSClusterFinderV2SSD.cxx:755
 AliITSClusterFinderV2SSD.cxx:756
 AliITSClusterFinderV2SSD.cxx:757
 AliITSClusterFinderV2SSD.cxx:758
 AliITSClusterFinderV2SSD.cxx:759
 AliITSClusterFinderV2SSD.cxx:760
 AliITSClusterFinderV2SSD.cxx:761
 AliITSClusterFinderV2SSD.cxx:762
 AliITSClusterFinderV2SSD.cxx:763
 AliITSClusterFinderV2SSD.cxx:764
 AliITSClusterFinderV2SSD.cxx:765
 AliITSClusterFinderV2SSD.cxx:766
 AliITSClusterFinderV2SSD.cxx:767
 AliITSClusterFinderV2SSD.cxx:768
 AliITSClusterFinderV2SSD.cxx:769
 AliITSClusterFinderV2SSD.cxx:770
 AliITSClusterFinderV2SSD.cxx:771
 AliITSClusterFinderV2SSD.cxx:772
 AliITSClusterFinderV2SSD.cxx:773
 AliITSClusterFinderV2SSD.cxx:774
 AliITSClusterFinderV2SSD.cxx:775
 AliITSClusterFinderV2SSD.cxx:776
 AliITSClusterFinderV2SSD.cxx:777
 AliITSClusterFinderV2SSD.cxx:778
 AliITSClusterFinderV2SSD.cxx:779
 AliITSClusterFinderV2SSD.cxx:780
 AliITSClusterFinderV2SSD.cxx:781
 AliITSClusterFinderV2SSD.cxx:782
 AliITSClusterFinderV2SSD.cxx:783
 AliITSClusterFinderV2SSD.cxx:784
 AliITSClusterFinderV2SSD.cxx:785
 AliITSClusterFinderV2SSD.cxx:786
 AliITSClusterFinderV2SSD.cxx:787
 AliITSClusterFinderV2SSD.cxx:788
 AliITSClusterFinderV2SSD.cxx:789
 AliITSClusterFinderV2SSD.cxx:790
 AliITSClusterFinderV2SSD.cxx:791
 AliITSClusterFinderV2SSD.cxx:792
 AliITSClusterFinderV2SSD.cxx:793
 AliITSClusterFinderV2SSD.cxx:794
 AliITSClusterFinderV2SSD.cxx:795
 AliITSClusterFinderV2SSD.cxx:796
 AliITSClusterFinderV2SSD.cxx:797
 AliITSClusterFinderV2SSD.cxx:798
 AliITSClusterFinderV2SSD.cxx:799
 AliITSClusterFinderV2SSD.cxx:800
 AliITSClusterFinderV2SSD.cxx:801
 AliITSClusterFinderV2SSD.cxx:802
 AliITSClusterFinderV2SSD.cxx:803
 AliITSClusterFinderV2SSD.cxx:804
 AliITSClusterFinderV2SSD.cxx:805
 AliITSClusterFinderV2SSD.cxx:806
 AliITSClusterFinderV2SSD.cxx:807
 AliITSClusterFinderV2SSD.cxx:808
 AliITSClusterFinderV2SSD.cxx:809
 AliITSClusterFinderV2SSD.cxx:810
 AliITSClusterFinderV2SSD.cxx:811
 AliITSClusterFinderV2SSD.cxx:812
 AliITSClusterFinderV2SSD.cxx:813
 AliITSClusterFinderV2SSD.cxx:814
 AliITSClusterFinderV2SSD.cxx:815
 AliITSClusterFinderV2SSD.cxx:816
 AliITSClusterFinderV2SSD.cxx:817
 AliITSClusterFinderV2SSD.cxx:818
 AliITSClusterFinderV2SSD.cxx:819
 AliITSClusterFinderV2SSD.cxx:820
 AliITSClusterFinderV2SSD.cxx:821
 AliITSClusterFinderV2SSD.cxx:822
 AliITSClusterFinderV2SSD.cxx:823
 AliITSClusterFinderV2SSD.cxx:824
 AliITSClusterFinderV2SSD.cxx:825
 AliITSClusterFinderV2SSD.cxx:826
 AliITSClusterFinderV2SSD.cxx:827
 AliITSClusterFinderV2SSD.cxx:828
 AliITSClusterFinderV2SSD.cxx:829
 AliITSClusterFinderV2SSD.cxx:830
 AliITSClusterFinderV2SSD.cxx:831
 AliITSClusterFinderV2SSD.cxx:832
 AliITSClusterFinderV2SSD.cxx:833
 AliITSClusterFinderV2SSD.cxx:834
 AliITSClusterFinderV2SSD.cxx:835
 AliITSClusterFinderV2SSD.cxx:836
 AliITSClusterFinderV2SSD.cxx:837
 AliITSClusterFinderV2SSD.cxx:838
 AliITSClusterFinderV2SSD.cxx:839
 AliITSClusterFinderV2SSD.cxx:840
 AliITSClusterFinderV2SSD.cxx:841
 AliITSClusterFinderV2SSD.cxx:842
 AliITSClusterFinderV2SSD.cxx:843
 AliITSClusterFinderV2SSD.cxx:844
 AliITSClusterFinderV2SSD.cxx:845
 AliITSClusterFinderV2SSD.cxx:846
 AliITSClusterFinderV2SSD.cxx:847
 AliITSClusterFinderV2SSD.cxx:848
 AliITSClusterFinderV2SSD.cxx:849
 AliITSClusterFinderV2SSD.cxx:850
 AliITSClusterFinderV2SSD.cxx:851
 AliITSClusterFinderV2SSD.cxx:852
 AliITSClusterFinderV2SSD.cxx:853
 AliITSClusterFinderV2SSD.cxx:854
 AliITSClusterFinderV2SSD.cxx:855
 AliITSClusterFinderV2SSD.cxx:856
 AliITSClusterFinderV2SSD.cxx:857
 AliITSClusterFinderV2SSD.cxx:858
 AliITSClusterFinderV2SSD.cxx:859
 AliITSClusterFinderV2SSD.cxx:860
 AliITSClusterFinderV2SSD.cxx:861
 AliITSClusterFinderV2SSD.cxx:862
 AliITSClusterFinderV2SSD.cxx:863
 AliITSClusterFinderV2SSD.cxx:864
 AliITSClusterFinderV2SSD.cxx:865
 AliITSClusterFinderV2SSD.cxx:866
 AliITSClusterFinderV2SSD.cxx:867
 AliITSClusterFinderV2SSD.cxx:868
 AliITSClusterFinderV2SSD.cxx:869
 AliITSClusterFinderV2SSD.cxx:870
 AliITSClusterFinderV2SSD.cxx:871
 AliITSClusterFinderV2SSD.cxx:872
 AliITSClusterFinderV2SSD.cxx:873
 AliITSClusterFinderV2SSD.cxx:874
 AliITSClusterFinderV2SSD.cxx:875
 AliITSClusterFinderV2SSD.cxx:876
 AliITSClusterFinderV2SSD.cxx:877
 AliITSClusterFinderV2SSD.cxx:878
 AliITSClusterFinderV2SSD.cxx:879
 AliITSClusterFinderV2SSD.cxx:880
 AliITSClusterFinderV2SSD.cxx:881
 AliITSClusterFinderV2SSD.cxx:882
 AliITSClusterFinderV2SSD.cxx:883
 AliITSClusterFinderV2SSD.cxx:884
 AliITSClusterFinderV2SSD.cxx:885
 AliITSClusterFinderV2SSD.cxx:886
 AliITSClusterFinderV2SSD.cxx:887
 AliITSClusterFinderV2SSD.cxx:888
 AliITSClusterFinderV2SSD.cxx:889
 AliITSClusterFinderV2SSD.cxx:890
 AliITSClusterFinderV2SSD.cxx:891
 AliITSClusterFinderV2SSD.cxx:892
 AliITSClusterFinderV2SSD.cxx:893
 AliITSClusterFinderV2SSD.cxx:894
 AliITSClusterFinderV2SSD.cxx:895
 AliITSClusterFinderV2SSD.cxx:896
 AliITSClusterFinderV2SSD.cxx:897
 AliITSClusterFinderV2SSD.cxx:898
 AliITSClusterFinderV2SSD.cxx:899
 AliITSClusterFinderV2SSD.cxx:900
 AliITSClusterFinderV2SSD.cxx:901
 AliITSClusterFinderV2SSD.cxx:902
 AliITSClusterFinderV2SSD.cxx:903
 AliITSClusterFinderV2SSD.cxx:904
 AliITSClusterFinderV2SSD.cxx:905
 AliITSClusterFinderV2SSD.cxx:906
 AliITSClusterFinderV2SSD.cxx:907
 AliITSClusterFinderV2SSD.cxx:908
 AliITSClusterFinderV2SSD.cxx:909
 AliITSClusterFinderV2SSD.cxx:910
 AliITSClusterFinderV2SSD.cxx:911
 AliITSClusterFinderV2SSD.cxx:912
 AliITSClusterFinderV2SSD.cxx:913
 AliITSClusterFinderV2SSD.cxx:914
 AliITSClusterFinderV2SSD.cxx:915
 AliITSClusterFinderV2SSD.cxx:916
 AliITSClusterFinderV2SSD.cxx:917
 AliITSClusterFinderV2SSD.cxx:918
 AliITSClusterFinderV2SSD.cxx:919
 AliITSClusterFinderV2SSD.cxx:920
 AliITSClusterFinderV2SSD.cxx:921
 AliITSClusterFinderV2SSD.cxx:922
 AliITSClusterFinderV2SSD.cxx:923
 AliITSClusterFinderV2SSD.cxx:924
 AliITSClusterFinderV2SSD.cxx:925
 AliITSClusterFinderV2SSD.cxx:926
 AliITSClusterFinderV2SSD.cxx:927
 AliITSClusterFinderV2SSD.cxx:928
 AliITSClusterFinderV2SSD.cxx:929
 AliITSClusterFinderV2SSD.cxx:930
 AliITSClusterFinderV2SSD.cxx:931
 AliITSClusterFinderV2SSD.cxx:932
 AliITSClusterFinderV2SSD.cxx:933
 AliITSClusterFinderV2SSD.cxx:934
 AliITSClusterFinderV2SSD.cxx:935
 AliITSClusterFinderV2SSD.cxx:936
 AliITSClusterFinderV2SSD.cxx:937
 AliITSClusterFinderV2SSD.cxx:938
 AliITSClusterFinderV2SSD.cxx:939
 AliITSClusterFinderV2SSD.cxx:940
 AliITSClusterFinderV2SSD.cxx:941
 AliITSClusterFinderV2SSD.cxx:942
 AliITSClusterFinderV2SSD.cxx:943
 AliITSClusterFinderV2SSD.cxx:944
 AliITSClusterFinderV2SSD.cxx:945
 AliITSClusterFinderV2SSD.cxx:946
 AliITSClusterFinderV2SSD.cxx:947
 AliITSClusterFinderV2SSD.cxx:948
 AliITSClusterFinderV2SSD.cxx:949
 AliITSClusterFinderV2SSD.cxx:950
 AliITSClusterFinderV2SSD.cxx:951
 AliITSClusterFinderV2SSD.cxx:952
 AliITSClusterFinderV2SSD.cxx:953
 AliITSClusterFinderV2SSD.cxx:954
 AliITSClusterFinderV2SSD.cxx:955
 AliITSClusterFinderV2SSD.cxx:956
 AliITSClusterFinderV2SSD.cxx:957
 AliITSClusterFinderV2SSD.cxx:958
 AliITSClusterFinderV2SSD.cxx:959
 AliITSClusterFinderV2SSD.cxx:960
 AliITSClusterFinderV2SSD.cxx:961
 AliITSClusterFinderV2SSD.cxx:962
 AliITSClusterFinderV2SSD.cxx:963
 AliITSClusterFinderV2SSD.cxx:964
 AliITSClusterFinderV2SSD.cxx:965
 AliITSClusterFinderV2SSD.cxx:966
 AliITSClusterFinderV2SSD.cxx:967
 AliITSClusterFinderV2SSD.cxx:968
 AliITSClusterFinderV2SSD.cxx:969
 AliITSClusterFinderV2SSD.cxx:970
 AliITSClusterFinderV2SSD.cxx:971
 AliITSClusterFinderV2SSD.cxx:972
 AliITSClusterFinderV2SSD.cxx:973
 AliITSClusterFinderV2SSD.cxx:974
 AliITSClusterFinderV2SSD.cxx:975
 AliITSClusterFinderV2SSD.cxx:976
 AliITSClusterFinderV2SSD.cxx:977
 AliITSClusterFinderV2SSD.cxx:978
 AliITSClusterFinderV2SSD.cxx:979
 AliITSClusterFinderV2SSD.cxx:980
 AliITSClusterFinderV2SSD.cxx:981
 AliITSClusterFinderV2SSD.cxx:982
 AliITSClusterFinderV2SSD.cxx:983
 AliITSClusterFinderV2SSD.cxx:984
 AliITSClusterFinderV2SSD.cxx:985
 AliITSClusterFinderV2SSD.cxx:986
 AliITSClusterFinderV2SSD.cxx:987
 AliITSClusterFinderV2SSD.cxx:988
 AliITSClusterFinderV2SSD.cxx:989
 AliITSClusterFinderV2SSD.cxx:990
 AliITSClusterFinderV2SSD.cxx:991
 AliITSClusterFinderV2SSD.cxx:992
 AliITSClusterFinderV2SSD.cxx:993
 AliITSClusterFinderV2SSD.cxx:994
 AliITSClusterFinderV2SSD.cxx:995
 AliITSClusterFinderV2SSD.cxx:996
 AliITSClusterFinderV2SSD.cxx:997
 AliITSClusterFinderV2SSD.cxx:998
 AliITSClusterFinderV2SSD.cxx:999
 AliITSClusterFinderV2SSD.cxx:1000
 AliITSClusterFinderV2SSD.cxx:1001
 AliITSClusterFinderV2SSD.cxx:1002
 AliITSClusterFinderV2SSD.cxx:1003
 AliITSClusterFinderV2SSD.cxx:1004
 AliITSClusterFinderV2SSD.cxx:1005
 AliITSClusterFinderV2SSD.cxx:1006
 AliITSClusterFinderV2SSD.cxx:1007
 AliITSClusterFinderV2SSD.cxx:1008
 AliITSClusterFinderV2SSD.cxx:1009
 AliITSClusterFinderV2SSD.cxx:1010
 AliITSClusterFinderV2SSD.cxx:1011
 AliITSClusterFinderV2SSD.cxx:1012
 AliITSClusterFinderV2SSD.cxx:1013
 AliITSClusterFinderV2SSD.cxx:1014
 AliITSClusterFinderV2SSD.cxx:1015
 AliITSClusterFinderV2SSD.cxx:1016
 AliITSClusterFinderV2SSD.cxx:1017
 AliITSClusterFinderV2SSD.cxx:1018
 AliITSClusterFinderV2SSD.cxx:1019
 AliITSClusterFinderV2SSD.cxx:1020
 AliITSClusterFinderV2SSD.cxx:1021
 AliITSClusterFinderV2SSD.cxx:1022
 AliITSClusterFinderV2SSD.cxx:1023
 AliITSClusterFinderV2SSD.cxx:1024
 AliITSClusterFinderV2SSD.cxx:1025
 AliITSClusterFinderV2SSD.cxx:1026
 AliITSClusterFinderV2SSD.cxx:1027
 AliITSClusterFinderV2SSD.cxx:1028
 AliITSClusterFinderV2SSD.cxx:1029
 AliITSClusterFinderV2SSD.cxx:1030
 AliITSClusterFinderV2SSD.cxx:1031
 AliITSClusterFinderV2SSD.cxx:1032
 AliITSClusterFinderV2SSD.cxx:1033
 AliITSClusterFinderV2SSD.cxx:1034
 AliITSClusterFinderV2SSD.cxx:1035
 AliITSClusterFinderV2SSD.cxx:1036
 AliITSClusterFinderV2SSD.cxx:1037
 AliITSClusterFinderV2SSD.cxx:1038
 AliITSClusterFinderV2SSD.cxx:1039
 AliITSClusterFinderV2SSD.cxx:1040
 AliITSClusterFinderV2SSD.cxx:1041
 AliITSClusterFinderV2SSD.cxx:1042
 AliITSClusterFinderV2SSD.cxx:1043
 AliITSClusterFinderV2SSD.cxx:1044
 AliITSClusterFinderV2SSD.cxx:1045
 AliITSClusterFinderV2SSD.cxx:1046
 AliITSClusterFinderV2SSD.cxx:1047
 AliITSClusterFinderV2SSD.cxx:1048
 AliITSClusterFinderV2SSD.cxx:1049
 AliITSClusterFinderV2SSD.cxx:1050
 AliITSClusterFinderV2SSD.cxx:1051
 AliITSClusterFinderV2SSD.cxx:1052
 AliITSClusterFinderV2SSD.cxx:1053
 AliITSClusterFinderV2SSD.cxx:1054
 AliITSClusterFinderV2SSD.cxx:1055
 AliITSClusterFinderV2SSD.cxx:1056
 AliITSClusterFinderV2SSD.cxx:1057
 AliITSClusterFinderV2SSD.cxx:1058
 AliITSClusterFinderV2SSD.cxx:1059
 AliITSClusterFinderV2SSD.cxx:1060
 AliITSClusterFinderV2SSD.cxx:1061
 AliITSClusterFinderV2SSD.cxx:1062
 AliITSClusterFinderV2SSD.cxx:1063
 AliITSClusterFinderV2SSD.cxx:1064
 AliITSClusterFinderV2SSD.cxx:1065
 AliITSClusterFinderV2SSD.cxx:1066
 AliITSClusterFinderV2SSD.cxx:1067
 AliITSClusterFinderV2SSD.cxx:1068
 AliITSClusterFinderV2SSD.cxx:1069
 AliITSClusterFinderV2SSD.cxx:1070
 AliITSClusterFinderV2SSD.cxx:1071
 AliITSClusterFinderV2SSD.cxx:1072
 AliITSClusterFinderV2SSD.cxx:1073
 AliITSClusterFinderV2SSD.cxx:1074
 AliITSClusterFinderV2SSD.cxx:1075
 AliITSClusterFinderV2SSD.cxx:1076
 AliITSClusterFinderV2SSD.cxx:1077
 AliITSClusterFinderV2SSD.cxx:1078
 AliITSClusterFinderV2SSD.cxx:1079
 AliITSClusterFinderV2SSD.cxx:1080
 AliITSClusterFinderV2SSD.cxx:1081
 AliITSClusterFinderV2SSD.cxx:1082
 AliITSClusterFinderV2SSD.cxx:1083
 AliITSClusterFinderV2SSD.cxx:1084
 AliITSClusterFinderV2SSD.cxx:1085
 AliITSClusterFinderV2SSD.cxx:1086
 AliITSClusterFinderV2SSD.cxx:1087
 AliITSClusterFinderV2SSD.cxx:1088
 AliITSClusterFinderV2SSD.cxx:1089
 AliITSClusterFinderV2SSD.cxx:1090
 AliITSClusterFinderV2SSD.cxx:1091
 AliITSClusterFinderV2SSD.cxx:1092
 AliITSClusterFinderV2SSD.cxx:1093
 AliITSClusterFinderV2SSD.cxx:1094
 AliITSClusterFinderV2SSD.cxx:1095
 AliITSClusterFinderV2SSD.cxx:1096
 AliITSClusterFinderV2SSD.cxx:1097
 AliITSClusterFinderV2SSD.cxx:1098
 AliITSClusterFinderV2SSD.cxx:1099
 AliITSClusterFinderV2SSD.cxx:1100
 AliITSClusterFinderV2SSD.cxx:1101
 AliITSClusterFinderV2SSD.cxx:1102
 AliITSClusterFinderV2SSD.cxx:1103
 AliITSClusterFinderV2SSD.cxx:1104
 AliITSClusterFinderV2SSD.cxx:1105
 AliITSClusterFinderV2SSD.cxx:1106
 AliITSClusterFinderV2SSD.cxx:1107
 AliITSClusterFinderV2SSD.cxx:1108
 AliITSClusterFinderV2SSD.cxx:1109
 AliITSClusterFinderV2SSD.cxx:1110
 AliITSClusterFinderV2SSD.cxx:1111
 AliITSClusterFinderV2SSD.cxx:1112
 AliITSClusterFinderV2SSD.cxx:1113
 AliITSClusterFinderV2SSD.cxx:1114
 AliITSClusterFinderV2SSD.cxx:1115
 AliITSClusterFinderV2SSD.cxx:1116
 AliITSClusterFinderV2SSD.cxx:1117
 AliITSClusterFinderV2SSD.cxx:1118
 AliITSClusterFinderV2SSD.cxx:1119
 AliITSClusterFinderV2SSD.cxx:1120
 AliITSClusterFinderV2SSD.cxx:1121
 AliITSClusterFinderV2SSD.cxx:1122
 AliITSClusterFinderV2SSD.cxx:1123
 AliITSClusterFinderV2SSD.cxx:1124
 AliITSClusterFinderV2SSD.cxx:1125
 AliITSClusterFinderV2SSD.cxx:1126
 AliITSClusterFinderV2SSD.cxx:1127
 AliITSClusterFinderV2SSD.cxx:1128
 AliITSClusterFinderV2SSD.cxx:1129
 AliITSClusterFinderV2SSD.cxx:1130
 AliITSClusterFinderV2SSD.cxx:1131
 AliITSClusterFinderV2SSD.cxx:1132
 AliITSClusterFinderV2SSD.cxx:1133
 AliITSClusterFinderV2SSD.cxx:1134
 AliITSClusterFinderV2SSD.cxx:1135
 AliITSClusterFinderV2SSD.cxx:1136
 AliITSClusterFinderV2SSD.cxx:1137
 AliITSClusterFinderV2SSD.cxx:1138
 AliITSClusterFinderV2SSD.cxx:1139
 AliITSClusterFinderV2SSD.cxx:1140
 AliITSClusterFinderV2SSD.cxx:1141
 AliITSClusterFinderV2SSD.cxx:1142
 AliITSClusterFinderV2SSD.cxx:1143
 AliITSClusterFinderV2SSD.cxx:1144
 AliITSClusterFinderV2SSD.cxx:1145
 AliITSClusterFinderV2SSD.cxx:1146
 AliITSClusterFinderV2SSD.cxx:1147
 AliITSClusterFinderV2SSD.cxx:1148
 AliITSClusterFinderV2SSD.cxx:1149
 AliITSClusterFinderV2SSD.cxx:1150
 AliITSClusterFinderV2SSD.cxx:1151
 AliITSClusterFinderV2SSD.cxx:1152
 AliITSClusterFinderV2SSD.cxx:1153
 AliITSClusterFinderV2SSD.cxx:1154
 AliITSClusterFinderV2SSD.cxx:1155
 AliITSClusterFinderV2SSD.cxx:1156
 AliITSClusterFinderV2SSD.cxx:1157
 AliITSClusterFinderV2SSD.cxx:1158
 AliITSClusterFinderV2SSD.cxx:1159
 AliITSClusterFinderV2SSD.cxx:1160
 AliITSClusterFinderV2SSD.cxx:1161
 AliITSClusterFinderV2SSD.cxx:1162
 AliITSClusterFinderV2SSD.cxx:1163
 AliITSClusterFinderV2SSD.cxx:1164
 AliITSClusterFinderV2SSD.cxx:1165
 AliITSClusterFinderV2SSD.cxx:1166
 AliITSClusterFinderV2SSD.cxx:1167
 AliITSClusterFinderV2SSD.cxx:1168
 AliITSClusterFinderV2SSD.cxx:1169
 AliITSClusterFinderV2SSD.cxx:1170
 AliITSClusterFinderV2SSD.cxx:1171
 AliITSClusterFinderV2SSD.cxx:1172
 AliITSClusterFinderV2SSD.cxx:1173
 AliITSClusterFinderV2SSD.cxx:1174
 AliITSClusterFinderV2SSD.cxx:1175
 AliITSClusterFinderV2SSD.cxx:1176
 AliITSClusterFinderV2SSD.cxx:1177
 AliITSClusterFinderV2SSD.cxx:1178
 AliITSClusterFinderV2SSD.cxx:1179
 AliITSClusterFinderV2SSD.cxx:1180
 AliITSClusterFinderV2SSD.cxx:1181
 AliITSClusterFinderV2SSD.cxx:1182
 AliITSClusterFinderV2SSD.cxx:1183
 AliITSClusterFinderV2SSD.cxx:1184
 AliITSClusterFinderV2SSD.cxx:1185
 AliITSClusterFinderV2SSD.cxx:1186
 AliITSClusterFinderV2SSD.cxx:1187
 AliITSClusterFinderV2SSD.cxx:1188
 AliITSClusterFinderV2SSD.cxx:1189
 AliITSClusterFinderV2SSD.cxx:1190
 AliITSClusterFinderV2SSD.cxx:1191
 AliITSClusterFinderV2SSD.cxx:1192
 AliITSClusterFinderV2SSD.cxx:1193
 AliITSClusterFinderV2SSD.cxx:1194
 AliITSClusterFinderV2SSD.cxx:1195
 AliITSClusterFinderV2SSD.cxx:1196
 AliITSClusterFinderV2SSD.cxx:1197
 AliITSClusterFinderV2SSD.cxx:1198
 AliITSClusterFinderV2SSD.cxx:1199
 AliITSClusterFinderV2SSD.cxx:1200
 AliITSClusterFinderV2SSD.cxx:1201
 AliITSClusterFinderV2SSD.cxx:1202
 AliITSClusterFinderV2SSD.cxx:1203
 AliITSClusterFinderV2SSD.cxx:1204
 AliITSClusterFinderV2SSD.cxx:1205
 AliITSClusterFinderV2SSD.cxx:1206
 AliITSClusterFinderV2SSD.cxx:1207
 AliITSClusterFinderV2SSD.cxx:1208
 AliITSClusterFinderV2SSD.cxx:1209
 AliITSClusterFinderV2SSD.cxx:1210
 AliITSClusterFinderV2SSD.cxx:1211
 AliITSClusterFinderV2SSD.cxx:1212
 AliITSClusterFinderV2SSD.cxx:1213
 AliITSClusterFinderV2SSD.cxx:1214
 AliITSClusterFinderV2SSD.cxx:1215
 AliITSClusterFinderV2SSD.cxx:1216
 AliITSClusterFinderV2SSD.cxx:1217
 AliITSClusterFinderV2SSD.cxx:1218
 AliITSClusterFinderV2SSD.cxx:1219
 AliITSClusterFinderV2SSD.cxx:1220
 AliITSClusterFinderV2SSD.cxx:1221
 AliITSClusterFinderV2SSD.cxx:1222
 AliITSClusterFinderV2SSD.cxx:1223
 AliITSClusterFinderV2SSD.cxx:1224
 AliITSClusterFinderV2SSD.cxx:1225
 AliITSClusterFinderV2SSD.cxx:1226
 AliITSClusterFinderV2SSD.cxx:1227
 AliITSClusterFinderV2SSD.cxx:1228
 AliITSClusterFinderV2SSD.cxx:1229
 AliITSClusterFinderV2SSD.cxx:1230
 AliITSClusterFinderV2SSD.cxx:1231
 AliITSClusterFinderV2SSD.cxx:1232
 AliITSClusterFinderV2SSD.cxx:1233
 AliITSClusterFinderV2SSD.cxx:1234
 AliITSClusterFinderV2SSD.cxx:1235
 AliITSClusterFinderV2SSD.cxx:1236
 AliITSClusterFinderV2SSD.cxx:1237
 AliITSClusterFinderV2SSD.cxx:1238
 AliITSClusterFinderV2SSD.cxx:1239
 AliITSClusterFinderV2SSD.cxx:1240
 AliITSClusterFinderV2SSD.cxx:1241
 AliITSClusterFinderV2SSD.cxx:1242
 AliITSClusterFinderV2SSD.cxx:1243
 AliITSClusterFinderV2SSD.cxx:1244
 AliITSClusterFinderV2SSD.cxx:1245
 AliITSClusterFinderV2SSD.cxx:1246
 AliITSClusterFinderV2SSD.cxx:1247
 AliITSClusterFinderV2SSD.cxx:1248
 AliITSClusterFinderV2SSD.cxx:1249
 AliITSClusterFinderV2SSD.cxx:1250
 AliITSClusterFinderV2SSD.cxx:1251
 AliITSClusterFinderV2SSD.cxx:1252
 AliITSClusterFinderV2SSD.cxx:1253
 AliITSClusterFinderV2SSD.cxx:1254
 AliITSClusterFinderV2SSD.cxx:1255
 AliITSClusterFinderV2SSD.cxx:1256
 AliITSClusterFinderV2SSD.cxx:1257
 AliITSClusterFinderV2SSD.cxx:1258
 AliITSClusterFinderV2SSD.cxx:1259
 AliITSClusterFinderV2SSD.cxx:1260
 AliITSClusterFinderV2SSD.cxx:1261
 AliITSClusterFinderV2SSD.cxx:1262
 AliITSClusterFinderV2SSD.cxx:1263
 AliITSClusterFinderV2SSD.cxx:1264
 AliITSClusterFinderV2SSD.cxx:1265
 AliITSClusterFinderV2SSD.cxx:1266
 AliITSClusterFinderV2SSD.cxx:1267
 AliITSClusterFinderV2SSD.cxx:1268
 AliITSClusterFinderV2SSD.cxx:1269
 AliITSClusterFinderV2SSD.cxx:1270
 AliITSClusterFinderV2SSD.cxx:1271
 AliITSClusterFinderV2SSD.cxx:1272
 AliITSClusterFinderV2SSD.cxx:1273
 AliITSClusterFinderV2SSD.cxx:1274
 AliITSClusterFinderV2SSD.cxx:1275
 AliITSClusterFinderV2SSD.cxx:1276
 AliITSClusterFinderV2SSD.cxx:1277
 AliITSClusterFinderV2SSD.cxx:1278
 AliITSClusterFinderV2SSD.cxx:1279
 AliITSClusterFinderV2SSD.cxx:1280
 AliITSClusterFinderV2SSD.cxx:1281
 AliITSClusterFinderV2SSD.cxx:1282
 AliITSClusterFinderV2SSD.cxx:1283
 AliITSClusterFinderV2SSD.cxx:1284
 AliITSClusterFinderV2SSD.cxx:1285
 AliITSClusterFinderV2SSD.cxx:1286
 AliITSClusterFinderV2SSD.cxx:1287
 AliITSClusterFinderV2SSD.cxx:1288
 AliITSClusterFinderV2SSD.cxx:1289
 AliITSClusterFinderV2SSD.cxx:1290
 AliITSClusterFinderV2SSD.cxx:1291
 AliITSClusterFinderV2SSD.cxx:1292
 AliITSClusterFinderV2SSD.cxx:1293
 AliITSClusterFinderV2SSD.cxx:1294
 AliITSClusterFinderV2SSD.cxx:1295
 AliITSClusterFinderV2SSD.cxx:1296
 AliITSClusterFinderV2SSD.cxx:1297
 AliITSClusterFinderV2SSD.cxx:1298
 AliITSClusterFinderV2SSD.cxx:1299
 AliITSClusterFinderV2SSD.cxx:1300
 AliITSClusterFinderV2SSD.cxx:1301
 AliITSClusterFinderV2SSD.cxx:1302
 AliITSClusterFinderV2SSD.cxx:1303
 AliITSClusterFinderV2SSD.cxx:1304
 AliITSClusterFinderV2SSD.cxx:1305
 AliITSClusterFinderV2SSD.cxx:1306
 AliITSClusterFinderV2SSD.cxx:1307
 AliITSClusterFinderV2SSD.cxx:1308
 AliITSClusterFinderV2SSD.cxx:1309
 AliITSClusterFinderV2SSD.cxx:1310
 AliITSClusterFinderV2SSD.cxx:1311
 AliITSClusterFinderV2SSD.cxx:1312
 AliITSClusterFinderV2SSD.cxx:1313
 AliITSClusterFinderV2SSD.cxx:1314
 AliITSClusterFinderV2SSD.cxx:1315
 AliITSClusterFinderV2SSD.cxx:1316
 AliITSClusterFinderV2SSD.cxx:1317
 AliITSClusterFinderV2SSD.cxx:1318
 AliITSClusterFinderV2SSD.cxx:1319
 AliITSClusterFinderV2SSD.cxx:1320
 AliITSClusterFinderV2SSD.cxx:1321
 AliITSClusterFinderV2SSD.cxx:1322
 AliITSClusterFinderV2SSD.cxx:1323
 AliITSClusterFinderV2SSD.cxx:1324
 AliITSClusterFinderV2SSD.cxx:1325
 AliITSClusterFinderV2SSD.cxx:1326
 AliITSClusterFinderV2SSD.cxx:1327
 AliITSClusterFinderV2SSD.cxx:1328
 AliITSClusterFinderV2SSD.cxx:1329
 AliITSClusterFinderV2SSD.cxx:1330
 AliITSClusterFinderV2SSD.cxx:1331
 AliITSClusterFinderV2SSD.cxx:1332
 AliITSClusterFinderV2SSD.cxx:1333
 AliITSClusterFinderV2SSD.cxx:1334
 AliITSClusterFinderV2SSD.cxx:1335
 AliITSClusterFinderV2SSD.cxx:1336
 AliITSClusterFinderV2SSD.cxx:1337
 AliITSClusterFinderV2SSD.cxx:1338
 AliITSClusterFinderV2SSD.cxx:1339
 AliITSClusterFinderV2SSD.cxx:1340
 AliITSClusterFinderV2SSD.cxx:1341
 AliITSClusterFinderV2SSD.cxx:1342
 AliITSClusterFinderV2SSD.cxx:1343
 AliITSClusterFinderV2SSD.cxx:1344
 AliITSClusterFinderV2SSD.cxx:1345
 AliITSClusterFinderV2SSD.cxx:1346
 AliITSClusterFinderV2SSD.cxx:1347
 AliITSClusterFinderV2SSD.cxx:1348
 AliITSClusterFinderV2SSD.cxx:1349
 AliITSClusterFinderV2SSD.cxx:1350
 AliITSClusterFinderV2SSD.cxx:1351
 AliITSClusterFinderV2SSD.cxx:1352
 AliITSClusterFinderV2SSD.cxx:1353
 AliITSClusterFinderV2SSD.cxx:1354
 AliITSClusterFinderV2SSD.cxx:1355
 AliITSClusterFinderV2SSD.cxx:1356
 AliITSClusterFinderV2SSD.cxx:1357
 AliITSClusterFinderV2SSD.cxx:1358
 AliITSClusterFinderV2SSD.cxx:1359
 AliITSClusterFinderV2SSD.cxx:1360
 AliITSClusterFinderV2SSD.cxx:1361
 AliITSClusterFinderV2SSD.cxx:1362
 AliITSClusterFinderV2SSD.cxx:1363
 AliITSClusterFinderV2SSD.cxx:1364
 AliITSClusterFinderV2SSD.cxx:1365
 AliITSClusterFinderV2SSD.cxx:1366
 AliITSClusterFinderV2SSD.cxx:1367
 AliITSClusterFinderV2SSD.cxx:1368
 AliITSClusterFinderV2SSD.cxx:1369
 AliITSClusterFinderV2SSD.cxx:1370
 AliITSClusterFinderV2SSD.cxx:1371
 AliITSClusterFinderV2SSD.cxx:1372
 AliITSClusterFinderV2SSD.cxx:1373
 AliITSClusterFinderV2SSD.cxx:1374
 AliITSClusterFinderV2SSD.cxx:1375
 AliITSClusterFinderV2SSD.cxx:1376
 AliITSClusterFinderV2SSD.cxx:1377
 AliITSClusterFinderV2SSD.cxx:1378
 AliITSClusterFinderV2SSD.cxx:1379
 AliITSClusterFinderV2SSD.cxx:1380
 AliITSClusterFinderV2SSD.cxx:1381
 AliITSClusterFinderV2SSD.cxx:1382
 AliITSClusterFinderV2SSD.cxx:1383
 AliITSClusterFinderV2SSD.cxx:1384
 AliITSClusterFinderV2SSD.cxx:1385
 AliITSClusterFinderV2SSD.cxx:1386
 AliITSClusterFinderV2SSD.cxx:1387
 AliITSClusterFinderV2SSD.cxx:1388
 AliITSClusterFinderV2SSD.cxx:1389
 AliITSClusterFinderV2SSD.cxx:1390
 AliITSClusterFinderV2SSD.cxx:1391
 AliITSClusterFinderV2SSD.cxx:1392
 AliITSClusterFinderV2SSD.cxx:1393
 AliITSClusterFinderV2SSD.cxx:1394
 AliITSClusterFinderV2SSD.cxx:1395
 AliITSClusterFinderV2SSD.cxx:1396
 AliITSClusterFinderV2SSD.cxx:1397
 AliITSClusterFinderV2SSD.cxx:1398
 AliITSClusterFinderV2SSD.cxx:1399
 AliITSClusterFinderV2SSD.cxx:1400
 AliITSClusterFinderV2SSD.cxx:1401
 AliITSClusterFinderV2SSD.cxx:1402
 AliITSClusterFinderV2SSD.cxx:1403
 AliITSClusterFinderV2SSD.cxx:1404
 AliITSClusterFinderV2SSD.cxx:1405
 AliITSClusterFinderV2SSD.cxx:1406
 AliITSClusterFinderV2SSD.cxx:1407
 AliITSClusterFinderV2SSD.cxx:1408
 AliITSClusterFinderV2SSD.cxx:1409
 AliITSClusterFinderV2SSD.cxx:1410
 AliITSClusterFinderV2SSD.cxx:1411
 AliITSClusterFinderV2SSD.cxx:1412
 AliITSClusterFinderV2SSD.cxx:1413
 AliITSClusterFinderV2SSD.cxx:1414
 AliITSClusterFinderV2SSD.cxx:1415
 AliITSClusterFinderV2SSD.cxx:1416
 AliITSClusterFinderV2SSD.cxx:1417
 AliITSClusterFinderV2SSD.cxx:1418
 AliITSClusterFinderV2SSD.cxx:1419
 AliITSClusterFinderV2SSD.cxx:1420
 AliITSClusterFinderV2SSD.cxx:1421
 AliITSClusterFinderV2SSD.cxx:1422
 AliITSClusterFinderV2SSD.cxx:1423
 AliITSClusterFinderV2SSD.cxx:1424
 AliITSClusterFinderV2SSD.cxx:1425
 AliITSClusterFinderV2SSD.cxx:1426
 AliITSClusterFinderV2SSD.cxx:1427
 AliITSClusterFinderV2SSD.cxx:1428
 AliITSClusterFinderV2SSD.cxx:1429
 AliITSClusterFinderV2SSD.cxx:1430
 AliITSClusterFinderV2SSD.cxx:1431
 AliITSClusterFinderV2SSD.cxx:1432
 AliITSClusterFinderV2SSD.cxx:1433
 AliITSClusterFinderV2SSD.cxx:1434
 AliITSClusterFinderV2SSD.cxx:1435
 AliITSClusterFinderV2SSD.cxx:1436
 AliITSClusterFinderV2SSD.cxx:1437
 AliITSClusterFinderV2SSD.cxx:1438
 AliITSClusterFinderV2SSD.cxx:1439
 AliITSClusterFinderV2SSD.cxx:1440
 AliITSClusterFinderV2SSD.cxx:1441
 AliITSClusterFinderV2SSD.cxx:1442
 AliITSClusterFinderV2SSD.cxx:1443
 AliITSClusterFinderV2SSD.cxx:1444
 AliITSClusterFinderV2SSD.cxx:1445
 AliITSClusterFinderV2SSD.cxx:1446
 AliITSClusterFinderV2SSD.cxx:1447
 AliITSClusterFinderV2SSD.cxx:1448
 AliITSClusterFinderV2SSD.cxx:1449
 AliITSClusterFinderV2SSD.cxx:1450
 AliITSClusterFinderV2SSD.cxx:1451
 AliITSClusterFinderV2SSD.cxx:1452
 AliITSClusterFinderV2SSD.cxx:1453
 AliITSClusterFinderV2SSD.cxx:1454
 AliITSClusterFinderV2SSD.cxx:1455
 AliITSClusterFinderV2SSD.cxx:1456
 AliITSClusterFinderV2SSD.cxx:1457
 AliITSClusterFinderV2SSD.cxx:1458
 AliITSClusterFinderV2SSD.cxx:1459
 AliITSClusterFinderV2SSD.cxx:1460
 AliITSClusterFinderV2SSD.cxx:1461
 AliITSClusterFinderV2SSD.cxx:1462
 AliITSClusterFinderV2SSD.cxx:1463
 AliITSClusterFinderV2SSD.cxx:1464
 AliITSClusterFinderV2SSD.cxx:1465
 AliITSClusterFinderV2SSD.cxx:1466
 AliITSClusterFinderV2SSD.cxx:1467
 AliITSClusterFinderV2SSD.cxx:1468
 AliITSClusterFinderV2SSD.cxx:1469
 AliITSClusterFinderV2SSD.cxx:1470
 AliITSClusterFinderV2SSD.cxx:1471
 AliITSClusterFinderV2SSD.cxx:1472
 AliITSClusterFinderV2SSD.cxx:1473
 AliITSClusterFinderV2SSD.cxx:1474
 AliITSClusterFinderV2SSD.cxx:1475
 AliITSClusterFinderV2SSD.cxx:1476
 AliITSClusterFinderV2SSD.cxx:1477
 AliITSClusterFinderV2SSD.cxx:1478
 AliITSClusterFinderV2SSD.cxx:1479
 AliITSClusterFinderV2SSD.cxx:1480
 AliITSClusterFinderV2SSD.cxx:1481
 AliITSClusterFinderV2SSD.cxx:1482
 AliITSClusterFinderV2SSD.cxx:1483
 AliITSClusterFinderV2SSD.cxx:1484
 AliITSClusterFinderV2SSD.cxx:1485
 AliITSClusterFinderV2SSD.cxx:1486
 AliITSClusterFinderV2SSD.cxx:1487
 AliITSClusterFinderV2SSD.cxx:1488
 AliITSClusterFinderV2SSD.cxx:1489
 AliITSClusterFinderV2SSD.cxx:1490
 AliITSClusterFinderV2SSD.cxx:1491
 AliITSClusterFinderV2SSD.cxx:1492
 AliITSClusterFinderV2SSD.cxx:1493
 AliITSClusterFinderV2SSD.cxx:1494
 AliITSClusterFinderV2SSD.cxx:1495
 AliITSClusterFinderV2SSD.cxx:1496
 AliITSClusterFinderV2SSD.cxx:1497
 AliITSClusterFinderV2SSD.cxx:1498
 AliITSClusterFinderV2SSD.cxx:1499
 AliITSClusterFinderV2SSD.cxx:1500
 AliITSClusterFinderV2SSD.cxx:1501
 AliITSClusterFinderV2SSD.cxx:1502
 AliITSClusterFinderV2SSD.cxx:1503
 AliITSClusterFinderV2SSD.cxx:1504
 AliITSClusterFinderV2SSD.cxx:1505
 AliITSClusterFinderV2SSD.cxx:1506
 AliITSClusterFinderV2SSD.cxx:1507
 AliITSClusterFinderV2SSD.cxx:1508
 AliITSClusterFinderV2SSD.cxx:1509
 AliITSClusterFinderV2SSD.cxx:1510
 AliITSClusterFinderV2SSD.cxx:1511
 AliITSClusterFinderV2SSD.cxx:1512
 AliITSClusterFinderV2SSD.cxx:1513
 AliITSClusterFinderV2SSD.cxx:1514
 AliITSClusterFinderV2SSD.cxx:1515
 AliITSClusterFinderV2SSD.cxx:1516
 AliITSClusterFinderV2SSD.cxx:1517
 AliITSClusterFinderV2SSD.cxx:1518
 AliITSClusterFinderV2SSD.cxx:1519
 AliITSClusterFinderV2SSD.cxx:1520
 AliITSClusterFinderV2SSD.cxx:1521
 AliITSClusterFinderV2SSD.cxx:1522
 AliITSClusterFinderV2SSD.cxx:1523
 AliITSClusterFinderV2SSD.cxx:1524
 AliITSClusterFinderV2SSD.cxx:1525
 AliITSClusterFinderV2SSD.cxx:1526
 AliITSClusterFinderV2SSD.cxx:1527
 AliITSClusterFinderV2SSD.cxx:1528
 AliITSClusterFinderV2SSD.cxx:1529
 AliITSClusterFinderV2SSD.cxx:1530
 AliITSClusterFinderV2SSD.cxx:1531
 AliITSClusterFinderV2SSD.cxx:1532
 AliITSClusterFinderV2SSD.cxx:1533
 AliITSClusterFinderV2SSD.cxx:1534
 AliITSClusterFinderV2SSD.cxx:1535
 AliITSClusterFinderV2SSD.cxx:1536
 AliITSClusterFinderV2SSD.cxx:1537
 AliITSClusterFinderV2SSD.cxx:1538
 AliITSClusterFinderV2SSD.cxx:1539
 AliITSClusterFinderV2SSD.cxx:1540
 AliITSClusterFinderV2SSD.cxx:1541
 AliITSClusterFinderV2SSD.cxx:1542
 AliITSClusterFinderV2SSD.cxx:1543
 AliITSClusterFinderV2SSD.cxx:1544
 AliITSClusterFinderV2SSD.cxx:1545
 AliITSClusterFinderV2SSD.cxx:1546
 AliITSClusterFinderV2SSD.cxx:1547
 AliITSClusterFinderV2SSD.cxx:1548
 AliITSClusterFinderV2SSD.cxx:1549
 AliITSClusterFinderV2SSD.cxx:1550
 AliITSClusterFinderV2SSD.cxx:1551
 AliITSClusterFinderV2SSD.cxx:1552
 AliITSClusterFinderV2SSD.cxx:1553
 AliITSClusterFinderV2SSD.cxx:1554
 AliITSClusterFinderV2SSD.cxx:1555
 AliITSClusterFinderV2SSD.cxx:1556
 AliITSClusterFinderV2SSD.cxx:1557
 AliITSClusterFinderV2SSD.cxx:1558
 AliITSClusterFinderV2SSD.cxx:1559
 AliITSClusterFinderV2SSD.cxx:1560
 AliITSClusterFinderV2SSD.cxx:1561
 AliITSClusterFinderV2SSD.cxx:1562
 AliITSClusterFinderV2SSD.cxx:1563
 AliITSClusterFinderV2SSD.cxx:1564
 AliITSClusterFinderV2SSD.cxx:1565
 AliITSClusterFinderV2SSD.cxx:1566
 AliITSClusterFinderV2SSD.cxx:1567
 AliITSClusterFinderV2SSD.cxx:1568
 AliITSClusterFinderV2SSD.cxx:1569
 AliITSClusterFinderV2SSD.cxx:1570
 AliITSClusterFinderV2SSD.cxx:1571
 AliITSClusterFinderV2SSD.cxx:1572
 AliITSClusterFinderV2SSD.cxx:1573
 AliITSClusterFinderV2SSD.cxx:1574
 AliITSClusterFinderV2SSD.cxx:1575
 AliITSClusterFinderV2SSD.cxx:1576
 AliITSClusterFinderV2SSD.cxx:1577
 AliITSClusterFinderV2SSD.cxx:1578
 AliITSClusterFinderV2SSD.cxx:1579
 AliITSClusterFinderV2SSD.cxx:1580
 AliITSClusterFinderV2SSD.cxx:1581
 AliITSClusterFinderV2SSD.cxx:1582
 AliITSClusterFinderV2SSD.cxx:1583
 AliITSClusterFinderV2SSD.cxx:1584
 AliITSClusterFinderV2SSD.cxx:1585
 AliITSClusterFinderV2SSD.cxx:1586
 AliITSClusterFinderV2SSD.cxx:1587
 AliITSClusterFinderV2SSD.cxx:1588
 AliITSClusterFinderV2SSD.cxx:1589
 AliITSClusterFinderV2SSD.cxx:1590
 AliITSClusterFinderV2SSD.cxx:1591
 AliITSClusterFinderV2SSD.cxx:1592
 AliITSClusterFinderV2SSD.cxx:1593
 AliITSClusterFinderV2SSD.cxx:1594
 AliITSClusterFinderV2SSD.cxx:1595
 AliITSClusterFinderV2SSD.cxx:1596
 AliITSClusterFinderV2SSD.cxx:1597
 AliITSClusterFinderV2SSD.cxx:1598
 AliITSClusterFinderV2SSD.cxx:1599
 AliITSClusterFinderV2SSD.cxx:1600
 AliITSClusterFinderV2SSD.cxx:1601
 AliITSClusterFinderV2SSD.cxx:1602
 AliITSClusterFinderV2SSD.cxx:1603
 AliITSClusterFinderV2SSD.cxx:1604
 AliITSClusterFinderV2SSD.cxx:1605
 AliITSClusterFinderV2SSD.cxx:1606
 AliITSClusterFinderV2SSD.cxx:1607
 AliITSClusterFinderV2SSD.cxx:1608
 AliITSClusterFinderV2SSD.cxx:1609
 AliITSClusterFinderV2SSD.cxx:1610
 AliITSClusterFinderV2SSD.cxx:1611
 AliITSClusterFinderV2SSD.cxx:1612
 AliITSClusterFinderV2SSD.cxx:1613
 AliITSClusterFinderV2SSD.cxx:1614
 AliITSClusterFinderV2SSD.cxx:1615
 AliITSClusterFinderV2SSD.cxx:1616
 AliITSClusterFinderV2SSD.cxx:1617
 AliITSClusterFinderV2SSD.cxx:1618
 AliITSClusterFinderV2SSD.cxx:1619
 AliITSClusterFinderV2SSD.cxx:1620
 AliITSClusterFinderV2SSD.cxx:1621
 AliITSClusterFinderV2SSD.cxx:1622
 AliITSClusterFinderV2SSD.cxx:1623
 AliITSClusterFinderV2SSD.cxx:1624
 AliITSClusterFinderV2SSD.cxx:1625
 AliITSClusterFinderV2SSD.cxx:1626
 AliITSClusterFinderV2SSD.cxx:1627
 AliITSClusterFinderV2SSD.cxx:1628
 AliITSClusterFinderV2SSD.cxx:1629
 AliITSClusterFinderV2SSD.cxx:1630
 AliITSClusterFinderV2SSD.cxx:1631
 AliITSClusterFinderV2SSD.cxx:1632
 AliITSClusterFinderV2SSD.cxx:1633
 AliITSClusterFinderV2SSD.cxx:1634
 AliITSClusterFinderV2SSD.cxx:1635
 AliITSClusterFinderV2SSD.cxx:1636
 AliITSClusterFinderV2SSD.cxx:1637
 AliITSClusterFinderV2SSD.cxx:1638
 AliITSClusterFinderV2SSD.cxx:1639
 AliITSClusterFinderV2SSD.cxx:1640
 AliITSClusterFinderV2SSD.cxx:1641
 AliITSClusterFinderV2SSD.cxx:1642
 AliITSClusterFinderV2SSD.cxx:1643
 AliITSClusterFinderV2SSD.cxx:1644
 AliITSClusterFinderV2SSD.cxx:1645
 AliITSClusterFinderV2SSD.cxx:1646
 AliITSClusterFinderV2SSD.cxx:1647
 AliITSClusterFinderV2SSD.cxx:1648
 AliITSClusterFinderV2SSD.cxx:1649
 AliITSClusterFinderV2SSD.cxx:1650
 AliITSClusterFinderV2SSD.cxx:1651
 AliITSClusterFinderV2SSD.cxx:1652
 AliITSClusterFinderV2SSD.cxx:1653
 AliITSClusterFinderV2SSD.cxx:1654
 AliITSClusterFinderV2SSD.cxx:1655
 AliITSClusterFinderV2SSD.cxx:1656
 AliITSClusterFinderV2SSD.cxx:1657
 AliITSClusterFinderV2SSD.cxx:1658
 AliITSClusterFinderV2SSD.cxx:1659
 AliITSClusterFinderV2SSD.cxx:1660
 AliITSClusterFinderV2SSD.cxx:1661
 AliITSClusterFinderV2SSD.cxx:1662
 AliITSClusterFinderV2SSD.cxx:1663
 AliITSClusterFinderV2SSD.cxx:1664
 AliITSClusterFinderV2SSD.cxx:1665
 AliITSClusterFinderV2SSD.cxx:1666
 AliITSClusterFinderV2SSD.cxx:1667
 AliITSClusterFinderV2SSD.cxx:1668
 AliITSClusterFinderV2SSD.cxx:1669
 AliITSClusterFinderV2SSD.cxx:1670
 AliITSClusterFinderV2SSD.cxx:1671
 AliITSClusterFinderV2SSD.cxx:1672
 AliITSClusterFinderV2SSD.cxx:1673
 AliITSClusterFinderV2SSD.cxx:1674
 AliITSClusterFinderV2SSD.cxx:1675
 AliITSClusterFinderV2SSD.cxx:1676
 AliITSClusterFinderV2SSD.cxx:1677
 AliITSClusterFinderV2SSD.cxx:1678
 AliITSClusterFinderV2SSD.cxx:1679
 AliITSClusterFinderV2SSD.cxx:1680
 AliITSClusterFinderV2SSD.cxx:1681
 AliITSClusterFinderV2SSD.cxx:1682
 AliITSClusterFinderV2SSD.cxx:1683
 AliITSClusterFinderV2SSD.cxx:1684
 AliITSClusterFinderV2SSD.cxx:1685
 AliITSClusterFinderV2SSD.cxx:1686
 AliITSClusterFinderV2SSD.cxx:1687
 AliITSClusterFinderV2SSD.cxx:1688
 AliITSClusterFinderV2SSD.cxx:1689
 AliITSClusterFinderV2SSD.cxx:1690
 AliITSClusterFinderV2SSD.cxx:1691
 AliITSClusterFinderV2SSD.cxx:1692
 AliITSClusterFinderV2SSD.cxx:1693
 AliITSClusterFinderV2SSD.cxx:1694
 AliITSClusterFinderV2SSD.cxx:1695
 AliITSClusterFinderV2SSD.cxx:1696
 AliITSClusterFinderV2SSD.cxx:1697
 AliITSClusterFinderV2SSD.cxx:1698
 AliITSClusterFinderV2SSD.cxx:1699
 AliITSClusterFinderV2SSD.cxx:1700
 AliITSClusterFinderV2SSD.cxx:1701
 AliITSClusterFinderV2SSD.cxx:1702
 AliITSClusterFinderV2SSD.cxx:1703
 AliITSClusterFinderV2SSD.cxx:1704
 AliITSClusterFinderV2SSD.cxx:1705
 AliITSClusterFinderV2SSD.cxx:1706
 AliITSClusterFinderV2SSD.cxx:1707
 AliITSClusterFinderV2SSD.cxx:1708
 AliITSClusterFinderV2SSD.cxx:1709
 AliITSClusterFinderV2SSD.cxx:1710
 AliITSClusterFinderV2SSD.cxx:1711
 AliITSClusterFinderV2SSD.cxx:1712
 AliITSClusterFinderV2SSD.cxx:1713
 AliITSClusterFinderV2SSD.cxx:1714
 AliITSClusterFinderV2SSD.cxx:1715
 AliITSClusterFinderV2SSD.cxx:1716
 AliITSClusterFinderV2SSD.cxx:1717
 AliITSClusterFinderV2SSD.cxx:1718
 AliITSClusterFinderV2SSD.cxx:1719
 AliITSClusterFinderV2SSD.cxx:1720
 AliITSClusterFinderV2SSD.cxx:1721
 AliITSClusterFinderV2SSD.cxx:1722
 AliITSClusterFinderV2SSD.cxx:1723
 AliITSClusterFinderV2SSD.cxx:1724
 AliITSClusterFinderV2SSD.cxx:1725
 AliITSClusterFinderV2SSD.cxx:1726
 AliITSClusterFinderV2SSD.cxx:1727
 AliITSClusterFinderV2SSD.cxx:1728
 AliITSClusterFinderV2SSD.cxx:1729
 AliITSClusterFinderV2SSD.cxx:1730
 AliITSClusterFinderV2SSD.cxx:1731
 AliITSClusterFinderV2SSD.cxx:1732
 AliITSClusterFinderV2SSD.cxx:1733
 AliITSClusterFinderV2SSD.cxx:1734
 AliITSClusterFinderV2SSD.cxx:1735
 AliITSClusterFinderV2SSD.cxx:1736
 AliITSClusterFinderV2SSD.cxx:1737
 AliITSClusterFinderV2SSD.cxx:1738
 AliITSClusterFinderV2SSD.cxx:1739
 AliITSClusterFinderV2SSD.cxx:1740
 AliITSClusterFinderV2SSD.cxx:1741
 AliITSClusterFinderV2SSD.cxx:1742
 AliITSClusterFinderV2SSD.cxx:1743
 AliITSClusterFinderV2SSD.cxx:1744
 AliITSClusterFinderV2SSD.cxx:1745
 AliITSClusterFinderV2SSD.cxx:1746
 AliITSClusterFinderV2SSD.cxx:1747
 AliITSClusterFinderV2SSD.cxx:1748
 AliITSClusterFinderV2SSD.cxx:1749
 AliITSClusterFinderV2SSD.cxx:1750
 AliITSClusterFinderV2SSD.cxx:1751
 AliITSClusterFinderV2SSD.cxx:1752
 AliITSClusterFinderV2SSD.cxx:1753
 AliITSClusterFinderV2SSD.cxx:1754
 AliITSClusterFinderV2SSD.cxx:1755
 AliITSClusterFinderV2SSD.cxx:1756
 AliITSClusterFinderV2SSD.cxx:1757
 AliITSClusterFinderV2SSD.cxx:1758
 AliITSClusterFinderV2SSD.cxx:1759
 AliITSClusterFinderV2SSD.cxx:1760
 AliITSClusterFinderV2SSD.cxx:1761
 AliITSClusterFinderV2SSD.cxx:1762
 AliITSClusterFinderV2SSD.cxx:1763
 AliITSClusterFinderV2SSD.cxx:1764
 AliITSClusterFinderV2SSD.cxx:1765
 AliITSClusterFinderV2SSD.cxx:1766
 AliITSClusterFinderV2SSD.cxx:1767
 AliITSClusterFinderV2SSD.cxx:1768
 AliITSClusterFinderV2SSD.cxx:1769
 AliITSClusterFinderV2SSD.cxx:1770
 AliITSClusterFinderV2SSD.cxx:1771
 AliITSClusterFinderV2SSD.cxx:1772
 AliITSClusterFinderV2SSD.cxx:1773
 AliITSClusterFinderV2SSD.cxx:1774
 AliITSClusterFinderV2SSD.cxx:1775
 AliITSClusterFinderV2SSD.cxx:1776
 AliITSClusterFinderV2SSD.cxx:1777
 AliITSClusterFinderV2SSD.cxx:1778
 AliITSClusterFinderV2SSD.cxx:1779
 AliITSClusterFinderV2SSD.cxx:1780
 AliITSClusterFinderV2SSD.cxx:1781
 AliITSClusterFinderV2SSD.cxx:1782
 AliITSClusterFinderV2SSD.cxx:1783
 AliITSClusterFinderV2SSD.cxx:1784
 AliITSClusterFinderV2SSD.cxx:1785
 AliITSClusterFinderV2SSD.cxx:1786
 AliITSClusterFinderV2SSD.cxx:1787
 AliITSClusterFinderV2SSD.cxx:1788
 AliITSClusterFinderV2SSD.cxx:1789
 AliITSClusterFinderV2SSD.cxx:1790
 AliITSClusterFinderV2SSD.cxx:1791
 AliITSClusterFinderV2SSD.cxx:1792
 AliITSClusterFinderV2SSD.cxx:1793
 AliITSClusterFinderV2SSD.cxx:1794
 AliITSClusterFinderV2SSD.cxx:1795
 AliITSClusterFinderV2SSD.cxx:1796
 AliITSClusterFinderV2SSD.cxx:1797
 AliITSClusterFinderV2SSD.cxx:1798
 AliITSClusterFinderV2SSD.cxx:1799
 AliITSClusterFinderV2SSD.cxx:1800
 AliITSClusterFinderV2SSD.cxx:1801
 AliITSClusterFinderV2SSD.cxx:1802
 AliITSClusterFinderV2SSD.cxx:1803
 AliITSClusterFinderV2SSD.cxx:1804
 AliITSClusterFinderV2SSD.cxx:1805
 AliITSClusterFinderV2SSD.cxx:1806
 AliITSClusterFinderV2SSD.cxx:1807
 AliITSClusterFinderV2SSD.cxx:1808
 AliITSClusterFinderV2SSD.cxx:1809
 AliITSClusterFinderV2SSD.cxx:1810
 AliITSClusterFinderV2SSD.cxx:1811
 AliITSClusterFinderV2SSD.cxx:1812
 AliITSClusterFinderV2SSD.cxx:1813
 AliITSClusterFinderV2SSD.cxx:1814
 AliITSClusterFinderV2SSD.cxx:1815
 AliITSClusterFinderV2SSD.cxx:1816
 AliITSClusterFinderV2SSD.cxx:1817
 AliITSClusterFinderV2SSD.cxx:1818
 AliITSClusterFinderV2SSD.cxx:1819
 AliITSClusterFinderV2SSD.cxx:1820
 AliITSClusterFinderV2SSD.cxx:1821
 AliITSClusterFinderV2SSD.cxx:1822
 AliITSClusterFinderV2SSD.cxx:1823
 AliITSClusterFinderV2SSD.cxx:1824
 AliITSClusterFinderV2SSD.cxx:1825
 AliITSClusterFinderV2SSD.cxx:1826
 AliITSClusterFinderV2SSD.cxx:1827
 AliITSClusterFinderV2SSD.cxx:1828
 AliITSClusterFinderV2SSD.cxx:1829
 AliITSClusterFinderV2SSD.cxx:1830
 AliITSClusterFinderV2SSD.cxx:1831
 AliITSClusterFinderV2SSD.cxx:1832
 AliITSClusterFinderV2SSD.cxx:1833
 AliITSClusterFinderV2SSD.cxx:1834
 AliITSClusterFinderV2SSD.cxx:1835
 AliITSClusterFinderV2SSD.cxx:1836
 AliITSClusterFinderV2SSD.cxx:1837
 AliITSClusterFinderV2SSD.cxx:1838
 AliITSClusterFinderV2SSD.cxx:1839
 AliITSClusterFinderV2SSD.cxx:1840
 AliITSClusterFinderV2SSD.cxx:1841
 AliITSClusterFinderV2SSD.cxx:1842
 AliITSClusterFinderV2SSD.cxx:1843
 AliITSClusterFinderV2SSD.cxx:1844
 AliITSClusterFinderV2SSD.cxx:1845
 AliITSClusterFinderV2SSD.cxx:1846
 AliITSClusterFinderV2SSD.cxx:1847
 AliITSClusterFinderV2SSD.cxx:1848
 AliITSClusterFinderV2SSD.cxx:1849
 AliITSClusterFinderV2SSD.cxx:1850
 AliITSClusterFinderV2SSD.cxx:1851
 AliITSClusterFinderV2SSD.cxx:1852
 AliITSClusterFinderV2SSD.cxx:1853
 AliITSClusterFinderV2SSD.cxx:1854
 AliITSClusterFinderV2SSD.cxx:1855
 AliITSClusterFinderV2SSD.cxx:1856
 AliITSClusterFinderV2SSD.cxx:1857
 AliITSClusterFinderV2SSD.cxx:1858
 AliITSClusterFinderV2SSD.cxx:1859