]> git.uio.no Git - u/mrichter/AliRoot.git/blobdiff - HBTAN/AliHBTLLWeights.cxx
Transition to NewIO
[u/mrichter/AliRoot.git] / HBTAN / AliHBTLLWeights.cxx
index 6761fbcc0ffe337338a3350d6f81cd9431ddae3e..e53acfd388fe063cb864252153e6a21bf54ccdf7 100644 (file)
-#include <Riostream.h>
 #include "AliHBTLLWeights.h"
-#include "AliPDG.h"
-#include "AliHBTPair.h"
-#include "AliHBTParticle.h"
-#include <TList.h>
-#include <TRandom.h>                                                                     
-#include <TMath.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.                  *
+ **************************************************************************/
+
+//_________________________________________________________________________
+///////////////////////////////////////////////////////////////////////////
+//
+//  class AliHBTLLWeights
+//
+//  This class introduces the weight's calculation 
+//  according to the Lednicky's algorithm.
+//  
+//  
+//  fsiw.f, fsiini.f  
+//
+//  Description from fortran code by author R. Lednicky
+//
+//  Calculates final state interaction (FSI) weights                     
+//  WEIF = weight due to particle - (effective) nucleus FSI (p-N)
+//  WEI  = weight due to p-p-N FSI
+//  WEIN = weight due to p-p FSI; note that WEIN=WEI if I3C=0;
+//                                note that if I3C=1 the calculation of
+//                                WEIN can be skipped by putting J=0
+//.......................................................................
+//  Correlation Functions:
+//  CF(p-p-N)   = sum(WEI)/sum(WEIF)
+//  CF(p-p)     = sum(WEIN)/sum(1); here the nucleus is completely
+//                                  inactive
+//  CF(p-p-"N") = sum(WEIN*WEIF')/sum(WEIF'), where WEIN and WEIF'
+//                are not correlated (calculated at different emission
+//                points, e.g., for different events);
+//                thus here the nucleus affects one-particle
+//                spectra but not the correlation
+//.......................................................................
+//  User must supply data file <fn> on unit NUNIT (e.g. =11) specifying
+//  LL   : particle pair
+//  NS   : approximation used to calculate Bethe-Salpeter amplitude
+//  ITEST: test switch
+//         If ITEST=1 then also following parameters are required
+//  ICH  : 1(0) Coulomb interaction between the two particles ON (OFF)
+//  IQS  : 1(0) quantum statistics for the two particles ON (OFF)
+//  ISI  : 1(0) strong interaction between the two particles ON (OFF)
+//  I3C  : 1(0) Coulomb interaction with residual nucleus ON (OFF)
+//  This data file can contain other information useful for the user.
+//  It is read by subroutines READINT4 and READREA8(4) (or READ_FILE).
+//  -------------------------------------------------------------------
+//-   LL       1  2  3  4   5    6   7  8  9 10  11  12  13  14 15 16 17
+//-   part. 1: n  p  n alfa pi+ pi0 pi+ n  p pi+ pi+ pi+ pi- K+ K+ K+ K-
+//-   part. 2: n  p  p alfa pi- pi0 pi+ d  d  K-  K+  p   p  K- K+ p  p
+//   NS=1 y/n: +  +  +  +   +    -   -  -  -  -   -   -   -  -  -  -  -
+//  -------------------------------------------------------------------
+//-   LL       18  19 20  21  22 23 24 25 26    27     28
+//-   part. 1:  d  d   t  t   K0 K0  d p  p      p      n
+//-   part. 2:  d alfa t alfa K0 K0b t t alfa lambda lambda
+//   NS=1 y/n:  -  -   -  -   -  -   - -  -      +      +
+//  -------------------------------------------------------------------
+//   NS=1  Square well potential,
+//   NS=3  not used
+//   NS=4  scattered wave approximated by the spherical wave,
+//   NS=2  same as NS=4 but the approx. of equal emission times in PRF
+//       not required (t=0 approx. used in all other cases).
+//   Note: if NS=2,4, the B-S amplitude diverges at zero distance r* in
+//       the two-particle c.m.s.; user can specify a cutoff AA in
+//       SUBROUTINE FSIINI, for example:
+//       IF(NS.EQ.2.OR.NS.EQ.4)AA=5.D0 !! in 1/GeV --> AA=1. fm
+//  ------------------------------------------------------------------
+//  ITEST=1 any values of parameters ICH, IQS, ISI, I3C are allowed
+//          and should be given in data file <fn>
+//  ITEST=0 physical values of these parameters are put automatically
+//          in FSIINI (their values are not required in data file)
+//=====================================================================
+//  At the beginning of calculation user should call FSIINI,
+//  which reads LL, NS, ITEST (and eventually ICH, IQS, ISI, I3C)
+//  and initializes various parameters.
+//  In particular the constants in
+//    COMMON/FSI_CONS/PI,PI2,SPI,DR,W
+//  may be useful for the user:
+//   W=1/.1973D0    ! from fm to 1/GeV
+//   PI=4*DATAN(1.D0)
+//   PI2=2*PI
+//   SPI=DSQRT(PI)
+//   DR=180.D0/PI   ! from radian to degree
+//    _______________________________________________________
+//  !! |Important note: all real quantities are assumed REAL*8 | !!
+//    -------------------------------------------------------
+//  For each event user should fill in the following information
+//  in COMMONs (all COMMONs in FSI calculation start with FSI_):
+//  ...................................................................
+//   COMMON/FSI_POC/AMN,AM1,AM2,CN,C1,C2,AC1,AC2
+//  Only
+//       AMN  = mass of the effective nucleus   [GeV/c**2]
+//       CN   = charge of the effective nucleus [elem. charge units]
+//  are required
+//  ...................................................................
+//   COMMON/FSI_MOM/P1X,P1Y,P1Z,E1,P1, !part. momenta in the rest frame 
+//  1               P2X,P2Y,P2Z,E2,P2  !of effective nucleus (NRF)
+//  Only the components
+//                      PiX,PiY,PiZ  [GeV/c]
+//  in NRF are required.
+//  To make the corresponding Lorentz transformation user can use the
+//  subroutines LTRAN and LTRANB
+//  ...................................................................
+//  COMMON/FSI_COOR/X1,Y1,Z1,T1,R1,     ! 4-coord. of emission
+//  1               X2,Y2,Z2,T2,R2      ! points in NRF
+//  The componets
+//                     Xi,Yi,Zi  [fm]
+//  and emission times
+//                        Ti   [fm/c]
+//  should be given in NRF with the origin assumed at the center
+//  of the effective nucleus. If the effect of residual nucleus is
+//  not calculated within FSIW, the NRF can be any fixed frame.
+//  --------------------------------------------------------------------
+//  Before calling FSIW the user must call
+//   CALL LTRAN12
+//  Besides Lorentz transformation to pair rest frame:
+//  (p1-p2)/2 --> k* it also transforms 4-coordinates of
+//  emission points from fm to 1/GeV and calculates Ei,Pi and Ri.
+//  Note that |k*|=AK in COMMON/FSI_PRF/
+//  --------------------------------------------------------------------
+//  After making some additional filtering using k* (say k* < k*max)
+//  or direction of vector k*,
+//  user can finally call FSIW to calculate the FSI weights
+//  to be used to construct the correlation function
+//======================================================================
+
 
 /*******************************************************************/
 /******      ROUTINES    USED    FOR     COMMUNUCATION      ********/
 # define fsiini fsiini_
 # define ltran12 ltran12_
 # define fsiw fsiw_
