]> git.uio.no Git - u/mrichter/AliRoot.git/blobdiff - TPC/AliTPCclustererMI.cxx
Use the inteface from AliTPCcalibBase (Magnus)
[u/mrichter/AliRoot.git] / TPC / AliTPCclustererMI.cxx
index bab72c5233d47f1cbf0b1be90f6eaf3390b44010..6da558b7aa5f072a5c7c1feedbbe5bfa734fbe66 100644 (file)
 //-------------------------------------------------------
 //          Implementation of the TPC clusterer
 //
+//  1. The Input data for reconstruction - Options
+//      1.a Simulated data  - TTree - invoked Digits2Clusters()
+//      1.b Raw data        - Digits2Clusters(AliRawReader* rawReader); 
+//
+//  2. The Output data
+//      2.a TTree with clusters - if  SetOutput(TTree * tree) invoked
+//      2.b TObjArray           - Faster option for HLT
+//
+//  3. Reconstruction setup
+//     see AliTPCRecoParam for list of parameters 
+//     The reconstruction parameterization taken from the 
+//     AliTPCReconstructor::GetRecoParam()
+//     Possible to setup it in reconstruction macro  AliTPCReconstructor::SetRecoParam(...)
+//     
+//
+//
 //   Origin: Marian Ivanov 
 //-------------------------------------------------------
 
@@ -30,7 +46,6 @@
 #include <TRandom.h>
 #include <TTree.h>
 #include <TTreeStream.h>
-#include <TVirtualFFT.h>
 
 #include "AliDigits.h"
 #include "AliLoader.h"
