]> git.uio.no Git - u/mrichter/AliRoot.git/commitdiff
New classes for finding multiple vertices (in case of pile-up). They will be used...
authormasera <masera@f7af4fe6-9843-0410-8265-dc069ae4e863>
Wed, 7 Jan 2009 09:02:34 +0000 (09:02 +0000)
committermasera <masera@f7af4fe6-9843-0410-8265-dc069ae4e863>
Wed, 7 Jan 2009 09:02:34 +0000 (09:02 +0000)
ITS/AliITSSortTrkl.cxx [new file with mode: 0644]
ITS/AliITSSortTrkl.h [new file with mode: 0644]
ITS/AliITSTracklPairs.cxx [new file with mode: 0644]
ITS/AliITSTracklPairs.h [new file with mode: 0644]
ITS/CMake_libITSrec.txt
ITS/ITSrecLinkDef.h
ITS/libITSrec.pkg

diff --git a/ITS/AliITSSortTrkl.cxx b/ITS/AliITSSortTrkl.cxx
new file mode 100644 (file)
index 0000000..d2cf229
--- /dev/null
@@ -0,0 +1,317 @@
+/**************************************************************************
+ * Copyright(c) 2009-2010, 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.                  *
+ **************************************************************************/
+#include<Riostream.h>
+#include<TClonesArray.h>
+#include<TMath.h>
+#include "AliStrLine.h"
+#include "AliITSSortTrkl.h"
+
+/* $Id$ */
+
+////////////////////////////////////////////////////////////////////////
+//           Helper class for finding multiple primary vertices       //
+//           To be used by AliITSVertexer3D                           //
+//           It is based on the association of pairs of tracklets     //
+//           obtained by matching reconstructed points onthe first    //
+//           2 layers of SPD                                          //
+//           Origin M. Masera masera@to.infn.it                       //
+////////////////////////////////////////////////////////////////////////
+
+
+ClassImp(AliITSSortTrkl)
+
+//______________________________________________________________________
+AliITSSortTrkl::AliITSSortTrkl():TObject(),
+fkSize(0),
+fIndex(0),
+fPairs(NULL),
+fClustersTmp(NULL),
+fClusters(NULL),
+fNoClus(0),
+fSize(NULL),
+fMark(),
+fCut(0.),
+fCoarseMaxRCut(0.)
+{
+  // Default constructor
+}
+
+//______________________________________________________________________
+AliITSSortTrkl::AliITSSortTrkl(Int_t n, Double_t cut):TObject(),
+fkSize(n),
+fIndex(0),
+fPairs(),
+fClustersTmp(),
+fClusters(NULL),
+fNoClus(0),
+fSize(NULL),
+fMark(n),
+fCut(cut),
+fCoarseMaxRCut(0.) {
+  // Standard constructor
+  fPairs = new AliITSTracklPairs* [fkSize];
+  fClustersTmp = new Int_t* [fkSize-1]; 
+}
+
+//______________________________________________________________________
+AliITSSortTrkl::AliITSSortTrkl(TClonesArray &tclo, Int_t n, Double_t cut, Double_t rcut):TObject(),
+fkSize(n),
+fIndex(0),
+fPairs(),
+fClustersTmp(),
+fClusters(NULL),
+fNoClus(0),
+fSize(NULL),
+fMark(n),
+fCut(cut),
+fCoarseMaxRCut(rcut){
+  // Constructor based on a TClonesArray of AliStrLine
+  Int_t numtrack=tclo.GetEntriesFast();
+  if(numtrack<2){
+    AliFatal(Form("Insufficient number of tracks (%d )",numtrack));
+    return;
+  }
+  TObject *member = tclo[0];
+  TString str(member->ClassName());
+  if(!(str.Contains("AliStrLine"))){
+    AliFatal(Form("Wrong type of class in input TClonesArray (%s )",str.Data()));
+    return;
+  }
+  Int_t siz = numtrack*(numtrack-1)/2;
+  if(fkSize < siz){
+    AliError(Form("fkSize is too small. It is %d and it should be %d",fkSize,siz)); 
+  }
+  fPairs = new AliITSTracklPairs* [fkSize];
+  fClustersTmp = new Int_t* [fkSize-1];
+  for(Int_t i=0;i<numtrack-1;i++){
+    AliStrLine *one = (AliStrLine*)tclo[i];
+    for(Int_t j=i+1;j<numtrack;j++){
+      AliStrLine *two = (AliStrLine*)tclo[j];
+      Double_t point[3];
+      one->Cross(two,point);
+      Double_t dca = one->GetDCA(two);
+      if(dca>fCut)continue;
+      Double_t rad=TMath::Sqrt(point[0]*point[0]+point[1]*point[1]);
+      if(rad>fCoarseMaxRCut)continue;
+      AddPairs(i,j,dca,point);
+    }
+  } 
+}
+
+//______________________________________________________________________
+AliITSSortTrkl::~AliITSSortTrkl(){
+  // Destructor
+  if(fPairs){
+    for(Int_t i=0;i<fIndex;i++)delete fPairs[i];
+    delete [] fPairs;
+  }
+  DeleteClustersTmp();
+  if(fClusters){
+    for(Int_t i=0;i<fNoClus;i++)delete []fClusters[i];
+    delete fClusters;
+    delete []fSize;
+  } 
+}
+
+//______________________________________________________________________
+void AliITSSortTrkl::DeleteClustersTmp(){
+  // fClustersTmp is deleted
+  if(fClustersTmp){
+    for(Int_t i=0;i<fIndex-1;i++)delete []fClustersTmp[i];
+    delete fClustersTmp;
+    fClustersTmp = NULL;
+  }
+}
+
+//______________________________________________________________________
+Int_t AliITSSortTrkl::AddPairs(Int_t t1, Int_t t2, Double_t dca, Double_t *coo){
+  // Add a tracklet pair at current position
+  fPairs[fIndex] = new AliITSTracklPairs(t1,t2,dca,coo);
+  //  cout<<"Pair "<<fIndex<<" Tracklets "<<t1<<" and "<<t2<<". DCA= "<<dca<<" Crossing "<<coo[0]<<" "<<coo[1]<<" "<<coo[2]<<endl;
+  fIndex++;
+  return fIndex-1;
+}
+
+//______________________________________________________________________
+Int_t AliITSSortTrkl::FindClusters(){
+  // find clusters
+  fMark.ResetAllBits();
+  PrepareClustersTmp();
+  for(Int_t i=0; i<fIndex-1;i++){
+    Int_t *v=fClustersTmp[i];
+    Clustering(i,v);
+    if(v[0]>0){
+      AliInfo(Form("Clusters starting from pair %d : %d",i,v[0]));
+      Int_t dim;
+      v[v[0]+1]=i;
+      Int_t *arr=FindLabels(v+1,2*(v[0]+1),dim);
+      cout<<"Pairs involved \n";
+      for(Int_t j=1;j<=v[0];j++){
+       cout<<v[j]<<" ";
+       if(j%10==0)cout<<endl;
+      }
+      cout<<endl;
+      cout<<"Tracklets involved\n";
+      for(Int_t j=0;j<dim;j++){
+       cout<<arr[j]<<" ";
+       if(j%10==0 && j>0)cout<<endl;
+      }
+      cout<<endl;
+      for(Int_t j=0;j<fIndex;j++){
+       if(fMark.TestBitNumber(j))continue;
+       for(Int_t k=0;k<dim;k++){
+         if(fPairs[j]->HasTrack(arr[k])){
+           fMark.SetBitNumber(j);
+           //      cout<<"Marked pair "<<j<<" because has tracklet "<<arr[k]<<endl;
+           k=dim;
+         }
+       }
+      }
+      delete []arr;
+    }
+  }
+  Cleanup();
+  return fNoClus;
+}
+
+//______________________________________________________________________
+void AliITSSortTrkl::Cleanup(){
+  // empty arrays are eliminated, the others are sorted according
+  // to cluster multiplicity
+  Int_t siz[fIndex-1];
+  Int_t index[fIndex-1];
+  fNoClus=0;
+  for(Int_t i=0; i<fIndex-1;i++){
+    Int_t *v=fClustersTmp[i];
+    if(v[0]>0)fNoClus++;
+    siz[i]=v[0];
+  }
+  if(fNoClus == 0)return;
+  TMath::Sort(fIndex-1,siz,index);
+  fClusters = new Int_t* [fNoClus];
+  fSize = new Int_t [fNoClus];
+  for(Int_t i=0;i<fNoClus;i++){
+    Int_t curind = index[i];
+    Int_t *v=fClustersTmp[curind];
+    fClusters[i] = new Int_t[v[0]+1];
+    fSize[i]=v[0]+1;
+    Int_t *vext=fClusters[i];
+    vext[0]=curind;
+    for(Int_t j=1;j<fSize[i];j++)vext[j]=v[j];
+  }
+}
+
+//______________________________________________________________________
+Int_t* AliITSSortTrkl::GetTrackletsLab(Int_t index, Int_t& dim) const {
+  // Returns the tracklet labels corresponding to cluster index
+  // Calling code must take care of memory deallocation
+  if(fNoClus <=0){
+    dim = 0;
+    return NULL;
+  }
+  Int_t dimmax = 2*GetSizeOfCluster(index);
+  if(dimmax<=0){
+    dim = 0;
+    return NULL;
+  } 
+  Int_t *v = GetClusters(index);
+  return FindLabels(v,dimmax,dim);
+}
+
+//______________________________________________________________________
+Int_t* AliITSSortTrkl::FindLabels(Int_t *v, Int_t dimmax, Int_t& dim) const {
+  // Returns the tracklet labels corresponding to te list of pairs 
+  // contained in v.
+  // Calling code must take care of memory deallocation
+  Int_t *arr = new Int_t [dimmax];
+  Int_t j=0;
+  for(Int_t i=0; i<dimmax/2; i++){
+    AliITSTracklPairs *pai=GetPairsAt(v[i]);
+    arr[j++]=pai->GetTrack1();
+    arr[j++]=pai->GetTrack2();
+  }
+  SortAndClean(dimmax,arr,dim);
+  return arr;
+}
+//______________________________________________________________________
+void AliITSSortTrkl::SortAndClean(Int_t numb, Int_t *arr, Int_t& numb2){
+  // Array arr (with numb elements) is sorted in ascending order. 
+  // Then possible reoccurrences
+  // of elements are eliminated. numb2 is the number of remaining elements
+  // after cleanup.
+  if(numb<=0)return;
+  Int_t index[numb];
+  TMath::Sort(numb,arr,index,kFALSE);
+  Int_t tmp[numb];
+  numb2 = 0;
+  tmp[0] = arr[index[0]];
+  for(Int_t i=1;i<numb;i++){
+    if(arr[index[i]] != tmp[numb2]){
+      ++numb2;
+      tmp[numb2]=arr[index[i]];
+    }
+  }
+  ++numb2;
+  for(Int_t i=0;i<numb;i++){
+    if(i<numb2){
+      arr[i]=tmp[i];
+    }
+    else {
+      arr[i]=0;
+    }
+  }
+}
+
+//______________________________________________________________________
+void AliITSSortTrkl::PrepareClustersTmp(){
+  // prepare arrays of clusters
+  for(Int_t i=0; i<fIndex-1;i++){
+    fClustersTmp[i] = new Int_t [fIndex-i];
+    Int_t *v = fClustersTmp[i];
+    v[0]=0;
+    for(Int_t j=1;j<fIndex-i;j++)v[j]=-1;
+  }
+}
+
+//______________________________________________________________________
+void AliITSSortTrkl::Clustering(Int_t i,Int_t *v){
+  // recursive method to build up clusters starting from point i
+  if(fMark.TestBitNumber(i))return;
+  AliITSTracklPairs *p1 = fPairs[i];
+  for(Int_t j=i+1;j<fIndex;j++){
+    if(fMark.TestBitNumber(j))continue;
+    AliITSTracklPairs *p2 = fPairs[j];
+    Double_t dist = p1->GetDistance(*p2);
+    //    AliInfo(Form("  ******* i %d , j %d . Distance %g ",i,j,dist));
+    if(dist<=fCut){
+      Int_t dimclu=v[0];
+      Bool_t already = kFALSE;
+      for(Int_t k=1;k<=dimclu;k++){
+       if(v[k]==j)already=kTRUE;
+      }
+      if(!already){
+       ++dimclu;
+       v[0]=dimclu;
+       fMark.SetBitNumber(j);
+       fMark.SetBitNumber(i);
+       v[dimclu]=j;
+       Clustering(j,v);
+      }
+    }
+  }
+}
+
+
+
diff --git a/ITS/AliITSSortTrkl.h b/ITS/AliITSSortTrkl.h
new file mode 100644 (file)
index 0000000..8d9693b
--- /dev/null
@@ -0,0 +1,70 @@
+#ifndef ALIITSSORTTRKL_H 
+#define ALIITSSORTTRKL_H 
+
+/* Copyright(c) 2009-2010, ALICE Experiment at CERN, All rights reserved. *
+ * See cxx source for full Copyright notice                               */
+
+/* $Id$ */
+
+////////////////////////////////////////////////////////////////////////
+//           Helper class for finding multiple primary vertices       //
+//           To be used by AliITSVertexer3D                           //
+//           Origin M. Masera masera@to.infn.it                       //
+////////////////////////////////////////////////////////////////////////
+
+
+#include<TBits.h>
+#include "AliLog.h"
+#include "AliITSTracklPairs.h"
+
+class TClonesArray;
+
+class AliITSSortTrkl : public TObject {
+
+ public:
+
+  AliITSSortTrkl();
+  AliITSSortTrkl(Int_t n, Double_t cut = 0.05);
+  AliITSSortTrkl(TClonesArray &tclo, Int_t n, Double_t cut, Double_t rcut);
+  virtual ~AliITSSortTrkl();
+  Int_t AddPairs(Int_t t1, Int_t t2, Double_t dca, Double_t *coo);
+  Int_t GetIndex() const {return fIndex;}
+  Int_t FindClusters();
+  void SetCut(Double_t cut){fCut = cut;}
+  Double_t GetCut() const {return fCut; }
+  Int_t* GetClusters(Int_t index) const {if(index>=0 && index<fNoClus){return fClusters[index];} else {return NULL;}}
+  Int_t GetNumberOfClusters() const {return fNoClus;}
+  Int_t GetSizeOfCluster(Int_t index) const {if(index>=0 && index<fNoClus){return fSize[index];} else {return -1;}}
+  static void SortAndClean(Int_t numb, Int_t *arr, Int_t& numb2);
+  Int_t* GetTrackletsLab(Int_t index, Int_t& dim) const;
+
+  // FOR DEBUGGING PURPOSES
+  Int_t* GetClustersTmp(Int_t index){return fClustersTmp[index];}
+  AliITSTracklPairs* GetPairsAt(Int_t i) const {if(!(i>=0 && i<fIndex)){AliError(Form("Index %d out of bounds",i)); return NULL;} else{ return fPairs[i];} }
+
+
+ protected:
+
+  AliITSSortTrkl(const AliITSSortTrkl& pa);
+  AliITSSortTrkl& operator=(const AliITSSortTrkl& /* pa */);
+  void Cleanup();
+  void DeleteClustersTmp();
+  void PrepareClustersTmp();
+  void Clustering(Int_t i, Int_t *v);
+  Int_t* AliITSSortTrkl::FindLabels(Int_t *v, Int_t dimmax, Int_t& dim) const;
+
+  const Int_t fkSize;         // Maximum number of tracklet pairs
+  Int_t fIndex;               // Total number of tracklet pairs (<=fkSize)
+  AliITSTracklPairs **fPairs;  // array of tracklet pairs (pointers to)
+  Int_t **fClustersTmp;      // Temporary list of clusters of tracklet pairs
+  Int_t **fClusters;      // List of clusters of tracklet pairs after cleanup
+  Int_t fNoClus;         // Number of clusters of tracklet pairs
+  Int_t *fSize;          // Number of pairs for each cluster
+  TBits fMark;           // Used to mask used pairs
+  Double_t fCut;         // cut on distance of DCAs of pairs for association
+  Double_t fCoarseMaxRCut;  // cut on distance from beam axis
+
+ ClassDef(AliITSSortTrkl,0);
+};
+
+#endif
diff --git a/ITS/AliITSTracklPairs.cxx b/ITS/AliITSTracklPairs.cxx
new file mode 100644 (file)
index 0000000..8bfb5f3
--- /dev/null
@@ -0,0 +1,65 @@
+/**************************************************************************
+ * Copyright(c) 2009-2010, 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$ */
+
+/////////////////////////////////////////////////////////////////////
+// Helper class for 3D primary vertexing                           //
+// Used by AliITSSortTrkl                                          //
+// In each object the labels of the 2 paired tracklets             //
+// are stored. DCA and crossing point coordinates are also stored. //
+// Origin M.Masera (masera@to.infn.it)                             //
+/////////////////////////////////////////////////////////////////////
+
+#include <TMath.h>
+#include "AliITSTracklPairs.h"
+
+ClassImp(AliITSTracklPairs)
+
+//______________________________________________________________________
+AliITSTracklPairs::AliITSTracklPairs():TObject(),
+fTrack1(0),
+fTrack2(0),
+fDCA(0.) {
+  // Default constructor
+
+  for(Int_t i=0;i<3;i++)fCross[i]=0.;
+}
+
+//______________________________________________________________________
+AliITSTracklPairs::AliITSTracklPairs(Int_t t1, Int_t t2, Double_t dca, Double_t *coo):TObject(),
+fTrack1(t1),
+fTrack2(t2),
+fDCA(dca) {
+  // Standard constructor
+
+  for(Int_t i=0;i<3;i++)fCross[i]=coo[i];
+}
+
+//______________________________________________________________________
+AliITSTracklPairs::~AliITSTracklPairs(){
+  // destructor
+}
+
+//______________________________________________________________________
+Double_t AliITSTracklPairs::GetDistance(const AliITSTracklPairs& pair) const {
+  // Get distance between the crossing point of pair and this
+  Double_t point1[3];
+  pair.GetCrossCoord(point1);
+  Double_t dist = 0.;
+  for(Int_t i=0; i<3; i++)dist+=(point1[i]-fCross[i])*(point1[i]-fCross[i]);
+  dist=TMath::Sqrt(dist);
+  return dist;
+}
diff --git a/ITS/AliITSTracklPairs.h b/ITS/AliITSTracklPairs.h
new file mode 100644 (file)
index 0000000..6aaa7dd
--- /dev/null
@@ -0,0 +1,39 @@
+#ifndef ALIITSTRACKLPAIRS_H 
+#define ALIITSTRACKLPAIRS_H
+
+#include<TObject.h>
+/* Copyright(c) 2009-2010, ALICE Experiment at CERN, All rights reserved. *
+ * See cxx source for full Copyright notice                               */
+
+/* $Id$ */
+
+////////////////////////////////////////////////////////////////
+// Helper class for 3D primary vertexing                      //
+// Used by AliITSSortTrkl                                     //
+// Origin M.Masera (masera@to.infn.it)                        //
+////////////////////////////////////////////////////////////////
+
+class AliITSTracklPairs : public TObject {
+
+ public:
+
+  AliITSTracklPairs();
+  AliITSTracklPairs(Int_t t1, Int_t t2, Double_t dca, Double_t *coo);
+  virtual ~AliITSTracklPairs();
+  Int_t GetTrack1() const {return fTrack1;}
+  Int_t GetTrack2() const {return fTrack2;}
+  Double_t GetDCA() const {return fDCA;}
+  void GetCrossCoord(Double_t *cr) const {for(int i=0;i<3;i++)cr[i]=fCross[i];}
+  Double_t GetDistance(const AliITSTracklPairs& pair) const;
+  Bool_t HasTrack(Int_t tr) const {return ((tr == fTrack1) || (tr == fTrack2));}
+
+ protected:
+  Int_t fTrack1;      // first tracklet index
+  Int_t fTrack2;      // second tracklet index
+  Double_t fDCA;      // DCA
+  Double_t fCross[3]; // intersection coordinates
+
+  ClassDef(AliITSTracklPairs,1);
+};
+
+#endif
index beb336e5404ee0ff5089388a2f38233e7eff7eb3..a709118168cae11890635fe815a50e8bef73ff15 100644 (file)
@@ -19,7 +19,9 @@ set(SRCS
                AliITSVertexer.cxx 
                AliITSVertexerIons.cxx 
                AliITSVertexerCosmics.cxx 
-               AliITSVertexer3D.cxx 
+               AliITSVertexer3D.cxx
+               AliITSTracklPairs.cxx 
+               AliITSSortTrkl.cxx
                AliITSVertexerZ.cxx 
                AliITSVertexerFast.cxx 
                AliITSVertexerFixed.cxx 
index dc29c4cada4fa0fec66c87a971b280d492db0c66..968447b6a9f87f688e0c3f9c4175b5834fb2a043 100644 (file)
@@ -38,6 +38,8 @@
 #pragma link C++ class  AliITSVertexerZ+;
 #pragma link C++ class  AliITSVertexer3D+;
 #pragma link C++ class  AliITSVertexer3DTapan+;
+#pragma link C++ class  AliITSTracklPairs+;
+#pragma link C++ class  AliITSSortTrkl+;
 #pragma link C++ class AliITSVertexerFast+;
 #pragma link C++ class AliITSVertexerFixed+;
 #pragma link C++ class  AliITSMeanVertexer+;
index ca99219dce9b897592ba75b60e34ee0e3a30547d..1c6d1deaa57ae3d5a1b499cf2968f497a321b957 100644 (file)
@@ -19,6 +19,8 @@ SRCS =        AliITSDetTypeRec.cxx \
                AliITSVertexerIons.cxx \
                AliITSVertexerCosmics.cxx \
                AliITSVertexer3D.cxx \
+               AliITSTracklPairs.cxx \
+               AliITSSortTrkl.cxx \
                AliITSVertexerZ.cxx \
                AliITSVertexerFast.cxx \
                AliITSVertexerFixed.cxx \