+# define setpdist setpdist_
 # define type_of_call
 #else
 # define led_bldata LED_BLDATA
 # define fsiini FSIINI
 # define ltran12 LTRAN12
 # define fsiw FSIW
+# define setpdist SETPDIST
 # define type_of_call _stdcall
 #endif
 /****************************************************************/
@@ -29,159 +160,171 @@ extern "C" void type_of_call led_bldata();
 extern "C" void type_of_call fsiini();
 extern "C" void type_of_call ltran12();
 extern "C" void type_of_call fsiw();
+extern "C" void type_of_call setpdist(Double_t& r);
 /**************************************************************/
 
-ClassImp(AliHBTLLWeights)  
+#include "AliHBTPair.h"
+#include "AliHBTParticle.h"
+#include "WLedCOMMONS.h"
+#include <TList.h>
+#include <TRandom.h>   
+#include <TMath.h>     
+#include <TPDGCode.h>
 
-//Interface to Richard Lednicky's weight alghorithm (Fortran implementation)
-//Ludmila Malinina JINR
-//Piotr Krzysztof Skowronski CERN/WUT
-AliHBTLLWeights* AliHBTLLWeights::fgLLWeights=NULL; 
 
-AliHBTLLWeights::AliHBTLLWeights()
+ClassImp(AliHBTLLWeights)  
+AliHBTLLWeights* AliHBTLLWeights::fgLLWeights = 0x0; 
+const Double_t AliHBTLLWeights::fgkWcons = 1./0.1973;
+
+AliHBTLLWeights::AliHBTLLWeights():
+ fTest(kTRUE),
+ fColoumbSwitch(kTRUE),
+ fQuantStatSwitch(kTRUE),
+ fStrongInterSwitch(kTRUE),
+ fColWithResidNuclSwitch(kTRUE),
+ fNuclMass(0.0),
+ fNuclCharge(0.0),
+ fRandomPosition(kFALSE),
+ fRadius(0.0),
+ fPID1(0),
+ fPID2(0),
+ fSigma(0.0)
 {
 // Default Constructor 
-    fPID1 = 0;
-    fPID2 = 0;
-    SetRandomPosition();
-    SetColWithResidNuclSwitch();
-    SetStrongInterSwitch();
-    SetQuantumStatistics();
-    SetColoumb();
-    SetTest();
 }
