]> git.uio.no Git - u/mrichter/AliRoot.git/blobdiff - ITS/AliITSsimulationSPDdubna.cxx
First commit.
[u/mrichter/AliRoot.git] / ITS / AliITSsimulationSPDdubna.cxx
index dc30353585c12a812e679203d0565af154bb16a3..ac18a05c177a482c343bada2fdffb64c08e49d09 100644 (file)
@@ -1,11 +1,44 @@
-#include <iostream.h>
+/**************************************************************************
+ * Copyright(c) 1998-1999, ALICE Experiment at CERN, All rights reserved. *
+ *                                                                        *
+ * Author: The ALICE Off-line Project.                                    *
+ * Contributors are mentioned in the code where appropriate.              *
+ *                                                                        *
+ * Permission to use, copy, modify and distribute this software and its   *
+ * documentation strictly for non-commercial purposes is hereby granted   *
+ * without fee, provided that the above copyright notice appears in all   *
+ * copies and that both the copyright notice and this permission notice   *
+ * appear in the supporting documentation. The authors make no claims     *
+ * about the suitability of this software for any purpose. It is          *
+ * provided "as is" without express or implied warranty.                  *
+ **************************************************************************/
+
+/*
+$Log$
+Revision 1.9  2002/10/22 14:45:45  alibrary
+Introducing Riostream.h
+
+Revision 1.8  2002/10/14 14:57:08  hristov
+Merging the VirtualMC branch to the main development branch (HEAD)
+
+Revision 1.3.8.2  2002/10/14 13:14:08  hristov
+Updating VirtualMC to v3-09-02
+
+Revision 1.7  2002/09/09 17:23:28  nilsen
+Minor changes in support of changes to AliITSdigitS?D class'.
+
+Revision 1.6  2002/08/21 22:09:58  nilsen
+Updated SPD simulation with difusion effects. ReWritten Hit to SDigits
+code.
+
+*/
+#include <Riostream.h>
 #include <TRandom.h>
 #include <TH1.h>
 #include <TMath.h>
 #include <TString.h>
 #include <TParticle.h>
 
-
 #include "AliRun.h"
 #include "AliITS.h"
 #include "AliITShit.h"
 #include "AliITSMapA2.h" 
 #include "AliITSpList.h"
 #include "AliITSsimulationSPDdubna.h"
-#include "AliITSsegmentation.h"
-#include "AliITSresponse.h"
-
-
+#include "AliITSsegmentationSPD.h"
+#include "AliITSresponseSPDdubna.h"
 
+//#define DEBUG
 
 ClassImp(AliITSsimulationSPDdubna)
 ////////////////////////////////////////////////////////////////////////
