]> git.uio.no Git - u/mrichter/AliRoot.git/blobdiff - RICH/AliRICHEllipse.cxx
Corrected drawing routine for RecHit3D (J. Barbosa)
[u/mrichter/AliRoot.git] / RICH / AliRICHEllipse.cxx
index d1f9d5ac1a991f9b41eaee60ac011f7502c2f171..e6ab33e6519560016f7443bd529e54465efe9832 100644 (file)
 
 /*
   $Log$
 
 /*
   $Log$
+  Revision 1.4  2001/05/10 12:34:43  jbarbosa
+  Changed drwaing routines.
+
+  Revision 1.3  2000/11/01 15:37:44  jbarbosa
+  Removed verbose output.
+
+  Revision 1.2  2000/06/30 16:31:51  dibari
+  New drawing routine from Nico and Daniela.
+
+  Revision 1.1  2000/06/12 15:21:57  jbarbosa
+  Cleaned up version.
+
 */
 
 */
 
+#include "TMath.h"
 #include "AliRICHEllipse.h"
 #include "AliRICH.h"
 #include "AliRun.h"
 #include "AliRICHEllipse.h"
 #include "AliRICH.h"
 #include "AliRun.h"
+#include "AliRICHPatRec.h"
+#include "AliRICHGeometry.h"
 
 #include <TRandom.h>
 
 
 #include <TRandom.h>
 
@@ -55,7 +70,7 @@ AliRICHEllipse::~AliRICHEllipse()
 
 
 //________________________________________________________________________________
 
 
 //________________________________________________________________________________
