95 if(p) { SetParticle(p); }
107 size_t n = partialSumSigma.size();
109 for(
size_t i=0; i<
n; i++) {
110 delete partialSumSigma[i];
129 if(p) { SetParticle(p); }
138 G4int nn = partialSumSigma.size();
139 G4int nc = cuts.size();
145 partialSumSigma.clear();
148 for (
G4int i=0; i<numOfCouples; i++) {
150 if(i < nc) cute = cuts[i];
153 G4DataVector* dv = ComputePartialSumSigma(material, 0.5*highKinEnergy,
154 std::min(cute, 0.25*highKinEnergy));
155 partialSumSigma.push_back(dv);
159 if(isInitialised)
return;
161 isInitialised =
true;
173 if(kineticEnergy < lowKinEnergy) {
return 0.0; }
177 G4double cut = std::min(cutEnergy, kineticEnergy);
193 G4double Z = (*theElementVector)[i]->GetZ();
194 G4double natom = theAtomicNumDensityVector[i];
197 if (kineticEnergy <= thigh) {
200 loss = ComputeBremLoss(Z, kineticEnergy, cut) ;
201 if (!
isElectron) loss *= PositronCorrFactorLoss(Z, kineticEnergy, cut);
211 loss = ComputeBremLoss(Z, thigh, cut) ;
212 if (!
isElectron) loss *= PositronCorrFactorLoss(Z, thigh, cut) ;
213 rate = cut/totalEnergy;
214 loss *= (1. + coef1*rate + coef2*rate*rate);
216 loss /= (1.+coef1*rate+coef2*rate*rate);
220 loss = ComputeBremLoss(Z, thigh, cuthigh) ;
221 if (!
isElectron) loss *= PositronCorrFactorLoss(Z, thigh, cuthigh) ;
222 rate = cut/totalEnergy;
223 loss *= (1. + coef1*rate + coef2*rate*rate);
224 loss *= cut*factorHigh;
229 G4double kp2 = MigdalConstant*totalEnergy*totalEnergy
243 G4int nn = (
G4int)(nmax*(vmax-vmin)/(log(highKinEnergy)-vmin)) ;
247 dv = (vmax-vmin)/nn ;
254 fac = u*SupressionFunction(material,kineticEnergy,u);
255 fac *= probsup*(u*u/(u*u+kp2))+1.-probsup;
256 if ((
n==0)||(
n==
nn)) c=0.5;
261 floss *=dv/(kmax-kmin);
266 if(floss > 1.) floss = 1.;
272 if(dedx < 0.) { dedx = 0.; }
283 static const G4double beta=1.0, ksi=2.0;
284 static const G4double clossh = 0.254 , closslow = 1./3. , alosslow = 1. ;
288 static const G4int NZ = 8 ;
289 static const G4int Nloss = 11 ;
291 {2.,4.,6.,14.,26.,50.,82.,92.};
292 static const G4double coefloss[NZ][Nloss] = {
294 { 0.98916, 0.47564, -0.2505, -0.45186, 0.14462,
295 0.21307, -0.013738, -0.045689, -0.0042914, 0.0034429,
299 { 1.0626, 0.37662, -0.23646, -0.45188, 0.14295,
300 0.22906, -0.011041, -0.051398, -0.0055123, 0.0039919,
303 { 1.0954, 0.315, -0.24011, -0.43849, 0.15017,
304 0.23001, -0.012846, -0.052555, -0.0055114, 0.0041283,
308 { 1.1649, 0.18976, -0.24972, -0.30124, 0.1555,
309 0.13565, -0.024765, -0.027047, -0.00059821, 0.0019373,
313 { 1.2261, 0.14272, -0.25672, -0.28407, 0.13874,
314 0.13586, -0.020562, -0.026722, -0.00089557, 0.0018665,
318 { 1.3147, 0.020049, -0.35543, -0.13927, 0.17666,
319 0.073746, -0.036076, -0.013407, 0.0025727, 0.00084005,
323 { 1.3986, -0.10586, -0.49187, -0.0048846, 0.23621,
324 0.031652, -0.052938, -0.0076639, 0.0048181, 0.00056486,
328 { 1.4217, -0.116, -0.55497, -0.044075, 0.27506,
329 0.081364, -0.058143, -0.023402, 0.0031322, 0.0020201,
339 for (
G4int ii=0; ii<NZ; ii++)
356 for (
G4int j=0; j<Nloss; j++) {
357 fl += yy+coefloss[
iz][j];
360 if (fl < 0.00001) fl = 0.00001;
361 else if (fl > 1.0) fl = 1.0;
367 loss = Z*(Z+ksi)*E*E/(T+E)*exp(beta*log(Cut/T))*(2.-clossh*exp(log(Z)/4.));
368 if (T <= Tlim) loss /= exp(closslow*log(Tlim/T));
369 if( T <= Cut) loss *= exp(alosslow*log(T/Cut));
371 loss *= (aaa+bbb*T/Tlim)/(1.+ccc*T/Tlim);
388 static const G4double a1=4.15e-1, a3=2.10e-3, a5=54.0e-5 ;
396 factor=log(1.-e0)/eta;
399 factor = eta*(1.-factor)/e0;
415 G4double tmax = min(maxEnergy, kineticEnergy);
416 G4double cut = min(cutEnergy, kineticEnergy);
417 if(cut >= tmax) {
return cross; }
426 kineticEnergy, (*theElementVector)[i]->GetZ(), dum, cut);
427 if (tmax < kineticEnergy) {
429 kineticEnergy, (*theElementVector)[i]->GetZ(), dum, tmax);
439 G4double kp2 = MigdalConstant*totalEnergy*totalEnergy
446 G4int nn = (
G4int)(nmax*(vmax-vmin)/(log(highKinEnergy)-vmin));
450 dv = (vmax-vmin)/nn ;
456 fac = SupressionFunction(material, kineticEnergy, u);
458 fac *= (4.-4.*y+3.*y*
y)/3.;
459 fac *= probsup*(u*u/(u*u+kp2))+1.-probsup;
461 if ((
n==0)||(
n==
nn)) c=0.5;
468 fsig *=dv/(-4.*log(y)/3.-4.*(1.-
y)/3.+0.5*(1.-y*y));
474 if (fsig > 1.) fsig = 1.;
495 if ( kineticEnergy <
keV || kineticEnergy < cut) {
return cross; }
497 static const G4double ksi=2.0, alfa=1.00;
498 static const G4double csigh = 0.127, csiglow = 0.25, asiglow = 0.020*
MeV ;
502 static const G4int NZ = 8 ;
503 static const G4int Nsig = 11 ;
505 {2.,4.,6.,14.,26.,50.,82.,92.} ;
506 static const G4double coefsig[NZ][Nsig] = {
508 { 0.4638, 0.37748, 0.32249, -0.060362, -0.065004,
509 -0.033457, -0.004583, 0.011954, 0.0030404, -0.0010077,
513 { 0.50008, 0.33483, 0.34364, -0.086262, -0.055361,
514 -0.028168, -0.0056172, 0.011129, 0.0027528, -0.00092265,
518 { 0.51587, 0.31095, 0.34996, -0.11623, -0.056167,
519 -0.0087154, 0.00053943, 0.0054092, 0.00077685, -0.00039635,
523 { 0.55058, 0.25629, 0.35854, -0.080656, -0.054308,
524 -0.049933, -0.00064246, 0.016597, 0.0021789, -0.001327,
528 { 0.5791, 0.26152, 0.38953, -0.17104, -0.099172,
529 0.024596, 0.023718, -0.0039205, -0.0036658, 0.00041749,
533 { 0.62085, 0.27045, 0.39073, -0.37916, -0.18878,
534 0.23905, 0.095028, -0.068744, -0.023809, 0.0062408,
538 { 0.66053, 0.24513, 0.35404, -0.47275, -0.22837,
539 0.35647, 0.13203, -0.1049, -0.034851, 0.0095046,
543 { 0.67143, 0.23079, 0.32256, -0.46248, -0.20013,
544 0.3506, 0.11779, -0.1024, -0.032013, 0.0092279,
551 for (
G4int ii=0; ii<NZ; ii++)
553 G4double absdelz = std::abs(Z-ZZ[ii]);
566 fs = coefsig[
iz][Nsig-1] ;
567 for (
G4int j=Nsig-2; j>=0; j--) {
569 fs = fs*xx+coefsig[
iz][j] ;
571 if(fs < 0.) { fs = 0.; }
574 cross = Z*(Z+ksi)*(1.-csigh*exp(log(Z)/4.))*pow(log(kineticEnergy/cut),alfa);
576 if (kineticEnergy <= Tlim)
577 cross *= exp(csiglow*log(Tlim/kineticEnergy))
578 *(1.+asiglow/(sqrt(Z)*kineticEnergy));
581 cross *= PositronCorrFactorSigma(Z, kineticEnergy, cut);
585 if (cross < 0.) { cross = 0.; }
602 static const G4double a1 = 4.15e-1, a3 = 2.10e-3, a5 = 54.0e-5;
604 G4double x = log(kineticEnergy/(K*Z*Z));
607 G4double eta = 0.5 + atan(a1*x + a3*x3 + a5*x3*x2)/
pi ;
609 return eta*pow((1. - cut/kineticEnergy), alfa);
614 G4DataVector* G4eBremsstrahlungModel::ComputePartialSumSigma(
632 for (
G4int i=0; i<nElements; i++ ) {
635 kineticEnergy, (*theElementVector)[i]->GetZ(), dum, cut);
636 dv->push_back(cross);
663 G4double tmax = min(maxEnergy, kineticEnergy);
664 if(tmin >= tmax) {
return; }
670 ah10 = 4.67733E+00, ah11 =-6.19012E-01, ah12 = 2.02225E-02,
671 ah20 =-7.34101E+00, ah21 = 1.00462E+00, ah22 =-3.20985E-02,
672 ah30 = 2.93119E+00, ah31 =-4.03761E-01, ah32 = 1.25153E-02;
675 bh10 = 4.23071E+00, bh11 =-6.10995E-01, bh12 = 1.95531E-02,
676 bh20 =-7.12527E+00, bh21 = 9.69160E-01, bh22 =-2.74255E-02,
677 bh30 = 2.69925E+00, bh31 =-3.63283E-01, bh32 = 9.55316E-03;
680 al00 =-2.05398E+00, al01 = 2.38815E-02, al02 = 5.25483E-04,
681 al10 =-7.69748E-02, al11 =-6.91499E-02, al12 = 2.22453E-03,
682 al20 = 4.06463E-02, al21 =-1.01281E-02, al22 = 3.40919E-04;
685 bl00 = 1.04133E+00, bl01 =-9.43291E-03, bl02 =-4.54758E-04,
686 bl10 = 1.19253E-01, bl11 = 4.07467E-02, bl12 =-1.30718E-03,
687 bl20 =-1.59391E-02, bl21 = 7.27752E-03, bl22 =-1.94405E-04;
709 if(xmax >= 1.) { xmax = 1.; }
710 else { kappa = log(xmax)/log(xmin); }
711 G4double epsilmin = tmin/totalEnergy;
712 G4double epsilmax = tmax/totalEnergy;
716 / (epsilmax*epsilmax);
718 G4double x, epsil, greject, migdal, grejmax, q;
719 G4double U = log(kineticEnergy/electron_mass_c2);
726 if (kineticEnergy > tlow) {
728 G4double ah1 = ah10 + ZZ* (ah11 + ZZ* ah12);
729 G4double ah2 = ah20 + ZZ* (ah21 + ZZ* ah22);
730 G4double ah3 = ah30 + ZZ* (ah31 + ZZ* ah32);
732 G4double bh1 = bh10 + ZZ* (bh11 + ZZ* bh12);
733 G4double bh2 = bh20 + ZZ* (bh21 + ZZ* bh22);
734 G4double bh3 = bh30 + ZZ* (bh31 + ZZ* bh32);
736 ah = 1. + (ah1*U2 + ah2*U + ah3) / (U2*U);
737 bh = 0.75 + (bh1*U2 + bh2*U + bh3) / (U2*U);
742 G4double screenmin = screenfac*epsilmin/(1.-epsilmin);
745 G4double F1 = max(ScreenFunction1(screenmin) - FZ ,0.);
746 G4double F2 = max(ScreenFunction2(screenmin) - FZ ,0.);
747 grejmax = (F1 - epsilmin* (F1*ah - bh*epsilmin*F2))/(42.392 - FZ);
751 G4double al0 = al00 + ZZ* (al01 + ZZ* al02);
752 G4double al1 = al10 + ZZ* (al11 + ZZ* al12);
753 G4double al2 = al20 + ZZ* (al21 + ZZ* al22);
755 G4double bl0 = bl00 + ZZ* (bl01 + ZZ* bl02);
756 G4double bl1 = bl10 + ZZ* (bl11 + ZZ* bl12);
757 G4double bl2 = bl20 + ZZ* (bl21 + ZZ* bl22);
759 ah = al0 + al1*U + al2*U2;
760 bh = bl0 + bl1*U + bl2*U2;
763 grejmax = max(1. + xmin* (ah + bh*xmin), 1.+ah+bh);
765 if ( xmin < xm && xm < xmax) grejmax = max(grejmax, 1.+ xm* (ah + bh*xm));
773 if (kineticEnergy > tlow) {
776 x = pow(xmin, q + kappa*(1.0 - q));
777 epsil = x*kineticEnergy/totalEnergy;
778 G4double screenvar = screenfac*epsil/(1.0-epsil);
779 G4double F1 = max(ScreenFunction1(screenvar) - FZ ,0.);
780 G4double F2 = max(ScreenFunction2(screenvar) - FZ ,0.);
781 migdal = (1. + MigdalFactor)/(1. + MigdalFactor/(x*x));
782 greject = migdal*(F1 - epsil* (ah*F1 - bh*epsil*F2))/(42.392 - FZ);
798 x = pow(xmin, q + kappa*(1.0 - q));
799 migdal = (1. + MigdalFactor)/(1. + MigdalFactor/(x*x));
800 greject = migdal*(1. + x* (ah + bh*
x));
812 gammaEnergy = x*kineticEnergy;
816 if (
G4UniformRand() <= SupressionFunction(material,kineticEnergy,
837 vdp->push_back(gamma);
839 G4double totMomentum = sqrt(kineticEnergy*(totalEnergy + electron_mass_c2));
842 - gammaEnergy*gammaDirection).unit();
845 G4double finalE = kineticEnergy - gammaEnergy;
882 elm = (*theElementVector)[nElements];
883 for (
G4int i=0; i<nElements; ++i) {
884 if (rval <= (*dv)[i]) {
885 elm = (*theElementVector)[i];
889 }
else { elm = (*theElementVector)[0]; }
905 G4double totEnergySquare = totEnergy*totEnergy ;
909 G4double gammaEnergySquare = gammaEnergy*gammaEnergy ;
914 (gammaEnergySquare+MigdalConstant*totEnergySquare*electronDensity);
920 G4double s2lpm = LPMEnergy*gammaEnergy/totEnergySquare;
924 G4double LPMgEnergyLimit = totEnergySquare/LPMEnergy ;
925 G4double LPMgEnergyLimit2 = LPMgEnergyLimit*LPMgEnergyLimit;
927 (LPMgEnergyLimit2+MigdalConstant*totEnergySquare*electronDensity);
930 if ((1.-sp) < 1.e-6) w = s2lpm*(3.-sp);
931 else w = s2lpm*(1.+1./
sp);
933 supr = (sqrt(w*w+4.*s2lpm)-w)/(sqrt(w*w+4.)-w) ;