]> git.uio.no Git - u/mrichter/AliRoot.git/blobdiff - TPC/AliTPCclustererMI.cxx
Applying transformation AliTPCTransform
[u/mrichter/AliRoot.git] / TPC / AliTPCclustererMI.cxx
index 2e7cf06d148550c985c0af286377a1fe9d08605c..b48ee755949d7e0ee63936aba11a8652e1e13b6d 100644 (file)
 //   Origin: Marian Ivanov 
 //-------------------------------------------------------
 
-#include "AliTPCReconstructor.h"
-#include "AliTPCclustererMI.h"
-#include "AliTPCclusterMI.h"
-#include <TObjArray.h>
+#include "Riostream.h"
+#include <TF1.h>
 #include <TFile.h>
-#include "AliTPCClustersArray.h"
-#include "AliTPCClustersRow.h"
-#include "AliTPCRawStream.h"
+#include <TGraph.h>
+#include <TH1F.h>
+#include <TObjArray.h>
+#include <TRandom.h>
+#include <TTree.h>
+#include <TTreeStream.h>
+#include <TVirtualFFT.h>
+
 #include "AliDigits.h"
+#include "AliLoader.h"
+#include "AliLog.h"
+#include "AliMathBase.h"
+#include "AliRawEventHeaderBase.h"
+#include "AliRawReader.h"
+#include "AliRunLoader.h"
 #include "AliSimDigits.h"
+#include "AliTPCCalPad.h"
+#include "AliTPCCalROC.h"
+#include "AliTPCClustersArray.h"
+#include "AliTPCClustersRow.h"
 #include "AliTPCParam.h"
-#include "AliRawReader.h"
 #include "AliTPCRawStream.h"
-#include "AliRunLoader.h"
-#include "AliLoader.h"
-#include "Riostream.h"
-#include <TTree.h>
+#include "AliTPCRecoParam.h"
+#include "AliTPCReconstructor.h"
+#include "AliTPCcalibDB.h"
+#include "AliTPCclusterInfo.h"
+#include "AliTPCclusterMI.h"
+#include "AliTPCclustererMI.h"
 
 ClassImp(AliTPCclustererMI)
 
 
 
