to be substituted by the new version based on Bari/Salerno model
authorbarbera <barbera@f7af4fe6-9843-0410-8265-dc069ae4e863>
Thu, 31 May 2001 21:00:04 +0000 (21:00 +0000)
committerbarbera <barbera@f7af4fe6-9843-0410-8265-dc069ae4e863>
Thu, 31 May 2001 21:00:04 +0000 (21:00 +0000)
ITS/AliITSClusterFinderSPD.cxx [deleted file]
ITS/AliITSClusterFinderSPD.h [deleted file]

diff --git a/ITS/AliITSClusterFinderSPD.cxx b/ITS/AliITSClusterFinderSPD.cxx
deleted file mode 100644 (file)
index df233a7..0000000
+++ /dev/null
@@ -1,402 +0,0 @@
-/**************************************************************************
- * Copyright(c) 1998-1999, ALICE Experiment at CERN, All rights reserved. *
- *                                                                        *
- * Author: The ALICE Off-line Project.                                    *
- * Contributors are mentioned in the code where appropriate.              *
- *                                                                        *
- * Permission to use, copy, modify and distribute this software and its   *
- * documentation strictly for non-commercial purposes is hereby granted   *
- * without fee, provided that the above copyright notice appears in all   *
- * copies and that both the copyright notice and this permission notice   *
- * appear in the supporting documentation. The authors make no claims     *
- * about the suitability of this software for any purpose. It is          *
- * provided "as is" without express or implied warranty.                  *
- **************************************************************************/
-
-/*
-$Log$
-Revision 1.15  2001/05/01 22:37:44  nilsen
-Added a dummy argument to FindRawClusters. Argument used for SSD version.
-
-Revision 1.14  2001/03/05 14:48:46  nilsen
-Fixed a reoccuring bug. Array sizes must be declare const.
-
-*/
-
-#include <iostream.h>
-#include "AliITSClusterFinderSPD.h"
-#include "AliITSMapA1.h"
-#include "AliITS.h"
-#include "AliITSdigit.h"
-#include "AliITSRawCluster.h"
-#include "AliITSRecPoint.h"
-#include "AliITSsegmentation.h"
-#include "AliITSresponse.h"
-#include "AliRun.h"
-
-
-
-ClassImp(AliITSClusterFinderSPD)
-
-//----------------------------------------------------------
-AliITSClusterFinderSPD::AliITSClusterFinderSPD
-(AliITSsegmentation *seg, TClonesArray *digits, TClonesArray *recp)   
-{
-  // constructor
-    fSegmentation=seg;
-    fDigits=digits;
-    fClusters=recp;
-    fNclusters= 0;
-    fMap=new AliITSMapA1(fSegmentation,fDigits);
-    SetDx();
-    SetDz();
-    SetNCells();
-}
-
-//_____________________________________________________________________________
-AliITSClusterFinderSPD::AliITSClusterFinderSPD()
-{
-  // constructor
-  fSegmentation=0;
-  fDigits=0;
-  fClusters=0;
-  fNclusters=0;
-  fMap=0;
-  SetDx();
-  SetDz();
-  SetNCells();
-  
-}
-
-//_____________________________________________________________________________
-AliITSClusterFinderSPD::~AliITSClusterFinderSPD()
-{
-  // destructor
-  if (fMap) delete fMap;
-
-
-}
-//_____________________________________________________________________________
-
-void AliITSClusterFinderSPD::Find1DClusters()
-{
-  // Find one dimensional clusters, i.e.
-  // in r*phi(x) direction for each colunm in z direction
-  
-  AliITS *iTS=(AliITS*)gAlice->GetModule("ITS");
-  
-  // retrieve the parameters 
-  Int_t fNofPixels = fSegmentation->Npz(); 
-  Int_t fMaxNofSamples = fSegmentation->Npx();
-  
-  // read in digits -> do not apply threshold 
-  // signal in fired pixels is always 1
-
-  fMap->FillMap();
-  
-  Int_t nofFoundClusters = 0;
-  
-  Int_t k,it,m;
-  for(k=0;k<fNofPixels;k++) {
-    
-    Int_t mmax = 10;  // a size of the window for the cluster finding
-    
-    for(it=0;it<fMaxNofSamples;it++) {
-      
-      Int_t lclx = 0;
-      Int_t xstart = 0;
-      Int_t xstop = 0;
-      Int_t id = 0;
-      Int_t ilcl =0;
-      
-      for(m=0;m<mmax;m++) {  // find the cluster inside the window
-       id = it+m;
-       if(id >= fMaxNofSamples) break;    // ! no possible for the fadc 
-       
-       if(fMap->TestHit(k,id) == kUnused) {   // start of the cluster
-         lclx += 1;
-         if(lclx == 1) xstart = id;
-         
-       }
-       
-       if(lclx > 0 && fMap->TestHit(k,id) == kEmpty) {  
-         // end of cluster if a gap exists
-         xstop = id-1;
-         ilcl = 1;
-         break;
-       }            
-       
-      }   //  end of m-loop
-      
-      if(lclx == 0 && ilcl == 0) it = id; // no cluster in the window,
-      // continue the "it" loop
-      
-      if(id >= fMaxNofSamples && lclx == 0) break; // the x row finished
-      
-      if(id < fMaxNofSamples && ilcl == 0 && lclx > 0) {  
-                                  // cluster end is outside of the window,
-       mmax += 5;                 // increase mmax and repeat the cluster
-                                  // finding
-       it -= 1;
-      }
-      
-      if(id >= fMaxNofSamples && lclx > 0) {  // the x row finished but
-       xstop = fMaxNofSamples - 1;           // the end cluster exists
-       ilcl = 1;
-      } 
-      
-      // ---  Calculate z and x coordinates for one dimensional clusters
-      
-      if(ilcl == 1) {         // new cluster exists
-       it = id;
-       mmax = 10;
-           nofFoundClusters++;
-           Float_t clusterCharge = 0.;
-            Float_t zpitch = fSegmentation->Dpz(k+1); 
-           Float_t clusterZ, dummyX; 
-            Int_t dummy=0;
-            fSegmentation->GetPadCxz(dummy,k,dummyX,clusterZ);
-            Float_t zstart = clusterZ - 0.5*zpitch;
-            Float_t zstop = clusterZ + 0.5*zpitch;
-           Float_t clusterX = 0.;
-            Int_t xstartfull = xstart;
-            Int_t xstopfull = xstop;
-           Int_t clusterSizeX = lclx;
-           Int_t clusterSizeZ = 1;
-           
-            Int_t its;
-           for(its=xstart; its<=xstop; its++) {
-              Int_t firedpixel=0;
-              if (fMap->GetHitIndex(k,its)>=0) firedpixel=1; 
-             clusterCharge += firedpixel;
-              clusterX +=its + 0.5;
-           }
-            Float_t fRphiPitch = fSegmentation->Dpx(dummy);
-           clusterX /= (clusterSizeX/fRphiPitch); // center of gravity for x 
-           
-           // Write the points (coordinates and some cluster information) to the
-           // AliITSRawClusterSPD object
-           
-           AliITSRawClusterSPD clust(clusterZ,clusterX,clusterCharge,clusterSizeZ,clusterSizeX,xstart,xstop,xstartfull,xstopfull,zstart,zstop,k);
-
-           iTS->AddCluster(0,&clust);
-
-      }    // new cluster (ilcl=1)
-    } // X direction loop (it)
-  } // Z direction loop (k)
-
-  //fMap->ClearMap();
-  return;
-  
-}
-
-//_____________________________________________________________________________
-void  AliITSClusterFinderSPD::GroupClusters()
-{
-  // Find two dimensional clusters, i.e. group one dimensional clusters
-  // into two dimensional ones (go both in x and z directions).
-  
-  // get number of clusters for this module
-  Int_t nofClusters = fClusters->GetEntriesFast();
-  nofClusters -= fNclusters;
-
-  AliITSRawClusterSPD *clusterI;
-  AliITSRawClusterSPD *clusterJ;
-  
-  Int_t *label=new Int_t[nofClusters];  
-  Int_t i,j;
-  for(i=0; i<nofClusters; i++) label[i] = 0;
-  for(i=0; i<nofClusters; i++) {
-    if(label[i] != 0) continue;
-    for(j=i+1; j<nofClusters; j++) { 
-      if(label[j] != 0) continue;
-      clusterI = (AliITSRawClusterSPD*) fClusters->At(i);
-      clusterJ = (AliITSRawClusterSPD*) fClusters->At(j);
-      Bool_t pair = clusterI->Brother(clusterJ,fDz,fDx);
-      if(pair) {     
-       
-       //    if((clusterI->XStop() == clusterJ->XStart()-1)||(clusterI->XStart()==clusterJ->XStop()+1)) cout<<"!! Diagonal cluster"<<endl;
-
-       /*
-             cout << "clusters " << i << "," << j << " before grouping" << endl;
-             clusterI->PrintInfo();
-             clusterJ->PrintInfo();
-       */
-
-       clusterI->Add(clusterJ);
-       //      cout << "remove cluster " << j << endl;
-       label[j] = 1;
-       fClusters->RemoveAt(j);
-
-       /*
-         cout << "cluster  " << i << " after grouping" << endl;
-         clusterI->PrintInfo();
-       */
-
-      }  // pair
-    } // J clusters  
-    label[i] = 1;
-  } // I clusters
-  fClusters->Compress();
-
-  /*
-    Int_t totalNofClusters = fClusters->GetEntriesFast();
-    cout << " Nomber of clusters at the group end ="<< totalNofClusters<<endl;
-  */
-
-  delete [] label;
-
-  return;
-  
-  
-}
-//_____________________________________________________________________________
-
-void AliITSClusterFinderSPD::TracksInCluster()
-{
-  
-  // Find tracks creating one cluster
-
-  // get number of clusters for this module
-  Int_t nofClusters = fClusters->GetEntriesFast();
-  nofClusters -= fNclusters;
-
-  Int_t i, ix, iz, jx, jz, xstart, xstop, zstart, zstop, nclx, nclz;
-  const Int_t trmax = 100;
-  Int_t cltracks[trmax], itr, tracki, ii, is, js, ie, ntr, tr0, tr1, tr2;
-
-  for(i=0; i<nofClusters; i++) { 
-    ii = 0;
-    memset(cltracks,-1,sizeof(int)*trmax);
-    tr0=tr1=tr2=-1;
-
-    AliITSRawClusterSPD *clusterI = (AliITSRawClusterSPD*) fClusters->At(i);
-
-    nclx = clusterI->NclX();
-    nclz = clusterI->NclZ();
-    xstart = clusterI->XStartf();
-    xstop = clusterI->XStopf();
-    zstart = clusterI->Zend()-nclz+1;
-    zstop = clusterI->Zend();
-    Int_t ind; 
-
-     for(iz=0; iz<nclz; iz++) { 
-         jz = zstart + iz;
-       for(ix=0; ix<nclx; ix++) { 
-        jx = xstart + ix;
-        ind = fMap->GetHitIndex(jz,jx);
-        if(ind < 0) {
-          continue;
-         }
-        if(ind == 0 && iz >= 0 && ix > 0) {
-          continue;
-         }
-        if(ind == 0 && iz > 0 && ix >= 0) {
-          continue;
-         }
-        if(ind == 0 && iz == 0 && ix == 0 && i > 0) {
-          continue;
-         }
-
-        AliITSdigitSPD *dig = (AliITSdigitSPD*)fMap->GetHit(jz,jx);
-
-       /*
-         signal=dig->fSignal;
-         track0=dig->fTracks[0];
-         track1=dig->fTracks[1];
-         track2=dig->fTracks[2];
-       */
-
-          for(itr=0; itr<3; itr++) { 
-           tracki = dig->fTracks[itr];
-            if(tracki >= 0) {
-             ii += 1;
-             if(ii > 90) { 
-             }
-             if(ii < 99) cltracks[ii-1] = tracki;
-            }
-         }
-       } // ix pixel
-     }  // iz pixel
-     for(is=0; is<trmax; is++) { 
-         if(cltracks[is]<0) continue;
-       for(js=is+1; js<trmax; js++) { 
-         if(cltracks[js]<0) continue;
-         if(cltracks[js]==cltracks[is]) cltracks[js]=-5;
-       }
-     }
-
-     ntr = 0;
-     for(ie=0; ie<trmax; ie++) { 
-       if(cltracks[ie] >= 0) {
-        ntr=ntr+1;
-        if(ntr==1) tr0=cltracks[ie];
-        if(ntr==2) tr1=cltracks[ie];
-        if(ntr==3) tr2=cltracks[ie];
-       }
-     }
-     // if delta ray only
-     if(ntr == 0) ntr = 1;
-
-     clusterI->SetNTracks(ntr);
-     clusterI->SetTracks(tr0,tr1,tr2);
-
-  } // I cluster
-
-}
-//_____________________________________________________________________________
-
-void AliITSClusterFinderSPD::GetRecPoints()
-{
-  // get rec points
-  AliITS *iTS=(AliITS*)gAlice->GetModule("ITS");
-  
-  // get number of clusters for this module
-  Int_t nofClusters = fClusters->GetEntriesFast();
-  nofClusters -= fNclusters;
-  const Float_t kconv = 1.0e-4;
-  const Float_t kRMSx = 12.0*kconv; // microns -> cm ITS TDR Table 1.3
-  const Float_t kRMSz = 70.0*kconv; // microns -> cm ITS TDR Table 1.3
-
-  Float_t spdLength = fSegmentation->Dz();
-  Float_t spdWidth = fSegmentation->Dx();
-
-  Int_t i;
-  Int_t track0, track1, track2;
-
-  for(i=0; i<nofClusters; i++) { 
-
-    AliITSRawClusterSPD *clusterI = (AliITSRawClusterSPD*) fClusters->At(i);
-    clusterI->GetTracks(track0, track1, track2); 
-    AliITSRecPoint rnew;
-
-    rnew.SetX((clusterI->X() - spdWidth/2)*kconv);
-    rnew.SetZ((clusterI->Z() - spdLength/2)*kconv);
-    rnew.SetQ(1.);
-    rnew.SetdEdX(0.);
-    rnew.SetSigmaX2(kRMSx*kRMSx);
-    rnew.SetSigmaZ2(kRMSz*kRMSz);
-    rnew.fTracks[0]=track0;
-    rnew.fTracks[1]=track1;
-    rnew.fTracks[2]=track2;
-    iTS->AddRecPoint(rnew);
-  } // I clusters
-
-  fMap->ClearMap();
-  
-}
-//_____________________________________________________________________________
-
-void AliITSClusterFinderSPD::FindRawClusters(Int_t mod)
-{
-  // find raw clusters
-  Find1DClusters();
-  GroupClusters();
-  TracksInCluster();
-  GetRecPoints();
-
-}
-
-
-
diff --git a/ITS/AliITSClusterFinderSPD.h b/ITS/AliITSClusterFinderSPD.h
deleted file mode 100644 (file)
index 787e52b..0000000
+++ /dev/null
@@ -1,69 +0,0 @@
-#ifndef ALIITSCLUSTERFINDERSPD_H
-#define ALIITSCLUSTERFINDERSPD_H
-
-////////////////////////////////////////////////
-//  ITS Cluster Finder Class                 //
-////////////////////////////////////////////////
-
-#include "AliITSClusterFinder.h"
-
-class AliITSMapA1;
-
-class AliITSClusterFinderSPD :
-  public AliITSClusterFinder
-
-{
-public:
-  AliITSClusterFinderSPD
-       (AliITSsegmentation *seg, TClonesArray *dig, TClonesArray *recp);
-  AliITSClusterFinderSPD();
-  virtual ~AliITSClusterFinderSPD();
-  
-  void SetDx(Float_t dx=1.) {
-    // set dx
-    fDx=dx;
-  }
-  void SetDz(Float_t dz=0.) {
-    // set dz
-    fDz=dz;
-  }
-  void SetNCells(Int_t minc=0) {
-    // set ncells
-    fMinNCells=minc;
-  }
-  
-  // Search for clusters
-  void FindRawClusters(Int_t mod=0);
-  void  Find1DClusters();
-  void  GroupClusters();
-  void  TracksInCluster();
-  void  SelectClusters() {
-    // selects clusters
-  }
-  void  GetRecPoints();
-  
-  private:
-
-  AliITSClusterFinderSPD(const AliITSClusterFinderSPD &source); // copy ctor
-  AliITSClusterFinderSPD& operator=(const AliITSClusterFinderSPD &source); 
-
-private:
-  
-  TClonesArray       *fClusters;      // clusters
-  Int_t               fNclusters;     // num of clusters
-  Float_t             fDz;            // dz
-  Float_t             fDx;            // dx
-  
-  Int_t               fMinNCells;     // min num of cells in the cluster
-  
-  ClassDef(AliITSClusterFinderSPD,1)  // SPD clustering - Boris B. algo based
-                                      // on Piergiorgio's algo
-    };
-#endif
-
-
-
-
-
-
-