+/**************************************************************/
 
-
- AliHBTLLWeights* AliHBTLLWeights::Instance()
-{                                                                                             
 if (fgLLWeights) 
-   { 
-     return fgLLWeights;                                                                   
-   
 else 
-   {                                                                                  
-    fgLLWeights = new AliHBTLLWeights();                                                        
-    return fgLLWeights;                                                                   
-  }                                                                                         
-}                                                                                             
-                                            
+AliHBTLLWeights* AliHBTLLWeights::Instance()
+{     
+// returns instance of class 
+ if (fgLLWeights) 
+  {
+    return fgLLWeights;
+  } 
+ else 
+  {
+   fgLLWeights = new AliHBTLLWeights();            
+   return fgLLWeights; 
+  } 
+}     
+                      
 
 Double_t AliHBTLLWeights::GetWeight(const AliHBTPair* partpair)
 {
-    AliHBTParticle *part1 = partpair->Particle1();
-    AliHBTParticle *part2 = partpair->Particle2();
-   
-    if ( (part1 == 0x0) || (part2 == 0x0))
-     {
-      Error("GetWeight","Null particle pointer");
+// calculates weight for a pair
+  static const Double_t cmtofm = 1.e13;
+  
+  AliHBTParticle *part1 = partpair->Particle1();
+  AliHBTParticle *part2 = partpair->Particle2();
+
+  if ( (part1 == 0x0) || (part2 == 0x0))
+   {
+     Error("GetWeight","Null particle pointer");
+     return 0.0;
+   }
+
+
+//eats a lot of time
+  if ( (part1->Px() == part2->Px()) && 
+       (part1->Py() == part2->Py()) && 
+       (part1->Pz() == part2->Pz()) )
+   {
+     return 0.0;
+   }
+
+  if ((!fRandomPosition) && 
+      (part1->Vx()  == part2->Vx()) && 
+      (part1->Vy()  == part2->Vy()) && 
+      (part1->Vz()  == part2->Vz()) )
+    {        
       return 0.0;
-     }
-   
-    Double_t part1Momentum[]={part1->Px(),part1->Py(),part1->Pz()};
-    Double_t part2Momentum[]={part2->Px(),part2->Py(),part2->Pz()};
-              
-   
-    if ( (part1->Px() == part2->Px()) && (part1->Py() == part2->Py()) 
-       && (part1->Pz() == part2->Pz()) )
-      {//if particles have the same momentum 
-        return 0.0;
-      }
-
-             
-    if ((!fRandomPosition) && (part1->Vx()  == part2->Vx()) && (part1->Vy()  == part2->Vy())
-          && (part1->Vz()  == part2->Vz()) )
-      { //if particles have the same position       
-       return 0.0;
-      }
-
-//put momenta of particles in LAB into Fortran commons
-
-    FSI_MOM.P1X=part1Momentum[0];
-    FSI_MOM.P1Y=part1Momentum[1];
-    FSI_MOM.P1Z=part1Momentum[2];
+    }
+
+  FSI_MOM.P1X = part1->Px();
+  FSI_MOM.P1Y = part1->Py();
+  FSI_MOM.P1Z = part1->Pz();
       
-    FSI_MOM.P2X=part2Momentum[0];
-    FSI_MOM.P2Y=part2Momentum[1];
-    FSI_MOM.P2Z=part2Momentum[2];
-        
-    if (fRandomPosition) 
-     {
-       Double_t rxcm = fsigma*gRandom->Gaus();
-       Double_t rycm = fsigma*gRandom->Gaus();
-       Double_t rzcm = fsigma*gRandom->Gaus();   
-    
-       FSI_PRF.X=rxcm*fwcons;
-       FSI_PRF.Y=rycm*fwcons;
-       FSI_PRF.Z=rzcm*fwcons;
-       FSI_PRF.T=0.;
-
-       Double_t rps=rxcm*rxcm+rycm*rycm+rzcm*rzcm;
-       Double_t rp=TMath::Sqrt(rps);
-       FSI_PRF.RP=rp;
-       FSI_PRF.RPS=rps;
-     }    
-          
-    ltran12();
-    fsiw();
-    return LEDWEIGHT.WEIN;
- }
+  FSI_MOM.P2X = part2->Px();
+  FSI_MOM.P2Y = part2->Py();
+  FSI_MOM.P2Z = part2->Pz();
+
+  FSI_COOR.X1 = part1->Vx()*cmtofm;
+  FSI_COOR.Y1 = part1->Vy()*cmtofm;
+  FSI_COOR.Z1 = part1->Vz()*cmtofm;
+  FSI_COOR.T1 = part1->T();
+
+  FSI_COOR.X2 = part2->Vx()*cmtofm;
+  FSI_COOR.Y2 = part2->Vy()*cmtofm;
+  FSI_COOR.Z2 = part2->Vz()*cmtofm;
+  FSI_COOR.T2 = part2->T();
+  
+  ltran12();
+
+  //this must  be after ltran12 because it would overwrite what we set below
+  if (fRandomPosition)
+   {
+     Double_t rxcm = fSigma*gRandom->Gaus();
+     Double_t rycm = fSigma*gRandom->Gaus();
+     Double_t rzcm = fSigma*gRandom->Gaus();
+
+     FSI_PRF.X=rxcm*fgkWcons;
+     FSI_PRF.Y=rycm*fgkWcons;
+     FSI_PRF.Z=rzcm*fgkWcons;
+     FSI_PRF.T=0.;
+
+     Double_t rps=rxcm*rxcm+rycm*rycm+rzcm*rzcm;
+     Double_t rp=TMath::Sqrt(rps);
+     setpdist(rp);
+   }
+               
+  fsiw();
+  return LEDWEIGHT.WEIN;
+}
 /************************************************************/
