1 /**************************************************************************
2 * Copyright(c) 1998-1999, ALICE Experiment at CERN, All rights reserved. *
4 * Author: The ALICE Off-line Project. *
5 * Contributors are mentioned in the code where appropriate. *
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 **************************************************************************/
18 ///////////////////////////////////////////////////////////////////////////////
20 // Pad response function object in two dimesions //
21 // This class contains the basic functions for the //
22 // calculation of PRF according generic charge distribution //
23 // In Update function object calculate table of response function //
24 // in discrete x and y position //
25 // This table is used for interpolation od response function in any position //
26 // (function GetPRF) //
28 // Origin: Marian Ivanov, Uni. of Bratislava, ivanov@fmph.uniba.sk //
30 ///////////////////////////////////////////////////////////////////////////////
32 #include <Riostream.h>
39 #include <TPaveText.h>
45 #include "AliTPCPRF2D.h"
48 extern TStyle * gStyle;
50 const Double_t AliTPCPRF2D::fgkDegtoRad = 0.01745329251994;
51 const Double_t AliTPCPRF2D::fgkSQRT12=3.464101;
52 const Int_t AliTPCPRF2D::fgkNPRF = 100;
55 static Double_t funGauss2D(Double_t *x, Double_t * par)
57 //Gauss function -needde by the generic function object
58 return ( TMath::Exp(-(x[0]*x[0])/(2*par[0]*par[0]))*
59 TMath::Exp(-(x[1]*x[1])/(2*par[1]*par[1])));
63 static Double_t funCosh2D(Double_t *x, Double_t * par)
65 //Cosh function -needde by the generic function object
66 return ( 1/(TMath::CosH(3.14159*x[0]/(2*par[0]))*
67 TMath::CosH(3.14159*x[1]/(2*par[1]))));
70 static Double_t funGati2D(Double_t *x, Double_t * par)
72 //Gati function -needde by the generic function object
74 Float_t k3R=TMath::Sqrt(k3);
75 Float_t k2=(TMath::Pi()/2)*(1-k3R/2.);
76 Float_t k1=k2*k3R/(4*TMath::ATan(k3R));
77 Float_t l=x[0]/par[0];
78 Float_t tan2=TMath::TanH(k2*l);
80 Float_t res = k1*(1-tan2)/(1+k3*tan2);
81 //par[4] = is equal to k3Y
84 k2=(TMath::Pi()/2)*(1-k3R/2.);
85 k1=k2*k3R/(4*TMath::ATan(k3R));
87 tan2=TMath::TanH(k2*l);
89 res = res*k1*(1-tan2)/(1+k3*tan2);
93 ///////////////////////////////////////////////////////////////////////////
94 ///////////////////////////////////////////////////////////////////////////
98 AliTPCPRF2D::AliTPCPRF2D()
134 //default constructor for response function object
138 //chewron default values
140 SetChevron(0.2,0.0,1.0);
142 SetInterpolationType(2,0);
145 AliTPCPRF2D::~AliTPCPRF2D()
147 if (fChargeArray!=0) delete [] fChargeArray;
148 if (fGRF !=0 ) fGRF->Delete();
151 void AliTPCPRF2D::SetY(Float_t y1, Float_t y2, Int_t nYdiv)
154 //set virtual line position
155 //first and last line and number of lines
161 void AliTPCPRF2D::SetPad(Float_t width, Float_t height)
163 //set base chevron parameters
167 void AliTPCPRF2D::SetChevron(Float_t hstep,
171 //set shaping of chewron parameters
177 void AliTPCPRF2D::SetChParam(Float_t width, Float_t height,
178 Float_t hstep, Float_t shifty, Float_t fac)
180 SetPad(width,height);
181 SetChevron(hstep,shifty,fac);
185 Float_t AliTPCPRF2D::GetPRF(Float_t xin, Float_t yin)
187 //function which return pad response
188 //for the charge in distance xin
189 //return cubic aproximation of PRF or PRF at nearest virtual wire
190 if (fChargeArray==0) return 0;
191 //transform position to "wire position"
192 Float_t y=fDYtoWire*(yin-fY1);
193 if (fNYdiv == 1) y=fY1;
194 //normaly it find nearest line charge
196 Int_t i=Int_t(0.5+y);
197 if (y<0) i=Int_t(-0.5+y);
198 if ((i<0) || (i>=fNYdiv) ) return 0;
199 fcharge = &(fChargeArray[i*fNPRF]);
200 return GetPRFActiv(xin);
202 //make interpolation from more fore lines
205 if ((i<0) || (i>=fNYdiv) ) return 0;
211 fcharge =&(fChargeArray[(i-1)*fNPRF]);
212 z0 = GetPRFActiv(xin);
214 fcharge =&(fChargeArray[i*fNPRF]);
217 fcharge =&(fChargeArray[(i+1)*fNPRF]);
218 z2 = GetPRFActiv(xin);
221 fcharge =&(fChargeArray[(i+2)*fNPRF]);
222 z3 = GetPRFActiv(xin);
231 Float_t dy=y-Float_t(i);
233 res = a+b*dy+c*dy*dy+d*dy*dy*dy;
238 Float_t AliTPCPRF2D::GetPRFActiv(Float_t xin)
240 //GEt response function on given charege line
241 //return spline aproximaton
242 Float_t x = (xin*fDStepM1)+fNPRF/2;
245 if ( (i>1) && ((i+2)<fNPRF)) {
248 b = (fcharge[i+1]-fcharge[i-1])*0.5;
249 k = fcharge[i+1]-a-b;
250 l = (fcharge[i+2]-fcharge[i])*0.5-b;
253 Float_t dx=x-Float_t(i);
254 Float_t res = a+b*dx+c*dx*dx+d*dx*dx*dx;
261 Float_t AliTPCPRF2D::GetGRF(Float_t xin, Float_t yin)
263 //function which returnoriginal charge distribution
264 //this function is just normalised for fKnorm
266 return fKNorm*GetGRF()->Eval(xin,yin)/fInteg;
272 void AliTPCPRF2D::SetParam( TF2 * GRF, Float_t kNorm,
273 Float_t sigmaX, Float_t sigmaY)
275 //adjust parameters of the original charge distribution
276 //and pad size parameters
277 if (fGRF !=0 ) fGRF->Delete();
280 sprintf(fType,"User");
281 if (sigmaX ==0) sigmaX=(fWidth*(1+TMath::Abs(fK)))/fgkSQRT12;
282 if (sigmaY ==0) sigmaY=(fWidth*(1+TMath::Abs(fK)))/fgkSQRT12;
285 Double_t estimsigma =
286 TMath::Sqrt(sigmaX*sigmaX+(fWidth*fWidth*(1+TMath::Abs(fK))/12)+
287 TMath::Tan(fPadAngle*fgkDegtoRad)*TMath::Tan(fPadAngle*fgkDegtoRad)*fHeightFull*fHeightFull/12);
288 if (estimsigma < 5*sigmaX) {
289 fDStep = estimsigma/10.;
290 fNPRF = Int_t(estimsigma*8./fDStep);
294 Double_t width = fWidth*(1+TMath::Abs(fK))+TMath::Abs(TMath::Tan(fPadAngle*fgkDegtoRad))*fHeightFull;
295 fNPRF = Int_t((width+8.*sigmaX)/fDStep);
301 void AliTPCPRF2D::SetGauss(Float_t sigmaX, Float_t sigmaY,
305 // set parameters for Gauss generic charge distribution
310 sprintf(fType,"Gauss");
311 if (fGRF !=0 ) fGRF->Delete();
312 fGRF = new TF2("funGauss2D",funGauss2D,-5.,5.,-5.,5.,4);
317 funParam[3]=fHeightS;
319 fGRF->SetParameters(funParam);
320 Double_t estimsigma =
321 TMath::Sqrt(sigmaX*sigmaX+(fWidth*fWidth*(1+TMath::Abs(fK))/12)+
322 TMath::Tan(fPadAngle)*TMath::Tan(fPadAngle*fgkDegtoRad)*fHeightFull*fHeightFull/12);
323 if (estimsigma < 5*sigmaX) {
324 fDStep = estimsigma/10.;
325 fNPRF = Int_t(estimsigma*8./fDStep);
329 Double_t width = fWidth*(1+TMath::Abs(fK))+TMath::Abs(TMath::Tan(fPadAngle*fgkDegtoRad))*fHeightFull;
330 fNPRF = Int_t((width+8.*sigmaX)/fDStep);
335 void AliTPCPRF2D::SetCosh(Float_t sigmaX, Float_t sigmaY,
338 // set parameters for Cosh generic charge distribution
343 sprintf(fType,"Cosh");
344 if (fGRF !=0 ) fGRF->Delete();
345 fGRF = new TF2("funCosh2D", funCosh2D,-5.,5.,-5.,5.,4);
349 funParam[3]=fHeightS;
350 fGRF->SetParameters(funParam);
352 Double_t estimsigma = TMath::Sqrt(sigmaX*sigmaX+fWidth*fWidth*(1+TMath::Abs(fK))/12);
353 if (estimsigma < 5*sigmaX) {
354 fDStep = estimsigma/10.;
355 fNPRF = Int_t(estimsigma*8./fDStep);
359 fNPRF = Int_t((1.2*fWidth*(1+TMath::Abs(fK))+8.*sigmaX)/fDStep);
364 void AliTPCPRF2D::SetGati(Float_t K3X, Float_t K3Y,
368 // set parameters for Gati generic charge distribution
373 fPadDistance=padDistance;
374 sprintf(fType,"Gati");
375 if (fGRF !=0 ) fGRF->Delete();
376 fGRF = new TF2("funGati2D", funGati2D,-5.,5.,-5.,5.,5);
378 funParam[0]=padDistance;
381 funParam[3]=fHeightS;
383 fGRF->SetParameters(funParam);
384 fOrigSigmaX=padDistance;
385 fOrigSigmaY=padDistance;
386 Float_t sigmaX = fOrigSigmaX;
387 Double_t estimsigma = TMath::Sqrt(sigmaX*sigmaX+fWidth*fWidth*(1+TMath::Abs(fK))/12);
388 if (estimsigma < 5*sigmaX) {
389 fDStep = estimsigma/10.;
390 fNPRF = Int_t(estimsigma*8./fDStep);
394 fNPRF = Int_t((1.2*fWidth*(1+TMath::Abs(fK))+8.*sigmaX)/fDStep);
400 void AliTPCPRF2D::Update()
403 //update fields with interpolated values for
406 if ( fGRF == 0 ) return;
407 //initialize interpolated values to 0
409 if (fChargeArray!=0) delete [] fChargeArray;
410 fChargeArray = new Float_t[fNPRF*fNYdiv];
411 fNChargeArray = fNPRF*fNYdiv;
412 for (i =0; i<fNPRF*fNYdiv;i++) fChargeArray[i] = 0;
413 //firstly calculate total integral of charge
415 ////////////////////////////////////////////////////////
416 //I'm waiting for normal integral
417 //in this moment only sum
418 Float_t x2= 4*fOrigSigmaX;
419 Float_t y2= 4*fOrigSigmaY;
420 Float_t dx = fOrigSigmaX/Float_t(fNdiv*6);
421 Float_t dy = fOrigSigmaY/Float_t(fNdiv*6);
422 Int_t nx = Int_t(0.5+x2/dx);
423 Int_t ny = Int_t(0.5+y2/dy);
427 for (ix=-nx;ix<=nx;ix++)
428 for ( iy=-ny;iy<=ny;iy++)
429 dInteg+=fGRF->Eval(Float_t(ix)*dx,Float_t(iy)*dy)*dx*dy;
430 /////////////////////////////////////////////////////
432 if ( fInteg == 0 ) fInteg = 1;
434 for (i=0; i<fNYdiv; i++){
435 if (fNYdiv == 1) fCurrentY = fY1;
437 fCurrentY = fY1+Double_t(i)*(fY2-fY1)/Double_t(fNYdiv-1);
438 fcharge = &(fChargeArray[i*fNPRF]);
441 //calculate conversion coefitient to convert position to virtual wire
442 fDYtoWire=Float_t(fNYdiv-1)/(fY2-fY1);
447 void AliTPCPRF2D::Update1()
450 //update fields with interpolated values for
451 //PRF calculation for given charge line
453 Double_t cos = TMath::Cos(fChargeAngle);
454 Double_t sin = TMath::Sin(fChargeAngle);
455 const Double_t kprec =0.00000001;
456 //integrate charge over pad for different distance of pad
457 for (i =0; i<fNPRF;i++){
458 //x in cm fWidth in cm
460 Double_t xch = fDStep * (Double_t)(i-fNPRF/2);
465 for (Double_t ym=-fHeightFull/2.-fShiftY; ym<fHeightFull/2.-kprec;ym+=fHeightS){
466 Double_t y2chev=TMath::Min((ym+fHeightS),Double_t(fHeightFull/2.)); // end of chevron step
467 Double_t y1chev= ym; //beginning of chevron step
468 Double_t y2 = TMath::Min(y2chev,fCurrentY+3.5*fOrigSigmaY);
469 Double_t y1 = TMath::Max((y1chev),Double_t(-fHeightFull/2.));
470 y1 = TMath::Max(y1chev,fCurrentY-3.5*fOrigSigmaY);
472 Double_t x0 = fWidth*(-1.-(Double_t(k)*fK))*0.5+ym*TMath::Tan(fPadAngle*fgkDegtoRad);
473 Double_t kx = Double_t(k)*(fK*fWidth)/fHeightS;
474 kx = TMath::Tan(TMath::ATan(kx))+TMath::Tan(fPadAngle*fgkDegtoRad);
476 Int_t ny = TMath::Max(Int_t(fNdiv*TMath::Exp(-(y1-fCurrentY)*(y1-fCurrentY)/(2*fOrigSigmaY*fOrigSigmaY))),4);
477 Double_t dy = TMath::Min(fOrigSigmaY/Double_t(ny),y2-y1);
480 //loop over different y strips with variable step size dy
481 if (y2>(y1+kprec)) for (Double_t y = y1; y<y2+kprec;){
484 ny = TMath::Max(Int_t(fNdiv*TMath::Exp(-(y-fCurrentY)*(y-fCurrentY)/(2*fOrigSigmaY*fOrigSigmaY))),5);
485 ndy = fOrigSigmaY/Double_t(ny);
488 if (ndy<kprec) ndy=2*kprec; //calculate new delta y
492 //calculation of x borders and initial step
493 Double_t deltay = (y-y1chev);
495 Double_t xp1 = x0+deltay*kx;
496 //x begining of pad at position y
497 Double_t xp2 =xp1+fWidth; //x end of pad at position y
498 Double_t xp3 =xp1+kx*dy; //...at position y+dy
499 Double_t xp4 =xp2+kx*dy; //..
501 Double_t x1 = TMath::Min(xp1,xp3);
502 x1 = TMath::Max(xp1,xch-3.5*fOrigSigmaX); //beging of integration
503 Double_t x2 = TMath::Max(xp2,xp4);
504 x2 = TMath::Min(xp2+dy*kx,xch+3.5*fOrigSigmaX); //end of integration
506 Int_t nx = TMath::Max(Int_t(fNdiv*TMath::Exp(-(x1-xch)*(x1-xch)/(2*fOrigSigmaX*fOrigSigmaX))*
507 TMath::Exp(-(y1-fCurrentY)*(y1-fCurrentY)/(2*fOrigSigmaY*fOrigSigmaY))),2);
508 Double_t dx = TMath::Min(fOrigSigmaX/Double_t(nx),x2-x1)/5.; //on the border more iteration
512 for (Double_t x = x1; x<x2+kprec ;){
514 nx = TMath::Max(Int_t(fNdiv*TMath::Exp(-(x-xch)*(x-xch)/(2*fOrigSigmaX*fOrigSigmaX))),3);
515 ndx = fOrigSigmaX/Double_t(nx);
519 if ( ( (x+dx+ndx)<TMath::Max(xp3,xp1)) || ( (x+dx+ndx)>TMath::Min(xp4,xp2))) {
522 if (ndx<kprec) ndx=2*kprec;
523 //INTEGRAL APROXIMATION
524 Double_t ddx,ddy,dddx,dddy;
526 ddy = fCurrentY-(y+dy/2.);
527 dddx = cos*ddx-sin*ddy;
528 dddy = sin*ddx+cos*ddy;
529 Double_t z0=fGRF->Eval(dddx,dddy); //middle point
533 dddx = cos*ddx-sin*ddy;
534 dddy = sin*ddx+cos*ddy;
535 Double_t z1=fGRF->Eval(dddx,dddy); //point down
538 ddy = fCurrentY-(y+dy);
539 dddx = cos*ddx-sin*ddy;
540 dddy = sin*ddx+cos*ddy;
541 Double_t z3=fGRF->Eval(dddx,dddy); //point up
544 ddy = fCurrentY-(y+dy/2.);
545 dddx = cos*ddx-sin*ddy;
546 dddy = sin*ddx+cos*ddy;
547 Double_t z2=fGRF->Eval(dddx,dddy); //point left
550 ddy = fCurrentY-(y+dy/2.);
551 dddx = cos*ddx-sin*ddy;
552 dddy = sin*ddx+cos*ddy;
553 Double_t z4=fGRF->Eval(dddx,dddy); //point right
556 if (z0<0) {z0=0;z1=0;z2=0;z3=0;z4=0;}
558 Double_t f2x= (z3+z1-2*z0)*4.;//second derivation in y
559 Double_t f2y= (z2+z4-2*z0)*4.;//second derivation in x
560 Double_t f1y= (z3-z1);
562 z = (z0+f2x/6.+f2y/6.);//second order aproxiation of integral
563 if (kx>kprec){ //positive derivation
564 if (x<(xp1+dy*kx)){ //calculate volume at left border
566 Double_t xx2 = TMath::Min(x+dx,xp1+dy*kx);
567 Double_t yy1 = y+(xx1-xp1)/kx;
568 Double_t yy2 = TMath::Min(y+(xx2-xp1)/kx,y+dy);
571 z-= z0*(y+dy-yy2)/dy; //constant part rectangle
572 z-= f1y*(xx2-xx1)*(y+dy-yy2)*(y+dy-yy2)/(2.*dx*dy);
574 z-=z0*(xx2-xx1)*(yy2-yy1)/(2*dx*dy); //constant part rectangle
577 if (x>xp2){ //calculate volume at right border
580 Double_t yy1 = y+(xx1-xp2)/kx;
581 Double_t yy2 = y+(xx2-xp2)/kx;
584 z-=z0*(yy1-y)/dy; //constant part
585 z-=f1y*(xx2-xx1)*(yy1-y)*(yy1-y)/(2*dx*dy);
587 z-=z0*(xx2-xx1)*(yy2-yy1)/(2*dx*dy); //constant part
590 if (kx<-kprec){ //negative derivation
591 if (x<(xp1+dy*kx)){ //calculate volume at left border
593 Double_t xx2 = TMath::Min(x+dx,xp3-dy/kx);
594 Double_t yy1 = y+(xx1-xp1)/kx;
595 Double_t yy2 = TMath::Max(y,yy1+(xx2-xx1)/kx); //yy2<yy1
597 z-= z0*(yy2-y)/dy; // constant part rectangle
598 z-= f1y*(xx2-xx1)*(yy2-y)*(yy2-y)/(2.*dx*dy);
599 z-=z0*(xx2-xx1)*(yy1-yy2)/(2*dx*dy); //constant part triangle
601 if (x>xp2){ //calculate volume at right border
602 Double_t xx1 = TMath::Max(x,xp2+dy*kx);
604 Double_t yy1 = TMath::Min(y+dy,y-(xp2-xx1)/kx);
605 Double_t yy2 = y-(xp2-xx2)/kx;
607 z-=z0*(yy2-y)/dy; //constant part rextangle
608 z-= f1y*(xx2-xx1)*(yy2-y)*(yy2-y)/(2.*dx*dy);
609 z-=z0*(xx2-xx1)*(yy1-yy2)/(2*dx*dy); //constant part triangle
613 if (z>0.) sumch+=fKNorm*z*dx*dy/fInteg;
622 }//step over different y
626 }//step over different points on line NPRF
629 void AliTPCPRF2D::UpdateSigma()
632 //calulate effective sigma X and sigma y of PRF
642 for (i=-1; i<=fNYdiv; i++){
643 if (fNYdiv == 1) y = fY1;
645 y = fY1+Float_t(i)*(fY2-fY1)/Float_t(fNYdiv-1);
646 for (x =-fNPRF*fDStep; x<fNPRF*fDStep;x+=fDStep)
648 //x in cm fWidth in cm
649 Float_t weight = GetPRF(x,y);
660 fSigmaX = TMath::Sqrt(fSigmaX/sum-fMeanX*fMeanX);
661 fSigmaY = TMath::Sqrt(fSigmaY/sum-fMeanY*fMeanY);
667 void AliTPCPRF2D::Streamer(TBuffer &R__b)
669 // Stream an object of class AliTPCPRF2D
671 if (R__b.IsReading()) {
673 Version_t R__v = R__b.ReadVersion(&R__s, &R__c);
674 AliTPCPRF2D::Class()->ReadBuffer(R__b, this, R__v, R__s, R__c);
676 if (strncmp(fType,"User",3)!=0){
678 if (strncmp(fType,"Gauss",3)==0)
679 fGRF = new TF2("funGauss2D",funGauss2D,-5.,5.,-5.,5.,4);
680 if (strncmp(fType,"Cosh",3)==0)
681 fGRF = new TF2("funCosh2D",funCosh2D,-5.,5.,-5.,5.,4);
682 if (strncmp(fType,"Gati",3)==0)
683 fGRF = new TF2("funGati2D",funGati2D,-5.,5.,-5.,5.,5);
684 if (fGRF!=0) fGRF->SetParameters(funParam);
686 //calculate conversion coefitient to convert position to virtual wire
687 fDYtoWire=Float_t(fNYdiv-1)/(fY2-fY1);
690 AliTPCPRF2D::Class()->WriteBuffer(R__b,this);
695 TH1F * AliTPCPRF2D::GenerDrawXHisto(Float_t x1, Float_t x2,Float_t y)
697 //gener one dimensional hist of pad response function
701 sprintf(s,"Pad Response Function");
702 TH1F * hPRFc = new TH1F("hPRFc",s,kn+1,x1,x2);
706 for (Int_t i = 0;i<kn+1;i++)
708 x+=(x2-x1)/Float_t(kn);
712 hPRFc->SetXTitle("pad (cm)");
716 AliH2F * AliTPCPRF2D::GenerDrawHisto(Float_t x1, Float_t x2, Float_t y1, Float_t y2, Int_t Nx, Int_t Ny)
719 //gener two dimensional histogram with PRF
722 sprintf(s,"Pad Response Function");
723 AliH2F * hPRFc = new AliH2F("hPRFc",s,Nx,x1,x2,Ny,y1,y2);
724 Float_t dx=(x2-x1)/Float_t(Nx);
725 Float_t dy=(y2-y1)/Float_t(Ny) ;
729 for ( Int_t i = 0;i<=Nx;i++,x+=dx){
731 for (Int_t j = 0;j<=Ny;j++,y+=dy){
733 hPRFc->SetCellContent(i,j,z);
736 hPRFc->SetXTitle("pad direction (cm)");
737 hPRFc->SetYTitle("pad row direction (cm)");
738 hPRFc->SetTitleOffset(1.5,"X");
739 hPRFc->SetTitleOffset(1.5,"Y");
744 AliH2F * AliTPCPRF2D::GenerDrawDistHisto(Float_t x1, Float_t x2, Float_t y1, Float_t y2, Int_t Nx, Int_t Ny, Float_t thr)
746 //return histogram with distortion
747 const Float_t kminth=0.00001;
748 if (thr<kminth) thr=kminth;
750 sprintf(s,"COG distortion of PRF (threshold=%2.2f)",thr);
751 AliH2F * hPRFDist = new AliH2F("hDistortion",s,Nx,x1,x2,Ny,y1,y2);
752 Float_t dx=(x2-x1)/Float_t(Nx);
753 Float_t dy=(y2-y1)/Float_t(Ny) ;
756 for ( Int_t i = 0;i<=Nx;i++,x+=dx){
758 for(Int_t j = 0;j<=Ny;j++,y+=dy)
762 for (Int_t k=-3;k<=3;k++)
764 Float_t padx=Float_t(k)*fWidth;
765 z = GetPRF(x-padx,y);
773 ddx = (x-(sumx/sum));
776 if (TMath::Abs(ddx)<10) hPRFDist->SetCellContent(i,j,ddx);
780 hPRFDist->SetXTitle("pad direction (cm)");
781 hPRFDist->SetYTitle("pad row direction (cm)");
782 hPRFDist->SetTitleOffset(1.5,"X");
783 hPRFDist->SetTitleOffset(1.5,"Y");
791 void AliTPCPRF2D::DrawX(Float_t x1 ,Float_t x2,Float_t y1,Float_t y2, Int_t N)
794 //draw pad response function at interval <x1,x2> at given y position
797 TCanvas * c1 = new TCanvas("PRFX","Pad response function",700,900);
800 TPaveText * comment = new TPaveText(0.05,0.02,0.95,0.20,"NDC");
801 comment->SetTextAlign(12);
802 comment->SetFillColor(42);
803 DrawComment(comment);
807 TPad * pad2 = new TPad("pPRF","",0.05,0.22,0.95,0.95);
808 pad2->Divide(2,(N+1)/2);
810 gStyle->SetOptFit(1);
811 gStyle->SetOptStat(1);
812 for (Int_t i=0;i<N;i++){
816 else y = y1+i*(y2-y1)/Float_t(N-1);
818 TH1F * hPRFc =GenerDrawXHisto(x1, x2,y);
819 sprintf(ch,"PRF at wire position: %2.3f",y);
821 sprintf(ch,"PRF %d",i);
830 void AliTPCPRF2D::DrawPRF(Float_t x1 ,Float_t x2,Float_t y1, Float_t y2, Int_t Nx, Int_t Ny)
834 TCanvas * c1 = new TCanvas("canPRF","Pad response function",700,900);
836 TPad * pad2 = new TPad("pad2PRF","",0.05,0.22,0.95,0.95);
838 gStyle->SetOptFit(1);
839 gStyle->SetOptStat(1);
840 TH2F * hPRFc = GenerDrawHisto(x1, x2, y1, y2, Nx,Ny);
844 TPaveText * comment = new TPaveText(0.05,0.02,0.95,0.20,"NDC");
845 comment->SetTextAlign(12);
846 comment->SetFillColor(42);
847 DrawComment(comment);
851 void AliTPCPRF2D::DrawDist(Float_t x1 ,Float_t x2,Float_t y1, Float_t y2, Int_t Nx, Int_t Ny, Float_t thr)
854 //draw distortion of the COG method - for different threshold parameter
855 TCanvas * c1 = new TCanvas("padDistortion","COG distortion",700,900);
857 TPad * pad1 = new TPad("dist","",0.05,0.55,0.95,0.95,21);
859 TPad * pad2 = new TPad("dist","",0.05,0.22,0.95,0.53,21);
861 gStyle->SetOptFit(1);
862 gStyle->SetOptStat(0);
864 AliH2F * hPRFDist = GenerDrawDistHisto(x1, x2, y1, y2, Nx,Ny,thr);
867 hPRFDist->Draw("surf");
868 Float_t distmax =hPRFDist->GetMaximum();
869 Float_t distmin =hPRFDist->GetMinimum();
870 gStyle->SetOptStat(1);
872 TH1F * dist = hPRFDist->GetAmplitudes(distmin,distmax,distmin-1);
876 TPaveText * comment = new TPaveText(0.05,0.02,0.95,0.20,"NDC");
877 comment->SetTextAlign(12);
878 comment->SetFillColor(42);
879 DrawComment(comment);
883 void AliTPCPRF2D::DrawComment(TPaveText *comment)
886 //function to write comment to picture
889 //draw comments to picture
890 TText * title = comment->AddText("Pad Response Function parameters:");
891 title->SetTextSize(0.03);
892 sprintf(s,"Height of pad: %2.2f cm",fHeightFull);
894 sprintf(s,"Width pad: %2.2f cm",fWidth);
896 sprintf(s,"Pad Angle: %2.2f ",fPadAngle);
899 if (TMath::Abs(fK)>0.0001){
900 sprintf(s,"Height of one chevron unit h: %2.2f cm",2*fHeightS);
902 sprintf(s,"Overlap factor: %2.2f",fK);
906 if (strncmp(fType,"User",3)==0){
907 sprintf(s,"Charge distribution - user defined function %s ",fGRF->GetTitle());
909 sprintf(s,"Sigma x of charge distribution: %2.2f ",fOrigSigmaX);
911 sprintf(s,"Sigma y of charge distribution: %2.2f ",fOrigSigmaY);
914 if (strncmp(fType,"Gauss",3)==0){
915 sprintf(s,"Gauss charge distribution");
917 sprintf(s,"Sigma x of charge distribution: %2.2f ",fOrigSigmaX);
919 sprintf(s,"Sigma y of charge distribution: %2.2f ",fOrigSigmaY);
922 if (strncmp(fType,"Gati",3)==0){
923 sprintf(s,"Gati charge distribution");
925 sprintf(s,"K3X of Gati : %2.2f ",fK3X);
927 sprintf(s,"K3Y of Gati: %2.2f ",fK3Y);
929 sprintf(s,"Wire to Pad Distance: %2.2f ",fPadDistance);
932 if (strncmp(fType,"Cosh",3)==0){
933 sprintf(s,"Cosh charge distribution");
935 sprintf(s,"Sigma x of charge distribution: %2.2f ",fOrigSigmaX);
937 sprintf(s,"Sigma y of charge distribution: %2.2f ",fOrigSigmaY);
940 sprintf(s,"Normalisation: %2.2f ",fKNorm);