@@ -49,6 +81,7 @@ AliITSsimulationSPDdubna::AliITSsimulationSPDdubna(){
 AliITSsimulationSPDdubna::AliITSsimulationSPDdubna(AliITSsegmentation *seg,
                                                   AliITSresponse *resp){
     // standard constructor
+    const Double_t kmictocm = 1.0e-4; // convert microns to cm.
 
     fHis = 0;
     fResponse = resp;
@@ -56,12 +89,14 @@ AliITSsimulationSPDdubna::AliITSsimulationSPDdubna(AliITSsegmentation *seg,
     fModule = 0;
     fEvent = 0;
 
-    fNPixelsZ=fSegmentation->Npz();
-    fNPixelsX=fSegmentation->Npx();
+    fNPixelsZ=GetSeg()->Npz();
+    fNPixelsX=GetSeg()->Npx();
 
-    fResponse->GetNoiseParam(fNoise,fBaseline);
+    GetResp()->GetNoiseParam(fNoise,fBaseline);
+    GetResp()->SetDistanceOverVoltage(kmictocm*GetSeg()->Dy(),50.0);
 
-    fMapA2 = new AliITSMapA2(fSegmentation);
+//    fMapA2 = new AliITSMapA2(GetSeg());
+    fMapA2 = 0;
 
     fpList = new AliITSpList(fNPixelsZ+1,fNPixelsX+1);
 
@@ -70,7 +105,7 @@ AliITSsimulationSPDdubna::AliITSsimulationSPDdubna(AliITSsegmentation *seg,
 AliITSsimulationSPDdubna::~AliITSsimulationSPDdubna(){
     // destructor
 
-    delete fMapA2;
+    if(fMapA2) delete fMapA2;
 
     if (fHis) {
        fHis->Delete(); 
@@ -121,7 +156,7 @@ void AliITSsimulationSPDdubna::InitSimulationModule(Int_t module, Int_t event){
 
     fModule = module;
     fEvent  = event;
-    fMapA2->ClearMap();
+//    fMapA2->ClearMap();
     fpList->ClearMap();
 }
 //_____________________________________________________________________
@@ -146,7 +181,7 @@ void AliITSsimulationSPDdubna::SDigitiseModule(AliITSmodule *mod, Int_t mask,
     fModule = mod->GetIndex();
     HitToSDigit(mod, module, mask, fpList);
     WriteSDigits(fpList);
-    fMapA2->ClearMap();
+//    fMapA2->ClearMap();
     fpList->ClearMap();
 }
 //______________________________________________________________________
@@ -161,15 +196,19 @@ void AliITSsimulationSPDdubna::WriteSDigits(AliITSpList *pList){
     //
     //  Return:
     //    none
-    Int_t i, ni, j, nj;
+    Int_t ix, nix, iz, niz;
     static AliITS *aliITS = (AliITS*)gAlice->GetModule("ITS");
 
-    pList->GetMaxMapIndex(ni, nj);
-    for(i=0; i<ni; i++)for(j=0; j<nj; j++){
-       if(pList->GetSignalOnly(i, j)>0.0){
-           aliITS->AddSumDigit(*(pList->GetpListItem(i, j)));
+    pList->GetMaxMapIndex(niz, nix);
+    for(iz=0; iz<niz-1; iz++)for(ix=0; ix<nix-1; ix++){
+       if(pList->GetSignalOnly(iz+1,ix+1)>0.0){
+           aliITS->AddSumDigit(*(pList->GetpListItem(iz+1,ix+1)));
+#ifdef DEBUG
+           cout <<"SDigits " << iz << "," << ix << "," << 
+               *(pList->GetpListItem(iz+1,ix+1)) << endl;
+#endif
        } // end if pList
-    } // end for i,j
+    } // end for iz,ix
     return; 
 }
 //______________________________________________________________________
@@ -205,7 +244,7 @@ void AliITSsimulationSPDdubna::SDigitsToDigits(Int_t module,
 
     fModule = module;
     ChargeToSignal(pList); // Charge To Signal both adds noise and
-    fMapA2->ClearMap();
+//    fMapA2->ClearMap();
     pList->ClearMap();
 }
 //______________________________________________________________________
@@ -228,19 +267,19 @@ void AliITSsimulationSPDdubna::DigitiseModule(AliITSmodule *mod, Int_t module,
     fModule = mod->GetIndex();  //This calls the module for HitToSDigit
     HitToSDigit(mod,fModule, dummy, fpList);
     ChargeToSignal(fpList);
-    fMapA2->ClearMap();
+//    fMapA2->ClearMap();
     fpList->ClearMap();
 }
 //______________________________________________________________________
-void AliITSsimulationSPDdubna::UpdateMapSignal(Int_t i, Int_t j, Int_t trk,
+void AliITSsimulationSPDdubna::UpdateMapSignal(Int_t iz, Int_t ix, Int_t trk,
                                               Int_t ht, Int_t module,
                                               Double_t signal,
                                               AliITSpList *pList){
     //  This function adds a signal to the pList from the pList class
     //
     //  Inputs:
-    //    Int_t       i      // row number
-    //    Int_t            // column number
+    //    Int_t       iz     // row number
+    //    Int_t       ix     // column number
     //    Int_t       trk    // track number
     //    Int_t       ht     // hit number
     //    Double_t    signal // signal strength
@@ -256,23 +295,20 @@ void AliITSsimulationSPDdubna::UpdateMapSignal(Int_t i, Int_t j, Int_t trk,
     //
     //  Return:
     //    none
-    Int_t    iz = j;
-    Int_t    ix = i;
-    Double_t sig = signal;
 
-    fMapA2->AddSignal(iz, ix, sig);
-    pList->AddSignal(i, j, trk, ht, fModule, signal);
+//    fMapA2->AddSignal(iz, ix, signal);
+    pList->AddSignal(iz+1,ix+1, trk, ht, fModule, signal);
 }
 //______________________________________________________________________
-void AliITSsimulationSPDdubna::UpdateMapNoise(Int_t i, Int_t j, Int_t ix,
-                                             Int_t iz, Int_t fModule,
+void AliITSsimulationSPDdubna::UpdateMapNoise(Int_t iz,
+                                             Int_t ix, Int_t fModule,
                                              Double_t sig, Float_t noise,
                                              AliITSpList *pList){
     //  This function adds noise to data in the MapA2 as well as the pList
     //
     //  Inputs:
-    //    Int_t       i == ix // row number
-    //    Int_t       j == iz // column number
+    //    Int_t       iz       // row number
+    //    Int_t       ix       // column number
     //    Int_t       mod     // module number
     //    Double_t    sig     // signal strength
     //    Double_t    noise   // electronic noise generated by ChargeToSignal
@@ -285,8 +321,8 @@ void AliITSsimulationSPDdubna::UpdateMapNoise(Int_t i, Int_t j, Int_t ix,
     //  Return:
     //    none
 
-    fMapA2->AddSignal(iz, ix, sig);
-    pList->AddNoise(i, j, fModule, noise);
+//    fMapA2->AddSignal(iz, ix, noise);
+    pList->AddNoise(iz+1,ix+1, fModule, noise);
 }
 //______________________________________________________________________
 void AliITSsimulationSPDdubna::HitToDigit(AliITSmodule *mod, Int_t module,
@@ -295,34 +331,235 @@ void AliITSsimulationSPDdubna::HitToDigit(AliITSmodule *mod, Int_t module,
 }
 //______________________________________________________________________
 void AliITSsimulationSPDdubna::HitToSDigit(AliITSmodule *mod, Int_t module,
+                                           Int_t dummy,AliITSpList *pList){
+    // Does the charge distributions using Gaussian diffusion charge charing.
+    const Double_t kmictocm = 1.0e-4; // convert microns to cm.
+    TObjArray *hits = mod->GetHits();
+    Int_t nhits = hits->GetEntriesFast();
+    Int_t h,ix,iz;
+    Int_t idtrack;
+    Double_t x0=0.0,x1=0.0,y0=0.0,y1=0.0,z0=0.0,z1=0.0,de=0.0;
+    Double_t x,y,z,t,tp,st,dt=0.2,el,sig;
+    Double_t thick = kmictocm*GetSeg()->Dy();
+
+    if(nhits<=0) return;
+    for(h=0;h<nhits;h++){
+#ifdef DEBUG
+       cout << "Hits=" << h << "," << *(mod->GetHit(h)) << endl;
+#endif
+       if(mod->LineSegmentL(h,x0,x1,y0,y1,z0,z1,de,idtrack)){
+       st =TMath::Sqrt(x1*x1+y1*y1+z1*z1);
+       if(st>0.0){
+           st = (Double_t)((Int_t)(1.0E+04*st)); // number of microns
+           if(st<=0.0) st = 1.0;
+           dt = 1.0/st;
+           for(t=0;t<1.0;t+=dt){ // Integrate over t
+               tp = t+0.5*dt;
+               el = GetResp()->GeVToCharge((Float_t)(dt*de));
+#ifdef DEBUG
+               if(el<=0.0) cout << "el="<<el<<" dt="<<dt<<" de="<<de<<endl;
+#endif
+               x = x0+x1*tp;
+               y = y0+y1*tp;
+               z = z0+z1*tp;
+               GetSeg()->LocalToDet(x,z,ix,iz);
+               sig = GetResp()->SigmaDiffusion1D(thick + y);
+               SpreadCharge(x,y,z,ix,iz,el,sig,idtrack,
+                            mod->GetHitTrackIndex(h),h,mod->GetIndex());
+           } // end for t
+       } else { // st == 0.0 deposit it at this point
+           el = GetResp()->GeVToCharge((Float_t)de);
+           x = x0;
+           y = y0;
+           z = z0;
+           GetSeg()->LocalToDet(x,z,ix,iz);
+           sig = GetResp()->SigmaDiffusion1D(thick + y);
+           SpreadCharge(x,y,z,ix,iz,el,sig,
+                        idtrack,mod->GetHitTrackIndex(h),h,mod->GetIndex());
+       } // end if st>0.0
+    }} // Loop over all hits h
+}/*
+//______________________________________________________________________
+void AliITSsimulationSPDdubna::HitToSDigit(AliITSmodule *mod, Int_t module,
+                                           Int_t dummy,AliITSpList *pList){
+    // Does the charge distributions using Gaussian diffusion charge charing.
+    const Double_t kmictocm = 1.0e-4; // convert microns to cm.
+    TObjArray *hits = mod->GetHits();
+    Int_t nhits = hits->GetEntriesFast();
+    Int_t h,ix,iz,i,n;
+    Int_t idtrack;
+    Double_t x0=0.0,x1=0.0,y0=0.0,y1=0.0,z0=0.0,z1=0.0,de=0.0;
+    Double_t x,y,z,*ta,t,tp,st,dt=0.2,el,sig;
+    Double_t thick = kmictocm*GetSeg()->Dy();
+
+    if(nhits<=0) return;
+    for(h=0;h<nhits;h++){
+#ifdef DEBUG
+       cout << "Hits=" << h << "," << *(mod->GetHit(h)) << endl;
+#endif
+       if(mod->LineSegmentL(h,x0,x1,y0,y1,z0,z1,de,idtrack)){
+       st =TMath::Sqrt(x1*x1+y1*y1+z1*z1);
+       if(st>0.0){
+           st =TMath::Sqrt(x1*x1+y1*y1+z1*z1)*(ta[i+1]-ta[i]);
+           ta = CreateFindCellEdges(x0,x1,z0,z1,n);
+           for(i=0;i<n-1;i++){
+               dt = TMath::Min((1.0E-4)/st,);
+               for(t=ta[i];t<ta[i+1];t+=dt){ // Integrate over t
+               tp = t+0.5*dt;
+               el = GetResp()->GeVToCharge((Float_t)(dt*de));
+#ifdef DEBUG
+               if(el<=0.0) cout << "el="<<el<<" dt="<<dt<<" de="<<de<<endl;
+#endif
+               x = x0+x1*tp;
+               y = y0+y1*tp;
+               z = z0+z1*tp;
+               GetSeg()->LocalToDet(x,z,ix,iz);
+               sig = GetResp()->SigmaDiffusion1D(thick + y);
+               SpreadCharge(x,y,z,ix,iz,el,sig,idtrack,
+                            mod->GetHitTrackIndex(h),h,mod->GetIndex());
+           } // end for t[i]
+           delete[] t;
+       } else { // st == 0.0 deposit it at this point
+           el = GetResp()->GeVToCharge((Float_t)de);
+           x = x0;
+           y = y0;
+           z = z0;
+           GetSeg()->LocalToDet(x,z,ix,iz);
+           sig = GetResp()->SigmaDiffusion1D(thick + y);
+           SpreadCharge(x,y,z,ix,iz,el,sig,
+                        idtrack,mod->GetHitTrackIndex(h),h,mod->GetIndex());
+       } // end if st>0.0
+    }} // Loop over all hits h
+    }*/
+//______________________________________________________________________
+void AliITSsimulationSPDdubna::SpreadCharge(Double_t x0,Double_t y0,
+                                           Double_t z0,Int_t ix0,Int_t iz0,
+                                           Double_t el,Double_t sig,Int_t t,
+                                           Int_t ti,Int_t hi,Int_t mod){
+    // Spreads the charge over neighboring cells. Assume charge is distributed
+    // as charge(x,z) = (el/2*pi*sig*sig)*exp(-arg)
+    // arg=((x-x0)*(x-x0)/2*sig*sig)+((z-z0*z-z0)/2*sig*sig)
+    // Defined this way, the integral over all x and z is el.
+    const Int_t knx = 3,knz = 2;
+    const Double_t kRoot2 = 1.414213562; // Sqrt(2).
+    const Double_t kmictocm = 1.0e-4; // convert microns to cm.
+    Int_t ix,iz,ixs,ixe,izs,ize;
+    Float_t x,z;
+    Double_t x1,x2,z1,z2,s,sp;
+
+    if(sig<=0.0) {
+       fpList->AddSignal(iz0+1,ix0+1,t,hi,mod,el);
+       return;
+    } // end if
+    sp = 1.0/(sig*kRoot2);
+#ifdef DEBUG
+    cout << "sig=" << sig << " sp=" << sp << endl;
+#endif
+    ixs = TMath::Max(-knx+ix0,0);
+    ixe = TMath::Min(knx+ix0,GetSeg()->Npx()-1);
+    izs = TMath::Max(-knz+iz0,0);
+    ize = TMath::Min(knz+iz0,GetSeg()->Npz()-1);
+    for(ix=ixs;ix<=ixe;ix++) for(iz=izs;iz<=ize;iz++){
+       GetSeg()->DetToLocal(ix,iz,x,z); // pixel center
+       x1 = x;
+       z1 = z;
+       x2  = x1 + 0.5*kmictocm*GetSeg()->Dpx(ix); // Upper
+       x1 -= 0.5*kmictocm*GetSeg()->Dpx(ix);  // Lower
+       z2  = z1 + 0.5*kmictocm*GetSeg()->Dpz(iz); // Upper
+       z1 -= 0.5*kmictocm*GetSeg()->Dpz(iz);  // Lower
+       x1 -= x0; // Distance from where track traveled
+       x2 -= x0; // Distance from where track traveled
+       z1 -= z0; // Distance from where track traveled
+       z2 -= z0; // Distance from where track traveled
+       s = 0.25; // Correction based on definision of Erfc
+       s *= TMath::Erfc(sp*x1) - TMath::Erfc(sp*x2);
+#ifdef DEBUG
+       cout << "el=" << el << " ix0=" << ix0 << " ix=" << ix << " x0="<< x <<
+           " iz0=" << iz0 << " iz=" << iz << " z0=" << z  << 
+           " sp*x1=" << sp*x1 <<" sp*x2=" << sp*x2 << " s=" << s;
+#endif
+       s *= TMath::Erfc(sp*z1) - TMath::Erfc(sp*z2);
+#ifdef DEBUG
+       cout << " sp*z1=" << sp*z1 <<" sp*z2=" << sp*z2 << " s=" << s << endl;
+#endif
+       fpList->AddSignal(iz+1,ix+1,t,hi,mod,s*el);
+    } // end for ix, iz
+}
+//______________________________________________________________________
+Double_t *AliITSsimulationSPDdubna::CreateFindCellEdges(Double_t x0,Double_t x1,
+                                             Double_t z0,Double_t z1,Int_t &n){
+    // Note: This function is a potensial source for a memory leak. The memory
+    // pointed to in its return, must be deleted.
+    // Inputs:
+    //    Double_t x0   The starting location of the track step in x
+    //    Double_t x1   The distance allong x for the track step
+    //    Double_t z0   The starting location of the track step in z
+    //    Double_t z1   The distance allong z for the track step
+    // Output:
+    //    Int)t &n      The size of the array returned. Minimal n=2.
+    // Return:
+    //    The pointer to the array of track steps.
+    Int_t ix0,ix1,ix,iz0,iz1,iz,i;
+    Double_t x,z,lx,ux,lz,uz,a,b,c,d;
+    Double_t *t;
+
+    GetSeg()->LocalToDet(x0,z0,ix0,iz0);
+    GetSeg()->LocalToDet(x1,z1,ix1,iz1);
+    n = 2 + TMath::Abs(ix1-ix0) + TMath::Abs(iz1-iz0);
+    t = new Double_t[n];
+    t[0] = 0.0;
+    t[n-1] = 1.0;
+    x = x0;
+    z = z0;
+    for(i=1;i<n-1;i++){
+       GetSeg()->LocalToDet(x,z,ix,iz);
+       GetSeg()->CellBoundries(ix,iz,lx,ux,lz,uz);
+       a = (lx-x0)/x1;
+       if(a<=t[i-1]) a = 1.0;
+       b = (ux-x0)/x1;
+       if(b<=t[i-1]) b = 1.0;
+       c = (lz-z0)/z1;
+       if(c<=t[i-1]) c = 1.0;
+       d = (uz-z0)/z1;
+       if(d<=t[i-1]) d = 1.0;
+       t[i] = TMath::Min(TMath::Min(TMath::Min(a,b),c),d);
+       x = x0+x1*(t[i]*1.00000001);
+       z = z0+z1*(t[i]*1.00000001);
+       i++;
+    } // end for i
+    return t;
+}
+//______________________________________________________________________
+void AliITSsimulationSPDdubna::HitToSDigitOld(AliITSmodule *mod, Int_t module,
                                            Int_t dummy, AliITSpList *pList){
     // digitize module 
     const Float_t kEnToEl = 2.778e+8; // GeV->charge in electrons 
                                       // for 3.6 eV/pair 
     const Float_t kconv = 10000.;     // cm -> microns
 
-    Float_t spdLength = fSegmentation->Dz();
-    Float_t spdWidth = fSegmentation->Dx();
-    Float_t spdThickness = fSegmentation->Dy();
+    Float_t spdLength = GetSeg()->Dz();
+    Float_t spdWidth = GetSeg()->Dx();
+    Float_t spdThickness = GetSeg()->Dy();
     Float_t difCoef, dum;       
-    fResponse->DiffCoeff(difCoef,dum); 
+    GetResp()->DiffCoeff(difCoef,dum); 
     if(spdThickness > 290) difCoef = 0.00613;  
 
     Float_t zPix0 = 1e+6;
     Float_t xPix0 = 1e+6;
     Float_t yPrev = 1e+6;   
 
-    Float_t zPitch = fSegmentation->Dpz(0);
-    Float_t xPitch = fSegmentation->Dpx(0);
+    Float_t zPitch = GetSeg()->Dpz(0);
+    Float_t xPitch = GetSeg()->Dpx(0);
   
     TObjArray *fHits = mod->GetHits();
     module = mod->GetIndex();
     Int_t nhits = fHits->GetEntriesFast();
     if (!nhits) return;
-
+#ifdef DEBUG
     cout<<"len,wid,thickness,nx,nz,pitchx,pitchz,difcoef ="<<spdLength<<","
        <<spdWidth<<","<<spdThickness<<","<<fNPixelsX<<","<<fNPixelsZ<<","
        <<xPitch<<","<<zPitch<<","<<difCoef<<endl;
+#endif
     //  Array of pointers to the label-signal list
     Int_t indexRange[4] = {0,0,0,0};
 
@@ -332,9 +569,14 @@ void AliITSsimulationSPDdubna::HitToSDigit(AliITSmodule *mod, Int_t module,
     Int_t lasttrack=-2;
     Int_t hit, iZi, jz, jx;
     Int_t idhit=-1; //!
+#ifdef DEBUG
     cout<<"SPDdubna: module,nhits ="<<module<<","<<nhits<<endl;
+#endif
     for (hit=0;hit<nhits;hit++) {
         AliITShit *iHit = (AliITShit*) fHits->At(hit);
+#ifdef DEBUG
+       cout << "Hits=" << hit << "," << *iHit << endl;
+#endif
        //Int_t layer = iHit->GetLayer();
         Float_t yPix0 = -spdThickness/2; 
 
@@ -375,19 +617,27 @@ void AliITSsimulationSPDdubna::HitToSDigit(AliITSmodule *mod, Int_t module,
 
        // Check boundaries
        if(zPix  > spdLength/2) {
-           //cout<<"!!! SPD: z outside ="<<zPix<<endl;
+#ifdef DEBUG
+           cout<<"!!! SPD: z outside ="<<zPix<<endl;
+#endif
            zPix = spdLength/2 - 10;
        }
        if(zPix  < 0 && zPix < -spdLength/2) {
-           //cout<<"!!! SPD: z outside ="<<zPix<<endl;
+#ifdef DEBUG
+           cout<<"!!! SPD: z outside ="<<zPix<<endl;
+#endif
            zPix = -spdLength/2 + 10;
        }
        if(xPix  > spdWidth/2) {
-           //cout<<"!!! SPD: x outside ="<<xPix<<endl;
+#ifdef DEBUG
+           cout<<"!!! SPD: x outside ="<<xPix<<endl;
+#endif
            xPix = spdWidth/2 - 10;
        }
        if(xPix  < 0 && xPix < -spdWidth/2) {
-           //cout<<"!!! SPD: x outside ="<<xPix<<endl;
+#ifdef DEBUG
+           cout<<"!!! SPD: x outside ="<<xPix<<endl;
+#endif
            xPix = -spdWidth/2 + 10;
        }
        Int_t trdown = 0;
@@ -473,9 +723,9 @@ void AliITSsimulationSPDdubna::HitToSDigit(AliITSmodule *mod, Int_t module,
            zPixn = (zPixn + spdLength/2.);  
            xPixn = (xPixn + spdWidth/2.);  
             Int_t nZpix, nXpix;
-            fSegmentation->GetPadIxz(xPixn,zPixn,nXpix,nZpix);
-           zPitch = fSegmentation->Dpz(nZpix);
-            fSegmentation->GetPadTxz(xPixn,zPixn);
+            GetSeg()->GetPadIxz(xPixn,zPixn,nXpix,nZpix);
+           zPitch = GetSeg()->Dpz(nZpix);
+            GetSeg()->GetPadTxz(xPixn,zPixn);
            // set the window for the integration
            Int_t jzmin = 1;  
            Int_t jzmax = 3; 
@@ -543,9 +793,8 @@ void AliITSsimulationSPDdubna::HitToSDigit(AliITSmodule *mod, Int_t module,
                        Float_t dXCharge =0.5*(xProb1-xProb2)*dZCharge;
 
                        if(dXCharge > 1.) {
-                           Int_t index = kz-1;
                            if (first) {
-                               indexRange[0]=indexRange[1]=index;
+                               indexRange[0]=indexRange[1]=kz-1;
                                indexRange[2]=indexRange[3]=kx-1;
                                first=kFALSE;
                            } // end if first
@@ -553,25 +802,24 @@ void AliITSsimulationSPDdubna::HitToSDigit(AliITSmodule *mod, Int_t module,
                            indexRange[1]=TMath::Max(indexRange[1],kz-1);
                            indexRange[2]=TMath::Min(indexRange[2],kx-1);
                            indexRange[3]=TMath::Max(indexRange[3],kx-1);
-
+/*
                            // build the list of digits for this module 
-                           Double_t signal=fMapA2->GetSignal(index,kx-1);
+                           Double_t signal = fMapA2->GetSignal(kz-1,kx-1);
                            signal+=dXCharge;
-                           fMapA2->SetHit(index,kx-1,(double)signal);
-
+                           fMapA2->SetHit(kz-1,kx-1,(double)signal);
+*/
                            // The calling sequence for UpdateMapSignal was 
                            // moved into the (dx > 1 e-) loop because it 
                            // needs to call signal which is defined inside 
                            // this loop
-                           Int_t i   = kx-1;
-                           Int_t j   = kz-1;
-                           Int_t trk = mod->GetHitTrackIndex(hit);
-                           Int_t ht  = hit;
                            fModule   = module;//Defined because functions 
                                               // called by UpdateMapSignal 
                                               // expect module to be an 
                                               // integer
-                           UpdateMapSignal(j,i,trk,ht,fModule,signal,pList);
+                           UpdateMapSignal(kz-1,kx-1,
+//                                         mod->GetHitTrackIndex(hit),
+                             ((AliITShit*)(mod->GetHit(hit)))->GetTrack(),
+                                           hit,fModule,dXCharge,pList);
                        }      // dXCharge > 1 e-
                    }       // jx loop
                }       // dZCharge > 1 e-
@@ -588,44 +836,53 @@ void AliITSsimulationSPDdubna::HitToSDigit(AliITSmodule *mod, Int_t module,
 void AliITSsimulationSPDdubna::ChargeToSignal(AliITSpList *pList){
     // add noise and electronics, perform the zero suppression and add the
     // digit to the list
-
-    AliITS *aliITS = (AliITS*)gAlice->GetModule("ITS");  
-
-    Float_t threshold = (float)fResponse->MinVal();
-
-    Int_t    digits[3], tracks[3], hits[3], gi, j1;
-    Float_t  charges[3];
+    static AliITS *aliITS = (AliITS*)gAlice->GetModule("ITS");
+    Float_t threshold = (float)GetResp()->MinVal();
+    Int_t j;
+//    Int_t    digits[3], tracks[3], hits[3];
+//    Float_t  charges[3];
     Float_t  electronics;
-    Float_t  signal;
-    Float_t  phys; 
+//    Float_t  phys; 
     Double_t sig;
-    Int_t    module = 0;
+    const Int_t    nmaxtrk=AliITSdigitSPD::GetNTracks();
+    static AliITSdigitSPD dig;
+
     for(Int_t iz=0; iz<fNPixelsZ; iz++){
        for(Int_t ix=0; ix<fNPixelsX; ix++){
            electronics = fBaseline + fNoise*gRandom->Gaus();
-           signal = (float)pList->GetSignalOnly(ix, iz);
-           sig = Double_t (signal);  // sig will be passed along to 
-                                     // UpdateMapNoise this is necessary so 
-                                     // that a signal without electronic
-                                     // noise is passed along
-           signal += electronics;
-           gi =iz*fNPixelsX+ix; // global index
-           if (signal > threshold) {
-               digits[0]=iz;
-               digits[1]=ix;
-               digits[2]=1;
-               for(j1=0;j1<3;j1++){
-                   if (pList->GetTrack(ix, iz, gi)) {
-                       //b.b.       tracks[j1]=-3;
-                       tracks[j1] = (Int_t)(pList->GetTrack(ix, iz, j1)+j1);
-                       hits[j1] = (Int_t)(pList->GetHit(ix, iz, j1)+j1+6);
-                   }else {
-                       tracks[j1]=-2; //noise
-                       hits[j1] = -1;
+           sig = pList->GetSignalOnly(iz+1,ix+1);
+           UpdateMapNoise(iz,ix,fModule,sig,electronics,pList);
+#ifdef DEBUG
+//         cout << sig << "+" << electronics <<">threshold=" << threshold 
+//              << endl;
+#endif
+           if (sig+electronics > threshold) {
+               dig.fCoord1 = iz;
+               dig.fCoord2 = ix;
+               dig.fSignal = 1;
+               dig.fSignalSPD = (Int_t) pList->GetSignal(iz+1,ix+1);
+               /*
+               digits[0] = iz;
+               digits[1] = ix;
+               digits[2] = 1; */
+               for(j=0;j<nmaxtrk;j++){
+//                 charges[j] = 0.0;
+                   if (j<pList->GetNEnteries()) {
+                       dig.fTracks[j] = pList->GetTrack(iz+1,ix+1,j);
+                       dig.fHits[j]   = pList->GetHit(iz+1,ix+1,j);
+                       /*
+                       tracks[j] = pList->GetTrack(iz+1,ix+1,j);
+                       hits[j]   = pList->GetHit(iz+1,ix+1,j);
+                       */
+                   }else { // Default values
+                       dig.fTracks[j] = -3;
+                       dig.fHits[j]   = -1;
+/*                     tracks[j] = -2; //noise
+                       hits[j]   = -1;  */
                    } // end if pList
-                   charges[j1] = 0;
-               } // end for j1
-
+               } // end for j
+//             charges[0] = (Float_t) pList->GetSumSignal(iz+1,ix+1);
+/*
                if(tracks[0] == tracks[1] && tracks[0] == tracks[2]) {
                    tracks[1] = -3;
                    hits[1] = -1;
@@ -641,14 +898,14 @@ void AliITSsimulationSPDdubna::ChargeToSignal(AliITSpList *pList){
                    tracks[2] = -3;
                    hits[2] = -1;   
                } // end if
-
-               phys = 0;
-
-               Int_t i       = ix; // These variables are declared so to be
-               Int_t j       = iz; // passed along to UpdateMapNoise and
-               Float_t noise = electronics; // in that function
-               UpdateMapNoise(j, i, ix, iz, fModule, sig, noise, pList);
-               aliITS->AddSimDigit(0, phys, digits, tracks, hits, charges);
+*/
+//             phys = 0.0;
+#ifdef DEBUG
+               cout << iz << "," << ix << "," << 
+                   *(pList->GetpListItem(iz+1,ix+1)) << endl;
+#endif
+//             aliITS->AddSimDigit(0, phys, digits, tracks, hits, charges);
+               aliITS->AddSimDigit(0,&dig);
            } // 
        } // 
     } //