Geant4  10.01
G4DiffuseElastic.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: G4DiffuseElastic.cc 84417 2014-10-15 08:22:44Z gcosmo $
27 //
28 //
29 // Physics model class G4DiffuseElastic
30 //
31 //
32 // G4 Model: optical diffuse elastic scattering with 4-momentum balance
33 //
34 // 24-May-07 V. Grichine
35 //
36 
37 #include "G4DiffuseElastic.hh"
38 #include "G4ParticleTable.hh"
39 #include "G4ParticleDefinition.hh"
40 #include "G4IonTable.hh"
41 #include "G4NucleiProperties.hh"
42 
43 #include "Randomize.hh"
44 #include "G4Integrator.hh"
45 #include "globals.hh"
46 #include "G4PhysicalConstants.hh"
47 #include "G4SystemOfUnits.hh"
48 
49 #include "G4Proton.hh"
50 #include "G4Neutron.hh"
51 #include "G4Deuteron.hh"
52 #include "G4Alpha.hh"
53 #include "G4PionPlus.hh"
54 #include "G4PionMinus.hh"
55 
56 #include "G4Element.hh"
57 #include "G4ElementTable.hh"
58 #include "G4NistManager.hh"
59 #include "G4PhysicsTable.hh"
60 #include "G4PhysicsLogVector.hh"
61 #include "G4PhysicsFreeVector.hh"
62 
64 //
65 // Test Constructor. Just to check xsc
66 
67 
69  : G4HadronElastic("DiffuseElastic"), fParticle(0)
70 {
71  SetMinEnergy( 0.01*MeV ); // 0.01*GeV );
72  SetMaxEnergy( 1.*TeV );
73  verboseLevel = 0;
74  lowEnergyRecoilLimit = 100.*keV;
75  lowEnergyLimitQ = 0.0*GeV;
76  lowEnergyLimitHE = 0.0*GeV;
77  lowestEnergyLimit= 0.0*keV;
78  plabLowLimit = 20.0*MeV;
79 
86 
87  fEnergyBin = 200;
88  fAngleBin = 200;
89 
91  fAngleTable = 0;
92 
93  fParticle = 0;
94  fWaveVector = 0.;
95  fAtomicWeight = 0.;
96  fAtomicNumber = 0.;
97  fNuclearRadius = 0.;
98  fBeta = 0.;
99  fZommerfeld = 0.;
100  fAm = 0.;
101  fAddCoulomb = false;
102 }
103 
105 //
106 // Destructor
107 
109 {
110  if ( fEnergyVector ) {
111  delete fEnergyVector;
112  fEnergyVector = 0;
113  }
114 
115  for ( std::vector<G4PhysicsTable*>::iterator it = fAngleBank.begin();
116  it != fAngleBank.end(); ++it ) {
117  if ( (*it) ) (*it)->clearAndDestroy();
118  delete *it;
119  *it = 0;
120  }
121  fAngleTable = 0;
122 }
123 
125 //
126 // Initialisation for given particle using element table of application
127 
129 {
130 
131  // fEnergyVector = new G4PhysicsLogVector( theMinEnergy, theMaxEnergy, fEnergyBin );
132 
133  const G4ElementTable* theElementTable = G4Element::GetElementTable();
134 
135  size_t jEl, numOfEl = G4Element::GetNumberOfElements();
136 
137  for(jEl = 0 ; jEl < numOfEl; ++jEl) // application element loop
138  {
139  fAtomicNumber = (*theElementTable)[jEl]->GetZ(); // atomic number
142 
143  if(verboseLevel > 0)
144  {
145  G4cout<<"G4DiffuseElastic::Initialise() the element: "
146  <<(*theElementTable)[jEl]->GetName()<<G4endl;
147  }
149  fElementNameVector.push_back((*theElementTable)[jEl]->GetName());
150 
151  BuildAngleTable();
152  fAngleBank.push_back(fAngleTable);
153  }
154  return;
155 }
156 
158 //
159 // return differential elastic cross section d(sigma)/d(omega)
160 
161 G4double
163  G4double theta,
164  G4double momentum,
165  G4double A )
166 {
167  fParticle = particle;
168  fWaveVector = momentum/hbarc;
169  fAtomicWeight = A;
170  fAddCoulomb = false;
172 
174 
175  return sigma;
176 }
177 
179 //
180 // return invariant differential elastic cross section d(sigma)/d(tMand)
181 
182 G4double
184  G4double tMand,
185  G4double plab,
186  G4double A, G4double Z )
187 {
188  G4double m1 = particle->GetPDGMass();
189  G4LorentzVector lv1(0.,0.,plab,std::sqrt(plab*plab+m1*m1));
190 
191  G4int iZ = static_cast<G4int>(Z+0.5);
192  G4int iA = static_cast<G4int>(A+0.5);
193  G4ParticleDefinition * theDef = 0;
194 
195  if (iZ == 1 && iA == 1) theDef = theProton;
196  else if (iZ == 1 && iA == 2) theDef = theDeuteron;
197  else if (iZ == 1 && iA == 3) theDef = G4Triton::Triton();
198  else if (iZ == 2 && iA == 3) theDef = G4He3::He3();
199  else if (iZ == 2 && iA == 4) theDef = theAlpha;
200  else theDef = G4ParticleTable::GetParticleTable()->GetIonTable()->GetIon(iZ,iA,0);
201 
202  G4double tmass = theDef->GetPDGMass();
203 
204  G4LorentzVector lv(0.0,0.0,0.0,tmass);
205  lv += lv1;
206 
207  G4ThreeVector bst = lv.boostVector();
208  lv1.boost(-bst);
209 
210  G4ThreeVector p1 = lv1.vect();
211  G4double ptot = p1.mag();
212  G4double ptot2 = ptot*ptot;
213  G4double cost = 1 - 0.5*std::fabs(tMand)/ptot2;
214 
215  if( cost >= 1.0 ) cost = 1.0;
216  else if( cost <= -1.0) cost = -1.0;
217 
218  G4double thetaCMS = std::acos(cost);
219 
220  G4double sigma = GetDiffuseElasticXsc( particle, thetaCMS, ptot, A);
221 
222  sigma *= pi/ptot2;
223 
224  return sigma;
225 }
226 
228 //
229 // return differential elastic cross section d(sigma)/d(omega) with Coulomb
230 // correction
231 
232 G4double
234  G4double theta,
235  G4double momentum,
236  G4double A, G4double Z )
237 {
238  fParticle = particle;
239  fWaveVector = momentum/hbarc;
240  fAtomicWeight = A;
241  fAtomicNumber = Z;
243  fAddCoulomb = false;
244 
245  G4double z = particle->GetPDGCharge();
246 
247  G4double kRt = fWaveVector*fNuclearRadius*theta;
248  G4double kRtC = 1.9;
249 
250  if( z && (kRt > kRtC) )
251  {
252  fAddCoulomb = true;
253  fBeta = CalculateParticleBeta( particle, momentum);
255  fAm = CalculateAm( momentum, fZommerfeld, fAtomicNumber);
256  }
258 
259  return sigma;
260 }
261 
263 //
264 // return invariant differential elastic cross section d(sigma)/d(tMand) with Coulomb
265 // correction
266 
267 G4double
269  G4double tMand,
270  G4double plab,
271  G4double A, G4double Z )
272 {
273  G4double m1 = particle->GetPDGMass();
274 
275  G4LorentzVector lv1(0.,0.,plab,std::sqrt(plab*plab+m1*m1));
276 
277  G4int iZ = static_cast<G4int>(Z+0.5);
278  G4int iA = static_cast<G4int>(A+0.5);
279 
280  G4ParticleDefinition* theDef = 0;
281 
282  if (iZ == 1 && iA == 1) theDef = theProton;
283  else if (iZ == 1 && iA == 2) theDef = theDeuteron;
284  else if (iZ == 1 && iA == 3) theDef = G4Triton::Triton();
285  else if (iZ == 2 && iA == 3) theDef = G4He3::He3();
286  else if (iZ == 2 && iA == 4) theDef = theAlpha;
287  else theDef = G4ParticleTable::GetParticleTable()->GetIonTable()->GetIon(iZ,iA,0);
288 
289  G4double tmass = theDef->GetPDGMass();
290 
291  G4LorentzVector lv(0.0,0.0,0.0,tmass);
292  lv += lv1;
293 
294  G4ThreeVector bst = lv.boostVector();
295  lv1.boost(-bst);
296 
297  G4ThreeVector p1 = lv1.vect();
298  G4double ptot = p1.mag();
299  G4double ptot2 = ptot*ptot;
300  G4double cost = 1 - 0.5*std::fabs(tMand)/ptot2;
301 
302  if( cost >= 1.0 ) cost = 1.0;
303  else if( cost <= -1.0) cost = -1.0;
304 
305  G4double thetaCMS = std::acos(cost);
306 
307  G4double sigma = GetDiffuseElasticSumXsc( particle, thetaCMS, ptot, A, Z );
308 
309  sigma *= pi/ptot2;
310 
311  return sigma;
312 }
313 
315 //
316 // return invariant differential elastic cross section d(sigma)/d(tMand) with Coulomb
317 // correction
318 
319 G4double
321  G4double tMand,
322  G4double plab,
323  G4double A, G4double Z )
324 {
325  G4double m1 = particle->GetPDGMass();
326  G4LorentzVector lv1(0.,0.,plab,std::sqrt(plab*plab+m1*m1));
327 
328  G4int iZ = static_cast<G4int>(Z+0.5);
329  G4int iA = static_cast<G4int>(A+0.5);
330  G4ParticleDefinition * theDef = 0;
331 
332  if (iZ == 1 && iA == 1) theDef = theProton;
333  else if (iZ == 1 && iA == 2) theDef = theDeuteron;
334  else if (iZ == 1 && iA == 3) theDef = G4Triton::Triton();
335  else if (iZ == 2 && iA == 3) theDef = G4He3::He3();
336  else if (iZ == 2 && iA == 4) theDef = theAlpha;
337  else theDef = G4ParticleTable::GetParticleTable()->GetIonTable()->GetIon(iZ,iA,0);
338 
339  G4double tmass = theDef->GetPDGMass();
340 
341  G4LorentzVector lv(0.0,0.0,0.0,tmass);
342  lv += lv1;
343 
344  G4ThreeVector bst = lv.boostVector();
345  lv1.boost(-bst);
346 
347  G4ThreeVector p1 = lv1.vect();
348  G4double ptot = p1.mag();
349  G4double ptot2 = ptot*ptot;
350  G4double cost = 1 - 0.5*std::fabs(tMand)/ptot2;
351 
352  if( cost >= 1.0 ) cost = 1.0;
353  else if( cost <= -1.0) cost = -1.0;
354 
355  G4double thetaCMS = std::acos(cost);
356 
357  G4double sigma = GetCoulombElasticXsc( particle, thetaCMS, ptot, Z );
358 
359  sigma *= pi/ptot2;
360 
361  return sigma;
362 }
363 
365 //
366 // return differential elastic probability d(probability)/d(omega)
367 
368 G4double
369 G4DiffuseElastic::GetDiffElasticProb( // G4ParticleDefinition* particle,
370  G4double theta
371  // G4double momentum,
372  // G4double A
373  )
374 {
375  G4double sigma, bzero, bzero2, bonebyarg, bonebyarg2, damp, damp2;
376  G4double delta, diffuse, gamma;
377  G4double e1, e2, bone, bone2;
378 
379  // G4double wavek = momentum/hbarc; // wave vector
380  // G4double r0 = 1.08*fermi;
381  // G4double rad = r0*std::pow(A, 1./3.);
382 
383  G4double kr = fWaveVector*fNuclearRadius; // wavek*rad;
384  G4double kr2 = kr*kr;
385  G4double krt = kr*theta;
386 
387  bzero = BesselJzero(krt);
388  bzero2 = bzero*bzero;
389  bone = BesselJone(krt);
390  bone2 = bone*bone;
391  bonebyarg = BesselOneByArg(krt);
392  bonebyarg2 = bonebyarg*bonebyarg;
393 
394  if (fParticle == theProton)
395  {
396  diffuse = 0.63*fermi;
397  gamma = 0.3*fermi;
398  delta = 0.1*fermi*fermi;
399  e1 = 0.3*fermi;
400  e2 = 0.35*fermi;
401  }
402  else // as proton, if were not defined
403  {
404  diffuse = 0.63*fermi;
405  gamma = 0.3*fermi;
406  delta = 0.1*fermi*fermi;
407  e1 = 0.3*fermi;
408  e2 = 0.35*fermi;
409  }
410  G4double lambda = 15.; // 15 ok
411 
412  // G4double kgamma = fWaveVector*gamma; // wavek*delta;
413 
414  G4double kgamma = lambda*(1.-std::exp(-fWaveVector*gamma/lambda)); // wavek*delta;
415  G4double kgamma2 = kgamma*kgamma;
416 
417  // G4double dk2t = delta*fWaveVector*fWaveVector*theta; // delta*wavek*wavek*theta;
418  // G4double dk2t2 = dk2t*dk2t;
419  // G4double pikdt = pi*fWaveVector*diffuse*theta;// pi*wavek*diffuse*theta;
420 
421  G4double pikdt = lambda*(1.-std::exp(-pi*fWaveVector*diffuse*theta/lambda)); // wavek*delta;
422 
423  damp = DampFactor(pikdt);
424  damp2 = damp*damp;
425 
426  G4double mode2k2 = (e1*e1+e2*e2)*fWaveVector*fWaveVector;
427  G4double e2dk3t = -2.*e2*delta*fWaveVector*fWaveVector*fWaveVector*theta;
428 
429 
430  sigma = kgamma2;
431  // sigma += dk2t2;
432  sigma *= bzero2;
433  sigma += mode2k2*bone2 + e2dk3t*bzero*bone;
434  sigma += kr2*bonebyarg2;
435  sigma *= damp2; // *rad*rad;
436 
437  return sigma;
438 }
439 
441 //
442 // return differential elastic probability d(probability)/d(omega) with
443 // Coulomb correction
444 
445 G4double
446 G4DiffuseElastic::GetDiffElasticSumProb( // G4ParticleDefinition* particle,
447  G4double theta
448  // G4double momentum,
449  // G4double A
450  )
451 {
452  G4double sigma, bzero, bzero2, bonebyarg, bonebyarg2, damp, damp2;
453  G4double delta, diffuse, gamma;
454  G4double e1, e2, bone, bone2;
455 
456  // G4double wavek = momentum/hbarc; // wave vector
457  // G4double r0 = 1.08*fermi;
458  // G4double rad = r0*std::pow(A, 1./3.);
459 
460  G4double kr = fWaveVector*fNuclearRadius; // wavek*rad;
461  G4double kr2 = kr*kr;
462  G4double krt = kr*theta;
463 
464  bzero = BesselJzero(krt);
465  bzero2 = bzero*bzero;
466  bone = BesselJone(krt);
467  bone2 = bone*bone;
468  bonebyarg = BesselOneByArg(krt);
469  bonebyarg2 = bonebyarg*bonebyarg;
470 
471  if (fParticle == theProton)
472  {
473  diffuse = 0.63*fermi;
474  // diffuse = 0.6*fermi;
475  gamma = 0.3*fermi;
476  delta = 0.1*fermi*fermi;
477  e1 = 0.3*fermi;
478  e2 = 0.35*fermi;
479  }
480  else // as proton, if were not defined
481  {
482  diffuse = 0.63*fermi;
483  gamma = 0.3*fermi;
484  delta = 0.1*fermi*fermi;
485  e1 = 0.3*fermi;
486  e2 = 0.35*fermi;
487  }
488  G4double lambda = 15.; // 15 ok
489  // G4double kgamma = fWaveVector*gamma; // wavek*delta;
490  G4double kgamma = lambda*(1.-std::exp(-fWaveVector*gamma/lambda)); // wavek*delta;
491 
492  // G4cout<<"kgamma = "<<kgamma<<G4endl;
493 
494  if(fAddCoulomb) // add Coulomb correction
495  {
496  G4double sinHalfTheta = std::sin(0.5*theta);
497  G4double sinHalfTheta2 = sinHalfTheta*sinHalfTheta;
498 
499  kgamma += 0.5*fZommerfeld/kr/(sinHalfTheta2+fAm); // correction at J0()
500  // kgamma += 0.65*fZommerfeld/kr/(sinHalfTheta2+fAm); // correction at J0()
501  }
502 
503  G4double kgamma2 = kgamma*kgamma;
504 
505  // G4double dk2t = delta*fWaveVector*fWaveVector*theta; // delta*wavek*wavek*theta;
506  // G4cout<<"dk2t = "<<dk2t<<G4endl;
507  // G4double dk2t2 = dk2t*dk2t;
508  // G4double pikdt = pi*fWaveVector*diffuse*theta;// pi*wavek*diffuse*theta;
509 
510  G4double pikdt = lambda*(1.-std::exp(-pi*fWaveVector*diffuse*theta/lambda)); // wavek*delta;
511 
512  // G4cout<<"pikdt = "<<pikdt<<G4endl;
513 
514  damp = DampFactor(pikdt);
515  damp2 = damp*damp;
516 
517  G4double mode2k2 = (e1*e1+e2*e2)*fWaveVector*fWaveVector;
518  G4double e2dk3t = -2.*e2*delta*fWaveVector*fWaveVector*fWaveVector*theta;
519 
520  sigma = kgamma2;
521  // sigma += dk2t2;
522  sigma *= bzero2;
523  sigma += mode2k2*bone2;
524  sigma += e2dk3t*bzero*bone;
525 
526  // sigma += kr2*(1 + 8.*fZommerfeld*fZommerfeld/kr2)*bonebyarg2; // correction at J1()/()
527  sigma += kr2*bonebyarg2; // correction at J1()/()
528 
529  sigma *= damp2; // *rad*rad;
530 
531  return sigma;
532 }
533 
534 
536 //
537 // return differential elastic probability d(probability)/d(t) with
538 // Coulomb correction
539 
540 G4double
542 {
543  G4double theta;
544 
545  theta = std::sqrt(alpha);
546 
547  // theta = std::acos( 1 - alpha/2. );
548 
549  G4double sigma, bzero, bzero2, bonebyarg, bonebyarg2, damp, damp2;
550  G4double delta, diffuse, gamma;
551  G4double e1, e2, bone, bone2;
552 
553  // G4double wavek = momentum/hbarc; // wave vector
554  // G4double r0 = 1.08*fermi;
555  // G4double rad = r0*std::pow(A, 1./3.);
556 
557  G4double kr = fWaveVector*fNuclearRadius; // wavek*rad;
558  G4double kr2 = kr*kr;
559  G4double krt = kr*theta;
560 
561  bzero = BesselJzero(krt);
562  bzero2 = bzero*bzero;
563  bone = BesselJone(krt);
564  bone2 = bone*bone;
565  bonebyarg = BesselOneByArg(krt);
566  bonebyarg2 = bonebyarg*bonebyarg;
567 
568  if (fParticle == theProton)
569  {
570  diffuse = 0.63*fermi;
571  // diffuse = 0.6*fermi;
572  gamma = 0.3*fermi;
573  delta = 0.1*fermi*fermi;
574  e1 = 0.3*fermi;
575  e2 = 0.35*fermi;
576  }
577  else // as proton, if were not defined
578  {
579  diffuse = 0.63*fermi;
580  gamma = 0.3*fermi;
581  delta = 0.1*fermi*fermi;
582  e1 = 0.3*fermi;
583  e2 = 0.35*fermi;
584  }
585  G4double lambda = 15.; // 15 ok
586  // G4double kgamma = fWaveVector*gamma; // wavek*delta;
587  G4double kgamma = lambda*(1.-std::exp(-fWaveVector*gamma/lambda)); // wavek*delta;
588 
589  // G4cout<<"kgamma = "<<kgamma<<G4endl;
590 
591  if(fAddCoulomb) // add Coulomb correction
592  {
593  G4double sinHalfTheta = theta*0.5; // std::sin(0.5*theta);
594  G4double sinHalfTheta2 = sinHalfTheta*sinHalfTheta;
595 
596  kgamma += 0.5*fZommerfeld/kr/(sinHalfTheta2+fAm); // correction at J0()
597  // kgamma += 0.65*fZommerfeld/kr/(sinHalfTheta2+fAm); // correction at J0()
598  }
599 
600  G4double kgamma2 = kgamma*kgamma;
601 
602  // G4double dk2t = delta*fWaveVector*fWaveVector*theta; // delta*wavek*wavek*theta;
603  // G4cout<<"dk2t = "<<dk2t<<G4endl;
604  // G4double dk2t2 = dk2t*dk2t;
605  // G4double pikdt = pi*fWaveVector*diffuse*theta;// pi*wavek*diffuse*theta;
606 
607  G4double pikdt = lambda*(1.-std::exp(-pi*fWaveVector*diffuse*theta/lambda)); // wavek*delta;
608 
609  // G4cout<<"pikdt = "<<pikdt<<G4endl;
610 
611  damp = DampFactor(pikdt);
612  damp2 = damp*damp;
613 
614  G4double mode2k2 = (e1*e1+e2*e2)*fWaveVector*fWaveVector;
615  G4double e2dk3t = -2.*e2*delta*fWaveVector*fWaveVector*fWaveVector*theta;
616 
617  sigma = kgamma2;
618  // sigma += dk2t2;
619  sigma *= bzero2;
620  sigma += mode2k2*bone2;
621  sigma += e2dk3t*bzero*bone;
622 
623  // sigma += kr2*(1 + 8.*fZommerfeld*fZommerfeld/kr2)*bonebyarg2; // correction at J1()/()
624  sigma += kr2*bonebyarg2; // correction at J1()/()
625 
626  sigma *= damp2; // *rad*rad;
627 
628  return sigma;
629 }
630 
631 
633 //
634 // return differential elastic probability 2*pi*sin(theta)*d(probability)/d(omega)
635 
636 G4double
638 {
639  G4double result;
640 
641  result = GetDiffElasticSumProbA(alpha);
642 
643  // result *= 2*pi*std::sin(theta);
644 
645  return result;
646 }
647 
649 //
650 // return integral elastic cross section d(sigma)/d(omega) integrated 0 - theta
651 
652 G4double
654  G4double theta,
655  G4double momentum,
656  G4double A )
657 {
658  G4double result;
659  fParticle = particle;
660  fWaveVector = momentum/hbarc;
661  fAtomicWeight = A;
662 
664 
665 
667 
668  // result = integral.Legendre10(this,&G4DiffuseElastic::GetIntegrandFunction, 0., theta );
669  result = integral.Legendre96(this,&G4DiffuseElastic::GetIntegrandFunction, 0., theta );
670 
671  return result;
672 }
673 
675 //
676 // Return inv momentum transfer -t > 0
677 
679 {
680  G4double theta = SampleThetaCMS( aParticle, p, A); // sample theta in cms
681  G4double t = 2*p*p*( 1 - std::cos(theta) ); // -t !!!
682  return t;
683 }
684 
686 //
687 // Return scattering angle sampled in cms
688 
689 
690 G4double
692  G4double momentum, G4double A)
693 {
694  G4int i, iMax = 100;
695  G4double norm, result, theta1, theta2, thetaMax, sum = 0.;
696 
697  fParticle = particle;
698  fWaveVector = momentum/hbarc;
699  fAtomicWeight = A;
700 
702 
703  thetaMax = 10.174/fWaveVector/fNuclearRadius;
704 
705  if (thetaMax > pi) thetaMax = pi;
706 
708 
709  // result = integral.Legendre10(this,&G4DiffuseElastic::GetIntegrandFunction, 0., theta );
710  norm = integral.Legendre96(this,&G4DiffuseElastic::GetIntegrandFunction, 0., thetaMax );
711 
712  norm *= G4UniformRand();
713 
714  for(i = 1; i <= iMax; i++)
715  {
716  theta1 = (i-1)*thetaMax/iMax;
717  theta2 = i*thetaMax/iMax;
718  sum += integral.Legendre10(this,&G4DiffuseElastic::GetIntegrandFunction, theta1, theta2);
719 
720  if ( sum >= norm )
721  {
722  result = 0.5*(theta1 + theta2);
723  break;
724  }
725  }
726  if (i > iMax ) result = 0.5*(theta1 + theta2);
727 
728  G4double sigma = pi*thetaMax/iMax;
729 
730  result += G4RandGauss::shoot(0.,sigma);
731 
732  if(result < 0.) result = 0.;
733  if(result > thetaMax) result = thetaMax;
734 
735  return result;
736 }
737 
741 //
742 // Return inv momentum transfer -t > 0 from initialisation table
743 
745  G4int Z, G4int A)
746 {
747  fParticle = aParticle;
748  G4double m1 = fParticle->GetPDGMass();
749  G4double totElab = std::sqrt(m1*m1+p*p);
751  G4LorentzVector lv1(p,0.0,0.0,totElab);
752  G4LorentzVector lv(0.0,0.0,0.0,mass2);
753  lv += lv1;
754 
755  G4ThreeVector bst = lv.boostVector();
756  lv1.boost(-bst);
757 
758  G4ThreeVector p1 = lv1.vect();
759  G4double momentumCMS = p1.mag();
760 
761  G4double t = SampleTableT( aParticle, momentumCMS, G4double(Z), G4double(A) ); // sample theta2 in cms
762  return t;
763 }
764 
766 //
767 // Return inv momentum transfer -t > 0 from initialisation table
768 
770  G4double Z, G4double A)
771 {
772  G4double alpha = SampleTableThetaCMS( aParticle, p, Z, A); // sample theta2 in cms
773  // G4double t = 2*p*p*( 1 - std::cos(std::sqrt(alpha)) ); // -t !!!
774  G4double t = p*p*alpha; // -t !!!
775  return t;
776 }
777 
779 //
780 // Return scattering angle2 sampled in cms according to precalculated table.
781 
782 
783 G4double
785  G4double momentum, G4double Z, G4double A)
786 {
787  size_t iElement;
788  G4int iMomentum, iAngle;
789  G4double randAngle, position, theta1, theta2, E1, E2, W1, W2, W;
790  G4double m1 = particle->GetPDGMass();
791 
792  for(iElement = 0; iElement < fElementNumberVector.size(); iElement++)
793  {
794  if( std::fabs(Z - fElementNumberVector[iElement]) < 0.5) break;
795  }
796  if ( iElement == fElementNumberVector.size() )
797  {
798  InitialiseOnFly(Z,A); // table preparation, if needed
799 
800  // iElement--;
801 
802  // G4cout << "G4DiffuseElastic: Element with atomic number " << Z
803  // << " is not found, return zero angle" << G4endl;
804  // return 0.; // no table for this element
805  }
806  // G4cout<<"iElement = "<<iElement<<G4endl;
807 
808  fAngleTable = fAngleBank[iElement];
809 
810  G4double kinE = std::sqrt(momentum*momentum + m1*m1) - m1;
811 
812  for( iMomentum = 0; iMomentum < fEnergyBin; iMomentum++)
813  {
814  if( kinE < fEnergyVector->GetLowEdgeEnergy(iMomentum) ) break;
815  }
816  if ( iMomentum >= fEnergyBin ) iMomentum = fEnergyBin-1; // kinE is more then theMaxEnergy
817  if ( iMomentum < 0 ) iMomentum = 0; // against negative index, kinE < theMinEnergy
818 
819  // G4cout<<"iMomentum = "<<iMomentum<<G4endl;
820 
821  if (iMomentum == fEnergyBin -1 || iMomentum == 0 ) // the table edges
822  {
823  position = (*(*fAngleTable)(iMomentum))(fAngleBin-2)*G4UniformRand();
824 
825  // G4cout<<"position = "<<position<<G4endl;
826 
827  for(iAngle = 0; iAngle < fAngleBin-1; iAngle++)
828  {
829  if( position > (*(*fAngleTable)(iMomentum))(iAngle) ) break;
830  }
831  if (iAngle >= fAngleBin-1) iAngle = fAngleBin-2;
832 
833  // G4cout<<"iAngle = "<<iAngle<<G4endl;
834 
835  randAngle = GetScatteringAngle(iMomentum, iAngle, position);
836 
837  // G4cout<<"randAngle = "<<randAngle<<G4endl;
838  }
839  else // kinE inside between energy table edges
840  {
841  // position = (*(*fAngleTable)(iMomentum))(fAngleBin-2)*G4UniformRand();
842  position = (*(*fAngleTable)(iMomentum))(0)*G4UniformRand();
843 
844  // G4cout<<"position = "<<position<<G4endl;
845 
846  for(iAngle = 0; iAngle < fAngleBin-1; iAngle++)
847  {
848  // if( position < (*(*fAngleTable)(iMomentum))(iAngle) ) break;
849  if( position > (*(*fAngleTable)(iMomentum))(iAngle) ) break;
850  }
851  if (iAngle >= fAngleBin-1) iAngle = fAngleBin-2;
852 
853  // G4cout<<"iAngle = "<<iAngle<<G4endl;
854 
855  theta2 = GetScatteringAngle(iMomentum, iAngle, position);
856 
857  // G4cout<<"theta2 = "<<theta2<<G4endl;
858  E2 = fEnergyVector->GetLowEdgeEnergy(iMomentum);
859 
860  // G4cout<<"E2 = "<<E2<<G4endl;
861 
862  iMomentum--;
863 
864  // position = (*(*fAngleTable)(iMomentum))(fAngleBin-2)*G4UniformRand();
865 
866  // G4cout<<"position = "<<position<<G4endl;
867 
868  for(iAngle = 0; iAngle < fAngleBin-1; iAngle++)
869  {
870  // if( position < (*(*fAngleTable)(iMomentum))(iAngle) ) break;
871  if( position > (*(*fAngleTable)(iMomentum))(iAngle) ) break;
872  }
873  if (iAngle >= fAngleBin-1) iAngle = fAngleBin-2;
874 
875  theta1 = GetScatteringAngle(iMomentum, iAngle, position);
876 
877  // G4cout<<"theta1 = "<<theta1<<G4endl;
878 
879  E1 = fEnergyVector->GetLowEdgeEnergy(iMomentum);
880 
881  // G4cout<<"E1 = "<<E1<<G4endl;
882 
883  W = 1.0/(E2 - E1);
884  W1 = (E2 - kinE)*W;
885  W2 = (kinE - E1)*W;
886 
887  randAngle = W1*theta1 + W2*theta2;
888 
889  // randAngle = theta2;
890  // G4cout<<"randAngle = "<<randAngle<<G4endl;
891  }
892  // G4double angle = randAngle;
893  // if (randAngle > 0.) randAngle /= 2*pi*std::sin(angle);
894 
895  return randAngle;
896 }
897 
899 //
900 // Initialisation for given particle on fly using new element number
901 
903 {
904  fAtomicNumber = Z; // atomic number
905  fAtomicWeight = G4NistManager::Instance()->GetAtomicMassAmu( static_cast< G4int >( Z ) );
906 
908 
909  if( verboseLevel > 0 )
910  {
911  G4cout<<"G4DiffuseElastic::Initialise() the element with Z = "
912  <<Z<<"; and A = "<<A<<G4endl;
913  }
915 
916  BuildAngleTable();
917 
918  fAngleBank.push_back(fAngleTable);
919 
920  return;
921 }
922 
924 //
925 // Build for given particle and element table of momentum, angle probability.
926 // For the moment in lab system.
927 
929 {
930  G4int i, j;
931  G4double partMom, kinE, a = 0., z = fParticle->GetPDGCharge(), m1 = fParticle->GetPDGMass();
932  G4double alpha1, alpha2, alphaMax, alphaCoulomb, delta = 0., sum = 0.;
933 
935 
937 
938  for( i = 0; i < fEnergyBin; i++)
939  {
940  kinE = fEnergyVector->GetLowEdgeEnergy(i);
941  partMom = std::sqrt( kinE*(kinE + 2*m1) );
942 
943  fWaveVector = partMom/hbarc;
944 
946  G4double kR2 = kR*kR;
947  G4double kRmax = 18.6; // 10.6; 10.6, 18, 10.174; ~ 3 maxima of J1 or 15., 25.
948  G4double kRcoul = 1.9; // 1.2; 1.4, 2.5; // on the first slope of J1
949  // G4double kRlim = 1.2;
950  // G4double kRlim2 = kRlim*kRlim/kR2;
951 
952  alphaMax = kRmax*kRmax/kR2;
953 
954  if (alphaMax > 4.) alphaMax = 4.; // vmg05-02-09: was pi2
955 
956  alphaCoulomb = kRcoul*kRcoul/kR2;
957 
958  if( z )
959  {
960  a = partMom/m1; // beta*gamma for m1
961  fBeta = a/std::sqrt(1+a*a);
964  }
965  G4PhysicsFreeVector* angleVector = new G4PhysicsFreeVector(fAngleBin-1);
966 
967  // G4PhysicsLogVector* angleBins = new G4PhysicsLogVector( 0.001*alphaMax, alphaMax, fAngleBin );
968 
969  G4double delth = alphaMax/fAngleBin;
970 
971  sum = 0.;
972 
973  // fAddCoulomb = false;
974  fAddCoulomb = true;
975 
976  // for(j = 1; j < fAngleBin; j++)
977  for(j = fAngleBin-1; j >= 1; j--)
978  {
979  // alpha1 = angleBins->GetLowEdgeEnergy(j-1);
980  // alpha2 = angleBins->GetLowEdgeEnergy(j);
981 
982  // alpha1 = alphaMax*(j-1)/fAngleBin;
983  // alpha2 = alphaMax*( j )/fAngleBin;
984 
985  alpha1 = delth*(j-1);
986  // if(alpha1 < kRlim2) alpha1 = kRlim2;
987  alpha2 = alpha1 + delth;
988 
989  // if( ( alpha2 > alphaCoulomb ) && z ) fAddCoulomb = true;
990  if( ( alpha1 < alphaCoulomb ) && z ) fAddCoulomb = false;
991 
992  delta = integral.Legendre10(this, &G4DiffuseElastic::GetIntegrandFunction, alpha1, alpha2);
993  // delta = integral.Legendre96(this, &G4DiffuseElastic::GetIntegrandFunction, alpha1, alpha2);
994 
995  sum += delta;
996 
997  angleVector->PutValue( j-1 , alpha1, sum ); // alpha2
998  // G4cout<<"j-1 = "<<j-1<<"; alpha2 = "<<alpha2<<"; sum = "<<sum<<G4endl;
999  }
1000  fAngleTable->insertAt(i,angleVector);
1001 
1002  // delete[] angleVector;
1003  // delete[] angleBins;
1004  }
1005  return;
1006 }
1007 
1009 //
1010 //
1011 
1012 G4double
1014 {
1015  G4double x1, x2, y1, y2, randAngle;
1016 
1017  if( iAngle == 0 )
1018  {
1019  randAngle = (*fAngleTable)(iMomentum)->GetLowEdgeEnergy(iAngle);
1020  // iAngle++;
1021  }
1022  else
1023  {
1024  if ( iAngle >= G4int((*fAngleTable)(iMomentum)->GetVectorLength()) )
1025  {
1026  iAngle = (*fAngleTable)(iMomentum)->GetVectorLength() - 1;
1027  }
1028  y1 = (*(*fAngleTable)(iMomentum))(iAngle-1);
1029  y2 = (*(*fAngleTable)(iMomentum))(iAngle);
1030 
1031  x1 = (*fAngleTable)(iMomentum)->GetLowEdgeEnergy(iAngle-1);
1032  x2 = (*fAngleTable)(iMomentum)->GetLowEdgeEnergy(iAngle);
1033 
1034  if ( x1 == x2 ) randAngle = x2;
1035  else
1036  {
1037  if ( y1 == y2 ) randAngle = x1 + ( x2 - x1 )*G4UniformRand();
1038  else
1039  {
1040  randAngle = x1 + ( position - y1 )*( x2 - x1 )/( y2 - y1 );
1041  }
1042  }
1043  }
1044  return randAngle;
1045 }
1046 
1047 
1048 
1050 //
1051 // Return scattering angle sampled in lab system (target at rest)
1052 
1053 
1054 
1055 G4double
1057  G4double tmass, G4double A)
1058 {
1059  const G4ParticleDefinition* theParticle = aParticle->GetDefinition();
1060  G4double m1 = theParticle->GetPDGMass();
1061  G4double plab = aParticle->GetTotalMomentum();
1062  G4LorentzVector lv1 = aParticle->Get4Momentum();
1063  G4LorentzVector lv(0.0,0.0,0.0,tmass);
1064  lv += lv1;
1065 
1066  G4ThreeVector bst = lv.boostVector();
1067  lv1.boost(-bst);
1068 
1069  G4ThreeVector p1 = lv1.vect();
1070  G4double ptot = p1.mag();
1071  G4double tmax = 4.0*ptot*ptot;
1072  G4double t = 0.0;
1073 
1074 
1075  //
1076  // Sample t
1077  //
1078 
1079  t = SampleT( theParticle, ptot, A);
1080 
1081  // NaN finder
1082  if(!(t < 0.0 || t >= 0.0))
1083  {
1084  if (verboseLevel > 0)
1085  {
1086  G4cout << "G4DiffuseElastic:WARNING: A = " << A
1087  << " mom(GeV)= " << plab/GeV
1088  << " S-wave will be sampled"
1089  << G4endl;
1090  }
1091  t = G4UniformRand()*tmax;
1092  }
1093  if(verboseLevel>1)
1094  {
1095  G4cout <<" t= " << t << " tmax= " << tmax
1096  << " ptot= " << ptot << G4endl;
1097  }
1098  // Sampling of angles in CM system
1099 
1100  G4double phi = G4UniformRand()*twopi;
1101  G4double cost = 1. - 2.0*t/tmax;
1102  G4double sint;
1103 
1104  if( cost >= 1.0 )
1105  {
1106  cost = 1.0;
1107  sint = 0.0;
1108  }
1109  else if( cost <= -1.0)
1110  {
1111  cost = -1.0;
1112  sint = 0.0;
1113  }
1114  else
1115  {
1116  sint = std::sqrt((1.0-cost)*(1.0+cost));
1117  }
1118  if (verboseLevel>1)
1119  {
1120  G4cout << "cos(t)=" << cost << " std::sin(t)=" << sint << G4endl;
1121  }
1122  G4ThreeVector v1(sint*std::cos(phi),sint*std::sin(phi),cost);
1123  v1 *= ptot;
1124  G4LorentzVector nlv1(v1.x(),v1.y(),v1.z(),std::sqrt(ptot*ptot + m1*m1));
1125 
1126  nlv1.boost(bst);
1127 
1128  G4ThreeVector np1 = nlv1.vect();
1129 
1130  // G4double theta = std::acos( np1.z()/np1.mag() ); // degree;
1131 
1132  G4double theta = np1.theta();
1133 
1134  return theta;
1135 }
1136 
1138 //
1139 // Return scattering angle in lab system (target at rest) knowing theta in CMS
1140 
1141 
1142 
1143 G4double
1145  G4double tmass, G4double thetaCMS)
1146 {
1147  const G4ParticleDefinition* theParticle = aParticle->GetDefinition();
1148  G4double m1 = theParticle->GetPDGMass();
1149  // G4double plab = aParticle->GetTotalMomentum();
1150  G4LorentzVector lv1 = aParticle->Get4Momentum();
1151  G4LorentzVector lv(0.0,0.0,0.0,tmass);
1152 
1153  lv += lv1;
1154 
1155  G4ThreeVector bst = lv.boostVector();
1156 
1157  lv1.boost(-bst);
1158 
1159  G4ThreeVector p1 = lv1.vect();
1160  G4double ptot = p1.mag();
1161 
1162  G4double phi = G4UniformRand()*twopi;
1163  G4double cost = std::cos(thetaCMS);
1164  G4double sint;
1165 
1166  if( cost >= 1.0 )
1167  {
1168  cost = 1.0;
1169  sint = 0.0;
1170  }
1171  else if( cost <= -1.0)
1172  {
1173  cost = -1.0;
1174  sint = 0.0;
1175  }
1176  else
1177  {
1178  sint = std::sqrt((1.0-cost)*(1.0+cost));
1179  }
1180  if (verboseLevel>1)
1181  {
1182  G4cout << "cos(tcms)=" << cost << " std::sin(tcms)=" << sint << G4endl;
1183  }
1184  G4ThreeVector v1(sint*std::cos(phi),sint*std::sin(phi),cost);
1185  v1 *= ptot;
1186  G4LorentzVector nlv1(v1.x(),v1.y(),v1.z(),std::sqrt(ptot*ptot + m1*m1));
1187 
1188  nlv1.boost(bst);
1189 
1190  G4ThreeVector np1 = nlv1.vect();
1191 
1192 
1193  G4double thetaLab = np1.theta();
1194 
1195  return thetaLab;
1196 }
1198 //
1199 // Return scattering angle in CMS system (target at rest) knowing theta in Lab
1200 
1201 
1202 
1203 G4double
1205  G4double tmass, G4double thetaLab)
1206 {
1207  const G4ParticleDefinition* theParticle = aParticle->GetDefinition();
1208  G4double m1 = theParticle->GetPDGMass();
1209  G4double plab = aParticle->GetTotalMomentum();
1210  G4LorentzVector lv1 = aParticle->Get4Momentum();
1211  G4LorentzVector lv(0.0,0.0,0.0,tmass);
1212 
1213  lv += lv1;
1214 
1215  G4ThreeVector bst = lv.boostVector();
1216 
1217  // lv1.boost(-bst);
1218 
1219  // G4ThreeVector p1 = lv1.vect();
1220  // G4double ptot = p1.mag();
1221 
1222  G4double phi = G4UniformRand()*twopi;
1223  G4double cost = std::cos(thetaLab);
1224  G4double sint;
1225 
1226  if( cost >= 1.0 )
1227  {
1228  cost = 1.0;
1229  sint = 0.0;
1230  }
1231  else if( cost <= -1.0)
1232  {
1233  cost = -1.0;
1234  sint = 0.0;
1235  }
1236  else
1237  {
1238  sint = std::sqrt((1.0-cost)*(1.0+cost));
1239  }
1240  if (verboseLevel>1)
1241  {
1242  G4cout << "cos(tlab)=" << cost << " std::sin(tlab)=" << sint << G4endl;
1243  }
1244  G4ThreeVector v1(sint*std::cos(phi),sint*std::sin(phi),cost);
1245  v1 *= plab;
1246  G4LorentzVector nlv1(v1.x(),v1.y(),v1.z(),std::sqrt(plab*plab + m1*m1));
1247 
1248  nlv1.boost(-bst);
1249 
1250  G4ThreeVector np1 = nlv1.vect();
1251 
1252 
1253  G4double thetaCMS = np1.theta();
1254 
1255  return thetaCMS;
1256 }
1257 
1259 //
1260 // Test for given particle and element table of momentum, angle probability.
1261 // For the moment in lab system.
1262 
1264  G4double Z, G4double A)
1265 {
1266  fAtomicNumber = Z; // atomic number
1267  fAtomicWeight = A; // number of nucleons
1269 
1270 
1271 
1272  G4cout<<"G4DiffuseElastic::TestAngleTable() init the element with Z = "
1273  <<Z<<"; and A = "<<A<<G4endl;
1274 
1276 
1277 
1278 
1279 
1280  G4int i=0, j;
1281  G4double a = 0., z = theParticle->GetPDGCharge(), m1 = fParticle->GetPDGMass();
1282  G4double alpha1=0., alpha2=0., alphaMax=0., alphaCoulomb=0.;
1283  G4double deltaL10 = 0., deltaL96 = 0., deltaAG = 0.;
1284  G4double sumL10 = 0.,sumL96 = 0.,sumAG = 0.;
1285  G4double epsilon = 0.001;
1286 
1288 
1290 
1291  fWaveVector = partMom/hbarc;
1292 
1294  G4double kR2 = kR*kR;
1295  G4double kRmax = 10.6; // 10.6, 18, 10.174; ~ 3 maxima of J1 or 15., 25.
1296  G4double kRcoul = 1.2; // 1.4, 2.5; // on the first slope of J1
1297 
1298  alphaMax = kRmax*kRmax/kR2;
1299 
1300  if (alphaMax > 4.) alphaMax = 4.; // vmg05-02-09: was pi2
1301 
1302  alphaCoulomb = kRcoul*kRcoul/kR2;
1303 
1304  if( z )
1305  {
1306  a = partMom/m1; // beta*gamma for m1
1307  fBeta = a/std::sqrt(1+a*a);
1309  fAm = CalculateAm( partMom, fZommerfeld, fAtomicNumber);
1310  }
1311  G4PhysicsFreeVector* angleVector = new G4PhysicsFreeVector(fAngleBin-1);
1312 
1313  // G4PhysicsLogVector* angleBins = new G4PhysicsLogVector( 0.001*alphaMax, alphaMax, fAngleBin );
1314 
1315 
1316  fAddCoulomb = false;
1317 
1318  for(j = 1; j < fAngleBin; j++)
1319  {
1320  // alpha1 = angleBins->GetLowEdgeEnergy(j-1);
1321  // alpha2 = angleBins->GetLowEdgeEnergy(j);
1322 
1323  alpha1 = alphaMax*(j-1)/fAngleBin;
1324  alpha2 = alphaMax*( j )/fAngleBin;
1325 
1326  if( ( alpha2 > alphaCoulomb ) && z ) fAddCoulomb = true;
1327 
1328  deltaL10 = integral.Legendre10(this, &G4DiffuseElastic::GetIntegrandFunction, alpha1, alpha2);
1329  deltaL96 = integral.Legendre96(this, &G4DiffuseElastic::GetIntegrandFunction, alpha1, alpha2);
1330  deltaAG = integral.AdaptiveGauss(this, &G4DiffuseElastic::GetIntegrandFunction,
1331  alpha1, alpha2,epsilon);
1332 
1333  // G4cout<<alpha1<<"\t"<<std::sqrt(alpha1)/degree<<"\t"
1334  // <<deltaL10<<"\t"<<deltaL96<<"\t"<<deltaAG<<G4endl;
1335 
1336  sumL10 += deltaL10;
1337  sumL96 += deltaL96;
1338  sumAG += deltaAG;
1339 
1340  G4cout<<alpha1<<"\t"<<std::sqrt(alpha1)/degree<<"\t"
1341  <<sumL10<<"\t"<<sumL96<<"\t"<<sumAG<<G4endl;
1342 
1343  angleVector->PutValue( j-1 , alpha1, sumL10 ); // alpha2
1344  }
1345  fAngleTable->insertAt(i,angleVector);
1346  fAngleBank.push_back(fAngleTable);
1347 
1348  /*
1349  // Integral over all angle range - Bad accuracy !!!
1350 
1351  sumL10 = integral.Legendre10(this, &G4DiffuseElastic::GetIntegrandFunction, 0., alpha2);
1352  sumL96 = integral.Legendre96(this, &G4DiffuseElastic::GetIntegrandFunction, 0., alpha2);
1353  sumAG = integral.AdaptiveGauss(this, &G4DiffuseElastic::GetIntegrandFunction,
1354  0., alpha2,epsilon);
1355  G4cout<<G4endl;
1356  G4cout<<alpha2<<"\t"<<std::sqrt(alpha2)/degree<<"\t"
1357  <<sumL10<<"\t"<<sumL96<<"\t"<<sumAG<<G4endl;
1358  */
1359  return;
1360 }
1361 
1362 //
1363 //
G4double ThetaCMStoThetaLab(const G4DynamicParticle *aParticle, G4double tmass, G4double thetaCMS)
G4double Legendre10(T &typeT, F f, G4double a, G4double b)
ThreeVector shoot(const G4int Ap, const G4int Af)
G4double IntegralElasticProb(const G4ParticleDefinition *particle, G4double theta, G4double momentum, G4double A)
G4double CalculateNuclearRad(G4double A)
static const double MeV
Definition: G4SIunits.hh:193
static G4double GetNuclearMass(const G4double A, const G4double Z)
G4double Legendre96(T &typeT, F f, G4double a, G4double b)
G4double CalculateZommerfeld(G4double beta, G4double Z1, G4double Z2)
void PutValue(size_t binNumber, G4double binValue, G4double dataValue)
G4double BesselJzero(G4double z)
CLHEP::Hep3Vector G4ThreeVector
void InitialiseOnFly(G4double Z, G4double A)
G4double z
Definition: TRTMaterials.hh:39
G4double GetInvElasticXsc(const G4ParticleDefinition *particle, G4double theta, G4double momentum, G4double A, G4double Z)
G4ParticleDefinition * GetIon(G4int Z, G4int A, G4int lvl=0)
Definition: G4IonTable.cc:463
const G4double pi
static const G4double e2
std::vector< G4String > fElementNameVector
G4ParticleDefinition * theProton
G4ParticleDefinition * GetDefinition() const
G4double a
Definition: TRTMaterials.hh:39
G4double GetDiffElasticSumProb(G4double theta)
G4double SampleThetaCMS(const G4ParticleDefinition *aParticle, G4double p, G4double A)
G4double GetLowEdgeEnergy(size_t binNumber) const
G4double GetScatteringAngle(G4int iMomentum, G4int iAngle, G4double position)
G4double BesselJone(G4double z)
G4double SampleT(const G4ParticleDefinition *aParticle, G4double p, G4double A)
int G4int
Definition: G4Types.hh:78
G4double SampleTableT(const G4ParticleDefinition *aParticle, G4double p, G4double Z, G4double A)
static G4NistManager * Instance()
G4double SampleThetaLab(const G4HadProjectile *aParticle, G4double tmass, G4double A)
G4double GetCoulombElasticXsc(const G4ParticleDefinition *particle, G4double theta, G4double momentum, G4double Z)
G4double AdaptiveGauss(T &typeT, F f, G4double a, G4double b, G4double e)
G4double GetTotalMomentum() const
const G4ParticleDefinition * thePionPlus
G4double CalculateAm(G4double momentum, G4double n, G4double Z)
const G4ParticleDefinition * thePionMinus
void SetMinEnergy(G4double anEnergy)
G4IonTable * GetIonTable() const
#define position
Definition: xmlparse.cc:605
#define G4UniformRand()
Definition: Randomize.hh:95
G4GLOB_DLL std::ostream G4cout
static size_t GetNumberOfElements()
Definition: G4Element.cc:410
const G4ParticleDefinition * GetDefinition() const
virtual ~G4DiffuseElastic()
G4double GetDiffElasticProb(G4double theta)
std::vector< G4PhysicsTable * > fAngleBank
static G4Triton * Triton()
Definition: G4Triton.cc:95
static G4Proton * Proton()
Definition: G4Proton.cc:93
static G4PionPlus * PionPlus()
Definition: G4PionPlus.cc:98
static const double GeV
Definition: G4SIunits.hh:196
G4double GetDiffuseElasticXsc(const G4ParticleDefinition *particle, G4double theta, G4double momentum, G4double A)
void TestAngleTable(const G4ParticleDefinition *theParticle, G4double partMom, G4double Z, G4double A)
static G4Neutron * Neutron()
Definition: G4Neutron.cc:104
static const G4double A[nN]
const G4LorentzVector & Get4Momentum() const
static G4Deuteron * Deuteron()
Definition: G4Deuteron.cc:94
G4LorentzVector Get4Momentum() const
static const G4double e1
G4ParticleDefinition * theAlpha
G4double DampFactor(G4double z)
G4PhysicsLogVector * fEnergyVector
G4double GetPDGMass() const
static G4ParticleTable * GetParticleTable()
G4double lowEnergyRecoilLimit
static G4PionMinus * PionMinus()
Definition: G4PionMinus.cc:98
G4double GetInvElasticSumXsc(const G4ParticleDefinition *particle, G4double tMand, G4double momentum, G4double A, G4double Z)
G4double GetDiffElasticSumProbA(G4double alpha)
G4double GetAtomicMassAmu(const G4String &symb) const
static const double degree
Definition: G4SIunits.hh:125
void insertAt(size_t, G4PhysicsVector *)
void SetMaxEnergy(const G4double anEnergy)
G4double GetDiffuseElasticSumXsc(const G4ParticleDefinition *particle, G4double theta, G4double momentum, G4double A, G4double Z)
G4double CalculateParticleBeta(const G4ParticleDefinition *particle, G4double momentum)
G4ParticleDefinition * theDeuteron
#define G4endl
Definition: G4ios.hh:61
G4double BesselOneByArg(G4double z)
static const double TeV
Definition: G4SIunits.hh:197
G4double ThetaLabToThetaCMS(const G4DynamicParticle *aParticle, G4double tmass, G4double thetaLab)
static G4Alpha * Alpha()
Definition: G4Alpha.cc:89
static const double keV
Definition: G4SIunits.hh:195
const G4ParticleDefinition * fParticle
G4double SampleTableThetaCMS(const G4ParticleDefinition *aParticle, G4double p, G4double Z, G4double A)
virtual G4double SampleInvariantT(const G4ParticleDefinition *p, G4double plab, G4int Z, G4int A)
std::vector< G4Element * > G4ElementTable
double G4double
Definition: G4Types.hh:76
static G4ElementTable * GetElementTable()
Definition: G4Element.cc:403
G4double GetPDGCharge() const
static const G4double alpha
std::vector< G4double > fElementNumberVector
static G4He3 * He3()
Definition: G4He3.cc:94
G4double GetInvCoulombElasticXsc(const G4ParticleDefinition *particle, G4double tMand, G4double momentum, G4double A, G4double Z)
G4PhysicsTable * fAngleTable
static const double fermi
Definition: G4SIunits.hh:93
G4double GetIntegrandFunction(G4double theta)
G4double GetTotalMomentum() const
CLHEP::HepLorentzVector G4LorentzVector
G4ParticleDefinition * theNeutron