-void AliHBTLLWeights::Init()
- {
-//---------------------------------------------------------------------
 
+void AliHBTLLWeights::Init()
+{
 //initial parameters of model
 
-  FSI_NS.NS = approximationModel;  
+  FSI_NS.NS = fApproximationModel;      
   
-  if(!ftest) LEDWEIGHT.ITEST=0;
-    
-  if(ftest)
+  LEDWEIGHT.ITEST = fTest;  
+  if(fTest)
    {
-     LEDWEIGHT.ITEST=1;
-     if(fColoumbSwitch) FSI_NS.ICH =1;
-     else FSI_NS.ICH=0;
-     
-     if(fStrongInterSwitch) FSI_NS.ISI=1;
-     else FSI_NS.ISI=0;
-   
-     if(fQuantStatSwitch) FSI_NS.IQS=1;
-     else FSI_NS.IQS=0;
-   
-     if(fColWithResidNuclSwitch) FSI_NS.I3C=1;
-     else FSI_NS.I3C=0;
+     FSI_NS.ICH = fColoumbSwitch;
+     FSI_NS.ISI = fStrongInterSwitch;
+     FSI_NS.IQS = fQuantStatSwitch;
+     FSI_NS.I3C = fColWithResidNuclSwitch;
+     LEDWEIGHT.IRANPOS = fRandomPosition;
    }
-  
-  if(fRandomPosition) LEDWEIGHT.IRANPOS=1;
-  else LEDWEIGHT.IRANPOS=0;
-
   if ( (fPID1 == 0) || (fPID2 == 0) )
    {
-    Fatal("Init","Particles types are not set");
-    return;//pro forma
+     Fatal("Init","Particles types are not set");
+     return;//pro forma
    }
-
   FSI_NS.LL = GetPairCode(fPID1,fPID2);
-   
+       
   if (FSI_NS.LL == 0) 
    {
      Fatal("Init","Particles types are not supported");
      return;//pro forma
    }
 
+
   TParticlePDG* tpart1 = TDatabasePDG::Instance()->GetParticle(fPID1);
   if (tpart1 == 0x0)
    {
-     Fatal("init","We can not find particle with ID=%d in our DataBase",fPID1);
+     Fatal("init","We can not find particle with ID=%d in PDG DataBase",fPID1);
      return;
    }
-  
+      
   FSI_POC.AM1=tpart1->Mass();
   FSI_POC.C1=tpart1->Charge(); 
 
   TParticlePDG* tpart2 = TDatabasePDG::Instance()->GetParticle(fPID2);
+//lv
   if (tpart2 == 0x0)
    {
      Fatal("init","We can not find particle with ID=%d in our DataBase",fPID2);
@@ -199,18 +342,21 @@ void AliHBTLLWeights::Init()
 
   if(fRandomPosition)
    {
-    fsigma =TMath::Sqrt(2.)*fRadius;     
-    fwcons =FSI_CONS.W;
+     fSigma =TMath::Sqrt(2.)*fRadius;     
    } 
 } 
+/************************************************************/
 
 Int_t AliHBTLLWeights::GetPairCode(const AliHBTPair* partpair)
 {
+//returns Code corresponding to that pair
  return GetPairCode(partpair->Particle1()->GetPdgCode(),partpair->Particle2()->GetPdgCode());
 }
+/************************************************************/
 
 Int_t AliHBTLLWeights::GetPairCode(Int_t pid1,Int_t pid2)
 {
+// returns code corresponding to the pair of PIDs
 //   pairCode   1  2  3  4   5    6   7  8  9 10  11  12  13  14 15 16 17 18  19  20   21   22  23 24 25 26    27     28
 //   hpid:      n  p  n alfa pi+ pi0 pi+ n  p pi+ pi+ pi+ pi- K+ K+ K+ K-  d  d    t   t    K0  K0  d p  p      p      n
 //   lpid:      n  p  p alfa pi- pi0 pi+ d  d  K-  K+  p   p  K- K+ p  p   d alfa  t  alfa  K0  K0b t t alfa lambda lambda
@@ -241,6 +387,11 @@ Int_t AliHBTLLWeights::GetPairCode(Int_t pid1,Int_t pid2)
     swap = kTRUE;
    }
 
+//mlv
+   hpid=pid1;
+   lpid=pid2;
+
+
 //Determine the pair code
   switch (hpid) //switch on first  particle id
    {
@@ -284,6 +435,7 @@ Int_t AliHBTLLWeights::GetPairCode(Int_t pid1,Int_t pid2)
       break;
 
      case kPiPlus:
+     
       switch (lpid)
        {
          case kPiPlus:
@@ -381,4 +533,85 @@ Int_t AliHBTLLWeights::GetPairCode(Int_t pid1,Int_t pid2)
    }
   return code;
 }
+/************************************************************/
+
+void AliHBTLLWeights::SetTest(Bool_t rtest)
+{
+  //Sets fTest member
+  fTest = rtest;
+} 
+/************************************************************/
+
+void AliHBTLLWeights::SetColoumb(Bool_t col)
+{
+  // (ICH in fortran code) Coulomb interaction between the two particles ON (OFF)
+  fColoumbSwitch = col;
+}
+/************************************************************/
+
+void AliHBTLLWeights::SetQuantumStatistics(Bool_t qss)
+{
+  //IQS: quantum statistics for the two particles ON (OFF) 
+  //if non-identical particles automatically off
+  fQuantStatSwitch = qss;
+}
+/************************************************************/
+
+void AliHBTLLWeights::SetStrongInterSwitch(Bool_t sis)
+{
+  //ISI: strong interaction between the two particles ON (OFF)
+  fStrongInterSwitch = sis;
+}
+/************************************************************/
+
+void AliHBTLLWeights::SetColWithResidNuclSwitch(Bool_t crn)
+{
+  //I3C: Coulomb interaction with residual nucleus ON (OFF)  
+  fColWithResidNuclSwitch = crn;
+}
+/************************************************************/
+
+void AliHBTLLWeights::SetApproxModel(Int_t ap)
+{
+  //sets  Model of Approximation (NS in Fortran code)
+  fApproximationModel=ap;
+}
+/************************************************************/
+     
+void AliHBTLLWeights::SetRandomPosition(Bool_t rp)
+{ 
+ //ON=kTRUE(OFF=kFALSE)
+ //ON -- calculation of the Gauss source radii 
+ //if the generator don't allows the source generation (for example MeVSim)
+ //if ON the following parameters are requested:
+ fRandomPosition = rp;
+}
+/************************************************************/
 
+void AliHBTLLWeights::SetR1dw(Double_t R)
+{
+  //spherical source model radii
+  fRadius=R;
+}
+/************************************************************/
+
+void AliHBTLLWeights::SetParticlesTypes(Int_t pid1, Int_t pid2)
+{
+  //set AliRoot particles types   
+  fPID1 = pid1; 
+  fPID2 = pid2;
+}
+/************************************************************/
+    
+void AliHBTLLWeights::SetNucleusCharge(Double_t ch)
+{
+  // not used now  (see comments in fortran code)
+  fNuclCharge=ch;
+}
+/************************************************************/
+
+void AliHBTLLWeights::SetNucleusMass(Double_t mass)
+{
+  // (see comments in fortran code)
+  fNuclMass=mass;
+}