]> git.uio.no Git - u/mrichter/AliRoot.git/blobdiff - ITS/AliITSsimulationSDD.cxx
Fixing FORWARD_NULL defects reported by Coverity
[u/mrichter/AliRoot.git] / ITS / AliITSsimulationSDD.cxx
index bc387713da5d863bd013196e1859eb8bc34824b0..3c06b4dd8a26f00e332b321c4e387c727f716e77 100644 (file)
@@ -18,7 +18,7 @@
 #include <Riostream.h>
 #include <stdlib.h>
 #include <stdio.h>
-#include <string.h>
+#include <cstring>
 
 #include <TCanvas.h>
 #include <TF1.h>
 #include "AliITSdigitSPD.h"
 #include "AliITSetfSDD.h"
 #include "AliITSmodule.h"
+#include "AliITShit.h"
 #include "AliITSpList.h"
-#include "AliITSresponseSDD.h"
 #include "AliITSCalibrationSDD.h"
-#include "AliITSsegmentationSDD.h"
+#include "AliITSresponseSDD.h"
 #include "AliITSsimulationSDD.h"
 #include "AliLog.h"
 #include "AliRun.h"
@@ -70,7 +70,6 @@ fNofMaps(0),
 fMaxNofSamples(0),
 fScaleSize(0){
     // Default constructor
-    SetScaleFourier();
     SetPerpendTracksFlag();
     SetCrosstalkFlag();
     SetDoFFT();
@@ -145,14 +144,13 @@ fScaleSize(0){
 void AliITSsimulationSDD::Init(){
     // Standard Constructor
 
-    SetScaleFourier();
+    AliITSsegmentationSDD* seg = (AliITSsegmentationSDD*)GetSegmentationModel(1);
+    fScaleSize = ScaleFourier(seg);
     SetPerpendTracksFlag();
     SetCrosstalkFlag();
     SetDoFFT();
 
-    AliITSsegmentationSDD* seg = (AliITSsegmentationSDD*)GetSegmentationModel(1);
-    
-    AliITSresponseSDD* res = (AliITSresponseSDD*)fDetType->GetResponse(1);
+    AliITSSimuParam* simpar = fDetType->GetSimuParam();
     fpList = new AliITSpList( seg->Npz(),
                               fScaleSize*seg->Npx() );
     fHitSigMap2 = new AliITSMapA2(seg,fScaleSize,1);
@@ -168,17 +166,14 @@ void AliITSsimulationSDD::Init(){
     Double_t timeStep  = (Double_t)seg->Dpx(0);
 
     if(anodePitch*(fNofMaps/2) > sddWidth) {
-        Warning("AliITSsimulationSDD",
-                "Too many anodes %d or too big pitch %f \n",
-                fNofMaps/2,anodePitch);
+      AliWarning(Form("Too many anodes %d or too big pitch %f ",
+                fNofMaps/2,anodePitch));
     } // end if
 
 
     fElectronics = new AliITSetfSDD(timeStep/fScaleSize,
-                                    res->Electronics());
+                                    simpar->GetSDDElectronics());
 
-    char opt1[20], opt2[20];
-    res->ParamOptions(opt1,opt2);
 
     fITS       = (AliITS*)gAlice->GetModule("ITS");
  
@@ -254,7 +249,6 @@ void AliITSsimulationSDD::FastFourierTransform(Double_t *real,
         m /= 2;
         m2 += m2;
     } // end for i
-  
     for(j=0; j<samples; j++) {
         Int_t j1 = j;
         Int_t p = 0;
@@ -304,9 +298,9 @@ void AliITSsimulationSDD::SDigitiseModule(AliITSmodule *mod,Int_t md,Int_t ev){
 Bool_t AliITSsimulationSDD::AddSDigitsToModule(TClonesArray *pItemArray,
                                                Int_t mask ) {
     // Add Summable digits to module maps.
-   AliITSresponseSDD* res = (AliITSresponseSDD*)fDetType->GetResponse(1);
+    AliITSSimuParam* simpar = fDetType->GetSimuParam();
     Int_t    nItems = pItemArray->GetEntries();
-    Double_t maxadc = res->MaxAdc();
+    Double_t maxadc = simpar->GetSDDMaxAdc();
     Bool_t sig = kFALSE;
     
     // cout << "Adding "<< nItems <<" SDigits to module " << fModule << endl;
@@ -378,8 +372,8 @@ void AliITSsimulationSDD::FinishDigits() {
     if( fCrosstalkFlag ) ApplyCrosstalk(fModule);
 
     AliITSCalibrationSDD* res = (AliITSCalibrationSDD*)GetCalibrationModel(fModule);
-    const char *kopt = res->GetZeroSuppOption();
-    if (strstr(kopt,"ZS")) Compress2D();
+    Bool_t isZeroSupp = res->GetZeroSupp();
+    if (isZeroSupp) Compress2D();
     else StoreAllDigits();
 }
 //______________________________________________________________________
@@ -387,250 +381,236 @@ void AliITSsimulationSDD::HitsToAnalogDigits( AliITSmodule *mod ) {
     // create maps to build the lists of tracks for each digit
   AliITSsegmentationSDD* seg = (AliITSsegmentationSDD*)GetSegmentationModel(1);
   AliITSCalibrationSDD* res = (AliITSCalibrationSDD*)GetCalibrationModel(fModule);
+  AliITSSimuParam* simpar = fDetType->GetSimuParam();
   TObjArray *hits     = mod->GetHits();
-    Int_t      nhits    = hits->GetEntriesFast();
-
-    //    Int_t      arg[6]   = {0,0,0,0,0,0};
-    Int_t     nofAnodes  = fNofMaps/2;
-    Double_t  sddLength  = seg->Dx();
-    Double_t  sddWidth   = seg->Dz();
-    Double_t  anodePitch = seg->Dpz(0);
-    Double_t  timeStep   = seg->Dpx(0);
-    Double_t  driftSpeed ;  // drift velocity (anode dependent)
-    //Float_t   maxadc     = res->GetMaxAdc();    
-    //Float_t   topValue   = res->GetDynamicRange();
-    Double_t  norm       = res->GetMaxAdc()/res->GetDynamicRange(); //   maxadc/topValue;
-    Double_t  cHloss     = res->GetChargeLoss();
-    Float_t   dfCoeff, s1; res->DiffCoeff(dfCoeff,s1); // Signal 2d Shape
-    Double_t  eVpairs    = res->GetGeVToCharge()*1.0E9; // 3.6 eV by def.
-    Double_t  nsigma     = res->GetNSigmaIntegration(); //
-    Int_t     nlookups   = res->GetGausNLookUp();       //
-    Float_t   jitter     = res->GetJitterError(); // 
-
-    // Piergiorgio's part (apart for few variables which I made float
-    // when i thought that can be done
-    // Fill detector maps with GEANT hits
-    // loop over hits in the module
-
-    const Float_t kconv = 1.0e+6;  // GeV->KeV
-    Int_t     itrack      = 0;
-    Int_t     iWing;       // which detector wing/side.
-    Int_t     ii,kk,ka,kt; // loop indexs
-    Int_t     ia,it,index; // sub-pixel integration indexies
-    Int_t     iAnode;      // anode number.
-    Int_t     timeSample;  // time buckett.
-    Int_t     anodeWindow; // anode direction charge integration width
-    Int_t     timeWindow;  // time direction charge integration width
-    Int_t     jamin,jamax; // anode charge integration window
-    Int_t     jtmin,jtmax; // time charge integration window
-    Int_t     ndiv;        // Anode window division factor.
-    Int_t     nsplit;      // the number of splits in anode and time windows==1.
-    Int_t     nOfSplits;   // number of times track length is split into
-    Float_t   nOfSplitsF;  // Floating point version of nOfSplits.
-    Float_t   kkF;         // Floating point version of loop index kk.
-    Double_t  pathInSDD; // Track length in SDD.
-    Double_t  drPath; // average position of track in detector. in microns
-    Double_t  drTime; // Drift time
-    Double_t  nmul;   // drift time window multiplication factor.
-    Double_t  avDrft;  // x position of path length segment in cm.
-    Double_t  avAnode; // Anode for path length segment in Anode number (float)
-    Double_t  zAnode;  // Floating point anode number.
-    Double_t  driftPath; // avDrft in microns.
-    Double_t  width;     // width of signal at anodes.
-    Double_t  depEnergy; // Energy deposited in this GEANT step.
-    Double_t  xL[3],dxL[3]; // local hit coordinates and diff.
-    Double_t  sigA; // sigma of signal at anode.
-    Double_t  sigT; // sigma in time/drift direction for track segment
-    Double_t  aStep,aConst; // sub-pixel size and offset anode
-    Double_t  tStep,tConst; // sub-pixel size and offset time
-    Double_t  amplitude; // signal amplitude for track segment in nanoAmpere
-    Double_t  chargeloss; // charge loss for track segment.
-    Double_t  anodeAmplitude; // signal amplitude in anode direction
-    Double_t  aExpo;          // exponent of Gaussian anode direction
-    Double_t  timeAmplitude;  // signal amplitude in time direction
-    Double_t  tExpo;          // exponent of Gaussian time direction
-    //  Double_t tof;            // Time of flight in ns of this step.    
-
-    for(ii=0; ii<nhits; ii++) {
-      if(!mod->LineSegmentL(ii,xL[0],dxL[0],xL[1],dxL[1],xL[2],dxL[2],
-                              depEnergy,itrack)) continue;
-      Float_t xloc=xL[0];
-      if(xloc>0) iWing=0; // left side, carlos channel 0
-      else iWing=1; // right side
-
-      Float_t zloc=xL[2]+0.5*dxL[2];
-      zAnode=seg->GetAnodeFromLocal(xloc,zloc); // anode number in the range 0.-511.
-      driftSpeed = res->GetDriftSpeedAtAnode(zAnode);
-      if(timeStep*fMaxNofSamples < sddLength/driftSpeed) {
-       AliWarning("Time Interval > Allowed Time Interval\n");
-      }
-      depEnergy  *= kconv;
-        
-      // scale path to simulate a perpendicular track
+  Int_t      nhits    = hits->GetEntriesFast();
+
+  //    Int_t      arg[6]   = {0,0,0,0,0,0};
+  Int_t     nofAnodes  = fNofMaps/2;
+  Double_t  sddLength  = seg->Dx();
+  Double_t  anodePitch = seg->Dpz(0);
+  Double_t  timeStep   = seg->Dpx(0);
+  Double_t  driftSpeed ;  // drift velocity (anode dependent)
+  Double_t  nanoampToADC       = simpar->GetSDDMaxAdc()/simpar->GetSDDDynamicRange(); //   maxadc/topValue;
+  Double_t  cHloss     = simpar->GetSDDChargeLoss();
+  Float_t   dfCoeff, s1; 
+  simpar->GetSDDDiffCoeff(dfCoeff,s1); // Signal 2d Shape
+  Double_t  eVpairs    = simpar->GetGeVToCharge()*1.0E9; // 3.6 eV by def.
+  Double_t  nsigma     = simpar->GetNSigmaIntegration(); //
+  Int_t     nlookups   = simpar->GetGausNLookUp();       //
+  Float_t   jitter     = simpar->GetSDDJitterError(); // 
+  Float_t   trigDelay  = simpar->GetSDDTrigDelay(); // compensation for MC time zero
+  if(res->IsAMAt20MHz()) trigDelay+=12.5; // compensation for discretization step
+  Float_t   timeZero=fDetType->GetResponseSDD()->GetTimeZero(fModule);
+
+  // Piergiorgio's part (apart for few variables which I made float
+  // when i thought that can be done
+  // Fill detector maps with GEANT hits
+  // loop over hits in the module
+  
+  const Float_t kconv = 1.0e+6;  // GeV->KeV
+  Int_t     itrack      = 0;
+  Int_t     iWing;       // which detector wing/side.
+  Int_t     ii,kk,ka,kt; // loop indexs
+  Int_t     ia,it,index; // sub-pixel integration indexies
+  Int_t     iAnode;      // anode number.
+  Int_t     timeSample;  // time buckett.
+  Int_t     anodeWindow; // anode direction charge integration width
+  Int_t     timeWindow;  // time direction charge integration width
+  Int_t     jamin,jamax; // anode charge integration window
+  Int_t     jtmin,jtmax; // time charge integration window
+  Int_t     nsplitAn;    // the number of splits in anode and time windows
+  Int_t     nsplitTb;    // the number of splits in anode and time windows
+  Int_t     nOfSplits;   // number of times track length is split into
+  Float_t   nOfSplitsF;  // Floating point version of nOfSplits.
+  Float_t   kkF;         // Floating point version of loop index kk.
+  Double_t  pathInSDD; // Track length in SDD.
+  Double_t  drPath; // average position of track in detector. in microns
+  Double_t  drTime; // Drift time
+  Double_t  avDrft;  // x position of path length segment in cm.
+  Double_t  avAnode; // Anode for path length segment in Anode number (float)
+  Double_t  zAnode;  // Floating point anode number.
+  Double_t  driftPath; // avDrft in microns.
+  Double_t  width;     // width of signal at anodes.
+  Double_t  depEnergy; // Energy deposited in this GEANT step.
+  Double_t  xL[3],dxL[3]; // local hit coordinates and diff.
+  Double_t  sigA; // sigma of signal at anode.
+  Double_t  sigT; // sigma in time/drift direction for track segment
+  Double_t  aStep,aConst; // sub-pixel size and offset anode
+  Double_t  tStep,tConst; // sub-pixel size and offset time
+  Double_t  amplitude; // signal amplitude for track segment in nanoAmpere
+  Double_t  chargeloss; // charge loss for track segment.
+  Double_t  anodeAmplitude; // signal amplitude in anode direction
+  Double_t  aExpo;          // exponent of Gaussian anode direction
+  Double_t  timeAmplitude;  // signal amplitude in time direction
+  Double_t  tExpo;          // exponent of Gaussian time direction
+  Double_t  tof;            // Time of flight in ns of this step.    
+  
+  for(ii=0; ii<nhits; ii++) {
+    if(!mod->LineSegmentL(ii,xL[0],dxL[0],xL[1],dxL[1],xL[2],dxL[2],
+                         depEnergy,itrack)) continue;
+    Float_t xloc=xL[0];
+    if(xloc>0) iWing=0; // left side, carlos channel 0
+    else iWing=1; // right side
+    
+    Float_t zloc=xL[2]+0.5*dxL[2];
+    zAnode=seg->GetAnodeFromLocal(xloc,zloc); // anode number in the range 0.-511.
+    driftSpeed = res->GetDriftSpeedAtAnode(zAnode);
+    if(timeStep*fMaxNofSamples < sddLength/driftSpeed) {
+      AliWarning("Time Interval > Allowed Time Interval");
+    }
+    depEnergy  *= kconv;
+    if (!depEnergy) {
+      AliDebug(1,
+              Form("fTrack = %d hit=%d module=%d This particle has passed without losing energy!",
+                   itrack,ii,mod->GetIndex()));
+      continue;
       // continue if the particle did not lose energy
       // passing through detector
-      if (!depEnergy) {
-       AliDebug(1,
-                Form("fTrack = %d hit=%d module=%d This particle has passed without losing energy!",
-                     itrack,ii,mod->GetIndex()));
-       continue;
-      } // end if !depEnergy
-      
-      xL[0] += 0.0001*gRandom->Gaus( 0, jitter ); //
-      pathInSDD = TMath::Sqrt(dxL[0]*dxL[0]+dxL[1]*dxL[1]+dxL[2]*dxL[2]);
+    } // end if !depEnergy
+     
+    tof=0.;
+    AliITShit* h=(AliITShit*)hits->At(ii);
+    if(h){ 
+      tof=h->GetTOF()*1E9; 
+      AliDebug(1,Form("TOF for hit %d on mod %d (particle %d)=%g",ii,fModule,h->Track(),tof));
+    }
 
-      if (fFlag && pathInSDD) { depEnergy *= (0.03/pathInSDD); }
-      drPath = TMath::Abs(10000.*(dxL[0]+2.*xL[0])*0.5);
-      drPath = sddLength-drPath;
-      if(drPath < 0) {
+    xL[0] += 0.0001*gRandom->Gaus( 0, jitter ); //
+    pathInSDD = TMath::Sqrt(dxL[0]*dxL[0]+dxL[1]*dxL[1]+dxL[2]*dxL[2]);
+    
+    if (fFlag && pathInSDD) { depEnergy *= (0.03/pathInSDD); }
+    drPath = TMath::Abs(10000.*(dxL[0]+2.*xL[0])*0.5);
+    drPath = sddLength-drPath;
+    if(drPath < 0) {
+      AliDebug(1, // this should be fixed at geometry level
+              Form("negative drift path drPath=%e sddLength=%e dxL[0]=%e xL[0]=%e",
+                   drPath,sddLength,dxL[0],xL[0]));
+      continue;
+    } // end if drPath < 0
+    
+    // Compute number of segments to brake step path into
+    drTime = drPath/driftSpeed;  //   Drift Time
+    sigA   = TMath::Sqrt(2.*dfCoeff*drTime+s1*s1);// Sigma along the anodes
+    // calcuate the number of time the path length should be split into.
+    nOfSplits = (Int_t) (1. + 10000.*pathInSDD/sigA);
+    if(fFlag) nOfSplits = 1;
+    
+    // loop over path segments, init. some variables.
+    depEnergy /= nOfSplits;
+    nOfSplitsF = (Float_t) nOfSplits;
+    Float_t theAverage=0.,theSteps=0.;
+    for(kk=0;kk<nOfSplits;kk++) { // loop over path segments
+      kkF       = (Float_t) kk + 0.5;
+      avDrft    = xL[0]+dxL[0]*kkF/nOfSplitsF;
+      avAnode   = xL[2]+dxL[2]*kkF/nOfSplitsF;
+      theSteps+=1.;
+      theAverage+=avAnode;
+      zAnode = seg->GetAnodeFromLocal(avDrft,avAnode);
+      driftSpeed = res->GetDriftSpeedAtAnode(zAnode);  
+      driftPath = TMath::Abs(10000.*avDrft);
+      driftPath = sddLength-driftPath;
+      if(driftPath < 0) {
        AliDebug(1, // this should be fixed at geometry level
-                Form("negative drift path drPath=%e sddLength=%e dxL[0]=%e xL[0]=%e",
-                  drPath,sddLength,dxL[0],xL[0]));
+                Form("negative drift path driftPath=%e sddLength=%e avDrft=%e dxL[0]=%e xL[0]=%e",
+                     driftPath,sddLength,avDrft,dxL[0],xL[0]));
        continue;
-      } // end if drPath < 0
-
-        // Compute number of segments to brake step path into
-      drTime = drPath/driftSpeed;  //   Drift Time
-      sigA   = TMath::Sqrt(2.*dfCoeff*drTime+s1*s1);// Sigma along the anodes
-      // calcuate the number of time the path length should be split into.
-      nOfSplits = (Int_t) (1. + 10000.*pathInSDD/sigA);
-      if(fFlag) nOfSplits = 1;
+      } // end if driftPath < 0
+      drTime     = driftPath/driftSpeed; // drift time for segment.
+      // Sigma along the anodes for track segment.
+      sigA       = TMath::Sqrt(2.*dfCoeff*drTime+s1*s1);
+      sigT       = sigA/driftSpeed;
+
+      drTime+=tof; // take into account Time Of Flight from production point
+      drTime-=trigDelay;
+      drTime+=timeZero;
+      timeSample = (Int_t) (fScaleSize*drTime/timeStep + 1.001); // time bin in range 1-256 !!!
+      if(zAnode>nofAnodes) zAnode-=nofAnodes;  // to have the anode number between 0. and 256.
+      iAnode = (Int_t) (1.001+zAnode); // iAnode in range 1-256 !!!!
       
-      // loop over path segments, init. some variables.
-      depEnergy /= nOfSplits;
-      nOfSplitsF = (Float_t) nOfSplits;
-      Float_t theAverage=0.,theSteps=0.;
-      for(kk=0;kk<nOfSplits;kk++) { // loop over path segments
-       kkF       = (Float_t) kk + 0.5;
-       avDrft    = xL[0]+dxL[0]*kkF/nOfSplitsF;
-       avAnode   = xL[2]+dxL[2]*kkF/nOfSplitsF;
-       theSteps+=1.;
-       theAverage+=avAnode;
-       zAnode = seg->GetAnodeFromLocal(avDrft,avAnode);
-       driftSpeed = res->GetDriftSpeedAtAnode(zAnode); 
-       driftPath = TMath::Abs(10000.*avDrft);
-       driftPath = sddLength-driftPath;
-       if(driftPath < 0) {
-         AliDebug(1, // this should be fixed at geometry level
-                  Form("negative drift path driftPath=%e sddLength=%e avDrft=%e dxL[0]=%e xL[0]=%e",
-                       driftPath,sddLength,avDrft,dxL[0],xL[0]));
-         continue;
-       } // end if driftPath < 0
-       drTime     = driftPath/driftSpeed; // drift time for segment.
-       timeSample = (Int_t) (fScaleSize*drTime/timeStep + 1); // time bin in range 1-256 !!!
-       if(timeSample > fScaleSize*fMaxNofSamples) {
-         AliWarning(Form("Wrong Time Sample: %e",timeSample));
-         continue;
-       } // end if timeSample > fScaleSize*fMaxNoofSamples
-       
-       if(zAnode>nofAnodes) zAnode-=nofAnodes;  // to have the anode number between 0. and 256.
-       if(zAnode*anodePitch > sddWidth || zAnode*anodePitch < 0.) 
-         AliWarning(Form("Exceeding sddWidth=%e Z = %e",sddWidth,zAnode*anodePitch));
-       iAnode = (Int_t) (1.+zAnode); // iAnode in range 1-256 !!!!
-       if(iAnode < 1 || iAnode > nofAnodes) {
-         AliWarning(Form("Wrong iAnode: 1<%d>%d  (xanode=%e)",iAnode,nofAnodes, zAnode));
-         continue;
-       } // end if iAnode < 1 || iAnode > nofAnodes
-
-       // store straight away the particle position in the array
-       // of particles and take idhit=ii only when part is entering (this
-       // requires FillModules() in the macro for analysis) :
-       
-       // Sigma along the anodes for track segment.
-       sigA       = TMath::Sqrt(2.*dfCoeff*drTime+s1*s1);
-       sigT       = sigA/driftSpeed;
        // Peak amplitude in nanoAmpere
-       amplitude  = fScaleSize*160.*depEnergy/
-         (timeStep*eVpairs*2.*acos(-1.)*sigT*sigA);
-       amplitude *= timeStep/25.; // WARNING!!!!! Amplitude scaling to 
-       // account for clock variations 
-       // (reference value: 40 MHz)
-       chargeloss = 1.-cHloss*driftPath/1000.;
-       amplitude *= chargeloss;
-       width  = 2.*nsigma/(nlookups-1);
-       // Spread the charge 
-       // Pixel index
-       ndiv = 2;
-       nmul = 3.; 
-       if(drTime > 1200.) { 
-         ndiv = 4;
-         nmul = 1.5;
-       } // end if drTime > 1200.
-       // Sub-pixel index
-       nsplit = 4; // hard-wired //nsplit=4;nsplit = (nsplit+1)/2*2;
-       // Sub-pixel size see computation of aExpo and tExpo.
-       aStep  = anodePitch/(nsplit*fScaleSize*sigA);
-       aConst = zAnode*anodePitch/sigA;
-       tStep  = timeStep/(nsplit*fScaleSize*sigT);
-       tConst = drTime/sigT;
-       // Define SDD window corresponding to the hit
-       anodeWindow = (Int_t)(fScaleSize*nsigma*sigA/anodePitch+1);
-       timeWindow  = (Int_t) (fScaleSize*nsigma*sigT/timeStep+1.);
-       jamin = (iAnode - anodeWindow/ndiv - 2)*fScaleSize*nsplit +1;
-       jamax = (iAnode + anodeWindow/ndiv + 1)*fScaleSize*nsplit;
-       if(jamin <= 0) jamin = 1;
-       if(jamax > fScaleSize*nofAnodes*nsplit) 
-         jamax = fScaleSize*nofAnodes*nsplit;
-       // jtmin and jtmax are Hard-wired
-       jtmin = (Int_t)(timeSample-timeWindow*nmul-1)*nsplit+1;
-       jtmax = (Int_t)(timeSample+timeWindow*nmul)*nsplit;
-       if(jtmin <= 0) jtmin = 1;
-       if(jtmax > fScaleSize*fMaxNofSamples*nsplit) 
-         jtmax = fScaleSize*fMaxNofSamples*nsplit;
-       // Spread the charge in the anode-time window
-       for(ka=jamin; ka <=jamax; ka++) {
-         ia = (ka-1)/(fScaleSize*nsplit) + 1;
-         if(ia <= 0) {
-           Warning("HitsToAnalogDigits","ia < 1: ");
-           continue;
-         } // end if
-         if(ia > nofAnodes) ia = nofAnodes;
-         aExpo     = (aStep*(ka-0.5)-aConst);
-         if(TMath::Abs(aExpo) > nsigma)  anodeAmplitude = 0.;
-         else {
-           Int_t theBin = (Int_t) ((aExpo+nsigma)/width+0.5);
-           anodeAmplitude = amplitude*res->GetGausLookUp(theBin);
-         } // end if TMath::Abs(aEspo) > nsigma
-         // index starts from 0
-         index = iWing*nofAnodes+ia-1;
-         if(anodeAmplitude){
-           for(kt=jtmin; kt<=jtmax; kt++) {
-             it = (kt-1)/nsplit+1;  // it starts from 1
-             if(it<=0){
-               Warning("HitsToAnalogDigits","it < 1:");
-               continue;
-             } // end if 
-             if(it>fScaleSize*fMaxNofSamples)
-               it = fScaleSize*fMaxNofSamples;
-             tExpo    = (tStep*(kt-0.5)-tConst);
-             if(TMath::Abs(tExpo) > nsigma) timeAmplitude = 0.;
-             else {
-               Int_t theBin = (Int_t) ((tExpo+nsigma)/width+0.5);
-               timeAmplitude = anodeAmplitude*res->GetGausLookUp(theBin);
-             } // end if TMath::Abs(tExpo) > nsigma
-             // build the list of Sdigits for this module        
-             //                    arg[0]     = index;
-             //                    arg[1]     = it;
-             //                    arg[2]     = itrack; // track number
-             //                    arg[3]     = ii-1; // hit number.
-             timeAmplitude *= norm;
-             timeAmplitude *= 10;
-             //         ListOfFiredCells(arg,timeAmplitude,alst,padr);
-             Double_t charge = timeAmplitude;
-             charge += fHitMap2->GetSignal(index,it-1);
-             fHitMap2->SetHit(index, it-1, charge);
-             fpList->AddSignal(index,it-1,itrack,ii-1,
-                               mod->GetIndex(),timeAmplitude);
-             fAnodeFire[index] = kTRUE;
-           }  // end loop over time in window               
-         } // end if anodeAmplitude 
-       } // loop over anodes in window
-      } // end loop over "sub-hits"
-    } // end loop over hits
+      amplitude  = fScaleSize*160.*depEnergy/
+       (timeStep*eVpairs*2.*acos(-1.));
+      chargeloss = 1.-cHloss*driftPath/1000.;
+      amplitude *= chargeloss;
+      width  = 2.*nsigma/(nlookups-1);
+      // Spread the charge 
+      nsplitAn = 4; 
+      nsplitTb=4;
+      aStep  = anodePitch/(nsplitAn*sigA);
+      aConst = zAnode*anodePitch/sigA;
+      tStep  = timeStep/(nsplitTb*fScaleSize*sigT);
+      tConst = drTime/sigT;
+      // Define SDD window corresponding to the hit
+      anodeWindow = (Int_t)(nsigma*sigA/anodePitch+1);
+      timeWindow  = (Int_t) (fScaleSize*nsigma*sigT/timeStep+1.);
+      jamin = (iAnode - anodeWindow - 2)*nsplitAn+1;
+      if(jamin <= 0) jamin = 1;
+      if(jamin > nofAnodes*nsplitAn){ 
+       AliDebug(1,Form("Energy deposition completely outside anode acceptance: anode min=%d",jamin));
+       continue;
+      }
+      jamax = (iAnode + anodeWindow + 2)*nsplitAn;
+      if(jamax > nofAnodes*nsplitAn) jamax = nofAnodes*nsplitAn;
+      if(jamax <=0){ 
+       AliDebug(1,Form("Energy deposition completely outside anode acceptance: anode max=%d",jamax));
+       continue;
+      }
+      jtmin = (Int_t)(timeSample-timeWindow-2)*nsplitTb+1;
+      if(jtmin <= 0) jtmin = 1;
+      if(jtmin > fScaleSize*fMaxNofSamples*nsplitTb){ 
+       AliDebug(1,Form("Energy deposition completely outside time acceptance: time sample min=%d  tof=%f",jtmin,tof));
+       continue; 
+      }
+      jtmax = (Int_t)(timeSample+timeWindow+2)*nsplitTb;
+      if(jtmax > fScaleSize*fMaxNofSamples*nsplitTb) jtmax = fScaleSize*fMaxNofSamples*nsplitTb;
+      if(jtmax <= 0){
+       AliDebug(1,Form("Energy deposition completely outside time acceptance: time sample max=%d  tof=%f",jtmax,tof));
+       continue; 
+      }
+
+      // Spread the charge in the anode-time window
+      for(ka=jamin; ka <=jamax; ka++) {          
+       ia = (ka-1)/nsplitAn + 1;
+       if(ia <= 0) ia=1; 
+       if(ia > nofAnodes) ia = nofAnodes;
+       aExpo     = (aStep*(ka-0.5)-aConst);
+       if(TMath::Abs(aExpo) > nsigma)  anodeAmplitude = 0.;
+       else {
+         Int_t theBin = (Int_t) ((aExpo+nsigma)/width+0.5);
+         anodeAmplitude = amplitude*simpar->GetGausLookUp(theBin);
+       }
+       // index starts from 0
+       index = iWing*nofAnodes+ia-1;
+       if(anodeAmplitude){
+         for(kt=jtmin; kt<=jtmax; kt++) {
+           it = (kt-1)/nsplitTb+1;  // it starts from 1
+           if(it<=0) it=1;
+           if(it>fScaleSize*fMaxNofSamples)
+             it = fScaleSize*fMaxNofSamples;
+           tExpo    = (tStep*(kt-0.5)-tConst);
+           if(TMath::Abs(tExpo) > nsigma) timeAmplitude = 0.;
+           else {
+             Int_t theBin = (Int_t) ((tExpo+nsigma)/width+0.5);
+             timeAmplitude = anodeAmplitude*simpar->GetGausLookUp(theBin)*aStep*tStep;
+           }
+           timeAmplitude *= nanoampToADC;
+           //         ListOfFiredCells(arg,timeAmplitude,alst,padr);
+           Double_t charge = timeAmplitude;
+           charge += fHitMap2->GetSignal(index,it-1);
+           fHitMap2->SetHit(index, it-1, charge);
+           fpList->AddSignal(index,it-1,itrack,ii-1,
+                             mod->GetIndex(),timeAmplitude);
+           fAnodeFire[index] = kTRUE;
+         }  // end loop over time in window               
+       } // end if anodeAmplitude 
+      } // loop over anodes in window
+    } // end loop over "sub-hits"
+  } // end loop over hits
 }
 
 //____________________________________________
-void AliITSsimulationSDD::AddDigit( Int_t i, Int_t j, Int_t signal ) {
+void AliITSsimulationSDD::AddDigit( Int_t i, Int_t j, Int_t signalc, Int_t signale) {
   // Adds a Digit.
   Int_t size = AliITSdigit::GetNTracks();
 
@@ -642,7 +622,7 @@ void AliITSsimulationSDD::AddDigit( Int_t i, Int_t j, Int_t signal ) {
 
   digits[0] = i;
   digits[1] = j;
-  digits[2] = signal;
+  digits[2] = signalc;
 
   AliITSpListItem *pItem = fpList->GetpListItem( i, j );
   if( pItem == 0 ) {
@@ -668,7 +648,7 @@ void AliITSsimulationSDD::AddDigit( Int_t i, Int_t j, Int_t signal ) {
     }// end for if
   }
 
-  fITS->AddSimDigit( 1, phys, digits, tracks, hits, charges ); 
+  fITS->AddSimDigit( 1, phys, digits, tracks, hits, charges, signale ); 
   delete [] tracks;
   delete [] hits;
   delete [] charges;
@@ -678,21 +658,24 @@ void AliITSsimulationSDD::ChargeToSignal(Int_t mod,Bool_t bAddNoise, Bool_t bAdd
   // add baseline, noise, gain, electronics and ADC saturation effects
   // apply dead channels
 
-  char opt1[20], opt2[20];
   AliITSCalibrationSDD* res = (AliITSCalibrationSDD*)GetCalibrationModel(mod);
-  res->GetParamOptions(opt1,opt2);
   Double_t baseline=0; 
   Double_t noise=0; 
   Double_t gain=0; 
   Float_t contrib=0;
   Int_t i,k,kk;
-  Float_t maxadc = res->GetMaxAdc();    
+  AliITSSimuParam* simpar = fDetType->GetSimuParam();
+  Float_t maxadc = simpar->GetSDDMaxAdc();    
+  Int_t nGroup=fScaleSize;
+  if(res->IsAMAt20MHz()){
+    nGroup=fScaleSize/2;
+  }
 
   for (i=0;i<fNofMaps;i++) {
     if( !fAnodeFire[i] ) continue;
     baseline = res->GetBaseline(i);
     noise = res->GetNoise(i);
-    gain = res->GetChannelGain(i);
+    gain = res->GetChannelGain(i)/fDetType->GetAverageGainSDD();
     if(res->IsBad()) gain=0.;
     if( res->IsChipBad(res->GetChip(i)) )gain=0.;
     for(k=0; k<fScaleSize*fMaxNofSamples; k++) {
@@ -704,7 +687,7 @@ void AliITSsimulationSDD::ChargeToSignal(Int_t mod,Bool_t bAddNoise, Bool_t bAdd
       }
       fInZI[k]  = 0.;
     } // end for k
-    if(!fDoFFT) {
+    if(!fDoFFT) {      
       for(k=0; k<fMaxNofSamples; k++) {
        Double_t newcont = 0.;
        Double_t maxcont = 0.;
@@ -715,7 +698,7 @@ void AliITSsimulationSDD::ChargeToSignal(Int_t mod,Bool_t bAddNoise, Bool_t bAdd
        newcont = maxcont;
        if (newcont >= maxadc) newcont = maxadc -1;
        if(newcont >= baseline){
-         Warning("","newcont=%d>=baseline=%d",newcont,baseline);
+         Warning("","newcont=%f>=baseline=%f",newcont,baseline);
        } // end if
          // back to analog: ?
        fHitMap2->SetHit(i,k,newcont);
@@ -732,7 +715,7 @@ void AliITSsimulationSDD::ChargeToSignal(Int_t mod,Bool_t bAddNoise, Bool_t bAdd
       for(k=0; k<fMaxNofSamples; k++) {
        Double_t newcont1 = 0.;
        Double_t maxcont1 = 0.;
-       for(kk=0;kk<fScaleSize;kk++) {
+       for(kk=0;kk<nGroup;kk++) {
          newcont1 = fOutZR[fScaleSize*k+kk];
          if(newcont1 > maxcont1) maxcont1 = newcont1;
        } // end for kk
@@ -749,17 +732,9 @@ void AliITSsimulationSDD::ChargeToSignal(Int_t mod,Bool_t bAddNoise, Bool_t bAdd
 void AliITSsimulationSDD::ApplyCrosstalk(Int_t mod) {
     // function add the crosstalk effect to signal
     // temporal function, should be checked...!!!
-    AliITSsegmentationSDD* seg = (AliITSsegmentationSDD*)GetSegmentationModel(1);
   
-    Int_t fNofMaps = seg->Npz();
-    Int_t fMaxNofSamples = seg->Npx();
-
     // create and inizialice crosstalk map
     Float_t* ctk = new Float_t[fNofMaps*fMaxNofSamples+1];
-    if( ctk == NULL ) {
-        Error( "ApplyCrosstalk", "no memory for temporal map: exit \n" );
-        return;
-    }
     memset( ctk, 0, sizeof(Float_t)*(fNofMaps*fMaxNofSamples+1) );
     AliITSCalibrationSDD* calibr = (AliITSCalibrationSDD*)GetCalibrationModel(mod);
     for( Int_t z=0; z<fNofMaps; z++ ) {
@@ -788,11 +763,6 @@ void AliITSsimulationSDD::ApplyCrosstalk(Int_t mod) {
                         // make smooth derivative
                         Float_t* dev = new Float_t[fMaxNofSamples+1];
                         memset( dev, 0, sizeof(Float_t)*(fMaxNofSamples+1) );
-                        if( ctk == NULL ) {
-                            Error( "ApplyCrosstalk", 
-                                   "no memory for temporal array: exit \n" );
-                            return;
-                        }
                         for( Int_t i=tstart; i<tstop; i++ ) {   
                             if( i > 2 && i < fMaxNofSamples-2 )
                                 dev[i] = -0.2*fHitMap2->GetSignal( z,i-2 ) 
@@ -844,10 +814,30 @@ Int_t AliITSsimulationSDD::Convert10to8(Int_t signal) const {
     return 0;
 }
 //______________________________________________________________________
+Int_t AliITSsimulationSDD::Convert8to10(Int_t signal) const {
+  // Decompression from 8 to 10 bit
+
+  if (signal < 0 || signal > 255) {
+    AliWarning(Form("Signal value %d out of range",signal));
+    return 0;
+  } // end if signal <0 || signal >255
+
+  if (signal < 128) return signal;
+  if (signal < 192) {
+    if (TMath::Odd(signal)) return (128+((signal-128)<<1));
+    else  return (128+((signal-128)<<1)+1);
+  } // end if signal < 192
+  if (signal < 224) {
+    if (TMath::Odd(signal)) return (256+((signal-192)<<3)+3);
+    else  return (256+((signal-192)<<3)+4);
+  } // end if signal < 224
+  if (TMath::Odd(signal)) return (512+((signal-224)<<4)+7);
+  return (512+((signal-224)<<4)+8);
+}
+//______________________________________________________________________
 void AliITSsimulationSDD::Compress2D(){
   // 2D zero-suppression algorithm as described in ALICE-INT-1999-28 V10
   AliITSCalibrationSDD* res = (AliITSCalibrationSDD*)GetCalibrationModel(fModule);  
-  Bool_t   do10to8=res->Do10to8();
   for (Int_t iWing=0; iWing<2; iWing++) {
     Int_t tL=res->GetZSLowThreshold(iWing);
     Int_t tH=res->GetZSHighThreshold(iWing);
@@ -880,10 +870,12 @@ void AliITSsimulationSDD::Compress2D(){
        if(sS>tL) nLow++;
        if(sS>tH) nHigh++;
        
-       if(nLow>=3 && nHigh>=1){
-         Int_t signal=(Int_t)(cC-tL);
-         if(do10to8) signal = Convert10to8(signal);
-         AddDigit(ian,itb,signal);  // store C (subtracting low threshold)
+       if(nLow>=2 && nHigh>=1){
+         Int_t signal=(Int_t)cC;
+         Int_t signalc = Convert10to8(signal);
+         Int_t signale = Convert8to10(signalc);
+         signalc-=tL; // subtract low threshold after 10 to 8 bit compression
+         if(signalc>=4) AddDigit(ian,itb,signalc,signale);  // store C 
        }
       }
     }
@@ -893,37 +885,28 @@ void AliITSsimulationSDD::Compress2D(){
 
 //______________________________________________________________________
 void AliITSsimulationSDD::StoreAllDigits(){
-  // if non-zero-suppressed data
-  AliITSCalibrationSDD* res = (AliITSCalibrationSDD*)GetCalibrationModel(fModule);
-
-  Bool_t do10to8 = res->Do10to8();
-  Int_t i, j, digits[3];
-
-  for (i=0; i<fNofMaps; i++) {
-    for (j=0; j<fMaxNofSamples; j++) {
-      Int_t signal=(Int_t)(fHitMap2->GetSignal(i,j));
-      if(do10to8) signal = Convert10to8(signal);
-      digits[0] = i;
-      digits[1] = j;
-      digits[2] = signal;
-      fITS->AddRealDigit(1,digits);
-    } // end for j
-  } // end for i
+  // store digits for non-zero-suppressed data
+  for (Int_t ian=0; ian<fNofMaps; ian++) {
+    for (Int_t itb=0; itb<fMaxNofSamples; itb++){
+      Int_t signal=(Int_t)(fHitMap2->GetSignal(ian,itb));
+      Int_t signalc = Convert10to8(signal);
+      Int_t signale = Convert8to10(signalc);
+      AddDigit(ian,itb,signalc,signale);  
+    } 
+  }
 } 
 //______________________________________________________________________
 void AliITSsimulationSDD::CreateHistograms(Int_t scale){
-    // Creates histograms of maps for debugging
-    Int_t i;
-
-    fHis=new TObjArray(fNofMaps);
-    for (i=0;i<fNofMaps;i++) {
-        TString sddName("sdd_");
-        Char_t candNum[4];
-        sprintf(candNum,"%d",i+1);
-        sddName.Append(candNum);
-        fHis->AddAt(new TH1F(sddName.Data(),"SDD maps",scale*fMaxNofSamples,
-                             0.,(Float_t) scale*fMaxNofSamples), i);
-    } // end for i
+  // Creates histograms of maps for debugging
+  Int_t i;
+  
+  fHis=new TObjArray(fNofMaps);
+  for (i=0;i<fNofMaps;i++) {
+    TString sddName;
+    sddName.Form("sdd_%d",i+1);
+    fHis->AddAt(new TH1F(sddName.Data(),"SDD maps",scale*fMaxNofSamples,
+                        0.,(Float_t) scale*fMaxNofSamples), i);
+  } // end for i
 }
 //______________________________________________________________________
 void AliITSsimulationSDD::FillHistograms(){