]> git.uio.no Git - u/mrichter/AliRoot.git/blame - ITS/AliITSsimulationSSD.cxx
Remove obsolete macros
[u/mrichter/AliRoot.git] / ITS / AliITSsimulationSSD.cxx
CommitLineData
57817f7c 1/**************************************************************************
2 * Copyright(c) 1998-1999, ALICE Experiment at CERN, All rights reserved. *
3 * *
4 * Author: The ALICE Off-line Project. *
5 * Contributors are mentioned in the code where appropriate. *
6 * *
7 * Permission to use, copy, modify and distribute this software and its *
8 * documentation strictly for non-commercial purposes is hereby granted *
9 * without fee, provided that the above copyright notice appears in all *
10 * copies and that both the copyright notice and this permission notice *
11 * appear in the supporting documentation. The authors make no claims *
12 * about the suitability of this software for any purpose. It is *
13 * provided "as is" without express or implied warranty. *
14 **************************************************************************/
15/* $Id$ */
16
b0f5e3fc 17#include <stdio.h>
8a00af9a 18#include <stdlib.h>
fd61217e 19#include <iostream.h>
57817f7c 20#include <iomanip.h>
b0f5e3fc 21#include <TObjArray.h>
84541af4 22#include <TParticle.h>
1ca7869b 23#include <TRandom.h>
fd61217e 24#include <TMath.h>
84541af4 25#include <TH1.h>
b0f5e3fc 26
fd61217e 27#include "AliITSmodule.h"
57817f7c 28#include "AliITSMapA2.h"
c7a4dac0 29#include "AliITSpList.h"
9e8d6423 30#include "AliITSresponseSSD.h"
c7a4dac0 31#include "AliITSsegmentationSSD.h"
b0f5e3fc 32#include "AliITSdcsSSD.h"
33#include "AliITS.h"
3a97c582 34#include "AliITShit.h"
b0f5e3fc 35#include "AliRun.h"
0315d466 36#include "AliITSgeom.h"
57817f7c 37#include "AliITSsimulationSSD.h"
84541af4 38#include "AliITSTableSSD.h"
b0f5e3fc 39
40ClassImp(AliITSsimulationSSD);
fd61217e 41////////////////////////////////////////////////////////////////////////
42// Version: 0
43// Written by Enrico Fragiacomo
44// July 2000
45//
46// AliITSsimulationSSD is the simulation of SSDs.
47
57817f7c 48//----------------------------------------------------------------------
49AliITSsimulationSSD::AliITSsimulationSSD(){
84541af4 50 //default Constructor
57817f7c 51
84541af4 52 fDCS = 0;
53 fDifConst[0] = fDifConst[1] = 0.0;
54 fDriftVel[0] = fDriftVel[1] = 0.0;
55 fMapA2 = 0;
3a97c582 56// fpList = 0;
57817f7c 57}
0315d466 58//----------------------------------------------------------------------
b0f5e3fc 59AliITSsimulationSSD::AliITSsimulationSSD(AliITSsegmentation *seg,
60 AliITSresponse *resp){
3a97c582 61 // Constructor
62 // Input:
63 // AliITSsegmentationSSD *seg Pointer to the SSD segmentation to be used
64 // AliITSresponseSSD *resp Pointer to the SSD responce class to be used
65 // Outputs:
66 // none.
67 // Return
68 // none.
69
70 fDCS = 0;
71 fDifConst[0] = fDifConst[1] = 0.0;
72 fDriftVel[0] = fDriftVel[1] = 0.0;
73 fMapA2 = 0;
74// fpList = 0;
75 Init((AliITSsegmentationSSD*)seg,(AliITSresponseSSD*)resp);
c7a4dac0 76}
77//----------------------------------------------------------------------
78void AliITSsimulationSSD::Init(AliITSsegmentationSSD *seg,
84541af4 79 AliITSresponseSSD *resp){
3a97c582 80 // Inilizer, Inilizes all of the variable as needed in a standard place.
81 // Input:
82 // AliITSsegmentationSSD *seg Pointer to the SSD segmentation to be used
83 // AliITSresponseSSD *resp Pointer to the SSD responce class to be used
84 // Outputs:
85 // none.
86 // Return
87 // none.
88
89 fSegmentation = seg;
90 fResponse = resp;
91 Float_t noise[2] = {0.,0.};
92 fResponse->GetNoiseParam(noise[0],noise[1]); // retrieves noise parameters
93 fDCS = new AliITSdcsSSD(seg,resp);
94
95 SetDriftVelocity(); // use default values in .h file
96 SetIonizeE(); // use default values in .h file
97 SetDiffConst(); // use default values in .h file
98 fpList = new AliITSpList(2,GetNStrips());
99 fMapA2 = new AliITSMapA2(fSegmentation);
b0f5e3fc 100}
0315d466 101//______________________________________________________________________
57817f7c 102AliITSsimulationSSD& AliITSsimulationSSD::operator=(
3a97c582 103 const AliITSsimulationSSD &s){
84541af4 104 // Operator =
105
106 if(this==&s) return *this;
107
108 this->fDCS = new AliITSdcsSSD(*(s.fDCS));
109 this->fMapA2 = s.fMapA2;
110 this->fIonE = s.fIonE;
111 this->fDifConst[0] = s.fDifConst[0];
112 this->fDifConst[1] = s.fDifConst[1];
113 this->fDriftVel[0] = s.fDriftVel[0];
114 this->fDriftVel[1] = s.fDriftVel[1];
115 return *this;
b0f5e3fc 116}
57817f7c 117//______________________________________________________________________
118AliITSsimulationSSD::AliITSsimulationSSD(const AliITSsimulationSSD &source){
84541af4 119 // copy constructor
fd61217e 120
84541af4 121 *this = source;
b0f5e3fc 122}
0315d466 123//______________________________________________________________________
b0f5e3fc 124AliITSsimulationSSD::~AliITSsimulationSSD() {
84541af4 125 // destructor
126 delete fMapA2;
127 delete fDCS;
0315d466 128}
57817f7c 129//______________________________________________________________________
3a97c582 130void AliITSsimulationSSD::InitSimulationModule(Int_t module,Int_t event){
131 // Creates maps to build the list of tracks for each sumable digit
132 // Inputs:
133 // Int_t module // Module number to be simulated
134 // Int_t event // Event number to be simulated
135 // Outputs:
136 // none.
137 // Return
138 // none.
139
140 fModule = module;
141 fEvent = event;
142 fMapA2->ClearMap();
143 fpList->ClearMap();
144}
145//______________________________________________________________________
146void AliITSsimulationSSD::FinishSDigitiseModule(){
147 // Does the Sdigits to Digits work
148 // Inputs:
149 // none.
150 // Outputs:
151 // none.
152 // Return:
153 // none.
154
155 FillMapFrompList(fpList); // need to check if needed here or not????
156 SDigitToDigit(fModule,fpList);
157 fpList->ClearMap();
158 fMapA2->ClearMap();
159}
160//______________________________________________________________________
c7a4dac0 161void AliITSsimulationSSD::DigitiseModule(AliITSmodule *mod,
84541af4 162 Int_t dummy0,Int_t dummy1) {
163 // Digitizes hits for one SSD module
164 Int_t module = mod->GetIndex();
0315d466 165
3a97c582 166 HitsToAnalogDigits(mod,fpList);
167 SDigitToDigit(module,fpList);
0315d466 168
3a97c582 169 fpList->ClearMap();
84541af4 170 fMapA2->ClearMap();
c7a4dac0 171}
172//______________________________________________________________________
173void AliITSsimulationSSD::SDigitiseModule(AliITSmodule *mod,Int_t dummy0,
84541af4 174 Int_t dummy1) {
3a97c582 175 // Produces Summable/Analog digits and writes them to the SDigit tree.
c7a4dac0 176
3a97c582 177 HitsToAnalogDigits(mod,fpList);
c7a4dac0 178
3a97c582 179 WriteSDigits(fpList);
c7a4dac0 180
3a97c582 181 fpList->ClearMap();
84541af4 182 fMapA2->ClearMap();
c7a4dac0 183}
184//______________________________________________________________________
185void AliITSsimulationSSD::SDigitToDigit(Int_t module,AliITSpList *pList){
84541af4 186 // Takes the pList and finishes the digitization.
fc2bd64b 187
84541af4 188 // FillMapFrompList(pList); //commented out to avoid double counting of the
fc2bd64b 189 //charge
c7a4dac0 190
84541af4 191 ApplyNoise(pList,module);
192 ApplyCoupling(pList,module);
c7a4dac0 193
84541af4 194 ChargeToSignal(pList);
c7a4dac0 195}
196//______________________________________________________________________
197void AliITSsimulationSSD::HitsToAnalogDigits(AliITSmodule *mod,
84541af4 198 AliITSpList *pList){
3a97c582 199 // Loops over all hits to produce Analog/floating point digits. This
200 // is also the first task in producing standard digits.
201 Int_t lasttrack = -2;
202 Int_t idtrack = -2;
203 Double_t x0=0.0, y0=0.0, z0=0.0;
204 Double_t x1=0.0, y1=0.0, z1=0.0;
205 Double_t de=0.0;
206 Int_t module = mod->GetIndex();
207
208 TObjArray *hits = mod->GetHits();
209 Int_t nhits = hits->GetEntriesFast();
210 if (nhits<=0) return;
211 AliITSTableSSD * tav = new AliITSTableSSD(GetNStrips());
212 module = mod->GetIndex();
213 if ( mod->GetLayer() == 6 ) GetSegmentation()->SetLayer(6);
214 if ( mod->GetLayer() == 5 ) GetSegmentation()->SetLayer(5);
215 for(Int_t i=0; i<nhits; i++) {
0315d466 216 // LineSegmentL returns 0 if the hit is entering
217 // If hits is exiting returns positions of entering and exiting hits
218 // Returns also energy loss
3a97c582 219// cout << i << " ";
220// cout << mod->GetHit(i)->GetXL() << " "<<mod->GetHit(i)->GetYL();
221// cout << " " << mod->GetHit(i)->GetZL();
222// cout << endl;
0315d466 223 if (mod->LineSegmentL(i, x0, x1, y0, y1, z0, z1, de, idtrack)) {
3a97c582 224 HitToDigit(module, x0, y0, z0, x1, y1, z1, de,tav);
225 if (lasttrack != idtrack || i==(nhits-1)) {
226 GetList(idtrack,i,module,pList,tav);
227 } // end if
228 lasttrack=idtrack;
0315d466 229 } // end if
3a97c582 230 } // end loop over hits
231 delete tav; tav=0;
232 return;
b0f5e3fc 233}
0315d466 234//----------------------------------------------------------------------
fd61217e 235void AliITSsimulationSSD::HitToDigit(Int_t module, Double_t x0, Double_t y0,
84541af4 236 Double_t z0, Double_t x1, Double_t y1,
237 Double_t z1, Double_t de,
238 AliITSTableSSD *tav) {
3a97c582 239 // Turns hits in SSD module into one or more digits.
240 Float_t tang[2] = {0.0,0.0};
241 GetSegmentation()->Angles(tang[0], tang[1]);//stereo<<->tan(stereo)~=stereo
242 Double_t x, y, z;
243 Double_t dex=0.0, dey=0.0, dez=0.0;
244 Double_t pairs; // pair generation energy per step.
245 Double_t sigma[2] = {0.,0.};// standard deviation of the diffusion gaussian
246 Double_t tdrift[2] = {0.,0.}; // time of drift
247 Double_t w;
248 Double_t inf[2], sup[2], par0[2];
249
250 // Steps in the module are determined "manually" (i.e. No Geant)
251 // NumOfSteps divide path between entering and exiting hits in steps
252 Int_t numOfSteps = NumOfSteps(x1, y1, z1, dex, dey, dez);
253 // Enery loss is equally distributed among steps
254 de = de/numOfSteps;
255 pairs = de/GetIonizeE(); // e-h pairs generated
256 for(Int_t j=0; j<numOfSteps; j++) { // stepping
0315d466 257 x = x0 + (j+0.5)*dex;
258 y = y0 + (j+0.5)*dey;
57817f7c 259 if ( y > (GetSegmentation()->Dy()/2+10)*1.0E-4 ) {
3a97c582 260 // check if particle is within the detector
261 Warning("HitToDigit","hit out of detector y0=%e,y=%e,dey=%e,j =%e",
262 y0,y,dey,j);
263 return;
0315d466 264 } // end if
265 z = z0 + (j+0.5)*dez;
3a97c582 266// cout <<"HitToDigit "<<x<<" "<<y<<" "<<z<< " "<<dex<<" "<<dey<<" "<<dez<<endl;
0315d466 267 // calculate drift time
268 // y is the minimum path
57817f7c 269 tdrift[0] = (y+(GetSegmentation()->Dy()*1.0E-4)/2)/GetDriftVelocity(0);
270 tdrift[1] = ((GetSegmentation()->Dy()*1.0E-4)/2-y)/GetDriftVelocity(1);
0315d466 271
272 for(Int_t k=0; k<2; k++) { // both sides remember: 0=Pside 1=Nside
273
3a97c582 274 tang[k]=TMath::Tan(tang[k]);
0315d466 275
3a97c582 276 // w is the coord. perpendicular to the strips
277 if(k==0) {
57817f7c 278 w = (x+(GetSegmentation()->Dx()*1.0E-4)/2) -
3a97c582 279 (z+(GetSegmentation()->Dz()*1.0E-4)/2)*tang[k];
280 }else{
57817f7c 281 w = (x+(GetSegmentation()->Dx()*1.0E-4)/2) +
3a97c582 282 (z-(GetSegmentation()->Dz()*1.0E-4)/2)*tang[k];
283 } // end if
284 w /= (GetStripPitch()*1.0E-4); // w is converted in units of pitch
0315d466 285
3a97c582 286 if((w<(-0.5)) || (w>(GetNStrips()-0.5))) {
0315d466 287 // this check rejects hits in regions not covered by strips
288 // 0.5 takes into account boundaries
82136bec 289 return; // There are dead region on the SSD sensitive volume.
3a97c582 290 } // end if
0315d466 291
3a97c582 292 // sigma is the standard deviation of the diffusion gaussian
293 if(tdrift[k]<0) return;
294 sigma[k] = TMath::Sqrt(2*GetDiffConst(k)*tdrift[k]);
295 sigma[k] /= (GetStripPitch()*1.0E-4); //units of Pitch
296 if(sigma[k]==0.0) {
b5456f1c 297 Error("HitToDigit"," sigma[%d]=0",k);
0315d466 298 exit(0);
3a97c582 299 } // end if
300
301 par0[k] = pairs;
302 // we integrate the diffusion gaussian from -3sigma to 3sigma
303 inf[k] = w - 3*sigma[k]; // 3 sigma from the gaussian average
304 sup[k] = w + 3*sigma[k]; // 3 sigma from the gaussian average
305 // IntegrateGaussian does the actual
306 // integration of diffusion gaussian
307 IntegrateGaussian(k, par0[k], w, sigma[k], inf[k], sup[k],tav);
0315d466 308 } // end for loop over side (0=Pside, 1=Nside)
3a97c582 309 } // end stepping
b0f5e3fc 310}
57817f7c 311//______________________________________________________________________
c7a4dac0 312void AliITSsimulationSSD::ApplyNoise(AliITSpList *pList,Int_t module){
84541af4 313 // Apply Noise.
314 Int_t k,ix;
315 Double_t signal,noise;
316 Double_t noiseP[2] = {0.,0.};
317 Float_t a,b;
318
319 fResponse->GetNoiseParam(a,b); // retrieves noise parameters
320 noiseP[0] = (Double_t) a; noiseP[1] = (Double_t) b;
321 for(k=0;k<2;k++){ // both sides (0=Pside, 1=Nside)
c7a4dac0 322 for(ix=0;ix<GetNStrips();ix++){ // loop over strips
3a97c582 323 noise = gRandom->Gaus(0,noiseP[k]);// get noise to signal
324 signal = noise + fMapA2->GetSignal(k,ix);//get signal from map
325 if(signal<0.) signal=0.0; // in case noise is negative...
326 fMapA2->SetHit(k,ix,signal); // give back signal to map
327 if(signal>0.0) pList->AddNoise(k,ix,module,noise);
0315d466 328 } // loop over strip
84541af4 329 } // loop over k (P or N side)
b0f5e3fc 330}
0315d466 331//______________________________________________________________________
c7a4dac0 332void AliITSsimulationSSD::ApplyCoupling(AliITSpList *pList,Int_t module) {
84541af4 333 // Apply the effect of electronic coupling between channels
334 Int_t ix;
335 Double_t signalLeft=0, signalRight=0,signal=0;
0315d466 336
84541af4 337 for(ix=0;ix<GetNStrips();ix++){
c7a4dac0 338 // P side coupling
57817f7c 339 if(ix>0.)signalLeft = fMapA2->GetSignal(0,ix-1)*fDCS->GetCouplingPL();
0315d466 340 else signalLeft = 0.0;
c7a4dac0 341 if(ix<(GetNStrips()-1)) signalRight = fMapA2->GetSignal(0,ix+1)*
84541af4 342 fDCS->GetCouplingPR();
0315d466 343 else signalRight = 0.0;
c7a4dac0 344 signal = signalLeft + signalRight;
345 fMapA2->AddSignal(0,ix,signal);
346 if(signal>0.0) pList->AddNoise(0,ix,module,signal);
347
348 signalLeft = signalRight = signal = 0.0;
349 // N side coupling
57817f7c 350 if(ix>0.) signalLeft = fMapA2->GetSignal(1,ix-1)*fDCS->GetCouplingNL();
0315d466 351 else signalLeft = 0.0;
c7a4dac0 352 if(ix<(GetNStrips()-1)) signalRight = fMapA2->GetSignal(1,ix+1)*
84541af4 353 fDCS->GetCouplingNR();
0315d466 354 else signalRight = 0.0;
c7a4dac0 355 signal = signalLeft + signalRight;
356 fMapA2->AddSignal(1,ix,signal);
357 if(signal>0.0) pList->AddNoise(1,ix,module,signal);
84541af4 358 } // loop over strips
b0f5e3fc 359}
0315d466 360//______________________________________________________________________
fd61217e 361Float_t AliITSsimulationSSD::F(Float_t av, Float_t x, Float_t s) {
84541af4 362 // Computes the integral of a gaussian using Error Function
363 Float_t sqrt2 = TMath::Sqrt(2.0);
364 Float_t sigm2 = sqrt2*s;
365 Float_t integral;
fd61217e 366
84541af4 367 integral = 0.5 * TMath::Erf( (x - av) / sigm2);
368 return integral;
0315d466 369}
370//______________________________________________________________________
fd61217e 371void AliITSsimulationSSD::IntegrateGaussian(Int_t k,Double_t par, Double_t w,
84541af4 372 Double_t sigma,
373 Double_t inf, Double_t sup,
374 AliITSTableSSD *tav) {
375 // integrate the diffusion gaussian
376 // remind: inf and sup are w-3sigma and w+3sigma
377 // we could define them here instead of passing them
378 // this way we are free to introduce asimmetry
379
380 Double_t a=0.0, b=0.0;
381 Double_t dXCharge1 = 0.0, dXCharge2 = 0.0;
382 // dXCharge1 and 2 are the charge to two neighbouring strips
383 // Watch that we only involve at least two strips
384 // Numbers greater than 2 of strips in a cluster depend on
385 // geometry of the track and delta rays, not charge diffusion!
fd61217e 386
84541af4 387 Double_t strip = TMath::Floor(w); // closest strip on the left
0315d466 388
84541af4 389 if ( TMath::Abs((strip - w)) < 0.5) {
3a97c582 390 // gaussian mean is closer to strip on the left
391 a = inf; // integration starting point
392 if((strip+0.5)<=sup) {
393 // this means that the tail of the gaussian goes beyond
394 // the middle point between strips ---> part of the signal
395 // is given to the strip on the right
396 b = strip + 0.5; // integration stopping point
397 dXCharge1 = F( w, b, sigma) - F(w, a, sigma);
398 dXCharge2 = F( w, sup, sigma) - F(w ,b, sigma);
399 }else {
400 // this means that all the charge is given to the strip on the left
401 b = sup;
402 dXCharge1 = 0.9973; // gaussian integral at 3 sigmas
403 dXCharge2 = 0.0;
404 } // end if
405 dXCharge1 = par * dXCharge1;// normalize by mean of number of carriers
406 dXCharge2 = par * dXCharge2;
407
408 // for the time being, signal is the charge
409 // in ChargeToSignal signal is converted in ADC channel
410 fMapA2->AddSignal(k,(Int_t)strip,dXCharge1);
411 tav->Add(k,(Int_t)strip);
412 if(((Int_t) strip) < (GetNStrips()-1)) {
413 // strip doesn't have to be the last (remind: last=GetNStrips()-1)
414 // otherwise part of the charge is lost
415 fMapA2->AddSignal(k,((Int_t)strip+1),dXCharge2);
416 tav->Add(k,((Int_t)(strip+1)));
417 } // end if
84541af4 418 }else{
3a97c582 419 // gaussian mean is closer to strip on the right
420 strip++; // move to strip on the rigth
421 b = sup; // now you know where to stop integrating
422 if((strip-0.5)>=inf) {
423 // tail of diffusion gaussian on the left goes left of
424 // middle point between strips
425 a = strip - 0.5; // integration starting point
426 dXCharge1 = F(w, b, sigma) - F(w, a, sigma);
427 dXCharge2 = F(w, a, sigma) - F(w, inf, sigma);
428 }else {
429 a = inf;
430 dXCharge1 = 0.9973; // gaussian integral at 3 sigmas
431 dXCharge2 = 0.0;
432 } // end if
433 dXCharge1 = par * dXCharge1; // normalize by means of carriers
434 dXCharge2 = par * dXCharge2;
435 // for the time being, signal is the charge
436 // in ChargeToSignal signal is converted in ADC channel
437 fMapA2->AddSignal(k,(Int_t)strip,dXCharge1);
438 tav->Add(k,(Int_t)strip);
439 if(((Int_t) strip) > 0) {
440 // strip doesn't have to be the first
441 // otherwise part of the charge is lost
442 fMapA2->AddSignal(k,((Int_t)strip-1),dXCharge2);
443 tav->Add(k,((Int_t)(strip-1)));
444 } // end if
84541af4 445 } // end if
b0f5e3fc 446}
0315d466 447//______________________________________________________________________
fd61217e 448Int_t AliITSsimulationSSD::NumOfSteps(Double_t x, Double_t y, Double_t z,
84541af4 449 Double_t & dex,Double_t & dey,Double_t & dez){
450 // number of steps
451 // it also returns steps for each coord
452 //AliITSsegmentationSSD *seg = new AliITSsegmentationSSD();
fd61217e 453
84541af4 454 Double_t step = 25E-4;
455 //step = (Double_t) seg->GetStepSize(); // step size (cm)
456 Int_t numOfSteps = (Int_t) (TMath::Sqrt(x*x+y*y+z*z)/step);
fd61217e 457
84541af4 458 if (numOfSteps < 1) numOfSteps = 1; // one step, at least
fd61217e 459
3a97c582 460 // we could condition the stepping depending on the incident angle
461 // of the track
84541af4 462 dex = x/numOfSteps;
463 dey = y/numOfSteps;
464 dez = z/numOfSteps;
b0f5e3fc 465
84541af4 466 return numOfSteps;
fd61217e 467}
0315d466 468//----------------------------------------------------------------------
c7a4dac0 469void AliITSsimulationSSD::GetList(Int_t label,Int_t hit,Int_t mod,
84541af4 470 AliITSpList *pList,AliITSTableSSD *tav) {
471 // loop over nonzero digits
472 Int_t ix,i;
473 Double_t signal=0.;
474
475 for(Int_t k=0; k<2; k++) {
476 ix=tav->Use(k);
477 while(ix>-1){
478 signal = fMapA2->GetSignal(k,ix);
479 if(signal==0.0) {
480 ix=tav->Use(k);
481 continue;
3a97c582 482 } // end if signal==0.0
84541af4 483 // check the signal magnitude
484 for(i=0;i<pList->GetNSignals(k,ix);i++){
485 signal -= pList->GetTSignal(k,ix,i);
3a97c582 486 } // end for i
84541af4 487 // compare the new signal with already existing list
488 if(signal>0)pList->AddSignal(k,ix,label,hit,mod,signal);
489 ix=tav->Use(k);
3a97c582 490 } // end of loop on strips
84541af4 491 } // end of loop on P/N side
492 tav->Clear();
fd61217e 493}
0315d466 494//----------------------------------------------------------------------
c7a4dac0 495void AliITSsimulationSSD::ChargeToSignal(AliITSpList *pList) {
84541af4 496 // charge to signal
497 static AliITS *aliITS = (AliITS*)gAlice->GetModule("ITS");
498 Float_t threshold = 0.;
499 Int_t digits[3], tracks[3],hits[3],j1;
500 Float_t charges[3] = {0.0,0.0,0.0};
501 Float_t signal;
502 Float_t noise[2] = {0.,0.};
0315d466 503
84541af4 504 ((AliITSresponseSSD*)fResponse)->GetNoiseParam(noise[0],noise[1]);
0315d466 505
84541af4 506 for(Int_t k=0;k<2;k++){ // both sides (0=Pside, 1=Nside)
0315d466 507 // Threshold for zero-suppression
508 // It can be defined in AliITSresponseSSD
509 // threshold = (Float_t)fResponse->MinVal(k);
510 // I prefer to think adjusting the threshold "manually", looking
511 // at the scope, and considering noise standard deviation
c7a4dac0 512 threshold = 4.0*noise[k]; // 4 times noise is a choice
513 for(Int_t ix=0;ix<GetNStrips();ix++){ // loop over strips
3a97c582 514 if(fMapA2->GetSignal(k,ix) <= threshold)continue;
515 // convert to ADC signal
516 signal = ((AliITSresponseSSD*)fResponse)->DEvToADC(
84541af4 517 fMapA2->GetSignal(k,ix));
3a97c582 518 if(signal>1024.) signal = 1024.;//if exceeding, accumulate last one
519 digits[0] = k;
520 digits[1] = ix;
521 digits[2] = (Int_t) signal;
522 for(j1=0;j1<3;j1++){ // only three in digit.
c7a4dac0 523 tracks[j1] = pList->GetTrack(k,ix,j1);
524 hits[j1] = pList->GetHit(k,ix,j1);
3a97c582 525 } // end for j1
526 // finally add digit
527 aliITS->AddSimDigit(2,0,digits,tracks,hits,charges);
0315d466 528 } // end for ix
84541af4 529 } // end for k
c7a4dac0 530}
531//______________________________________________________________________
532void AliITSsimulationSSD::WriteSDigits(AliITSpList *pList){
84541af4 533 // Fills the Summable digits Tree
534 Int_t i,ni,j,nj;
535 static AliITS *aliITS = (AliITS*)gAlice->GetModule("ITS");
c7a4dac0 536
84541af4 537 pList->GetMaxMapIndex(ni,nj);
538 for(i=0;i<ni;i++)for(j=0;j<nj;j++){
3a97c582 539 if(pList->GetSignalOnly(i,j)>0.0){
540 aliITS->AddSumDigit(*(pList->GetpListItem(i,j)));
541// cout << "pListSSD: " << *(pList->GetpListItem(i,j)) << endl;
542 } // end if
84541af4 543 } // end for i,j
544 return;
c7a4dac0 545}
546//______________________________________________________________________
547void AliITSsimulationSSD::FillMapFrompList(AliITSpList *pList){
84541af4 548 // Fills fMap2A from the pList of Summable digits
549 Int_t k,ix;
c7a4dac0 550
84541af4 551 for(k=0;k<2;k++)for(ix=0;ix<GetNStrips();ix++)
c7a4dac0 552 fMapA2->AddSignal(k,ix,pList->GetSignal(k,ix));
84541af4 553 return;
b0f5e3fc 554}
57817f7c 555//______________________________________________________________________
556void AliITSsimulationSSD::Print(ostream *os){
84541af4 557 //Standard output format for this class
558
559 //AliITSsimulation::Print(os);
560 *os << fIonE <<",";
561 *os << fDifConst[0] <<","<< fDifConst[1] <<",";
562 *os << fDriftVel[0] <<","<< fDriftVel[1];
563 //*os <<","; fDCS->Print(os);
564 //*os <<","; fMapA2->Print(os);
57817f7c 565}
566//______________________________________________________________________
567void AliITSsimulationSSD::Read(istream *is){
84541af4 568 // Standard output streaming function.
569
570 //AliITSsimulation::Read(is);
571 *is >> fIonE;
572 *is >> fDifConst[0] >> fDifConst[1];
573 *is >> fDriftVel[0] >> fDriftVel[1];
574 //fDCS->Read(is);
575 //fMapA2->Read(is);
57817f7c 576}
577//______________________________________________________________________
578ostream &operator<<(ostream &os,AliITSsimulationSSD &source){
84541af4 579 // Standard output streaming function.
57817f7c 580
84541af4 581 source.Print(&os);
582 return os;
57817f7c 583}
584//______________________________________________________________________
585istream &operator>>(istream &os,AliITSsimulationSSD &source){
84541af4 586 // Standard output streaming function.
57817f7c 587
84541af4 588 source.Read(&os);
589 return os;
57817f7c 590}
c7a4dac0 591//______________________________________________________________________
84541af4 592
593
594
595
596