-AliRICHEllipse::AliRICHEllipse(Float_t cx, Float_t cy, Float_t omega, Float_t theta, Float_t phi)
+AliRICHEllipse::AliRICHEllipse(Float_t cx, Float_t cy, Float_t omega, Float_t theta, Float_t phi, Float_t emiss)
 { 
 
 //  Constructor for a RICH ellipse
 { 
 
 //  Constructor for a RICH ellipse
@@ -65,7 +80,8 @@ AliRICHEllipse::AliRICHEllipse(Float_t cx, Float_t cy, Float_t omega, Float_t th
     fOmega = omega;
     fTheta = theta;
     fPhi = phi;
     fOmega = omega;
     fTheta = theta;
     fPhi = phi;
-    fh=11.25;
+    fEmissPoint = emiss;
+    fh=9.25;
 }
 
 //________________________________________________________________________________
 }
 
 //________________________________________________________________________________
@@ -73,73 +89,209 @@ void AliRICHEllipse::CreatePoints(Int_t chamber)
 {
 
 // Create points along the ellipse equation
 {
 
 // Create points along the ellipse equation
-
-  Int_t s1,s2;
-  Float_t fiducial=fh*TMath::Tan(fOmega+fTheta), l=fh/TMath::Cos(fTheta), xtrial, y=0, c0, c1, c2;
-  //TRandom *random=new TRandom();
+  
+  Float_t x, y, rotx, roty, h, cx, cy, phi, omega, theta, omega1, theta1, phiinc;
+  Float_t a,b,c,r,e, offset;
+  
+  Float_t kPi=TMath::Pi();
 
   AliRICH *pRICH  = (AliRICH*)gAlice->GetModule("RICH");
   AliRICHChamber*       iChamber;
 
   AliRICH *pRICH  = (AliRICH*)gAlice->GetModule("RICH");
   AliRICHChamber*       iChamber;
+  AliRICHGeometry*  geometry;
   
   iChamber = &(pRICH->Chamber(chamber));
   
   iChamber = &(pRICH->Chamber(chamber));
-  //cout<<"fiducial="<<fiducial<<endl;
+  geometry=iChamber->GetGeometryModel();
   
   
+  //h = 2.3 * geometry->GetRadiatorToPads();
+  h = geometry->GetRadiatorToPads();
+  //printf("h: %f",h);
+
+  cx = fCx;
+  cy = fCy;
+  theta = fTheta;
+  omega = fOmega;
+  phiinc = fPhi+kPi/2;
+  
+  printf("Omega: %f, Theta: %f, Phi: %f\n", omega, theta, phiinc); 
+
+
   for(Float_t i=0;i<1000;i++)
     {
   for(Float_t i=0;i<1000;i++)
     {
+      phi=((Float_t)(i)/1000)*2*kPi;
+      //printf("Phi: %f\n",phi);
+
+      //theta1=SnellAngle(theta1);
       
       
-      Float_t counter=0;
-      
-      c0=0;c1=0;c2=0;
-      while((c1*c1-4*c2*c0)<=0 && counter<1000)
-       {
-         //Choose which side to go...
-         if(i>250 && i<750) s1=1; 
-         //if (gRandom->Rndm(1)>.5) s1=1;
-         else s1=-1;
-         //printf("s1:%d\n",s1);
-         //Trial a y
-         y=s1*i*gRandom->Rndm(Int_t(fiducial/50));
-         //printf("Fiducial %f  for omega:%f theta:%f phi:%f\n",fiducial,fOmega,fTheta,fPhi);
-         Float_t alfa1=fTheta;
-         Float_t theta1=fPhi;
-         Float_t omega1=fOmega;
-         
-         //Solve the eq for a trial x
-         c0=-TMath::Power(y*TMath::Cos(alfa1)*TMath::Cos(theta1),2)-TMath::Power(y*TMath::Sin(alfa1),2)+TMath::Power(l*TMath::Tan(omega1),2)+2*l*y*TMath::Cos(alfa1)*TMath::Sin(theta1)*TMath::Power(TMath::Tan(omega1),2)+TMath::Power(y*TMath::Cos(alfa1)*TMath::Sin(theta1)*TMath::Tan(omega1),2);
-         c1=2*y*TMath::Cos(alfa1)*TMath::Sin(alfa1)-2*y*TMath::Cos(alfa1)*TMath::Power(TMath::Cos(theta1),2)*TMath::Sin(alfa1)+2*l*TMath::Sin(alfa1)*TMath::Sin(theta1)*TMath::Power(TMath::Tan(omega1),2)+2*y*TMath::Cos(alfa1)*TMath::Sin(alfa1)*TMath::Power(TMath::Sin(theta1),2)*TMath::Power(TMath::Tan(omega1),2);
-         c2=-TMath::Power(TMath::Cos(alfa1),2)-TMath::Power(TMath::Cos(theta1)*TMath::Sin(alfa1),2)+TMath::Power(TMath::Sin(alfa1)*TMath::Sin(theta1)*TMath::Tan(omega1),2);
-         //cout<<"Trial: y="<<y<<"c0="<<c0<<" c1="<<c1<<" c2="<<c2<<endl;
-         //printf("Result:%f\n\n",c1*c1-4*c2*c0);
-         //i+=.01;
-         counter +=1;
-       }
+      //if(phi<=TMath::Pi())
+      omega1=SnellAngle(omega);
+      theta1=SnellAngle(theta);
+      //omega1=SnellAngle(omega+cos(phi)*theta);
+      //if(phi>TMath::Pi())
+       //omega1=SnellAngle(omega+(1-2*(2*TMath::Pi()-phi)/(TMath::Pi()))*theta);
+
+   
+      //Omega1->Fill(omega1,(float) 1);
+
+      a = h*(tan(omega1+theta1)+tan(omega1-theta1))/2;
+      b = h*tan(omega1);
+      e = sqrt(1 - (b*b)/(a*a));
+      c = a*e;
+      r = (a*(1-e*e))/(1+e*cos(e));
+      offset = h*(tan(omega1+theta1)-tan(omega1-theta1))/2;
+       
+      x = b* sin(phi);
+      y = a* cos(phi) + offset;
+               
+      rotx = x*cos(phiinc)-y*sin(phiinc);
+      roty = x*sin(phiinc)+y*cos(phiinc);
+   
+      //x = h * 1/(tan(omega1)) * sin(phi+phiinc);
+      //y = x * 1/(tan(phi+phiinc));
+
       
       
-      if (counter>=1000)
-       y=0; 
-
-      //Choose which side to go...
-      //if(gRandom->Rndm(1)>.5) s=1; 
-      //else s=-1;
-      if(i>500) s2=1;
-      //if (gRandom->Rndm(1)>.5) s2=1;
-      else s2=-1;
-      xtrial=fCx+(-c1+s2*TMath::Sqrt(c1*c1-4*c2*c0))/(2*c2);
-      //cout<<"x="<<xtrial<<" y="<<cy+y<<endl;
-      //printf("Coordinates: %f %f\n",xtrial,fCy+y);
-
-      Float_t vectorLoc[3]={xtrial,6.276,(fCy+y)};
+
+      //Rings->Fill(x,y,(float) 1);
+
+      rotx += cx;
+      roty += cy;
+
+      //printf("x:%f, y: %f\n",x,y);
+
+      Float_t vectorLoc[3]={rotx,6.276,roty};
       Float_t  vectorGlob[3];
       iChamber->LocaltoGlobal(vectorLoc,vectorGlob);
       Float_t  vectorGlob[3];
       iChamber->LocaltoGlobal(vectorLoc,vectorGlob);
-      SetPoint(i,vectorGlob[0],vectorGlob[1],vectorGlob[2]);
+      SetPoint((Int_t) i,vectorGlob[0],vectorGlob[1],vectorGlob[2]);
       //printf("Coordinates: %f %f %f\n",vectorGlob[0],vectorGlob[1],vectorGlob[2]);
       //printf("Coordinates: %f %f %f\n",vectorGlob[0],vectorGlob[1],vectorGlob[2]);
+      
     }
     }
+
 }
 
 }
 
+void AliRICHEllipse::CerenkovRingDrawing(Int_t chamber,Int_t track)
+{
 
 
+//to draw Cherenkov ring by known Cherenkov angle
 
 
+  Int_t nmaxdegrees;
+  Int_t Nphpad;
+  Float_t phpad;
+  Float_t nfreonave, nquartzave;
+  Float_t aveEnerg;
+  Float_t energy[2];
+  Float_t e1, e2, f1, f2;
+  Float_t pointsOnCathode[3];
 
 
+  //printf("Drawing ring in chamber:%d\n",chamber);
+
+
+  AliRICH *pRICH  = (AliRICH*)gAlice->GetModule("RICH");
+  AliRICHChamber*       iChamber;
+  
+  iChamber = &(pRICH->Chamber(chamber));
 
 
+  AliRICHPatRec *PatRec = new AliRICHPatRec;
+  PatRec->TrackParam(track,chamber,fTheta,fOmega);
 
 
+  //printf("Just created PateRec\n");
+
+//parameters to calculate freon window refractive index vs. energy
+
+    Float_t a = 1.177;
+    Float_t b = 0.0172;
+    
+//parameters to calculate quartz window refractive index vs. energy
+/*
+   Energ[0]  = 5.6;
+   Energ[1]  = 7.7;
+*/     
+    energy[0]  = 5.0;
+    energy[1]  = 8.0;
+    e1  = 10.666;
+    e2  = 18.125;
+    f1  = 46.411;
+    f2  = 228.71;
+  
+
+    /*Float_t nquartz = 1.585;
+      Float_t ngas    = 1.;
+      Float_t nfreon  = 1.295;
+      Float_t value;
+    */
+
+
+
+   nmaxdegrees = 360;
+   
+   for (Nphpad=0; Nphpad<nmaxdegrees;Nphpad++) { 
+
+       phpad = (360./(Float_t)nmaxdegrees)*(Float_t)Nphpad;
+      
+       aveEnerg =  (energy[0]+energy[1])/2.;
+       //aveEnerg = 6.5;
+       
+       
+       nfreonave  = a+b*aveEnerg;
+       nquartzave = sqrt(1+(f1/(TMath::Power(e1,2)-TMath::Power(aveEnerg,2)))+
+                        (f2/(TMath::Power(e2,2)-TMath::Power(aveEnerg,2))));
+
+       //nfreonave = 1.295;
+       //nquartzave = 1.585;
+       
+       ///printf("Calling DistancefromMip %f %f \n",fEmissPoint,fOmega);
+       
+       //Float_t dummy = 
+        PatRec->DistanceFromMip(nfreonave, nquartzave,fEmissPoint,fOmega, phpad, pointsOnCathode,fTheta,fPhi);
+
+       //Float_t points[3];
+
+       //points = pointsOnCathode;
+
+
+       //printf(" values %f %f %f\n",points[0],points[1],points[2]);
+       
+       Float_t vectorLoc[3]={pointsOnCathode[0],pointsOnCathode[2],pointsOnCathode[1]};
+       Float_t  vectorGlob[3];
+       iChamber->LocaltoGlobal(vectorLoc,vectorGlob);
+       SetPoint(Nphpad,vectorGlob[0],vectorGlob[1],vectorGlob[2]);
+      //fCoordEllipse[0][Nphpad] = pointsOnCathode[0];
+      //fCoordEllipse[1][Nphpad] = pointsOnCathode[1];
+       
+       //printf(" values %f %f \n",pointsOnCathode[0],pointsOnCathode[1]);
+       
+   }
+
+}
+
+
+
+Float_t AliRICHEllipse:: SnellAngle(Float_t iangle)
+{ 
+
+// Compute the Snell angle
+
+  Float_t nfreon  = 1.295;
+  Float_t nquartz = 1.585;
+  Float_t ngas = 1;
+
+  Float_t sinrangle;
+  Float_t rangle;
+  Float_t a1, a2;
+
+  a1=nfreon/nquartz;
+  a2=nquartz/ngas;
+
+  sinrangle = a1*a2*sin(iangle);
+
+  if(sinrangle>1.) {
+     rangle = 999.;
+     return rangle;
+  }
+  
+  rangle = asin(sinrangle);  
+  //printf("iangle %f, a1*a2, %f, sinranlge, %f, rangle, %f\n", iangle, a1*a2, sinrangle, rangle);
+  return rangle;
+
+}