-AliTPCclustererMI::AliTPCclustererMI(const AliTPCParam* par)
+AliTPCclustererMI::AliTPCclustererMI(const AliTPCParam* par, const AliTPCRecoParam * recoParam):
+  fBins(0),
+  fSigBins(0),
+  fNSigBins(0),
+  fLoop(0),
+  fMaxBin(0),
+  fMaxTime(0),
+  fMaxPad(0),
+  fSector(-1),
+  fRow(-1),
+  fSign(0),
+  fRx(0),
+  fPadWidth(0),
+  fPadLength(0),
+  fZWidth(0),
+  fPedSubtraction(kFALSE),
+  fIsOldRCUFormat(kFALSE),
+  fEventHeader(0),
+  fTimeStamp(0),
+  fEventType(0),
+  fInput(0),
+  fOutput(0),
+  fRowCl(0),
+  fRowDig(0),
+  fParam(0),
+  fNcluster(0),
+  fAmplitudeHisto(0),
+  fDebugStreamer(0),
+  fRecoParam(0),
+  fBDumpSignal(kFALSE),
+  fFFTr2c(0)
 {
+  //
+  // COSNTRUCTOR
+  // param     - tpc parameters for given file
+  // recoparam - reconstruction parameters 
+  //
+  fIsOldRCUFormat = kFALSE;
   fInput =0;
   fOutput=0;
   fParam = par;
+  if (recoParam) {
+    fRecoParam = recoParam;
+  }else{
+    //set default parameters if not specified
+    fRecoParam = AliTPCReconstructor::GetRecoParam();
+    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)
+              :TObject(param),
+  fBins(0),
+  fSigBins(0),
+  fNSigBins(0),
+  fLoop(0),
+  fMaxBin(0),
+  fMaxTime(0),
+  fMaxPad(0),
+  fSector(-1),
+  fRow(-1),
+  fSign(0),
+  fRx(0),
+  fPadWidth(0),
+  fPadLength(0),
+  fZWidth(0),
+  fPedSubtraction(kFALSE),
+  fIsOldRCUFormat(kFALSE),
+  fEventHeader(0),
+  fTimeStamp(0),
+  fEventType(0),
+  fInput(0),
+  fOutput(0),
+  fRowCl(0),
+  fRowDig(0),
+  fParam(0),
+  fNcluster(0),
+  fAmplitudeHisto(0),
+  fDebugStreamer(0),
+  fRecoParam(0),
+  fBDumpSignal(kFALSE),
+  fFFTr2c(0)
+{
+  //
+  // dummy
+  //
+  fMaxBin = param.fMaxBin;
+}
+//______________________________________________________________
+AliTPCclustererMI & AliTPCclustererMI::operator =(const AliTPCclustererMI & param)
+{
+  //
+  // assignment operator - dummy
+  //
+  fMaxBin=param.fMaxBin;
+  return (*this);
 }
+//______________________________________________________________
+AliTPCclustererMI::~AliTPCclustererMI(){
+  DumpHistos();
+  if (fAmplitudeHisto) delete fAmplitudeHisto;
+  if (fDebugStreamer) delete fDebugStreamer;
+}
+
 void AliTPCclustererMI::SetInput(TTree * tree)
 {
   //
@@ -77,7 +193,7 @@ void AliTPCclustererMI::SetOutput(TTree * tree)
 
 Float_t  AliTPCclustererMI::GetSigmaY2(Int_t iz){
   // sigma y2 = in digits  - we don't know the angle
-  Float_t z = iz*fParam->GetZWidth();
+  Float_t z = iz*fParam->GetZWidth()+fParam->GetNTBinsL1()*fParam->GetZWidth();
   Float_t sd2 = (z*fParam->GetDiffL()*fParam->GetDiffL())/
     (fPadWidth*fPadWidth);
   Float_t sres = 0.25;
@@ -88,9 +204,9 @@ Float_t  AliTPCclustererMI::GetSigmaY2(Int_t iz){
 
 Float_t  AliTPCclustererMI::GetSigmaZ2(Int_t iz){
   //sigma z2 = in digits - angle estimated supposing vertex constraint
-  Float_t z = iz*fZWidth;
+  Float_t z = iz*fZWidth+fParam->GetNTBinsL1()*fParam->GetZWidth();
   Float_t sd2 = (z*fParam->GetDiffL()*fParam->GetDiffL())/(fZWidth*fZWidth);
-  Float_t angular = fPadLength*(fParam->GetZLength()-z)/(fRx*fZWidth);
+  Float_t angular = fPadLength*(fParam->GetZLength(fSector)-z)/(fRx*fZWidth);
   angular*=angular;
   angular/=12.;
   Float_t sres = fParam->GetZSigma()/fZWidth;
@@ -99,19 +215,23 @@ Float_t  AliTPCclustererMI::GetSigmaZ2(Int_t iz){
   return res;
 }
 
-void AliTPCclustererMI::MakeCluster(Int_t k,Int_t max,Int_t *bins, UInt_t /*m*/,
+void AliTPCclustererMI::MakeCluster(Int_t k,Int_t max,Float_t *bins, UInt_t /*m*/,
 AliTPCclusterMI &c) 
 {
+  //
+  //  k    - Make cluster at position k  
+  //  bins - 2 D array of signals mapped to 1 dimensional array - 
+  //  max  - the number of time bins er one dimension
+  //  c    - refernce to cluster to be filled
+  //
   Int_t i0=k/max;  //central pad
   Int_t j0=k%max;  //central time bin
 
   // set pointers to data
   //Int_t dummy[5] ={0,0,0,0,0};
-  Int_t * matrix[5]; //5x5 matrix with digits  - indexing i = 0 ..4  j = -2..2
-  Int_t * resmatrix[5];
+  Float_t * matrix[5]; //5x5 matrix with digits  - indexing i = 0 ..4  j = -2..2
   for (Int_t di=-2;di<=2;di++){
     matrix[di+2]  =  &bins[k+di*max];
-    resmatrix[di+2]  =  &fResBins[k+di*max];
   }
   //build matrix with virtual charge
   Float_t sigmay2= GetSigmaY2(j0);
@@ -188,8 +308,10 @@ AliTPCclusterMI &c)
   
   //
   if ( ( (ry<0.6) || (rz<0.6) ) && fLoop==2) return;
-  if ( (ry <1.2) && (rz<1.2) ) {
-    //if cluster looks like expected 
+  if ( (ry <1.2) && (rz<1.2) || (!fRecoParam->GetDoUnfold())) {
+    //
+    //if cluster looks like expected or Unfolding not switched on
+    //standard COG is used
     //+1.2 deviation from expected sigma accepted
     //    c.fMax = FitMax(vmatrix,meani,meanj,TMath::Sqrt(sigmay2),TMath::Sqrt(sigmaz2));
 
@@ -199,24 +321,20 @@ AliTPCclusterMI &c)
     c.SetQ(sumw);
     c.SetY(meani*fPadWidth); 
     c.SetZ(meanj*fZWidth); 
+    c.SetPad(meani);
+    c.SetTimeBin(meanj);
     c.SetSigmaY2(mi2);
     c.SetSigmaZ2(mj2);
-    AddCluster(c);
-    //remove cluster data from data
-    for (Int_t di=-2;di<=2;di++)
-      for (Int_t dj=-2;dj<=2;dj++){
-       resmatrix[di+2][dj] -= Int_t(vmatrix[di+2][dj+2]);
-       if (resmatrix[di+2][dj]<0) resmatrix[di+2][dj]=0;
-      }
-    resmatrix[2][0] =0;
+    AddCluster(c,(Float_t*)vmatrix,k);
+
     return;     
   }
   //
   //unfolding when neccessary  
   //
   
-  Int_t * matrix2[7]; //7x7 matrix with digits  - indexing i = 0 ..6  j = -3..3
-  Int_t dummy[7]={0,0,0,0,0,0};
+  Float_t * matrix2[7]; //7x7 matrix with digits  - indexing i = 0 ..6  j = -3..3
+  Float_t dummy[7]={0,0,0,0,0,0};
   for (Int_t di=-3;di<=3;di++){
     matrix2[di+3] =  &bins[k+di*max];
     if ((k+di*max)<3)  matrix2[di+3] = &dummy[3];
@@ -234,10 +352,12 @@ AliTPCclusterMI &c)
   c.SetQ(sumu);
   c.SetY(meani*fPadWidth); 
   c.SetZ(meanj*fZWidth); 
+  c.SetPad(meani);
+  c.SetTimeBin(meanj);
   c.SetSigmaY2(mi2);
   c.SetSigmaZ2(mj2);
   c.SetType(Char_t(overlap)+1);
-  AddCluster(c);
+  AddCluster(c,(Float_t*)vmatrix,k);
 
   //unfolding 2
   meani-=i0;
@@ -248,7 +368,7 @@ AliTPCclusterMI &c)
 
 
 
-void AliTPCclustererMI::UnfoldCluster(Int_t * matrix2[7], Float_t recmatrix[5][5], Float_t & meani, Float_t & meanj, 
+void AliTPCclustererMI::UnfoldCluster(Float_t * matrix2[7], Float_t recmatrix[5][5], Float_t & meani, Float_t & meanj, 
                                      Float_t & sumu, Float_t & overlap )
 {
   //
@@ -395,7 +515,7 @@ Float_t AliTPCclustererMI::FitMax(Float_t vmatrix[5][5], Float_t y, Float_t z, F
   return max;
 }
 
-void AliTPCclustererMI::AddCluster(AliTPCclusterMI &c){
+void AliTPCclustererMI::AddCluster(AliTPCclusterMI &c, Float_t * matrix, Int_t pos){
   //
   // transform cluster to the global coordinata
   // add the cluster to the array
@@ -425,10 +545,20 @@ void AliTPCclustererMI::AddCluster(AliTPCclusterMI &c){
   w=fZWidth;
   c.SetSigmaZ2(s2*w*w);
   c.SetY((meani - 2.5 - 0.5*fMaxPad)*fParam->GetPadPitchWidth(fSector));
+  c.SetPad(meani-2.5);
+  if (!fRecoParam->GetBYMirror()){
+    if (fSector%36>17){
+      c.SetY(-(meani - 2.5 - 0.5*fMaxPad)*fParam->GetPadPitchWidth(fSector));
+    }
+  }
+  c.SetTimeBin(meanj-3);
   c.SetZ(fZWidth*(meanj-3)); 
-  c.SetZ(c.GetZ()   - 3.*fParam->GetZSigma()); // PASA delay 
-  c.SetZ(fSign*(fParam->GetZLength() - c.GetZ()));
-  
+  c.SetZ(c.GetZ() - 3.*fParam->GetZSigma() + fParam->GetNTBinsL1()*fParam->GetZWidth()); // PASA delay + L1 delay
+  c.SetZ(fSign*(fParam->GetZLength(fSector) - c.GetZ()));
+  c.SetX(fRx);
+  c.SetDetector(fSector);
+  c.SetRow(fRow);
+
   if (ki<=1 || ki>=fMaxPad-1 || kj==1 || kj==fMaxTime-2) {
     //c.SetSigmaY2(c.GetSigmaY2()*25.);
     //c.SetSigmaZ2(c.GetSigmaZ2()*4.);
@@ -437,8 +567,20 @@ void AliTPCclustererMI::AddCluster(AliTPCclusterMI &c){
   if (fLoop==2) c.SetType(100);
 
   TClonesArray * arr = fRowCl->GetArray();
-  // AliTPCclusterMI * cl = 
-  new ((*arr)[fNcluster]) AliTPCclusterMI(c);
+  AliTPCclusterMI * cl = new ((*arr)[fNcluster]) AliTPCclusterMI(c);
+  if (fRecoParam->DumpSignal() &&matrix ) {
+    Int_t nbins=0;
+    Float_t *graph =0;
+    if (fRecoParam->GetCalcPedestal() && cl->GetMax()>fRecoParam->GetDumpAmplitudeMin() &&fBDumpSignal){
+      nbins = fMaxTime;
+      graph = &(fBins[fMaxTime*(pos/fMaxTime)]);
+    }
+    AliTPCclusterInfo * info = new AliTPCclusterInfo(matrix,nbins,graph);
+    cl->SetInfo(info);
+  }
+  if (!fRecoParam->DumpSignal()) {
+    cl->SetInfo(0);
+  }
 
   fNcluster++;
 }
@@ -461,6 +603,9 @@ void AliTPCclustererMI::Digits2Clusters()
     return;
   }
 
+  AliTPCCalPad * gainTPC = AliTPCcalibDB::Instance()->GetPadGainFactor();
+  AliTPCCalPad * noiseTPC = AliTPCcalibDB::Instance()->GetPadNoise();
+
   AliSimDigits digarr, *dummy=&digarr;
   fRowDig = dummy;
   fInput->GetBranch("Segment")->SetAddress(&dummy);
@@ -469,15 +614,17 @@ void AliTPCclustererMI::Digits2Clusters()
   fMaxTime=fParam->GetMaxTBin()+6; // add 3 virtual time bins before and 3   after
     
   Int_t nclusters  = 0;
-  
+
   for (Int_t n=0; n<nentries; n++) {
     fInput->GetEvent(n);
-    Int_t row;
-    if (!fParam->AdjustSectorRow(digarr.GetID(),fSector,row)) {
+    if (!fParam->AdjustSectorRow(digarr.GetID(),fSector,fRow)) {
       cerr<<"AliTPC warning: invalid segment ID ! "<<digarr.GetID()<<endl;
       continue;
     }
-        
+    Int_t row = fRow;
+    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");
@@ -504,26 +651,30 @@ void AliTPCclustererMI::Digits2Clusters()
     
     
     fMaxBin=fMaxTime*(fMaxPad+6);  // add 3 virtual pads  before and 3 after
-    fBins    =new Int_t[fMaxBin];
-    fResBins =new Int_t[fMaxBin];  //fBins with residuals after 1 finder loop 
-    memset(fBins,0,sizeof(Int_t)*fMaxBin);
+    fBins    =new Float_t[fMaxBin];
+    fSigBins =new Int_t[fMaxBin];
+    fNSigBins = 0;
+    memset(fBins,0,sizeof(Float_t)*fMaxBin);
     
     if (digarr.First()) //MI change
       do {
-       Short_t dig=digarr.CurrentDigit();
+       Float_t dig=digarr.CurrentDigit();
        if (dig<=fParam->GetZeroSup()) continue;
        Int_t j=digarr.CurrentRow()+3, i=digarr.CurrentColumn()+3;
-       fBins[i*fMaxTime+j]=dig;
+       Float_t gain = gainROC->GetValue(row,digarr.CurrentColumn());
+       Int_t bin = i*fMaxTime+j;
+       fBins[bin]=dig/gain;
+       fSigBins[fNSigBins++]=bin;
       } while (digarr.Next());
     digarr.ExpandTrackBuffer();
 
-    FindClusters();
+    FindClusters(noiseROC);
 
     fOutput->Fill();
     delete clrow;    
     nclusters+=fNcluster;    
-    delete[] fBins;      
-    delete[] fResBins;  
+    delete[] fBins;
+    delete[] fSigBins;
   }  
 
   Info("Digits2Clusters", "Number of found clusters : %d", nclusters);
@@ -532,7 +683,10 @@ void AliTPCclustererMI::Digits2Clusters()
 void AliTPCclustererMI::Digits2Clusters(AliRawReader* rawReader)
 {
 //-----------------------------------------------------------------
-// This is a cluster finder for raw data.
+// This is a cluster finder for the TPC raw data.
+// The method assumes NO ordering of the altro channels.
+// The pedestal subtraction can be switched on and off
+// using an option of the TPC reconstructor
 //-----------------------------------------------------------------
 
   if (!fOutput) {
@@ -540,10 +694,18 @@ void AliTPCclustererMI::Digits2Clusters(AliRawReader* rawReader)
     return;
   }
 
-  rawReader->Reset();
+  fRowDig = NULL;
+  AliTPCROC * roc = AliTPCROC::Instance();
+  AliTPCCalPad * gainTPC = AliTPCcalibDB::Instance()->GetPadGainFactor();
+  AliTPCCalPad * pedestalTPC = AliTPCcalibDB::Instance()->GetPedestals();
+  AliTPCCalPad * noiseTPC = AliTPCcalibDB::Instance()->GetPadNoise();
   AliTPCRawStream input(rawReader);
+  fEventHeader = (AliRawEventHeaderBase*)rawReader->GetEventHeader();
+  if (fEventHeader){
+    fTimeStamp = fEventHeader->Get("Timestamp");  
+    fEventType = fEventHeader->Get("Type");  
+  }
 
-  fRowDig = NULL;
 
   Int_t nclusters  = 0;
   
@@ -553,192 +715,759 @@ void AliTPCclustererMI::Digits2Clusters(AliRawReader* rawReader)
   const Int_t kNS = kNIS + kNOS;
   fZWidth = fParam->GetZWidth();
   Int_t zeroSup = fParam->GetZeroSup();
+  //
+  //alocate memory for sector - maximal case
+  //
+  Float_t** allBins = NULL;
+  Int_t** allSigBins = NULL;
+  Int_t*  allNSigBins = NULL;
+  Int_t nRowsMax = roc->GetNRows(roc->GetNSector()-1);
+  Int_t nPadsMax = roc->GetNPads(roc->GetNSector()-1,nRowsMax-1);
+  allBins = new Float_t*[nRowsMax];
+  allSigBins = new Int_t*[nRowsMax];
+  allNSigBins = new Int_t[nRowsMax];
+  for (Int_t iRow = 0; iRow < nRowsMax; iRow++) {
+    //
+    Int_t maxBin = fMaxTime*(nPadsMax+6);  // add 3 virtual pads  before and 3 after
+    allBins[iRow] = new Float_t[maxBin];
+    memset(allBins[iRow],0,sizeof(Float_t)*maxBin);
+    allSigBins[iRow] = new Int_t[maxBin];
+    allNSigBins[iRow]=0;
+  }
+  //
+  // Loop over sectors
+  //
+  for(fSector = 0; fSector < kNS; fSector++) {
 
-  fBins = NULL;
-  Int_t** splitRows = new Int_t* [kNS*2];
-  Int_t** splitRowsRes = new Int_t* [kNS*2];
-  for (Int_t iSector = 0; iSector < kNS*2; iSector++)
-    splitRows[iSector] = NULL;
-  Int_t iSplitRow = -1;
-
-  Bool_t next = kTRUE;
-  while (next) {
-    next = input.Next();
-
-    // when the sector or row number has changed ...
-    if (input.IsNewRow() || !next) {
-
-      // ... find clusters in the previous pad row, and ...
-      if (fBins) {
-       if ((iSplitRow < 0) || splitRows[fSector + kNS*iSplitRow]) {
-         fRowCl = new AliTPCClustersRow;
-         fRowCl->SetClass("AliTPCclusterMI");
-         fRowCl->SetArray(1);
-         fRowCl->SetID(fParam->GetIndex(fSector, input.GetPrevRow()));
-         fOutput->GetBranch("Segment")->SetAddress(&fRowCl);
-
-         FindClusters();
-
-         fOutput->Fill();
-         delete fRowCl;    
-         nclusters += fNcluster;    
-         delete[] fBins;
-         delete[] fResBins;
-         if (iSplitRow >= 0) splitRows[fSector + kNS*iSplitRow] = NULL;
-
-       } else if (iSplitRow >= 0) {
-         splitRows[fSector + kNS*iSplitRow] = fBins;
-         splitRowsRes[fSector + kNS*iSplitRow] = fResBins;
-       }
-      }
-
-      if (!next) break;
+    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
+    Int_t nRows = 0;
+    Int_t nDDLs = 0, indexDDL = 0;
+    if (fSector < kNIS) {
+      nRows = fParam->GetNRowLow();
+      fSign = (fSector < kNIS/2) ? 1 : -1;
+      nDDLs = 2;
+      indexDDL = fSector * 2;
+    }
+    else {
+      nRows = fParam->GetNRowUp();
+      fSign = ((fSector-kNIS) < kNOS/2) ? 1 : -1;
+      nDDLs = 4;
+      indexDDL = (fSector-kNIS) * 4 + kNIS * 2;
+    }
 
-      // ... prepare for the next pad row
-      fSector = input.GetSector();
-      Int_t iRow = input.GetRow();
-      fRx = fParam->GetPadRowRadii(fSector, iRow);
+    for (Int_t iRow = 0; iRow < nRows; iRow++) {
+      Int_t maxPad;
+      if (fSector < kNIS)
+       maxPad = fParam->GetNPadsLow(iRow);
+      else
+       maxPad = fParam->GetNPadsUp(iRow);
+      
+      Int_t maxBin = fMaxTime*(maxPad+6);  // add 3 virtual pads  before and 3 after
+      memset(allBins[iRow],0,sizeof(Float_t)*maxBin);
+      allNSigBins[iRow] = 0;
+    }
     
-      iSplitRow = -1;
-      if (fSector < kNIS) {
-       fMaxPad = fParam->GetNPadsLow(iRow);
-       fSign = (fSector < kNIS/2) ? 1 : -1;
-       if (iRow == 30) iSplitRow = 0;
-      } else {
-       fMaxPad = fParam->GetNPadsUp(iRow);
-       fSign = ((fSector-kNIS) < kNOS/2) ? 1 : -1;
-       if (iRow == 27) iSplitRow = 0;
-       else if (iRow == 76) iSplitRow = 1;
+    // Loas the raw data for corresponding DDLs
+    rawReader->Reset();
+    input.SetOldRCUFormat(fIsOldRCUFormat);
+    rawReader->Select("TPC",indexDDL,indexDDL+nDDLs-1);
+    Int_t digCounter=0;
+    // Begin loop over altro data
+    Bool_t calcPedestal = fRecoParam->GetCalcPedestal();
+    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) !",
+                     iRow, 0, nRows -1));
+      //pad
+      Int_t iPad = input.GetPad();
+      if (iPad < 0 || iPad >= nPadsMax)
+       AliFatal(Form("Pad index (%d) outside the range (%d -> %d) !",
+                     iPad, 0, nPadsMax-1));
+      if (iPad!=lastPad){
+       gain    = gainROC->GetValue(iRow,iPad);
+       lastPad = iPad;
       }
-      fPadLength = fParam->GetPadPitchLength(fSector, iRow);
-      fPadWidth  = fParam->GetPadPitchWidth();
-    
-      fMaxBin = fMaxTime*(fMaxPad+6);  // add 3 virtual pads  before and 3 after
-      if ((iSplitRow < 0) || !splitRows[fSector + kNS*iSplitRow]) {
-       fBins    = new Int_t[fMaxBin];
-       fResBins = new Int_t[fMaxBin];  //fBins with residuals after 1 finder loop 
-       memset(fBins, 0, sizeof(Int_t)*fMaxBin);
-      } else {
-       fBins    = splitRows[fSector + kNS*iSplitRow];
-       fResBins = splitRowsRes[fSector + kNS*iSplitRow];
+      iPad+=3;
+      //time
+      Int_t iTimeBin = input.GetTime();
+      if ( iTimeBin < 0 || iTimeBin >= fParam->GetMaxTBin())
+       AliFatal(Form("Timebin index (%d) outside the range (%d -> %d) !",
+                     iTimeBin, 0, iTimeBin -1));
+      iTimeBin+=3;
+      //signal
+      Float_t signal = input.GetSignal();
+      if (!calcPedestal && signal <= zeroSup) continue;      
+      if (!calcPedestal) {
+       Int_t bin = iPad*fMaxTime+iTimeBin;
+       allBins[iRow][bin] = signal/gain;
+       allSigBins[iRow][allNSigBins[iRow]++] = bin;
+      }else{
+       allBins[iRow][iPad*fMaxTime+iTimeBin] = signal;
       }
-    }
-
-    // fill fBins with digits data
-    if (input.GetSignal() <= zeroSup) continue;
-    Int_t i = input.GetPad() + 3;
-    Int_t j = input.GetTime() + 3;
-    fBins[i*fMaxTime+j] = input.GetSignal();
-  }
-
-  // find clusters in split rows that were skipped until now.
-  // this can happen if the rows were not splitted 
-  for (fSector = 0; fSector < kNS; fSector++)
-    for (Int_t iSplit = 0; iSplit < 2; iSplit++)
-      if (splitRows[fSector + kNS*iSplit]) {
-
-       Int_t iRow = -1;
-       if (fSector < kNIS) {
-         iRow = 30;
-         fMaxPad = fParam->GetNPadsLow(iRow);
-         fSign = (fSector < kNIS/2) ? 1 : -1;
-       } else {
-         if (iSplit == 0) iRow = 27; else iRow = 76;
-         fMaxPad = fParam->GetNPadsUp(iRow);
-         fSign = ((fSector-kNIS) < kNOS/2) ? 1 : -1;
+      allBins[iRow][iPad*fMaxTime+0]=1.;  // pad with signal
+    } // End of the loop over altro data
+    //
+    //
+    // Now loop over rows and perform pedestal subtraction
+    if (digCounter==0) continue;
+    //    if (fPedSubtraction) {
+    if (calcPedestal) {
+      for (Int_t iRow = 0; iRow < nRows; iRow++) {
+       Int_t maxPad;
+       if (fSector < kNIS)
+         maxPad = fParam->GetNPadsLow(iRow);
+       else
+         maxPad = fParam->GetNPadsUp(iRow);
+
+       for (Int_t iPad = 3; iPad < maxPad + 3; iPad++) {
+         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);      
+         Int_t id[3] = {fSector, iRow, iPad-3};
+         // calib values
+         Double_t rmsCalib=  noiseROC->GetValue(iRow,iPad-3);
+         Double_t pedestalCalib = pedestalROC->GetValue(iRow,iPad-3);
+         Double_t rmsEvent       = rmsCalib;
+         Double_t pedestalEvent  = pedestalCalib;
+         ProcesSignal(p, fMaxTime, id, rmsEvent, pedestalEvent);
+         if (rmsEvent<rmsCalib) rmsEvent = rmsCalib;   // take worst scenario
+         if (TMath::Abs(pedestalEvent-pedestalCalib)<1.0) pedestalEvent = pedestalCalib;  
+         
+         //
+         for (Int_t iTimeBin = 0; iTimeBin < fMaxTime; iTimeBin++) {
+           Int_t bin = iPad*fMaxTime+iTimeBin;
+           allBins[iRow][bin] -= pedestalEvent;
+           if (iTimeBin < AliTPCReconstructor::GetRecoParam()->GetFirstBin())  
+             allBins[iRow][bin] = 0;
+           if (iTimeBin > AliTPCReconstructor::GetRecoParam()->GetLastBin())  
+             allBins[iRow][bin] = 0;
+           if (allBins[iRow][iPad*fMaxTime+iTimeBin] < zeroSup)
+             allBins[iRow][bin] = 0;
+           if (allBins[iRow][bin] < 3.0*rmsEvent)   // 3 sigma cut on RMS
+             allBins[iRow][bin] = 0;
+           if (allBins[iRow][bin]) allSigBins[iRow][allNSigBins[iRow]++] = bin;
+         }
        }
-       fRx = fParam->GetPadRowRadii(fSector, iRow);
-       fPadLength = fParam->GetPadPitchLength(fSector, iRow);
-       fPadWidth  = fParam->GetPadPitchWidth();
-
-       fMaxBin = fMaxTime*(fMaxPad+6);  // add 3 virtual pads  before and 3 after
-       fBins    = splitRows[fSector + kNS*iSplit];
-       fResBins = splitRowsRes[fSector + kNS*iSplit];
-
-       fRowCl = new AliTPCClustersRow;
-       fRowCl->SetClass("AliTPCclusterMI");
-       fRowCl->SetArray(1);
-       fRowCl->SetID(fParam->GetIndex(fSector, iRow));
-       fOutput->GetBranch("Segment")->SetAddress(&fRowCl);
-
-       FindClusters();
-
-       fOutput->Fill();
-       delete fRowCl;    
-       nclusters += fNcluster;    
-       delete[] fBins;
-       delete[] fResBins;
       }
+    }
+    // Now loop over rows and find clusters
+    for (fRow = 0; fRow < nRows; fRow++) {
+      fRowCl = new AliTPCClustersRow;
+      fRowCl->SetClass("AliTPCclusterMI");
+      fRowCl->SetArray(1);
+      fRowCl->SetID(fParam->GetIndex(fSector, fRow));
+      fOutput->GetBranch("Segment")->SetAddress(&fRowCl);
+
+      fRx = fParam->GetPadRowRadii(fSector, fRow);
+      fPadLength = fParam->GetPadPitchLength(fSector, fRow);
+      fPadWidth  = fParam->GetPadPitchWidth();
+      if (fSector < kNIS)
+       fMaxPad = fParam->GetNPadsLow(fRow);
+      else
+       fMaxPad = fParam->GetNPadsUp(fRow);
+      fMaxBin = fMaxTime*(fMaxPad+6);  // add 3 virtual pads  before and 3 after
+
+      fBins = allBins[fRow];
+      fSigBins = allSigBins[fRow];
+      fNSigBins = allNSigBins[fRow];
+
+      FindClusters(noiseROC);
+
+      fOutput->Fill();
+      delete fRowCl;    
+      nclusters += fNcluster;    
+    } // End of loop to find clusters
+  } // End of loop over sectors
+  
+  for (Int_t iRow = 0; iRow < nRowsMax; iRow++) {
+    delete [] allBins[iRow];
+    delete [] allSigBins[iRow];
+  }  
+  delete [] allBins;
+  delete [] allSigBins;
+  delete [] allNSigBins;
+  
+  Info("Digits2Clusters", "File  %s Event\t%d\tNumber of found clusters : %d\n", fOutput->GetName(),*(rawReader->GetEventId()), nclusters);
 
-  delete[] splitRows;
-  delete[] splitRowsRes;
-  Info("Digits2Clusters", "Number of found clusters : %d\n", nclusters);
 }
 
-void AliTPCclustererMI::FindClusters()
+void AliTPCclustererMI::FindClusters(AliTPCCalROC * noiseROC)
 {
-  //add virtual charge at the edge   
-  for (Int_t i=0; i<fMaxTime; i++){
-    Float_t amp1 = fBins[i+3*fMaxTime]; 
-    Float_t amp0 =0;
-    if (amp1>0){
-      Float_t amp2 = fBins[i+4*fMaxTime];
-      if (amp2==0) amp2=0.5;
-      Float_t sigma2 = GetSigmaY2(i);          
-      amp0 = (amp1*amp1/amp2)*TMath::Exp(-1./sigma2);  
-      if (gDebug>4) printf("\n%f\n",amp0);
-    }  
-    fBins[i+2*fMaxTime] = Int_t(amp0);    
-    amp0 = 0;
-    amp1 = fBins[(fMaxPad+2)*fMaxTime+i];
-    if (amp1>0){
-      Float_t amp2 = fBins[i+(fMaxPad+1)*fMaxTime];
-      if (amp2==0) amp2=0.5;
-      Float_t sigma2 = GetSigmaY2(i);          
-      amp0 = (amp1*amp1/amp2)*TMath::Exp(-1./sigma2);          
-      if (gDebug>4) printf("\n%f\n",amp0);
-    }        
-    fBins[(fMaxPad+3)*fMaxTime+i] = Int_t(amp0);           
-  }
-
-//  memcpy(fResBins,fBins, fMaxBin*2);
-  memcpy(fResBins,fBins, fMaxBin);
+  
+  //
+  // add virtual charge at the edge   
+  //
+  Double_t kMaxDumpSize = 500000;
+  if (fRecoParam->GetCalcPedestal() && fOutput->GetZipBytes()< kMaxDumpSize) fBDumpSignal =kTRUE;   //dump signal flag
   //
   fNcluster=0;
-  //first loop - for "gold cluster" 
   fLoop=1;
-  Int_t *b=&fBins[-1]+2*fMaxTime;
-  Int_t crtime = Int_t((fParam->GetZLength()-AliTPCReconstructor::GetCtgRange()*fRx)/fZWidth-5);
-
-  for (Int_t i=2*fMaxTime; i<fMaxBin-2*fMaxTime; i++) {
-    b++;
-    if (*b<8) continue;   //threshold form maxima
-    if (i%fMaxTime<crtime) {
-      Int_t delta = -(i%fMaxTime)+crtime;
-      b+=delta;
-      i+=delta;
-      continue; 
-    }
-     
+  Int_t crtime = Int_t((fParam->GetZLength(fSector)-fRecoParam->GetCtgRange()*fRx)/fZWidth-fParam->GetNTBinsL1()-5);
+  Float_t minMaxCutAbs       = fRecoParam->GetMinMaxCutAbs();
+  Float_t minLeftRightCutAbs = fRecoParam->GetMinLeftRightCutAbs();
+  Float_t minUpDownCutAbs    = fRecoParam->GetMinUpDownCutAbs();
+  Float_t minMaxCutSigma       = fRecoParam->GetMinMaxCutSigma();
+  Float_t minLeftRightCutSigma = fRecoParam->GetMinLeftRightCutSigma();
+  Float_t minUpDownCutSigma    = fRecoParam->GetMinUpDownCutSigma();
+  for (Int_t iSig = 0; iSig < fNSigBins; iSig++) {
+    Int_t i = fSigBins[iSig];
+    if (i%fMaxTime<=crtime) continue;
+    Float_t *b = &fBins[i];
+    //absolute custs
+    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[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;
-    AliTPCclusterMI c;
+    //
+    Float_t noise = noiseROC->GetValue(fRow, i/fMaxTime);
+    // 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 
+    if ((b[0]+b[-fMaxTime]+b[fMaxTime])<minLeftRightCutSigma*noise) continue;   //threshold for left right (PRF)    
+  
+    AliTPCclusterMI c(kFALSE);   // default cosntruction  without info
     Int_t dummy=0;
     MakeCluster(i, fMaxTime, fBins, dummy,c);
+    
     //}
   }
-  //memcpy(fBins,fResBins, fMaxBin*2);
-  //second  loop - for rest cluster 
-  /*        
-  fLoop=2;
-  b=&fResBins[-1]+2*fMaxTime;
-  for (Int_t i=2*fMaxTime; i<fMaxBin-2*fMaxTime; i++) {
-    b++;
-    if (*b<25) continue;   // bigger threshold for maxima
-    if (!IsMaximum(*b,fMaxTime,b)) continue;
-    AliTPCclusterMI c;
-    Int_t dummy;
-    MakeCluster(i, fMaxTime, fResBins, dummy,c);
-    //}
+}
+
+
+Double_t AliTPCclustererMI::ProcesSignal(Float_t *signal, Int_t nchannels, Int_t id[3], Double_t &rmsEvent, Double_t &pedestalEvent){
+  //
+  // process signal on given pad - + streaming of additional information in special mode
+  //
+  // id[0] - sector
+  // id[1] - row
+  // id[2] - pad 
+
+  //
+  // ESTIMATE pedestal and the noise
+  // 
+  const Int_t kPedMax = 100;
+  Double_t kMaxDebugSize = 5000000.;
+  Float_t  max    =  0;
+  Float_t  maxPos =  0;
+  Int_t    median =  -1;
+  Int_t    count0 =  0;
+  Int_t    count1 =  0;
+  Float_t  rmsCalib   = rmsEvent;       // backup initial value ( from calib)
+  Float_t  pedestalCalib = pedestalEvent;// backup initial value ( from calib)
+  Int_t    firstBin = AliTPCReconstructor::GetRecoParam()->GetFirstBin();
+  //
+  UShort_t histo[kPedMax];
+  memset(histo,0,kPedMax*sizeof(UShort_t));
+  for (Int_t i=0; i<fMaxTime; i++){
+    if (signal[i]<=0) continue;
+    if (signal[i]>max && i>firstBin) {
+      max = signal[i];
+      maxPos = i;
+    }
+    if (signal[i]>kPedMax-1) continue;
+    histo[int(signal[i]+0.5)]++;
+    count0++;
+  }
+  //
+  for (Int_t i=1; i<kPedMax; i++){
+    if (count1<count0*0.5) median=i;
+    count1+=histo[i];
+  }
+  // truncated mean  
+  //
+  Float_t count10=histo[median] ,mean=histo[median]*median,  rms=histo[median]*median*median ;
+  Float_t count06=histo[median] ,mean06=histo[median]*median,  rms06=histo[median]*median*median ;
+  Float_t count09=histo[median] ,mean09=histo[median]*median,  rms09=histo[median]*median*median ;
+  //
+  for (Int_t idelta=1; idelta<10; idelta++){
+    if (median-idelta<=0) continue;
+    if (median+idelta>kPedMax) continue;
+    if (count06<0.6*count1){
+      count06+=histo[median-idelta];
+      mean06 +=histo[median-idelta]*(median-idelta);
+      rms06  +=histo[median-idelta]*(median-idelta)*(median-idelta);
+      count06+=histo[median+idelta];
+      mean06 +=histo[median+idelta]*(median+idelta);
+      rms06  +=histo[median+idelta]*(median+idelta)*(median+idelta);
+    }
+    if (count09<0.9*count1){
+      count09+=histo[median-idelta];
+      mean09 +=histo[median-idelta]*(median-idelta);
+      rms09  +=histo[median-idelta]*(median-idelta)*(median-idelta);
+      count09+=histo[median+idelta];
+      mean09 +=histo[median+idelta]*(median+idelta);
+      rms09  +=histo[median+idelta]*(median+idelta)*(median+idelta);
+    }
+    if (count10<0.95*count1){
+      count10+=histo[median-idelta];
+      mean +=histo[median-idelta]*(median-idelta);
+      rms  +=histo[median-idelta]*(median-idelta)*(median-idelta);
+      count10+=histo[median+idelta];
+      mean +=histo[median+idelta]*(median+idelta);
+      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));
+  rmsEvent = rms09;
+  //
+  pedestalEvent = median;
+  if (AliLog::GetDebugLevel("","AliTPCclustererMI")==0) return median;
+  //
+  UInt_t uid[3] = {UInt_t(id[0]),UInt_t(id[1]),UInt_t(id[2])};
+  //
+  // Dump mean signal info
+  //
+  (*fDebugStreamer)<<"Signal"<<
+    "TimeStamp="<<fTimeStamp<<
+    "EventType="<<fEventType<<
+    "Sector="<<uid[0]<<
+    "Row="<<uid[1]<<
+    "Pad="<<uid[2]<<
+    "Max="<<max<<
+    "MaxPos="<<maxPos<<
+    //
+    "Median="<<median<<
+    "Mean="<<mean<<
+    "RMS="<<rms<<      
+    "Mean06="<<mean06<<
+    "RMS06="<<rms06<<
+    "Mean09="<<mean09<<
+    "RMS09="<<rms09<<
+    "RMSCalib="<<rmsCalib<<
+    "PedCalib="<<pedestalCalib<<
+    "\n";
+  //
+  // 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]);
+    }
+  }
+  //
+  //
+  //
+  Float_t kMin =fRecoParam->GetDumpAmplitudeMin();   // minimal signal to be dumped
+  Float_t *dsignal = new Float_t[nchannels];
+  Float_t *dtime   = new Float_t[nchannels];
+  for (Int_t i=0; i<nchannels; i++){
+    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
+      
+
+  delete [] dsignal;
+  delete [] dtime;
+  if (rms06>fRecoParam->GetMaxNoise()) {
+    pedestalEvent+=1024.;
+    return 1024+median; // sign noisy channel in debug mode
+  }
+  return median;
+}
+
+
+
+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;
+}
+