Geant4  10.01
G4GoudsmitSaundersonMscModel.cc
Go to the documentation of this file.
1 //
2 // ********************************************************************
3 // * License and Disclaimer *
4 // * *
5 // * The Geant4 software is copyright of the Copyright Holders of *
6 // * the Geant4 Collaboration. It is provided under the terms and *
7 // * conditions of the Geant4 Software License, included in the file *
8 // * LICENSE and available at http://cern.ch/geant4/license . These *
9 // * include a list of copyright holders. *
10 // * *
11 // * Neither the authors of this software system, nor their employing *
12 // * institutes,nor the agencies providing financial support for this *
13 // * work make any representation or warranty, express or implied, *
14 // * regarding this software system or assume any liability for its *
15 // * use. Please see the license in the file LICENSE and URL above *
16 // * for the full disclaimer and the limitation of liability. *
17 // * *
18 // * This code implementation is the result of the scientific and *
19 // * technical work of the GEANT4 collaboration. *
20 // * By using, copying, modifying or distributing the software (or *
21 // * any work based on the software) you agree to acknowledge its *
22 // * use in resulting scientific publications, and indicate your *
23 // * acceptance of all terms of the Geant4 Software license. *
24 // ********************************************************************
25 //
26 // $Id: G4GoudsmitSaundersonMscModel.cc 86365 2014-11-10 08:43:52Z gcosmo $
27 //
28 // -------------------------------------------------------------------
29 //
30 // GEANT4 Class file
31 //
32 // File name: G4GoudsmitSaundersonMscModel
33 //
34 // Author: Omrane Kadri
35 //
36 // Creation date: 20.02.2009
37 //
38 // Modifications:
39 // 04.03.2009 V.Ivanchenko cleanup and format according to Geant4 EM style
40 //
41 // 15.04.2009 O.Kadri: cleanup: discard no scattering and single scattering theta
42 // sampling from SampleCosineTheta() which means the splitting
43 // step into two sub-steps occur only for msc regime
44 //
45 // 12.06.2009 O.Kadri: linear log-log extrapolation of lambda0 & lambda1 between 1 GeV - 100 TeV
46 // adding a theta min limit due to screening effect of the atomic nucleus
47 // 26.08.2009 O.Kadri: Cubic Spline interpolation was replaced with polynomial method
48 // within CalculateIntegrals method
49 // 05.10.2009 O.Kadri: tuning small angle theta distributions
50 // assuming the case of lambdan<1 as single scattering regime
51 // tuning theta sampling for theta below the screening angle
52 // 08.02.2010 O.Kadri: bugfix in compound xsection calculation and small angle computation
53 // adding a rejection condition to hard collision angular sampling
54 // ComputeTruePathLengthLimit was taken from G4WentzelVIModel
55 // 26.03.2010 O.Kadri: direct xsection calculation not inverse of the inverse
56 // angular sampling without large angle rejection method
57 // longitudinal displacement is computed exactly from <z>
58 // 12.05.2010 O.Kadri: exchange between target and projectile has as a condition the particle type (e-/e-)
59 // some cleanup to minimize time consuming (adding lamdan12 & Qn12, changing the error to 1.0e-12 for scrA)
60 //
61 //
62 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
63 //REFERENCES:
64 //Ref.1:E. Benedito et al.,"Mixed simulation ... cross-sections", NIMB 174 (2001) pp 91-110;
65 //Ref.2:I. Kawrakow et al.,"On the condensed ... transport",NIMB 142 (1998) pp 253-280;
66 //Ref.3:I. Kawrakow et al.,"On the representation ... calculations",NIMB 134 (1998) pp 325-336;
67 //Ref.4:Bielajew et al.,".....", NIMB 173 (2001) 332-343;
68 //Ref.5:F. Salvat et al.,"ELSEPA--Dirac partial ...molecules", Comp.Phys.Comm.165 (2005) pp 157-190;
69 //Ref.6:G4UrbanMscModel G4 9.2;
70 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
73 
74 #include "G4PhysicalConstants.hh"
75 #include "G4SystemOfUnits.hh"
76 
78 #include "G4MaterialCutsCouple.hh"
79 #include "G4DynamicParticle.hh"
80 #include "G4Electron.hh"
81 #include "G4Positron.hh"
82 
83 #include "G4LossTableManager.hh"
84 #include "G4Track.hh"
85 #include "G4PhysicsTable.hh"
86 #include "Randomize.hh"
87 #include "G4Log.hh"
88 #include "G4Exp.hh"
89 #include <fstream>
90 
91 using namespace std;
92 
98 
99 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
101  : G4VMscModel(nam),lowKEnergy(0.1*keV),highKEnergy(100.*TeV)
102 {
106  =lambda11=mass=0.0;
108 
109  fr=0.02,rangeinit=0.,masslimite=0.6*MeV,
110  particle=0;tausmall=1.e-16;taulim=1.e-6;tlimit=1.e10*mm;
111  tlimitmin=10.e-6*mm;geombig=1.e50*mm;geommin=1.e-3*mm,tgeom=geombig;
114  inside=false;insideskin=false;
115  samplez=false;
116  firstStep = true;
117 
118  currentCouple = 0;
119  fParticleChange = 0;
120 
122 
123  if(ener[0] < 0.0){
124  G4cout << "### G4GoudsmitSaundersonMscModel loading ELSEPA data" << G4endl;
126  }
127 }
128 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
130 {
131  delete GSTable;
132 }
133 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
135  const G4DataVector&)
136 {
138  SetParticle(p);
140 }
141 
142 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
143 
144 G4double
146  G4double kineticEnergy,G4double Z, G4double, G4double, G4double)
147 {
148  G4double kinEnergy = kineticEnergy;
149  if(kinEnergy<lowKEnergy) kinEnergy=lowKEnergy;
150  if(kinEnergy>highKEnergy)kinEnergy=highKEnergy;
151 
152  G4double cs(0.0), cs0(0.0);
153  CalculateIntegrals(p,Z,kinEnergy,cs0,cs);
154 
155  return cs;
156 }
157 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
158 
161 {
162  fDisplacement.set(0.0,0.0,0.0);
163  G4double kineticEnergy = currentKinEnergy;
164 
165  //G4cout << "G4GoudsmitSaundersonMscModel::SampleScattering E= "
166  //<< kineticEnergy<<G4endl;
167 
168  //dynParticle->GetKineticEnergy();
169  if((kineticEnergy <= 0.0) || (tPathLength <= tlimitminfix)||
170  (tPathLength/tausmall < lambda1)) { return fDisplacement; }
171 
173  // Effective energy
174  G4double eloss = 0.0;
175  if (tPathLength > currentRange*dtrl) {
176  eloss = kineticEnergy -
178  } else {
179  eloss = tPathLength*GetDEDX(particle,kineticEnergy,currentCouple);
180  }
181  /*
182  G4double ttau = kineticEnergy/electron_mass_c2;
183  G4double ttau2 = ttau*ttau;
184  G4double epsilonpp = eloss/kineticEnergy;
185  G4double cst1 = epsilonpp*epsilonpp*(6+10*ttau+5*ttau2)/(24*ttau2+48*ttau+72);
186  kineticEnergy *= (1 - cst1);
187  */
188  kineticEnergy -= 0.5*eloss;
189 
191  // additivity rule for mixture and compound xsection's
192  const G4Material* mat = currentCouple->GetMaterial();
193  const G4ElementVector* theElementVector = mat->GetElementVector();
194  const G4double* theAtomNumDensityVector = mat->GetVecNbOfAtomsPerVolume();
195  G4int nelm = mat->GetNumberOfElements();
196  G4double s0(0.0), s1(0.0);
197  lambda0 = 0.0;
198  for(G4int i=0;i<nelm;i++)
199  {
200  CalculateIntegrals(particle,(*theElementVector)[i]->GetZ(),kineticEnergy,s0,s1);
201  lambda0 += (theAtomNumDensityVector[i]*s0);
202  }
203  if(lambda0>0.0) { lambda0 =1./lambda0; }
204 
205  // Newton-Raphson root's finding method of scrA from:
206  // Sig1(PWA)/Sig0(PWA)=g1=2*scrA*((1+scrA)*log(1+1/scrA)-1)
207  G4double g1=0.0;
208  if(lambda1>0.0) { g1 = lambda0/lambda1; }
209 
210  G4double logx0,x1,delta;
211  G4double x0=g1*0.5;
212  // V.Ivanchenko added limit of the loop
213  for(G4int i=0;i<1000;++i)
214  {
215  logx0 = G4Log(1.+1./x0);
216  x1 = x0-(x0*((1.+x0)*logx0-1.0)-g1*0.5)/( (1.+2.*x0)*logx0-2.0);
217 
218  // V.Ivanchenko cut step size of iterative procedure
219  if(x1 < 0.0) { x1 = 0.5*x0; }
220  else if(x1 > 2*x0) { x1 = 2*x0; }
221  else if(x1 < 0.5*x0) { x1 = 0.5*x0; }
222  delta = std::fabs( x1 - x0 );
223  x0 = x1;
224  if(delta < 1.0e-3*x1) { break;}
225  }
226  G4double scrA = x1;
227 
228  G4double lambdan=0.;
229 
230  if(lambda0>0.0) { lambdan=tPathLength/lambda0; }
231  if(lambdan<=1.0e-12) { return fDisplacement; }
232 
233  // G4cout << "E(eV)= " << kineticEnergy/eV << " L0= " << lambda0
234  // << " L1= " << lambda1 << G4endl;
235 
236  G4double cosTheta1,sinTheta1,cosTheta2,sinTheta2;
237 
238  G4double epsilon1=G4UniformRand();
239  G4double expn = G4Exp(-lambdan);
240 
241  //G4cout << "expn= " << expn << " epsilon1= " << epsilon1 << " lambdan= " << lambdan
242  // << " scrA= " << scrA << G4endl;
243 
244  G4ThreeVector newDirection(0.0,0.0,1.0);
245 
246  if(epsilon1<expn)// no scattering
247  { return fDisplacement; }
248 
249  //single or plural scattering (Rutherford DCS's)
250  else if((epsilon1<((1.+lambdan)*expn))||(lambdan<1.))
251  {
252  G4double xi=G4UniformRand();
253  xi= 2.*scrA*xi/(1.-xi + scrA);
254  if(xi<0.)xi=0.;
255  else if(xi>2.)xi=2.;
256  G4double ws=(1. - xi);
257  G4double wss=std::sqrt(xi*(2.-xi));
258  G4double phi0=CLHEP::twopi*G4UniformRand();
259  newDirection.set(wss*cos(phi0),wss*sin(phi0),ws);
260  }
261  else // multiple scattering
262  {
263  // Ref.2 subsection 4.4 "The best solution found"
264  // Sample first substep scattering angle
265  SampleCosineTheta(0.5*lambdan,scrA,cosTheta1,sinTheta1);
266  G4double phi1 = CLHEP::twopi*G4UniformRand();
267  G4ThreeVector newDirection1(sinTheta1*cos(phi1),sinTheta1*sin(phi1),cosTheta1);
268 
269  fDisplacement.set(0.0, 0.0, -0.5*zPathLength);
270  fDisplacement += 0.5*zPathLength*newDirection1;
271 
272  // Sample second substep scattering angle
273  SampleCosineTheta(0.5*lambdan,scrA,cosTheta2,sinTheta2);
274  G4double phi2 = CLHEP::twopi*G4UniformRand();
275  newDirection.set(sinTheta2*cos(phi2),sinTheta2*sin(phi2),cosTheta2);
276  newDirection.rotateUz(newDirection1);
277  }
278 
279  newDirection.rotateUz(oldDirection);
281  fDisplacement.rotateUz(oldDirection);
282 
283  return fDisplacement;
284 }
285 
286 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
287 
288 void
290  G4double &cost, G4double &sint)
291 {
292  G4double r1,tet,xi=0.;
293  G4double Qn1 = 2.* lambdan;
294  if(scrA < 10.) { Qn1 *= scrA*((1.+scrA)*G4Log(1.+1./scrA)-1.); }
295  else { Qn1*= (1.0 - 0.5/scrA - 0.5/(scrA*scrA)) ; }
296  if (Qn1<0.001)
297  {
298  do{
299  r1=G4UniformRand();
300  xi=-0.5*Qn1*G4Log(G4UniformRand());
301  tet=acos(1.-xi);
302  }while(tet*r1*r1>sin(tet));
303  }
304  else if(Qn1>0.5) { xi=2.*G4UniformRand(); }//isotropic distribution
305  else{ xi=2.*(GSTable->SampleTheta(lambdan,scrA,G4UniformRand()));}
306 
307 
308  if(xi<0.)xi=0.;
309  else if(xi>2.)xi=2.;
310 
311  cost=(1. - xi);
312  sint=sqrt(xi*(2.-xi));
313 
314 }
315 
316 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
317 // Polynomial log-log interpolation of Lambda0 and Lambda1 between 100 eV - 1 GeV
318 // linear log-log extrapolation between 1 GeV - 100 TeV
319 
320 void
322  G4double kinEnergy,G4double &Sig0,
323  G4double &Sig1)
324 {
325  G4double x1,x2,y1,y2,acoeff,bcoeff;
326  G4double kineticE = kinEnergy;
327  if(kineticE<lowKEnergy)kineticE=lowKEnergy;
328  if(kineticE>highKEnergy)kineticE=highKEnergy;
329  kineticE /= eV;
330  G4double logE=G4Log(kineticE);
331 
332  G4int iZ = G4int(Z);
333  if(iZ > 103) iZ = 103;
334 
335  G4int enerInd=0;
336  for(G4int i=0;i<105;i++)
337  {
338  if((logE>=ener[i])&&(logE<ener[i+1])){enerInd=i;break;}
339  }
340 
341  if(p==G4Electron::Electron())
342  {
343  if(kineticE<=1.0e+9)//Interpolation of the form y=ax²+b
344  {
345  x1=ener[enerInd];
346  x2=ener[enerInd+1];
347  y1=TCSE[iZ-1][enerInd];
348  y2=TCSE[iZ-1][enerInd+1];
349  acoeff=(y2-y1)/(x2*x2-x1*x1);
350  bcoeff=y2-acoeff*x2*x2;
351  Sig0=acoeff*logE*logE+bcoeff;
352  Sig0 =G4Exp(Sig0);
353  y1=FTCSE[iZ-1][enerInd];
354  y2=FTCSE[iZ-1][enerInd+1];
355  acoeff=(y2-y1)/(x2*x2-x1*x1);
356  bcoeff=y2-acoeff*x2*x2;
357  Sig1=acoeff*logE*logE+bcoeff;
358  Sig1=G4Exp(Sig1);
359  }
360  else //Interpolation of the form y=ax+b
361  {
362  x1=ener[104];
363  x2=ener[105];
364  y1=TCSE[iZ-1][104];
365  y2=TCSE[iZ-1][105];
366  Sig0=(y2-y1)*(logE-x1)/(x2-x1)+y1;
367  Sig0=G4Exp(Sig0);
368  y1=FTCSE[iZ-1][104];
369  y2=FTCSE[iZ-1][105];
370  Sig1=(y2-y1)*(logE-x1)/(x2-x1)+y1;
371  Sig1=G4Exp(Sig1);
372  }
373  }
374  if(p==G4Positron::Positron())
375  {
376  if(kinEnergy<=1.0e+9)
377  {
378  x1=ener[enerInd];
379  x2=ener[enerInd+1];
380  y1=TCSP[iZ-1][enerInd];
381  y2=TCSP[iZ-1][enerInd+1];
382  acoeff=(y2-y1)/(x2*x2-x1*x1);
383  bcoeff=y2-acoeff*x2*x2;
384  Sig0=acoeff*logE*logE+bcoeff;
385  Sig0 =G4Exp(Sig0);
386  y1=FTCSP[iZ-1][enerInd];
387  y2=FTCSP[iZ-1][enerInd+1];
388  acoeff=(y2-y1)/(x2*x2-x1*x1);
389  bcoeff=y2-acoeff*x2*x2;
390  Sig1=acoeff*logE*logE+bcoeff;
391  Sig1=G4Exp(Sig1);
392  }
393  else
394  {
395  x1=ener[104];
396  x2=ener[105];
397  y1=TCSP[iZ-1][104];
398  y2=TCSP[iZ-1][105];
399  Sig0=(y2-y1)*(logE-x1)/(x2-x1)+y1;
400  Sig0 =G4Exp(Sig0);
401  y1=FTCSP[iZ-1][104];
402  y2=FTCSP[iZ-1][105];
403  Sig1=(y2-y1)*(logE-x1)/(x2-x1)+y1;
404  Sig1=G4Exp(Sig1);
405  }
406  }
407 
408  Sig0 *= barn;
409  Sig1 *= barn;
410 
411 }
412 
413 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
414 
416 {
418  firstStep = true;
419  inside = false;
420  insideskin = false;
421  tlimit = geombig;
422 }
423 
424 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
425 //t->g->t step transformations taken from Ref.6
426 
427 G4double
429  G4double& currentMinimalStep)
430 {
431  tPathLength = currentMinimalStep;
432  const G4DynamicParticle* dp = track.GetDynamicParticle();
433  G4StepPoint* sp = track.GetStep()->GetPreStepPoint();
434  G4StepStatus stepStatus = sp->GetStepStatus();
440 
442 
443  // stop here if small range particle
444  if(inside || tPathLength < tlimitminfix) {
445  return ConvertTrueToGeom(tPathLength, currentMinimalStep);
446  }
448 
449  G4double presafety = sp->GetSafety();
450 
451  //G4cout << "G4GS::StepLimit tPathLength= "
452  // <<tPathLength<<" safety= " << presafety
453  // << " range= " <<currentRange<< " lambda= "<<lambda1
454  // << " Alg: " << steppingAlgorithm <<G4endl;
455 
456  // far from geometry boundary
457  if(currentRange < presafety)
458  {
459  inside = true;
460  return ConvertTrueToGeom(tPathLength, currentMinimalStep);
461  }
462 
463  // standard version
464  //
466  {
467  //compute geomlimit and presafety
468  G4double geomlimit = ComputeGeomLimit(track, presafety, tPathLength);
469 
470  // is far from boundary
471  if(currentRange <= presafety)
472  {
473  inside = true;
474  return ConvertTrueToGeom(tPathLength, currentMinimalStep);
475  }
476 
477  smallstep += 1.;
478  insideskin = false;
479 
480  if(firstStep || stepStatus == fGeomBoundary)
481  {
483  if(firstStep) smallstep = 1.e10;
484  else smallstep = 1.;
485 
486  //define stepmin here (it depends on lambda!)
487  //rough estimation of lambda_elastic/lambda_transport
489  rat = 1.e-3/(rat*(10.+rat)) ;
490  //stepmin ~ lambda_elastic
491  stepmin = rat*lambda1;
493  //define tlimitmin
494  tlimitmin = 10.*stepmin;
496 
497  //G4cout << "rangeinit= " << rangeinit << " stepmin= " << stepmin
498  // << " tlimitmin= " << tlimitmin << " geomlimit= " << geomlimit <<G4endl;
499  // constraint from the geometry
500  if((geomlimit < geombig) && (geomlimit > geommin))
501  {
502  if(stepStatus == fGeomBoundary)
503  tgeom = geomlimit/facgeom;
504  else
505  tgeom = 2.*geomlimit/facgeom;
506  }
507  else
508  tgeom = geombig;
509 
510  }
511 
512  //step limit
514  if(tlimit < facsafety*presafety)
515  tlimit = facsafety*presafety;
516 
517  //lower limit for tlimit
519 
520  if(tlimit > tgeom) tlimit = tgeom;
521 
522  //G4cout << "tgeom= " << tgeom << " geomlimit= " << geomlimit
523  // << " tlimit= " << tlimit << " presafety= " << presafety << G4endl;
524 
525  // shortcut
526  if((tPathLength < tlimit) && (tPathLength < presafety) &&
527  (smallstep >= skin) && (tPathLength < geomlimit-0.999*skindepth))
528  return ConvertTrueToGeom(tPathLength, currentMinimalStep);
529 
530  // step reduction near to boundary
531  if(smallstep < skin)
532  {
533  tlimit = stepmin;
534  insideskin = true;
535  }
536  else if(geomlimit < geombig)
537  {
538  if(geomlimit > skindepth)
539  {
540  if(tlimit > geomlimit-0.999*skindepth)
541  tlimit = geomlimit-0.999*skindepth;
542  }
543  else
544  {
545  insideskin = true;
546  if(tlimit > stepmin) tlimit = stepmin;
547  }
548  }
549 
550  if(tlimit < stepmin) tlimit = stepmin;
551 
553 
554  }
555  // for 'normal' simulation with or without magnetic field
556  // there no small step/single scattering at boundaries
557  else if(steppingAlgorithm == fUseSafety)
558  {
559  // compute presafety again if presafety <= 0 and no boundary
560  // i.e. when it is needed for optimization purposes
561  if((stepStatus != fGeomBoundary) && (presafety < tlimitminfix))
562  presafety = ComputeSafety(sp->GetPosition(),tPathLength);
563 
564  // is far from boundary
565  if(currentRange < presafety)
566  {
567  inside = true;
568  return ConvertTrueToGeom(tPathLength, currentMinimalStep);
569  }
570 
571  if(firstStep || stepStatus == fGeomBoundary)
572  {
574  fr = facrange;
575  // 9.1 like stepping for e+/e- only (not for muons,hadrons)
576  if(mass < masslimite)
577  {
578  if(lambda1 > currentRange)
579  rangeinit = lambda1;
580  if(lambda1 > lambdalimit)
581  fr *= 0.75+0.25*lambda1/lambdalimit;
582  }
583 
584  //lower limit for tlimit
586  rat = 1.e-3/(rat*(10.+rat)) ;
587  tlimitmin = 10.*lambda1*rat;
589  }
590  //step limit
591  tlimit = fr*rangeinit;
592 
593  if(tlimit < facsafety*presafety)
594  tlimit = facsafety*presafety;
595 
596  //lower limit for tlimit
598 
600  }
601 
602  // version similar to 7.1 (needed for some experiments)
603  else
604  {
605  if (stepStatus == fGeomBoundary)
606  {
608  else tlimit = facrange*lambda1;
609 
612  }
613  }
614  //G4cout << "tPathLength= " << tPathLength
615  // << " currentMinimalStep= " << currentMinimalStep << G4endl;
616  return ConvertTrueToGeom(tPathLength, currentMinimalStep);
617 }
618 
619 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
620 // taken from Ref.6
622 {
623  firstStep = false;
624  par1 = -1. ;
625  par2 = par3 = 0. ;
626 
627  // do the true -> geom transformation
629 
630  // z = t for very small tPathLength
631  if(tPathLength < tlimitminfix) { return zPathLength; }
632 
633  // this correction needed to run MSC with eIoni and eBrem inactivated
634  // and makes no harm for a normal run
637 
639 
640  if ((tau <= tausmall) || insideskin) {
643  return zPathLength;
644  }
645 
646  G4double zmean = tPathLength;
647  if (tPathLength < currentRange*dtrl) {
648  if(tau < taulim) zmean = tPathLength*(1.-0.5*tau) ;
649  else zmean = lambda1*(1.-G4Exp(-tau));
650  } else if(currentKinEnergy < mass || tPathLength == currentRange) {
651  par1 = 1./currentRange ;
652  par2 = 1./(par1*lambda1) ;
653  par3 = 1.+par2 ;
655  zmean = (1.-G4Exp(par3*G4Log(1.-tPathLength/currentRange)))/(par1*par3) ;
656  else
657  zmean = 1./(par1*par3) ;
658  } else {
660 
662 
664  par2 = 1./(par1*lambda1) ;
665  par3 = 1.+par2 ;
666  zmean = (1.-G4Exp(par3*G4Log(lambda11/lambda1)))/(par1*par3) ;
667  }
668 
669  zPathLength = zmean ;
670  // sample z
671  if(samplez) {
672 
673  const G4double ztmax = 0.99;
674  G4double zt = zmean/tPathLength ;
675 
676  if (tPathLength > stepmin && zt < ztmax) {
677 
678  G4double u,cz1;
679  if(zt >= 0.333333333) {
680 
681  G4double cz = 0.5*(3.*zt-1.)/(1.-zt) ;
682  cz1 = 1.+cz ;
683  G4double u0 = cz/cz1 ;
684  G4double grej ;
685  do {
686  u = G4Exp(G4Log(G4UniformRand())/cz1) ;
687  grej = exp(cz*G4Log(u/u0))*(1.-u)/(1.-u0) ;
688  } while (grej < G4UniformRand()) ;
689 
690  } else {
691  cz1 = 1./zt-1.;
692  u = 1.-G4Exp(G4Log(G4UniformRand())/cz1) ;
693  }
695  }
696  }
698  //G4cout << "zPathLength= " << zPathLength << " lambda1= " << lambda1 << G4endl;
699 
700  return zPathLength;
701 }
702 
703 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
704 // taken from Ref.6
705 G4double
707 {
708  // step defined other than transportation
709  if(geomStepLength == zPathLength && tPathLength <= currentRange)
710  return tPathLength;
711 
712  // t = z for very small step
713  zPathLength = geomStepLength;
714  tPathLength = geomStepLength;
715  if(geomStepLength < tlimitminfix) return tPathLength;
716 
717  // recalculation
718  if((geomStepLength > lambda1*tausmall) && !insideskin)
719  {
720  if(par1 < 0.)
721  tPathLength = -lambda1*G4Log(1.-geomStepLength/lambda1) ;
722  else
723  {
724  if(par1*par3*geomStepLength < 1.)
725  tPathLength = (1.-G4Exp(G4Log(1.-par1*par3*geomStepLength)/par3))/par1 ;
726  else
728  }
729  }
730  if(tPathLength < geomStepLength) tPathLength = geomStepLength;
731  //G4cout << "tPathLength= " << tPathLength << " step= " << geomStepLength << G4endl;
732 
733  return tPathLength;
734 }
735 
736 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
737 //Total & first transport x sections for e-/e+ generated from ELSEPA code
738 
740 {
741  G4String filename = "XSECTIONS.dat";
742 
743  char* path = getenv("G4LEDATA");
744  if (!path)
745  {
746  G4Exception("G4GoudsmitSaundersonMscModel::LoadELSEPAXSections()","em0006",
748  "Environment variable G4LEDATA not defined");
749  return;
750  }
751 
752  G4String pathString(path);
753  G4String dirFile = pathString + "/msc_GS/" + filename;
754  std::ifstream infile(dirFile, std::ios::in);
755  if( !infile.is_open()) {
757  ed << "Data file <" + dirFile + "> is not opened!";
758  G4Exception("G4GoudsmitSaundersonMscModel::LoadELSEPAXSections()",
759  "em0003",FatalException,ed);
760  return;
761  }
762 
763  // Read parameters from tables and take logarithms
764  G4double aRead;
765  for(G4int i=0 ; i<106 ;i++){
766  infile >> aRead;
767  if(infile.fail()) {
769  ed << "Error reading <" + dirFile + "> loop #1 i= " << i;
770  G4Exception("G4GoudsmitSaundersonMscModel::LoadELSEPAXSections()",
771  "em0003",FatalException,ed);
772  return;
773  } else {
774  if(aRead > 0.0) { aRead = G4Log(aRead); }
775  else { aRead = 0.0; }
776  }
777  ener[i]=aRead;
778  }
779  for(G4int j=0;j<103;j++){
780  for(G4int i=0;i<106;i++){
781  infile >> aRead;
782  if(infile.fail()) {
784  ed << "Error reading <" + dirFile + "> loop #2 j= " << j
785  << "; i= " << i;
786  G4Exception("G4GoudsmitSaundersonMscModel::LoadELSEPAXSections()",
787  "em0003",FatalException,ed);
788  return;
789  } else {
790  if(aRead > 0.0) { aRead = G4Log(aRead); }
791  else { aRead = 0.0; }
792  }
793  TCSE[j][i]=aRead;
794  }
795  }
796  for(G4int j=0;j<103;j++){
797  for(G4int i=0;i<106;i++){
798  infile >> aRead;
799  if(infile.fail()) {
801  ed << "Error reading <" + dirFile + "> loop #3 j= " << j
802  << "; i= " << i;
803  G4Exception("G4GoudsmitSaundersonMscModel::LoadELSEPAXSections()",
804  "em0003",FatalException,ed);
805  return;
806  } else {
807  if(aRead > 0.0) { aRead = G4Log(aRead); }
808  else { aRead = 0.0; }
809  }
810  FTCSE[j][i]=aRead;
811  }
812  }
813  for(G4int j=0;j<103;j++){
814  for(G4int i=0;i<106;i++){
815  infile >> aRead;
816  if(infile.fail()) {
818  ed << "Error reading <" + dirFile + "> loop #4 j= " << j
819  << "; i= " << i;
820  G4Exception("G4GoudsmitSaundersonMscModel::LoadELSEPAXSections()",
821  "em0003",FatalException,ed);
822  return;
823  } else {
824  if(aRead > 0.0) { aRead = G4Log(aRead); }
825  else { aRead = 0.0; }
826  }
827  TCSP[j][i]=aRead;
828  }
829  }
830  for(G4int j=0;j<103;j++){
831  for(G4int i=0;i<106;i++){
832  infile >> aRead;
833  if(infile.fail()) {
835  ed << "Error reading <" + dirFile + "> loop #5 j= " << j
836  << "; i= " << i;
837  G4Exception("G4GoudsmitSaundersonMscModel::LoadELSEPAXSections()",
838  "em0003",FatalException,ed);
839  return;
840  } else {
841  if(aRead > 0.0) { aRead = G4Log(aRead); }
842  else { aRead = 0.0; }
843  }
844  FTCSP[j][i]=aRead;
845  }
846  }
847 
848  infile.close();
849 }
850 
851 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
G4GoudsmitSaundersonMscModel(const G4String &nam="GoudsmitSaunderson")
void CalculateIntegrals(const G4ParticleDefinition *, G4double, G4double, G4double &, G4double &)
G4double facgeom
Definition: G4VMscModel.hh:178
virtual G4double ComputeTrueStepLength(G4double geomStepLength)
static const double MeV
Definition: G4SIunits.hh:193
static G4LossTableManager * Instance()
std::vector< G4Element * > G4ElementVector
std::ostringstream G4ExceptionDescription
Definition: globals.hh:76
G4double GetKineticEnergy() const
CLHEP::Hep3Vector G4ThreeVector
G4double dtrl
Definition: G4VMscModel.hh:181
const G4DynamicParticle * GetDynamicParticle() const
G4double facrange
Definition: G4VMscModel.hh:177
G4StepStatus GetStepStatus() const
G4bool samplez
Definition: G4VMscModel.hh:189
G4double ConvertTrueToGeom(G4double &tLength, G4double &gLength)
Definition: G4VMscModel.hh:247
G4double skin
Definition: G4VMscModel.hh:180
const G4MaterialCutsCouple * GetMaterialCutsCouple() const
const G4ParticleDefinition * particle
G4double SampleTheta(G4double, G4double, G4double)
G4ParticleDefinition * GetDefinition() const
const G4Step * GetStep() const
G4double ComputeSafety(const G4ThreeVector &position, G4double limit=DBL_MAX)
Definition: G4VMscModel.hh:239
const G4ElementVector * GetElementVector() const
Definition: G4Material.hh:188
int G4int
Definition: G4Types.hh:78
G4StepStatus
Definition: G4StepStatus.hh:49
G4StepPoint * GetPreStepPoint() const
G4double GetEnergy(const G4ParticleDefinition *part, G4double range, const G4MaterialCutsCouple *couple)
Definition: G4VMscModel.hh:309
static const G4double scrA[76 *11]
virtual G4double ComputeTruePathLengthLimit(const G4Track &track, G4double &currentMinimalStep)
const G4double * GetVecNbOfAtomsPerVolume() const
Definition: G4Material.hh:204
#define G4UniformRand()
Definition: Randomize.hh:95
G4GLOB_DLL std::ostream G4cout
const G4ThreeVector & GetPosition() const
G4double GetRange(const G4ParticleDefinition *part, G4double kineticEnergy, const G4MaterialCutsCouple *couple)
Definition: G4VMscModel.hh:289
G4ParticleChangeForMSC * GetParticleChangeForMSC(const G4ParticleDefinition *p=0)
Definition: G4VMscModel.cc:89
virtual void Initialise(const G4ParticleDefinition *, const G4DataVector &)
G4double ComputeGeomLimit(const G4Track &, G4double &presafety, G4double limit)
Definition: G4VMscModel.hh:257
G4ThreeVector fDisplacement
Definition: G4VMscModel.hh:186
G4double GetTransportMeanFreePath(const G4ParticleDefinition *part, G4double kinEnergy)
Definition: G4VMscModel.hh:346
void G4Exception(const char *originOfException, const char *exceptionCode, G4ExceptionSeverity severity, const char *comments)
Definition: G4Exception.cc:41
G4double G4Log(G4double x)
Definition: G4Log.hh:230
G4double G4Exp(G4double initial_x)
Exponential Function double precision.
Definition: G4Exp.hh:183
void ProposeMomentumDirection(const G4ThreeVector &Pfinal)
static const double eV
Definition: G4SIunits.hh:194
static G4Positron * Positron()
Definition: G4Positron.cc:94
G4double facsafety
Definition: G4VMscModel.hh:179
void SetParticle(const G4ParticleDefinition *p)
G4double GetDEDX(const G4ParticleDefinition *part, G4double kineticEnergy, const G4MaterialCutsCouple *couple)
Definition: G4VMscModel.hh:274
void SetCurrentCouple(const G4MaterialCutsCouple *)
Definition: G4VEmModel.hh:426
virtual G4double ComputeCrossSectionPerAtom(const G4ParticleDefinition *particle, G4double KineticEnergy, G4double AtomicNumber, G4double, G4double, G4double)
G4double GetSafety() const
G4MscStepLimitType steppingAlgorithm
Definition: G4VMscModel.hh:187
static G4Electron * Electron()
Definition: G4Electron.cc:94
#define G4endl
Definition: G4ios.hh:61
static const double TeV
Definition: G4SIunits.hh:197
void SampleCosineTheta(G4double, G4double, G4double &, G4double &)
size_t GetNumberOfElements() const
Definition: G4Material.hh:184
static const double barn
Definition: G4SIunits.hh:95
static const double keV
Definition: G4SIunits.hh:195
virtual G4ThreeVector & SampleScattering(const G4ThreeVector &, G4double safety)
double G4double
Definition: G4Types.hh:76
static const double mm
Definition: G4SIunits.hh:102
const G4MaterialCutsCouple * currentCouple
const G4Material * GetMaterial() const
virtual G4double ComputeGeomPathLength(G4double truePathLength)