@@ -80,15 +95,14 @@ AliTPCclustererMI::AliTPCclustererMI(const AliTPCParam* par, const AliTPCRecoPar
   fEventType(0),
   fInput(0),
   fOutput(0),
+  fOutputArray(0),
   fRowCl(0),
   fRowDig(0),
   fParam(0),
   fNcluster(0),
-  fAmplitudeHisto(0),
   fDebugStreamer(0),
   fRecoParam(0),
-  fBDumpSignal(kFALSE),
-  fFFTr2c(0)
+  fBDumpSignal(kFALSE)
 {
   //
   // COSNTRUCTOR
@@ -97,7 +111,6 @@ AliTPCclustererMI::AliTPCclustererMI(const AliTPCParam* par, const AliTPCRecoPar
   //
   fIsOldRCUFormat = kFALSE;
   fInput =0;
-  fOutput=0;
   fParam = par;
   if (recoParam) {
     fRecoParam = recoParam;
@@ -107,9 +120,7 @@ AliTPCclustererMI::AliTPCclustererMI(const AliTPCParam* par, const AliTPCRecoPar
     if (!fRecoParam)  fRecoParam = AliTPCRecoParam::GetLowFluxParam();
   }
   fDebugStreamer = new TTreeSRedirector("TPCsignal.root");
-  fAmplitudeHisto = 0;
   Int_t nPoints = fRecoParam->GetLastBin()-fRecoParam->GetFirstBin();
-  fFFTr2c = TVirtualFFT::FFT(1, &nPoints, "R2C  K");
 }
 //______________________________________________________________
 AliTPCclustererMI::AliTPCclustererMI(const AliTPCclustererMI &param)
@@ -135,15 +146,14 @@ AliTPCclustererMI::AliTPCclustererMI(const AliTPCclustererMI &param)
   fEventType(0),
   fInput(0),
   fOutput(0),
+  fOutputArray(0),
   fRowCl(0),
   fRowDig(0),
   fParam(0),
   fNcluster(0),
-  fAmplitudeHisto(0),
   fDebugStreamer(0),
   fRecoParam(0),
-  fBDumpSignal(kFALSE),
-  fFFTr2c(0)
+  fBDumpSignal(kFALSE)
 {
   //
   // dummy
@@ -161,9 +171,14 @@ AliTPCclustererMI & AliTPCclustererMI::operator =(const AliTPCclustererMI & para
 }
 //______________________________________________________________
 AliTPCclustererMI::~AliTPCclustererMI(){
-  DumpHistos();
-  if (fAmplitudeHisto) delete fAmplitudeHisto;
+  //
+  //
+  //
   if (fDebugStreamer) delete fDebugStreamer;
+  if (fOutputArray){
+    fOutputArray->Delete();
+    delete fOutputArray;
+  }
 }
 
 void AliTPCclustererMI::SetInput(TTree * tree)
@@ -182,8 +197,11 @@ void AliTPCclustererMI::SetInput(TTree * tree)
 void AliTPCclustererMI::SetOutput(TTree * tree) 
 {
   //
+  // Set the output tree
+  // If not set the ObjArray used - Option for HLT 
   //
-  fOutput= tree;  
+  if (!tree) return;
+  fOutput= tree;
   AliTPCClustersRow clrow;
   AliTPCClustersRow *pclrow=&clrow;  
   clrow.SetClass("AliTPCclusterMI");
@@ -192,6 +210,21 @@ void AliTPCclustererMI::SetOutput(TTree * tree)
 }
 
 
+void AliTPCclustererMI::FillRow(){
+  //
+  // fill the output container - 
+  // 2 Options possible
+  //          Tree       
+  //          TObjArray
+  //
+  if (fOutput) fOutput->Fill();
+  if (!fOutput){
+    //
+    if (!fOutputArray) fOutputArray = new TObjArray;
+    if (fRowCl) fOutputArray->AddAt(fRowCl->Clone(), fRowCl->GetID());
+  }
+}
+
 Float_t  AliTPCclustererMI::GetSigmaY2(Int_t iz){
   // sigma y2 = in digits  - we don't know the angle
   Float_t z = iz*fParam->GetZWidth()+fParam->GetNTBinsL1()*fParam->GetZWidth();
@@ -321,7 +354,7 @@ AliTPCclusterMI &c)
     //set cluster parameters
     c.SetQ(sumw);
     c.SetPad(meani-2.5);
-    c.SetTimeBin(meanj-2.5);
+    c.SetTimeBin(meanj-3);
     c.SetSigmaY2(mi2);
     c.SetSigmaZ2(mj2);
     c.SetType(0);
@@ -600,11 +633,6 @@ void AliTPCclustererMI::Digits2Clusters()
     return;
   }
  
-  if (!fOutput) {
-    Error("Digits2Clusters", "output tree not initialised");
-    return;
-  }
-
   AliTPCCalPad * gainTPC = AliTPCcalibDB::Instance()->GetPadGainFactor();
   AliTPCCalPad * noiseTPC = AliTPCcalibDB::Instance()->GetPadNoise();
   AliSimDigits digarr, *dummy=&digarr;
@@ -626,13 +654,12 @@ void AliTPCclustererMI::Digits2Clusters()
     AliTPCCalROC * gainROC = gainTPC->GetCalROC(fSector);  // pad gains per given sector
     AliTPCCalROC * noiseROC   = noiseTPC->GetCalROC(fSector); // noise per given sector
     //
-    AliTPCClustersRow *clrow= new AliTPCClustersRow();
-    fRowCl = clrow;
-    clrow->SetClass("AliTPCclusterMI");
-    clrow->SetArray(1);
+    fRowCl= new AliTPCClustersRow();
+    fRowCl->SetClass("AliTPCclusterMI");
+    fRowCl->SetArray(1);
 
-    clrow->SetID(digarr.GetID());
-    fOutput->GetBranch("Segment")->SetAddress(&clrow);
+    fRowCl->SetID(digarr.GetID());
+    if (fOutput) fOutput->GetBranch("Segment")->SetAddress(&fRowCl);
     fRx=fParam->GetPadRowRadii(fSector,row);
     
     
@@ -670,9 +697,8 @@ void AliTPCclustererMI::Digits2Clusters()
     digarr.ExpandTrackBuffer();
 
     FindClusters(noiseROC);
-
-    fOutput->Fill();
-    delete clrow;    
+    FillRow();
+    delete fRowCl;    
     nclusters+=fNcluster;    
     delete[] fBins;
     delete[] fSigBins;
@@ -690,10 +716,6 @@ void AliTPCclustererMI::Digits2Clusters(AliRawReader* rawReader)
 // using an option of the TPC reconstructor
 //-----------------------------------------------------------------
 
-  if (!fOutput) {
-    Error("Digits2Clusters", "output tree not initialised");
-    return;
-  }
 
   fRowDig = NULL;
   AliTPCROC * roc = AliTPCROC::Instance();
@@ -745,7 +767,11 @@ void AliTPCclustererMI::Digits2Clusters(AliRawReader* rawReader)
     AliTPCCalROC * gainROC    = gainTPC->GetCalROC(fSector);  // pad gains per given sector
     AliTPCCalROC * pedestalROC = pedestalTPC->GetCalROC(fSector);  // pedestal per given sector
     AliTPCCalROC * noiseROC   = noiseTPC->GetCalROC(fSector);  // noise per given sector
+    //check the presence of the calibration
+    if (!noiseROC ||!pedestalROC ) {
+      AliError(Form("Missing calibration per sector\t%d\n",fSector));
+      continue;
+    }
     Int_t nRows = 0;
     Int_t nDDLs = 0, indexDDL = 0;
     if (fSector < kNIS) {
@@ -783,20 +809,23 @@ void AliTPCclustererMI::Digits2Clusters(AliRawReader* rawReader)
     Float_t gain =1;
     Int_t lastPad=-1;
     while (input.Next()) {
-      digCounter++;
       if (input.GetSector() != fSector)
        AliFatal(Form("Sector index mismatch ! Expected (%d), but got (%d) !",fSector,input.GetSector()));
 
       
       Int_t iRow = input.GetRow();
-      if (iRow < 0 || iRow >= nRows)
-       AliFatal(Form("Pad-row index (%d) outside the range (%d -> %d) !",
+      if (iRow < 0 || iRow >= nRows){
+       AliError(Form("Pad-row index (%d) outside the range (%d -> %d) !",
                      iRow, 0, nRows -1));
+       continue;
+      }
       //pad
       Int_t iPad = input.GetPad();
-      if (iPad < 0 || iPad >= nPadsMax)
-       AliFatal(Form("Pad index (%d) outside the range (%d -> %d) !",
+      if (iPad < 0 || iPad >= nPadsMax) {
+       AliError(Form("Pad index (%d) outside the range (%d -> %d) !",
                      iPad, 0, nPadsMax-1));
+       continue;
+      }
       if (iPad!=lastPad){
        gain    = gainROC->GetValue(iRow,iPad);
        lastPad = iPad;
@@ -810,6 +839,7 @@ void AliTPCclustererMI::Digits2Clusters(AliRawReader* rawReader)
                      iTimeBin, 0, iTimeBin -1));
       }
       iTimeBin+=3;
+
       //signal
       Float_t signal = input.GetSignal();
       if (!calcPedestal && signal <= zeroSup) continue;      
@@ -820,14 +850,19 @@ void AliTPCclustererMI::Digits2Clusters(AliRawReader* rawReader)
       }else{
        allBins[iRow][iPad*fMaxTime+iTimeBin] = signal;
       }
-      allBins[iRow][iPad*fMaxTime+0]=1.;  // pad with signal
+      allBins[iRow][iPad*fMaxTime+0]+=1.;  // pad with signal
+
+      // Temporary
+      digCounter++;
     } // End of the loop over altro data
     //
     //
+    //
+    //
     // Now loop over rows and perform pedestal subtraction
     if (digCounter==0) continue;
-    //    if (fPedSubtraction) {
-    if (calcPedestal) {
+    //    if (calcPedestal) {
+    if (kTRUE) {
       for (Int_t iRow = 0; iRow < nRows; iRow++) {
        Int_t maxPad;
        if (fSector < kNIS)
@@ -836,6 +871,15 @@ void AliTPCclustererMI::Digits2Clusters(AliRawReader* rawReader)
          maxPad = fParam->GetNPadsUp(iRow);
 
        for (Int_t iPad = 3; iPad < maxPad + 3; iPad++) {
+         //
+         // Temporary fix for data production - !!!! MARIAN
+         // The noise calibration should take mean and RMS - currently the Gaussian fit used
+         // In case of double peak  - the pad should be rejected
+         //
+         // Line mean - if more than given digits over threshold - make a noise calculation
+         // and pedestal substration
+         if (!calcPedestal && allBins[iRow][iPad*fMaxTime+0]<50) continue;
+         //
          if (allBins[iRow][iPad*fMaxTime+0] <1 ) continue;  // no data
          Float_t *p = &allBins[iRow][iPad*fMaxTime+3];
          //Float_t pedestal = TMath::Median(fMaxTime, p);      
@@ -872,7 +916,7 @@ void AliTPCclustererMI::Digits2Clusters(AliRawReader* rawReader)
       fRowCl->SetClass("AliTPCclusterMI");
       fRowCl->SetArray(1);
       fRowCl->SetID(fParam->GetIndex(fSector, fRow));
-      fOutput->GetBranch("Segment")->SetAddress(&fRowCl);
+      if (fOutput) fOutput->GetBranch("Segment")->SetAddress(&fRowCl);
 
       fRx = fParam->GetPadRowRadii(fSector, fRow);
       fPadLength = fParam->GetPadPitchLength(fSector, fRow);
@@ -888,8 +932,7 @@ void AliTPCclustererMI::Digits2Clusters(AliRawReader* rawReader)
       fNSigBins = allNSigBins[fRow];
 
       FindClusters(noiseROC);
-
-      fOutput->Fill();
+      FillRow();
       delete fRowCl;    
       nclusters += fNcluster;    
     } // End of loop to find clusters
@@ -903,8 +946,13 @@ void AliTPCclustererMI::Digits2Clusters(AliRawReader* rawReader)
   delete [] allSigBins;
   delete [] allNSigBins;
   
-  Info("Digits2Clusters", "File  %s Event\t%d\tNumber of found clusters : %d\n", fOutput->GetName(),*(rawReader->GetEventId()), nclusters);
-
+//   if (rawReader->GetEventId() && fOutput ){
+//     Info("Digits2Clusters", "File  %s Event\t%d\tNumber of found clusters : %d\n", fOutput->GetName(),*(rawReader->GetEventId()), nclusters);
+//   }else{
+//     Info("Digits2Clusters", "Event\t%d\tNumber of found clusters : %d\n",*(rawReader->GetEventId()), nclusters);
+    
+//   }
+  
 }
 
 void AliTPCclustererMI::FindClusters(AliTPCCalROC * noiseROC)
@@ -914,8 +962,12 @@ void AliTPCclustererMI::FindClusters(AliTPCCalROC * noiseROC)
   // add virtual charge at the edge   
   //
   Double_t kMaxDumpSize = 500000;
-  if (fRecoParam->GetCalcPedestal() && fOutput->GetZipBytes()< kMaxDumpSize) fBDumpSignal =kTRUE;   //dump signal flag
-  //
+  if (!fOutput) {
+    fBDumpSignal =kFALSE;
+  }else{
+    if (fRecoParam->GetCalcPedestal() && fOutput->GetZipBytes()< kMaxDumpSize) fBDumpSignal =kTRUE;   //dump signal flag
+  }
+   
   fNcluster=0;
   fLoop=1;
   Int_t crtime = Int_t((fParam->GetZLength(fSector)-fRecoParam->GetCtgRange()*fRx)/fZWidth-fParam->GetNTBinsL1()-5);
@@ -933,14 +985,15 @@ void AliTPCclustererMI::FindClusters(AliTPCCalROC * noiseROC)
     if (b[0]<minMaxCutAbs) continue;   //threshold for maxima  
     //
     if (b[-1]+b[1]+b[-fMaxTime]+b[fMaxTime]<=0) continue;  // cut on isolated clusters 
-    //    if (b[-1]+b[1]<=0) continue;               // cut on isolated clusters
-    //if (b[-fMaxTime]+b[fMaxTime]<=0) continue; // cut on isolated clusters
+    if (b[-1]+b[1]<=0) continue;               // cut on isolated clusters
+    if (b[-fMaxTime]+b[fMaxTime]<=0) continue; // cut on isolated clusters
     //
     if ((b[0]+b[-1]+b[1])<minUpDownCutAbs) continue;   //threshold for up down  (TRF) 
     if ((b[0]+b[-fMaxTime]+b[fMaxTime])<minLeftRightCutAbs) continue;   //threshold for left right (PRF)    
     if (!IsMaximum(*b,fMaxTime,b)) continue;
     //
     Float_t noise = noiseROC->GetValue(fRow, i/fMaxTime);
+    if (noise>fRecoParam->GetMaxNoise()) continue;
     // sigma cuts
     if (b[0]<minMaxCutSigma*noise) continue;   //threshold form maxima  
     if ((b[0]+b[-1]+b[1])<minUpDownCutSigma*noise) continue;   //threshold for up town TRF 
@@ -1028,12 +1081,18 @@ Double_t AliTPCclustererMI::ProcesSignal(Float_t *signal, Int_t nchannels, Int_t
       rms  +=histo[median+idelta]*(median+idelta)*(median+idelta);
     }
   }
-  mean  /=count10;
-  mean06/=count06;
-  mean09/=count09;
-  rms    = TMath::Sqrt(TMath::Abs(rms/count10-mean*mean));
-  rms06    = TMath::Sqrt(TMath::Abs(rms06/count06-mean06*mean06));
- rms09    = TMath::Sqrt(TMath::Abs(rms09/count09-mean09*mean09));
+  if (count10) {
+    mean  /=count10;
+    rms    = TMath::Sqrt(TMath::Abs(rms/count10-mean*mean));
+  }
+  if (count06) {
+    mean06/=count06;
+    rms06    = TMath::Sqrt(TMath::Abs(rms06/count06-mean06*mean06));
+  }
+  if (count09) {
+    mean09/=count09;
+    rms09    = TMath::Sqrt(TMath::Abs(rms09/count09-mean09*mean09));
+  }
   rmsEvent = rms09;
   //
   pedestalEvent = median;
@@ -1066,35 +1125,7 @@ Double_t AliTPCclustererMI::ProcesSignal(Float_t *signal, Int_t nchannels, Int_t
   // fill pedestal histogram
   //
   AliTPCROC * roc = AliTPCROC::Instance();
-  if (!fAmplitudeHisto){
-    fAmplitudeHisto = new TObjArray(72);
-  }  
-  //
-  if (uid[0]<roc->GetNSectors() 
-      && uid[1]< roc->GetNRows(uid[0])  && 
-      uid[2] <roc->GetNPads(uid[0], uid[1])){
-    TObjArray  * sectorArray = (TObjArray*)fAmplitudeHisto->UncheckedAt(uid[0]);
-    if (!sectorArray){
-      Int_t npads =roc->GetNChannels(uid[0]);
-      sectorArray = new TObjArray(npads);
-      fAmplitudeHisto->AddAt(sectorArray, uid[0]);
-    }
-    Int_t position =  uid[2]+roc->GetRowIndexes(uid[0])[uid[1]];
-    // TH1F * histo = (TH1F*)sectorArray->UncheckedAt(position);
-//     if (!histo){
-//       char hname[100];
-//       sprintf(hname,"Amp_%d_%d_%d",uid[0],uid[1],uid[2]);
-//       TFile * backup = gFile;
-//       fDebugStreamer->GetFile()->cd();
-//       histo = new TH1F(hname, hname, 100, 5,100);
-//       //histo->SetDirectory(0);     // histogram not connected to directory -(File)
-//       sectorArray->AddAt(histo, position);
-//       if (backup) backup->cd();
-//     }
-//     for (Int_t i=0; i<nchannels; i++){
-//       histo->Fill(signal[i]);
-//     }
-  }
+
   //
   //
   //
@@ -1105,265 +1136,31 @@ Double_t AliTPCclustererMI::ProcesSignal(Float_t *signal, Int_t nchannels, Int_t
     dtime[i] = i;
     dsignal[i] = signal[i];
   }
-  //
-  // Digital noise
-  //
- //  if (max-median>30.*TMath::Max(1.,Double_t(rms06)) &&  (((*fDebugStreamer)<<"SignalDN").GetSize()<kMaxDebugSize)){    
-//     //
-//     //
-//     TGraph * graph =new TGraph(nchannels, dtime, dsignal);
-//     //
-//     //
-//     // jumps left - right
-//     Int_t    njumps0=0;
-//     Double_t deltaT0[2000];
-//     Double_t deltaA0[2000];
-//     Int_t    lastJump0 = fRecoParam->GetFirstBin();
-//     Int_t    njumps1=0;
-//     Double_t deltaT1[2000];
-//     Double_t deltaA1[2000];
-//     Int_t    lastJump1 = fRecoParam->GetFirstBin();
-//     Int_t    njumps2=0;
-//     Double_t deltaT2[2000];
-//     Double_t deltaA2[2000];
-//     Int_t    lastJump2 = fRecoParam->GetFirstBin();
-
-//     for (Int_t itime=fRecoParam->GetFirstBin()+1; itime<fRecoParam->GetLastBin()-1; itime++){
-//       if (TMath::Abs(dsignal[itime]-dsignal[itime-1])>30.*TMath::Max(1.,Double_t(rms06))  && 
-//       TMath::Abs(dsignal[itime]-dsignal[itime+1])>30.*TMath::Max(1.,Double_t(rms06))  &&
-//       (dsignal[itime-1]-median<5.*rms06) &&
-//       (dsignal[itime+1]-median<5.*rms06)      
-//       ){
-//     deltaA0[njumps0] = dsignal[itime]-dsignal[itime-1];
-//     deltaT0[njumps0] = itime-lastJump0;
-//     lastJump0 = itime;
-//     njumps0++;
-//       }
-//       if (TMath::Abs(dsignal[itime]-dsignal[itime-1])>30.*TMath::Max(1.,Double_t(rms06)) &&
-//       (dsignal[itime-1]-median<5.*rms06) 
-//       ) {
-//     deltaA1[njumps1] = dsignal[itime]-dsignal[itime-1];
-//     deltaT1[njumps1] = itime-lastJump1;
-//     lastJump1 = itime;
-//     njumps1++;
-//       }
-//       if (TMath::Abs(dsignal[itime]-dsignal[itime+1])>30.*TMath::Max(1.,Double_t(rms06)) &&
-//       (dsignal[itime+1]-median<5.*rms06) 
-//       ) {
-//     deltaA2[njumps2] = dsignal[itime]-dsignal[itime+1];
-//     deltaT2[njumps2] = itime-lastJump2;
-//     lastJump2 = itime;
-//     njumps2++;
-//       }
-//     }
-//     //
-//     if (njumps0>0 || njumps1>0 || njumps2>0){
-//       TGraph *graphDN0 = new TGraph(njumps0, deltaT0, deltaA0);
-//       TGraph *graphDN1 = new TGraph(njumps1, deltaT1, deltaA1);
-//       TGraph *graphDN2 = new TGraph(njumps2, deltaT2, deltaA2);
-//       (*fDebugStreamer)<<"SignalDN"<<    //digital - noise pads - or random sample of pads
-//     "TimeStamp="<<fTimeStamp<<
-//     "EventType="<<fEventType<<
-//     "Sector="<<uid[0]<<
-//     "Row="<<uid[1]<<
-//     "Pad="<<uid[2]<<
-//     "Graph="<<graph<<
-//     "Max="<<max<<
-//     "MaxPos="<<maxPos<<
-//     "Graph.="<<graph<<  
-//     "P0GraphDN0.="<<graphDN0<<
-//     "P1GraphDN1.="<<graphDN1<<
-//     "P2GraphDN2.="<<graphDN2<<
-//     //
-//     "Median="<<median<<
-//     "Mean="<<mean<<
-//     "RMS="<<rms<<      
-//     "Mean06="<<mean06<<
-//     "RMS06="<<rms06<<
-//     "Mean09="<<mean09<<
-//     "RMS09="<<rms09<<
-//     "\n";
-//       delete graphDN0;
-//       delete graphDN1;
-//       delete graphDN2;
-//     }
-//     delete graph;
-//   }
 
-  //
-  // NOISE STUDY  Fourier transform
-  //
   TGraph * graph;
-  Bool_t random = (gRandom->Rndm()<0.0003);
-  if (((*fDebugStreamer)<<"SignalN").GetSize()<kMaxDebugSize)
-    if (max-median>kMin || rms06>1.*fParam->GetZeroSup() || random){
-    graph =new TGraph(nchannels, dtime, dsignal);
-    if (rms06>1.*fParam->GetZeroSup() || random){
-      //Double_t *input, Double_t threshold, Bool_t locMax, Double_t *freq, Double_t *re, Double_t *im, Double_t *mag, Double_t *phi);
-      Float_t * input = &(dsignal[fRecoParam->GetFirstBin()]);
-      Float_t freq[2000], re[2000], im[2000], mag[2000], phi[2000];
-      Int_t npoints = TransformFFT(input, -1,kFALSE, freq, re, im, mag, phi);
-      TGraph *graphMag0 = new TGraph(npoints, freq, mag);
-      TGraph *graphPhi0 = new TGraph(npoints, freq, phi);
-      npoints = TransformFFT(input, 0.5,kTRUE, freq, re, im, mag, phi);
-      TGraph *graphMag1 = new TGraph(npoints, freq, mag);
-      TGraph *graphPhi1 = new TGraph(npoints, freq, phi);
-      
-      (*fDebugStreamer)<<"SignalN"<<    //noise pads - or random sample of pads
-       "TimeStamp="<<fTimeStamp<<
-       "EventType="<<fEventType<<
-       "Sector="<<uid[0]<<
-       "Row="<<uid[1]<<
-       "Pad="<<uid[2]<<
-       "Graph.="<<graph<<
-       "Max="<<max<<
-       "MaxPos="<<maxPos<<
-       //
-       "Median="<<median<<
-       "Mean="<<mean<<
-       "RMS="<<rms<<      
-       "Mean06="<<mean06<<
-       "RMS06="<<rms06<<
-       "Mean09="<<mean09<<
-       "RMS09="<<rms09<<
-       // FFT part
-       "Mag0.="<<graphMag0<<
-       "Mag1.="<<graphMag1<<
-       "Phi0.="<<graphPhi0<<
-       "Phi1.="<<graphPhi1<<
-       "\n";
-      delete graphMag0;
-      delete graphMag1;
-      delete graphPhi0;
-      delete graphPhi1;
-    }
-    //
-    // Big signals dumping
-    //
-    
-    if (max-median>kMin &&maxPos>AliTPCReconstructor::GetRecoParam()->GetFirstBin()) 
-      (*fDebugStreamer)<<"SignalB"<<     // pads with signal
-       "TimeStamp="<<fTimeStamp<<
-       "EventType="<<fEventType<<
-       "Sector="<<uid[0]<<
-       "Row="<<uid[1]<<
-       "Pad="<<uid[2]<<
-       "Graph="<<graph<<
-       "Max="<<max<<
-       "MaxPos="<<maxPos<<     
-       //
-       "Median="<<median<<
-       "Mean="<<mean<<
-       "RMS="<<rms<<      
-       "Mean06="<<mean06<<
-       "RMS06="<<rms06<<
-       "Mean09="<<mean09<<
-       "RMS09="<<rms09<<
-       "\n";
-    delete graph;
-  }
-  
-  //
-  //
-  //  Central Electrode signal analysis  
-  //
-  Float_t ceQmax  =0, ceQsum=0, ceTime=0;
-  Float_t cemean  = mean06, cerms=rms06 ;
-  Int_t    cemaxpos= 0;
-  Float_t ceThreshold=5.*cerms;
-  Float_t ceSumThreshold=8.*cerms;
-  const Int_t    kCemin=5;  // range for the analysis of the ce signal +- channels from the peak
-  const Int_t    kCemax=5;
-  for (Int_t i=nchannels-2; i>nchannels/2; i--){
-    if ( (dsignal[i]-mean06)>ceThreshold && dsignal[i]>=dsignal[i+1] && dsignal[i]>=dsignal[i-1] ){
-      cemaxpos=i;
-      break;
-    }
-  }
-  if (cemaxpos!=0){
-    ceQmax = 0;
-    Int_t cemaxpos2=0;
-    for (Int_t i=cemaxpos-20; i<cemaxpos+5; i++){
-      if (i<0 || i>nchannels-1) continue;
-      Double_t val=dsignal[i]- cemean;
-      if (val>ceQmax){
-       cemaxpos2=i;
-       ceQmax = val;
-      }
-    }
-    cemaxpos = cemaxpos2;
-    for (Int_t i=cemaxpos-kCemin; i<cemaxpos+kCemax; i++){
-      if (i>0 && i<nchannels&&dsignal[i]- cemean>0){
-       Double_t val=dsignal[i]- cemean;
-       ceTime+=val*dtime[i];
-       ceQsum+=val;
-       if (val>ceQmax) ceQmax=val;
-      }
-    }
-    if (ceQmax&&ceQsum>ceSumThreshold) {
-      ceTime/=ceQsum;
-      (*fDebugStreamer)<<"Signalce"<<
-       "TimeStamp="<<fTimeStamp<<
-       "EventType="<<fEventType<<
-       "Sector="<<uid[0]<<
-       "Row="<<uid[1]<<
-       "Pad="<<uid[2]<<
-       "Max="<<ceQmax<<
-       "Qsum="<<ceQsum<<
-       "Time="<<ceTime<<
-       "RMS06="<<rms06<<
-       //
-       "\n";
-    }
-  }
-  // end of ce signal analysis
-  //
-
   //
-  //  Gating grid signal analysis  
-  //
-  Double_t ggQmax  =0, ggQsum=0, ggTime=0;
-  Double_t ggmean  = mean06, ggrms=rms06 ;
-  Int_t    ggmaxpos= 0;
-  Double_t ggThreshold=5.*ggrms;
-  Double_t ggSumThreshold=8.*ggrms;
-
-  for (Int_t i=1; i<nchannels/4; i++){
-    if ( (dsignal[i]-mean06)>ggThreshold && dsignal[i]>=dsignal[i+1] && dsignal[i]>=dsignal[i-1] &&
-        (dsignal[i]+dsignal[i+1]+dsignal[i-1]-3*mean06)>ggSumThreshold){
-      ggmaxpos=i;
-      if (dsignal[i-1]>dsignal[i+1]) ggmaxpos=i-1;
-      break;
-    }
-  }
-  if (ggmaxpos!=0){
-      for (Int_t i=ggmaxpos-1; i<ggmaxpos+3; i++){       
-         if (i>0 && i<nchannels && dsignal[i]-ggmean>0){
-             Double_t val=dsignal[i]- ggmean;
-             ggTime+=val*dtime[i];
-             ggQsum+=val;
-             if (val>ggQmax) ggQmax=val;
-         }
-      }
-      if (ggQmax&&ggQsum>ggSumThreshold) {
-         ggTime/=ggQsum;
-         (*fDebugStreamer)<<"Signalgg"<<
-           "TimeStamp="<<fTimeStamp<<
-           "EventType="<<fEventType<<
-             "Sector="<<uid[0]<<
-             "Row="<<uid[1]<<
-             "Pad="<<uid[2]<<
-             "Max="<<ggQmax<<
-             "Qsum="<<ggQsum<<
-             "Time="<<ggTime<<
-             "RMS06="<<rms06<<
-             //
-             "\n";
-      }
-  }
-  // end of gg signal analysis
-      
+  // Big signals dumping
+  //    
+  if (max-median>kMin &&maxPos>AliTPCReconstructor::GetRecoParam()->GetFirstBin()) 
+    (*fDebugStreamer)<<"SignalB"<<     // pads with signal
+      "TimeStamp="<<fTimeStamp<<
+      "EventType="<<fEventType<<
+      "Sector="<<uid[0]<<
+      "Row="<<uid[1]<<
+      "Pad="<<uid[2]<<
+      "Graph="<<graph<<
+      "Max="<<max<<
+      "MaxPos="<<maxPos<<      
+      //
+      "Median="<<median<<
+      "Mean="<<mean<<
+      "RMS="<<rms<<      
+      "Mean06="<<mean06<<
+      "RMS06="<<rms06<<
+      "Mean09="<<mean09<<
+      "RMS09="<<rms09<<
+      "\n";
+  delete graph;  
 
   delete [] dsignal;
   delete [] dtime;
@@ -1376,103 +1173,5 @@ Double_t AliTPCclustererMI::ProcesSignal(Float_t *signal, Int_t nchannels, Int_t
 
 
 
-void AliTPCclustererMI::DumpHistos(){
-  //
-  // Dump histogram information
-  //
-  if (!fAmplitudeHisto) return;
-  AliTPCROC * roc = AliTPCROC::Instance();
-  for (UInt_t isector=0; isector<AliTPCROC::Instance()->GetNSectors(); isector++){
-    TObjArray * array = (TObjArray*)fAmplitudeHisto->UncheckedAt(isector);
-    if (!array) continue;
-    for (UInt_t ipad = 0; ipad <(UInt_t)array->GetEntriesFast(); ipad++){
-      TH1F * histo = (TH1F*) array->UncheckedAt(ipad);
-      if (!histo) continue;
-      if (histo->GetEntries()<100) continue;
-      histo->Fit("gaus","q");
-      Float_t mean =  histo->GetMean();
-      Float_t rms  =  histo->GetRMS();
-      Float_t gmean = histo->GetFunction("gaus")->GetParameter(1);
-      Float_t gsigma = histo->GetFunction("gaus")->GetParameter(2);
-      Float_t gmeanErr = histo->GetFunction("gaus")->GetParError(1);
-      Float_t gsigmaErr = histo->GetFunction("gaus")->GetParError(2);
-      Float_t max = histo->GetFunction("gaus")->GetParameter(0);
-
-      // get pad number
-      UInt_t row=0, pad =0;
-      const UInt_t *indexes =roc->GetRowIndexes(isector);
-      for (UInt_t irow=0; irow<roc->GetNRows(isector); irow++){
-       if (indexes[irow]<=ipad){
-         row = irow;
-         pad = ipad-indexes[irow];
-       }
-      }      
-      Int_t rpad = pad - (AliTPCROC::Instance()->GetNPads(isector,row))/2;
-      //
-      (*fDebugStreamer)<<"Fit"<<
-       "TimeStamp="<<fTimeStamp<<
-       "EventType="<<fEventType<<
-       "Sector="<<isector<<
-       "Row="<<row<<
-       "Pad="<<pad<<
-       "RPad="<<rpad<<
-       "Max="<<max<<
-       "Mean="<<mean<<
-       "RMS="<<rms<<      
-       "GMean="<<gmean<<
-       "GSigma="<<gsigma<<
-       "GMeanErr="<<gmeanErr<<
-       "GSigmaErr="<<gsigmaErr<<
-       "\n";
-      if (array->UncheckedAt(ipad)) fDebugStreamer->StoreObject(array->UncheckedAt(ipad));
-    }
-  }
-}
-
-
-
-Int_t  AliTPCclustererMI::TransformFFT(Float_t *input, Float_t threshold, Bool_t locMax, Float_t *freq, Float_t *re, Float_t *im, Float_t *mag, Float_t *phi)
-{
-  //
-  // calculate fourrie transform 
-  // return only frequncies with mag over threshold
-  // if locMax is spectified only freque with local maxima over theshold is returned 
-
-  if (! fFFTr2c) return kFALSE;
-  if (!freq) return kFALSE;
 
-  Int_t current=0;
-  Int_t nPoints = fRecoParam->GetLastBin()-fRecoParam->GetFirstBin();
-  Double_t *in = new Double_t[nPoints];
-  Double_t *rfft = new Double_t[nPoints];
-  Double_t *ifft = new Double_t[nPoints];
-  for (Int_t i=0; i<nPoints; i++){in[i]=input[i];}
-  fFFTr2c->SetPoints(in);
-  fFFTr2c->Transform();
-  fFFTr2c->GetPointsComplex(rfft, ifft);
-  for (Int_t i=3; i<nPoints/2-3; i++){
-    Float_t lmag =  TMath::Sqrt(rfft[i]*rfft[i]+ifft[i]*ifft[i])/nPoints;
-    if (lmag<threshold) continue;
-    if (locMax){
-      if ( TMath::Sqrt(rfft[i-1]*rfft[i-1]+ifft[i-1]*ifft[i-1])/nPoints>lmag) continue;
-      if ( TMath::Sqrt(rfft[i+1]*rfft[i+1]+ifft[i+1]*ifft[i+1])/nPoints>lmag) continue;
-      if ( TMath::Sqrt(rfft[i-2]*rfft[i-2]+ifft[i-2]*ifft[i-2])/nPoints>lmag) continue;
-      if ( TMath::Sqrt(rfft[i+2]*rfft[i+2]+ifft[i+2]*ifft[i+2])/nPoints>lmag) continue;
-      if ( TMath::Sqrt(rfft[i-3]*rfft[i-3]+ifft[i-3]*ifft[i-3])/nPoints>lmag) continue;
-      if ( TMath::Sqrt(rfft[i+3]*rfft[i+3]+ifft[i+3]*ifft[i+3])/nPoints>lmag) continue;
-    }
-    
-    freq[current] = Float_t(i)/Float_t(nPoints);
-    //
-    re[current] = rfft[i];
-    im[current] = ifft[i];
-    mag[current]=lmag;
-    phi[current]=TMath::ATan2(ifft[i],rfft[i]);
-    current++;
-  }
-  delete [] in;
-  delete [] rfft;
-  delete [] ifft;
-  return current;
-}