From deb0fc734db40b337ece4075a22440c4f838019e Mon Sep 17 00:00:00 2001 From: bnandi Date: Sat, 13 Sep 2003 21:01:13 +0000 Subject: [PATCH] clustering algorithm --- PMD/AliPMDClustering.cxx | 820 +++++++++++++++++++++++++++++++++++++++ PMD/AliPMDClustering.h | 111 ++++++ 2 files changed, 931 insertions(+) create mode 100644 PMD/AliPMDClustering.cxx create mode 100644 PMD/AliPMDClustering.h diff --git a/PMD/AliPMDClustering.cxx b/PMD/AliPMDClustering.cxx new file mode 100644 index 00000000000..55f587e750c --- /dev/null +++ b/PMD/AliPMDClustering.cxx @@ -0,0 +1,820 @@ +//-----------------------------------------------------// +// // +// Source File : PMDClustering.cxx, Version 00 // +// // +// Date : September 26 2002 // +// // +// clustering code for alice pmd // +// // +//-----------------------------------------------------// + +/* + -------------------------------------------------------------------- + Code developed by S. C. Phatak, Institute of Physics, + Bhubaneswar 751 005 ( phatak@iopb.res.in ) Given the energy deposited + ( or ADC value ) in each cell of supermodule ( pmd or cpv ), the code + builds up superclusters and breaks them into clusters. The input is + in array d[ndimx][ndimy] and cluster information is in array + clusters[5][5000]. integer clno gives total number of clusters in the + supermodule. + + d, clno and clusters are the only global ( public ) variables. Others + are local ( private ) to the code. + + At the moment, the data is read for whole detector ( all supermodules + and pmd as well as cpv. This will have to be modify later ) + + LAST UPDATE : October 23, 2002 +----------------------------------------------------------------------- +*/ + + + +#include +#include +#include "AliPMDContainer.h" +#include "AliPMDcluster.h" +#include "AliPMDClustering.h" +#include + +ClassImp(AliPMDClustering) + +AliPMDClustering::AliPMDClustering() +{ + fMessage = 0; + for(int i = 0; i < ndimx; i++) + { + for(int j = 0; j < ndimy; j++) + { + coord[0][i][j] = i+j/2.; + coord[1][i][j] = sqrth*j; + } + } +} +AliPMDClustering::~AliPMDClustering() +{ + +} + +//void AliPMDClustering::DoClust(int idet, int isup, double d1[72][72], AliPMDContainer *pmdc) +void AliPMDClustering::DoClust(int idet, int isup, double d1[72][72], TObjArray *pmdcont) +{ + + AliPMDcluster *pmdcl = 0; + + int i, i1, i2, j, nmx1, incr; + double cutoff, ave; + Float_t clusdata[5]; + + const float twobysqrt3 = 1.1547; // 2./sqrt(3.) + + // if (fMessage == 1) + { + cout << " supermodule no. " << idet << " " << isup << endl; + } + + for (i = 0; i < ndimx; i++) + { + for (j = 0; j < ndimy; j++) + { + d[i][j] = d1[i][j]; + } + } + order(idet); // order the data + cutoff=400.; // cutoff used to discard cells having ener. dep. + ave=0.; + nmx1=-1; + + for(j=0;j 0.) {ave=ave+d[i1][i2];} + if (d[i1][i2] >= cutoff ) nmx1 = nmx1 + 1; + } + // nmx1 --- number of cells having ener dep >= cutoff + if (fMessage == 1) + { + cout << " nmx1 " << nmx1 << endl; + } + ave=ave/nmx1; + if (fMessage == 1) + { + cout <<"nmx " << nmx << " nmx1 " << nmx1<< " ave "<Add(pmdcl); + } + + delete pmdcl; + +} + +void AliPMDClustering::order(int idet) +{ + // using simple sort + double dd[nmx], adum;// matrix d converted into + // one dimensional array dd. adum a place holder for double + int i, j, i1, i2, iord1[nmx], itst, idum; // information of + // ordering is stored in iord1, original array not ordered + // + // define arrays dd and iord1 + for(i1=0; i1 < ndimx; i1++){ + for(i2=0; i2 < ndimy; i2++){ + i=i1+i2*ndimx; + iord1[i]=i; dd[i]=d[i1][i2]; + } + } + // sort and store sorting information in iord1 + for(j=1; j < nmx; j++){ + itst=0; adum=dd[j]; idum=iord1[j]; + for(i1=0; i1 < j ; i1++){ + if(adum > dd[i1] && itst == 0){ + itst=1; + for(i2=j-1; i2 >= i1 ; i2=i2--){ + dd[i2+1]=dd[i2]; + iord1[i2+1]=iord1[i2]; + } + dd[i1]=adum; iord1[i1]=idum; + } + } + } + // store the sorted information in iord for later use + for(i=0; i single cluster + // cluster center at the centyer of the cell + // cluster radius = half cell dimension + clno=clno+1; + i1=infcl[1][id]; + i2=infcl[2][id]; + clusters[0][clno]=coord[0][i1][i2]; + clusters[1][clno]=coord[1][i1][i2]; + clusters[2][clno]=d[i1][i2]; + clusters[3][clno]=1.; + clusters[4][clno]=0.5; + //ofl1 << icl << " " << coord[0][i1][i2] << " " << coord[1][i1][i2] << + //" " << d[i1][i2] << " " << clusters[3][clno] < single cluster + // cluster center is at ener. dep.-weighted mean of two cells + // cluster radius == half cell dimension + id=id+1; + icl=icl+1; + clno=clno+1; + i1=infcl[1][id]; + i2=infcl[2][id]; + x1=coord[0][i1][i2]; + y1=coord[1][i1][i2]; + z1=d[i1][i2]; + id=id+1; + i1=infcl[1][id]; + i2=infcl[2][id]; + x2=coord[0][i1][i2]; + y2=coord[1][i1][i2]; + z2=d[i1][i2]; + clusters[0][clno]=(x1*z1+x2*z2)/(z1+z2); + clusters[1][clno]=(y1*z1+y2*z2)/(z1+z2); + clusters[2][clno]=z1+z2; + clusters[3][clno]=2.; + clusters[4][clno]=0.5; + //ofl1 << icl << " " << clusters[0][clno] << " " << clusters[1][clno] + // << " " << clusters[2][clno] << " " < 1 cell) + // Begin from cell having largest energy deposited This is first + // cluster center + i1=infcl[1][id]; + i2=infcl[2][id]; + x[0]=coord[0][i1][i2]; + y[0]=coord[1][i1][i2]; + z[0]=d[i1][i2]; + iord[0]=0; + for(j=1;j<=ncl[i];j++){ + id=id+1; + i1=infcl[1][id]; + i2=infcl[2][id]; + iord[j]=j; + x[j]=coord[0][i1][i2]; + y[j]=coord[1][i1][i2]; + z[j]=d[i1][i2]; + } + // arranging cells within supercluster in decreasing order + for(j=1;j<=ncl[i];j++){ + itest=0; ihld=iord[j]; + for(i1=0;i1=i1;i2--){ + iord[i2+1]=iord[i2]; + } + iord[i1]=ihld; + } + } + } + // compute the number of Gaussians and their centers ( first + // guess ) + // centers must be separated by cells having smaller ener. dep. + // neighbouring centers should be either strong or well-separated + ig=0; + xc[ig]=x[iord[0]]; + yc[ig]=y[iord[0]]; + zc[ig]=z[iord[0]]; + for(j=1;j<=ncl[i];j++){ + itest=-1; + x1=x[iord[j]]; + y1=y[iord[j]]; + for(k=0;k<=ig;k++){ + x2=xc[k]; y2=yc[k]; + rr=Dist(x1,y1,x2,y2); + if( rr >= 1.1 && rr < 1.8 && z[iord[j]] > zc[k]/4.) + itest=itest+1; + if( rr >= 1.8 && rr < 2.1 && z[iord[j]] > zc[k]/10.) + itest=itest+1; + if( rr >= 2.1)itest=itest+1; + } + if(itest == ig){ + ig=ig+1; + xc[ig]=x1; + yc[ig]=y1; + zc[ig]=z[iord[j]]; + } + } + // for(j=0; j<=ig; j++){ + //ofl1 << icl+j+1 << " " << xc[j] << " " < 0){ + for(j=0; j<=ncl[i]; j++){ + lev1[0]=0; + lev2[0]=0; + for(k=0; k<=ig; k++){ + dist=Dist(x[j], y[j], xc[k], yc[k]); + if(dist < sqrt(3.) ){ + lev1[0]++; + i1=lev1[0]; + lev1[i1]=k; + }else{ + if(dist < 2.1){ + lev2[0]++; + i1=lev2[0]; + lev2[i1]=k; + } + } + } + if(lev1[0] != 0){ + if(lev1[0] == 1){cells[lev1[1]]=cells[lev1[1]]+1.;} + else{ + sum=0.; + for(k=1; k<=lev1[0]; k++){ + sum=sum+zc[lev1[k]]; + } + for(k=1; k<=lev1[0]; k++){ + cells[lev1[k]]=cells[lev1[k]]+zc[lev1[k]]/sum; + } + } + }else{ + if(lev2[0] == 0){cells[lev2[1]]=cells[lev2[1]]+1.;} + else{ + sum=0.; + for(k=1; k<=lev2[0]; k++){ + sum=sum+zc[lev2[k]]; + } + for(k=1; k<=lev2[0]; k++){ + cells[lev2[k]]=cells[lev2[k]]+zc[lev2[k]]/sum; + } + } + } + } + } + for(j=0; j<=ig; j++){ + clno=clno+1; + clusters[0][clno]=xc[j]; + clusters[1][clno]=yc[j]; + clusters[2][clno]=zc[j]; + clusters[4][clno]=rc[j]; + if(ig == 0){ + clusters[3][clno]=ncl[i]; + }else{ + clusters[3][clno]=cells[j]; + } + } + } + } + +} + + +void AliPMDClustering::gaussfit(int ncell, int nclust, double &x, double &y ,double &z, double &xc, double &yc, double &zc, double &rc) +{ + int i, j, i1, i2, jmax, novar, idd, jj; + double xx[4500], yy[4500], zz[4500], xxc[4500], yyc[4500]; + double a[4500], b[4500], c[4500], d[4500], ha[4500], hb[4500]; + double hc[4500], hd[4500], zzc[4500], rrc[4500]; + int neib[4500][50]; + double sum, dx, dy, str, str1, aint, sum1, rr, dum; + double x1, x2, y1, y2; + str=0.; + str1=0.; + rr=0.3; + novar=0; + + j = 0; // Just put not to see the compiler warning, BKN + + + for(i=0; i<=ncell; i++){ + xx[i]=*(&x+i); + yy[i]=*(&y+i); + zz[i]=*(&z+i); + str=str+zz[i]; + } + for(i=0; i<=nclust; i++){ + xxc[i]=*(&xc+i); + yyc[i]=*(&yc+i); + zzc[i]=*(&zc+i); + str1=str1+zzc[i]; + rrc[i]=0.5; + + } + for(i=0; i<=nclust; i++){ + zzc[i]=str/str1*zzc[i]; + ha[i]=xxc[i]; + hb[i]=yyc[i]; + hc[i]=zzc[i]; + hd[i]=rrc[i]; + x1=xxc[i]; + y1=yyc[i]; + } + for(i=0; i<=ncell; i++){ + idd=0; + x1=xx[i]; + y1=yy[i]; + for(j=0; j<=nclust; j++){ + x2=xxc[j]; + y2=yyc[j]; + if(Dist(x1,y1,x2,y2) <= 3.){ idd=idd+1; neib[i][idd]=j; } + } + + neib[i][0]=idd; + } + sum=0.; + for(i1=0; i1<=ncell; i1++){ + aint=0.; + idd=neib[i1][0]; + for(i2=1; i2<=idd; i2++){ + jj=neib[i1][i2]; + dx=xx[i1]-xxc[jj]; + dy=yy[i1]-yyc[jj]; + dum=rrc[j]*rrc[jj]+rr*rr; + aint=aint+exp(-(dx*dx+dy*dy)/dum)*zzc[idd]*rr*rr/dum; + } + sum=sum+(aint-zz[i1])*(aint-zz[i1])/str; + } + jmax=nclust*1000; + if(nclust > 20)jmax=20000; + for(j=0; j= 0 && jd1 < 72) && (jd2 >= 0 && jd2 < 72) && + infocl[0][jd1][jd2] == 0){ + numcell=numcell+1; + infocl[0][jd1][jd2]=2; + infocl[1][jd1][jd2]=icl; + clust[0][numcell]=jd1; + clust[1][numcell]=jd2; + cellcount=cellcount+1; + infcl[0][cellcount]=icl; + infcl[1][cellcount]=jd1; + infcl[2][cellcount]=jd2; + } + } + // --------------------------------------------------------------- + // check adc count for neighbour's neighbours recursively and + // if nonzero, add these to the cluster. + // --------------------------------------------------------------- + for(i=1;i < 5000;i++){ + if(clust[0][i] != 0){ + id1=clust[0][i]; + id2=clust[1][i]; + for(j=0; j<6 ; j++){ + jd1=id1+neibx[j]; + jd2=id2+neiby[j]; + if( (jd1 >= 0 && jd1 < 72) && (jd2 >= 0 && jd2 < 72) && + infocl[0][jd1][jd2] == 0 ){ + infocl[0][jd1][jd2]=2; + infocl[1][jd1][jd2]=icl; + numcell=numcell+1; + clust[0][numcell]=jd1; + clust[1][numcell]=jd2; + cellcount=cellcount+1; + infcl[0][cellcount]=icl; + infcl[1][cellcount]=jd1; + infcl[2][cellcount]=jd2; + } + } + } + } + } + } + // for(icell=0; icell<=cellcount; icell++){ + // ofl0 << infcl[0][icell] << " " << infcl[1][icell] << " " << + // infcl[2][icell] << endl; + // } + return cellcount; +} + +double AliPMDClustering::ranmar() +{ + /* C==========================C*/ + /*===================================C==========================*/ + /* Universal random number generator proposed by Marsaglia and Zaman + in report FSU-SCRI-87-50 */ + + // clock_t start; + int ii, jj; + static int i=96, j=32, itest=0, i1, i2, i3, i4, i5; + static double u[97], c, cd, cm, s, t; + static double uni; + int count1,count2,idum; + /* $$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$ */ + if (itest == 0) { + //******************************************************* + // following three lines if the seed to be provided by computer + // start = time(NULL); + // ii=start; + // jj=start; + //******************************************************* + //following two lines for fixed seed ( during testing only. Else + //use preceeing three lines + ii=8263; + jj=5726; + if(ii > 31328 ) ii = ii - ( ii / 31328 ) * 31328; + if(jj > 30081 ) jj = jj - ( jj / 30081 ) * 30081; + itest=itest+1; + if((( ii > 0 ) && ( ii <= 31328 )) && (( jj > 0 ) && + ( jj <= 30081 ))){ + i1=ii/177+2; i2=ii-(i1-2)*177+2; i3=jj/169+1; i4=jj-(i3-1)*169; + i4 = jj - (i3-1)*169; + count1=0; + while ( count1 < 97 ){ + s=0.; + t=0.5; + count2=0; + while( count2 < 24 ){ + idum=i1*i2/179; + idum=( i1*i2 - (i1*i2/179)*179 ) * i3; + i5=idum-(idum/179)*179; + i1=i2; i2=i3; i3=i5; idum=53*i4+1; i4=idum-(idum/169)*169; + if( i4*i5-((i4*i5)/64)*64 >= 32 ) s=s+t; + t=0.5*t; + count2=count2+1; + } + u[count1] = s; + count1 = count1 +1; + } + c = 362436./16777216.; cd = 7654321./16777216.; + cm = 16777213./16777216.; + } + else{ + cout << " wrong initialization " << endl; + } + } + else{ + uni = u[i] - u[j]; if( uni < 0.) uni = uni + 1; u[i] = uni; + i = i -1; + if( i < 0 ) i = 96; j = j - 1; if ( j < 0 ) j = 96; c = c - cd; + if( c < 0. ) c = c+cm; uni = uni-c ; if( uni < 0. )uni = uni+1.; + // return uni; + } + return uni; + +} + +void AliPMDClustering::ConvertL2G(int smnumber, double xcell, double ycell, double &xpos, double &ypos) +{ + float xreal = -999., yreal = -999.; + float cell_rad=0.25, celldia_x=0.5, celldia_y=0.4330127; + float xcon, ycon; + float xoff1, xoff2, yoff=0.2886751, yoff3; + float xhex1 = -27.09375, yhex1 = -15.652584; + float xhex2 = 27.09375, yhex2 = -15.652584; + float xhex3 = 0.0, yhex3 = 31.285168; + + + double xcorner[27] = + { + 9.435395, 45.560394, 81.685394, -8.627106, + 27.497894, 63.622894, -26.689606, 9.435394, + 45.560394, 9.435344, -8.627106, -26.689556, + 45.560345, 27.497894, 9.435445, 81.685341, + 63.622894, 45.560444, -18.870789, -36.933388, + -54.995991, -36.933189, -54.995789, -73.058388, + -54.995586, -73.058189, -91.120789 + }; + + double ycorner[27] = + { + -16.342583, -16.34258, -16.34258, -47.627750, -47.627750, + -47.627750, -78.912918, -78.912918, -78.912918, 16.342611, + 47.627808, 78.913002, 16.342554, 47.627750, 78.912949, + 16.342495, 47.627693, 78.912888, -0.000116, -31.285227, + -62.570335, 31.285110, 0.000000, -31.285110, 62.570335, + 31.285227, 0.000116 + }; + + if (smnumber<=8) + { + xcon = xcorner[smnumber]+xhex1; + ycon = ycorner[smnumber]+yhex1; + xoff1 = celldia_x+(ycell-1)*cell_rad; + xreal = xcon+xoff1+celldia_x*(xcell-1); + yreal = ycon+yoff+celldia_y*(ycell-1); + } + + if (smnumber>8 && smnumber<=17) + { + xcon = xcorner[smnumber]+xhex2; + ycon = ycorner[smnumber]+yhex2; + xoff2 = celldia_x+(xcell-1)*cell_rad; + xreal = xcon-(xoff2+celldia_x*(ycell-1)); + yreal = ycon+yoff+celldia_y*(xcell-1); + } + + if (smnumber>17) + { + xcon = xcorner[smnumber]+xhex3; + ycon = ycorner[smnumber]+yhex3; + yoff3 = celldia_x * 0.8660254 + cell_rad * 0.57735027; + xreal = xcon+(ycell-xcell)*cell_rad; + yreal = ycon-(yoff3+(xcell+ycell-2)*celldia_y); + } + + xpos = xreal; + ypos = yreal; +} + +void AliPMDClustering::cell_pos(Int_t isup, Int_t j, int k, Float_t &xp, Float_t &yp){ + + /* + This converts PMD cluster or CELL coordinates + to Global coordinates. + Written by Prof. S.C. Phatak + */ + + Int_t i; + Float_t celldia = 0.5; + const Float_t pi = 3.14159; + const double sqrth=0.8660254; // sqrth = sqrt(3.)/2. + /* + isup --> supermodule no ( 0 - 26 ) + idet --> detector ( pmd or cpv : not required now ) + j --> xpad ( goes from 1 to 72 ) + k --> ypad ( goes from 1 to 72 ) + xp --> global x coordinate + yp --> global y coordinate + + (xp0,yp0) corner positions of all supermodules in global + coordinate system. That is the origin + of the local ( supermodule ) coordinate system. +*/ + + Float_t xp0[27] = + { + -17.9084, 18.2166, 54.3416, -35.9709, 0.154144, + 36.2791, -54.0334, -17.9084, 18.2166, 36.7791, + 18.7166, 0.654194, 72.9041, 54.8416, 36.7792, + 109.029, 90.9666, 72.9042, -18.8708, -36.9334, + -54.996, -36.9332, -54.9958, -73.0584, -54.9956, + -73.0582, -91.1208 + }; + + Float_t yp0[27] = + { + -32.1395, -32.1395, -32.1395, -63.4247, -63.4247, + -63.4247, -94.7098, -94.7098, -94.7098, 0.545689, + 31.8309, 63.1161, 0.545632, 31.8308, 63.116, + 0.545573, 31.8308, 63.116, 31.5737, 0.288616, + -30.9965, 62.859, 31.5738, 0.288733, 94.1442, + 62.8591, 31.574 + }; + + /* + angles of rotation for three sets of supermodules + The angle is same for first nine, next nine and last nine + supermodules + */ + + Float_t th[3] = {0., -2.*pi/3., 2.*pi/3.}; + Float_t xr, yr, xinit, yinit, cs, sn; + + /* + xinit and yinit are coordinates of the cell in local coordinate system + */ + + xinit = (j)*celldia+(k)/2.*celldia; + yinit = sqrth*(k)/2.; + i=isup/9; + cs=cos(th[i]); + sn=sin(th[i]); + // + // rotate first + // + xr=cs*xinit+sn*yinit; + yr=-sn*xinit+cs*yinit; + // + // then translate + // + xp=xr+xp0[isup]; + yp=yr+yp0[isup]; + +} +void AliPMDClustering::SetMessage(Int_t imessage) +{ + fMessage = imessage; +} diff --git a/PMD/AliPMDClustering.h b/PMD/AliPMDClustering.h new file mode 100644 index 00000000000..89d89e85efe --- /dev/null +++ b/PMD/AliPMDClustering.h @@ -0,0 +1,111 @@ +#ifndef PMDClustering_H +#define PMDClustering_H +//-----------------------------------------------------// +// // +// Header File : PMDClustering.h, Version 00 // +// // +// Date : September 26 2002 // +// // +// clustering code for alice pmd // +// // +//-----------------------------------------------------// +/* + -------------------------------------------------------------------- + Code developed by S. C. Phatak, Institute of Physics, + Bhubaneswar 751 005 ( phatak@iopb.res.in ) Given the energy deposited + ( or ADC value ) in each cell of supermodule ( pmd or cpv ), the code + builds up superclusters and breaks them into clusters. The input is + in array d[ndimx][ndimy] and cluster information is in array + clusters[5][5000]. integer clno gives total number of clusters in the + supermodule. + + d, clno and clusters are the only global ( public ) variables. Others + are local ( private ) to the code. + + At the moment, the data is read for whole detector ( all supermodules + and pmd as well as cpv. This will have to be modify later ) + + LAST UPDATE : October 23, 2002 +----------------------------------------------------------------------- +*/ + + +#include // define cout stream +#include // defines exit() functions +#include // for time function +#include // for mathematical functions +#include "Rtypes.h" + +class TNtuple; +class TObjArray; +class AliPMDContainer; +class AliPMDcluster; +class AliPMDClustering +{ + + protected: + + static const double pi=3.141593; + static const double sqrth=0.8660254; // sqrth = sqrt(3.)/2. + static const int nmx=5184; + static const int ndimx=72; + static const int ndimy=72; + + /* + nmx : # of cells in a supermodule + ndimx : maximum number of cells along x direction (origin at one corner) + ndimy : maximum number of cells along axis at 60 degrees with x axis + */ + + double d[ndimx][ndimy], clusters[5][5000]; + int clno; + + /* + d ---- energy deposited ( or ADC ) in each cell of the supermodule + clno --- number of clusters in a supermodule + A cell is defined in terms of two integers (i,j) giving the its location + clusters[0][i] --- x position of the cluster center + clusters[1][i] --- y position of the cluster center + clusters[2][i] --- total energy in the cluster + clusters[3][i] --- number of cells forming the cluster + ( possibly fractional ) + clusters[4][i] --- cluster radius + One corner of the supermodule is chosen as the origin + */ + + + int iord[2][nmx], infocl[2][ndimx][ndimy], infcl[3][nmx]; + double coord[2][ndimx][ndimy]; + + /* + iord --- ordered list of i and j according to decreasing energy dep. + infocl --- cellwise information on the cluster to which the cell + belongs and whether it has largest energy dep. or not + ( now redundant - probably ) + infcl --- cluster information [0][i] -- cluster number + [1][i] -- i of the cell + [2][i] -- j of the cell + coord --- x and y coordinates of center of each cell + */ + + Int_t fMessage; + + public: + AliPMDClustering(); + virtual ~AliPMDClustering(); + + void DoClust(int, int, double [][72], TObjArray *); + int crclust(double, double, int, int); + void refclust(int, int, int); + double ranmar(); + void order(int); + double Dist(double, double, double, double); + void gaussfit(int, int, double &, double &, double &, double &, double &, + double &, double &); + void ConvertL2G(int, double, double, double &, double &); + void cell_pos(Int_t , Int_t , Int_t , Float_t &, Float_t &); + void SetMessage(Int_t); + + ClassDef(AliPMDClustering,1) +}; +#endif -- 2.43.0