58 fAccumSpectrum.clear();
61 fFa.resize(fNMCPhotons);
62 fSs.resize(fNMCPhotons);
63 fSc.resize(fNMCPhotons);
64 fSsx.resize(fNMCPhotons);
65 fSsy.resize(fNMCPhotons);
66 fScx.resize(fNMCPhotons);
67 fScy.resize(fNMCPhotons);
68 std::fill(fFa.begin(), fFa.end(), 0.);
69 std::fill(fSs.begin(), fSs.end(), 0.);
70 std::fill(fSc.begin(), fSc.end(), 0.);
71 std::fill(fSsx.begin(), fSsx.end(), 0.);
72 std::fill(fSsy.begin(), fSsy.end(), 0.);
73 std::fill(fScx.begin(), fScx.end(), 0.);
74 std::fill(fScy.begin(), fScy.end(), 0.);
77 fMeanPhotonAngleX =0.;
79 fParamPhotonAngleX=1.e-3*rad;
81 fMeanPhotonAngleY =0.;
83 fParamPhotonAngleY=1.e-3*rad;
89 fParticleAnglesX.clear();
90 fParticleAnglesY.clear();
91 fScatteringAnglesX.clear();
92 fScatteringAnglesY.clear();
95 fParticleCoordinatesXYZ.clear();
100 fImax0.push_back(0.);
103 fTotalRadiationProbabilityAlongTrajectory.clear();
105 fTotalRadiationProbabilityAlongTrajectory.push_back(0.);
114 fMinPhotonEnergy = emin;
115 fMaxPhotonEnergy = emax;
116 fNBinsSpectrum = numberOfBins;
118 fLogEmaxdEmin =
G4Log(fMaxPhotonEnergy/fMinPhotonEnergy);
121 fNPhotonsPerBin.resize(fNBinsSpectrum);
122 std::fill(fNPhotonsPerBin.begin(), fNPhotonsPerBin.end(), 0);
125 fSpectrum.resize(fNBinsSpectrum);
126 std::fill(fSpectrum.begin(), fSpectrum.end(), 0);
129 fAccumTotalSpectrum.resize(fNBinsSpectrum);
130 std::fill(fAccumTotalSpectrum.begin(), fAccumTotalSpectrum.end(), 0);
133 fTotalSpectrum.resize(fNBinsSpectrum);
134 std::fill(fTotalSpectrum.begin(), fTotalSpectrum.end(), 0);
136 fPhotonEnergyInSpectrum.clear();
137 for (
G4int j=0;j<fNBinsSpectrum;j++)
140 fPhotonEnergyInSpectrum.push_back(fMinPhotonEnergy*
141 (std::exp(fLogEmaxdEmin*j/fNBinsSpectrum)+
142 std::exp(fLogEmaxdEmin*(j+1)/fNBinsSpectrum))/2.);
154 G4int timesPhotonStatistics)
157 if(timesPhotonStatistics<=1)
159 G4cout <<
"G4BaierKatkov model, "
160 "function AddStatisticsInPhotonEnergyRegion("
161 << emin/CLHEP::MeV <<
" MeV, "
162 << emax/CLHEP::MeV <<
" MeV, "
163 << timesPhotonStatistics <<
")" <<
G4endl;
164 G4cout <<
"Warning: the statistics factor cannot be <=1." <<
G4endl;
168 else if(fMinPhotonEnergy>emin)
170 G4cout <<
"G4BaierKatkov model, "
171 "function AddStatisticsInPhotonEnergyRegion("
172 << emin/CLHEP::MeV <<
" MeV, "
173 << emax/CLHEP::MeV <<
" MeV, "
174 << timesPhotonStatistics <<
")" <<
G4endl;
175 G4cout <<
"Warning: the minimal energy inserted is less then "
176 "the minimal energy cut of the spectrum: "
177 << fMinPhotonEnergy/CLHEP::MeV <<
" MeV." <<
G4endl;
183 G4cout <<
"G4BaierKatkov model, "
184 "function AddStatisticsInPhotonEnergyRegion("
185 << emin/CLHEP::MeV <<
" MeV, "
186 << emax/CLHEP::MeV <<
" MeV, "
187 << timesPhotonStatistics <<
")" <<
G4endl;
188 G4cout <<
"Warning: the maximal energy <= the minimal energy." <<
G4endl;
195 G4double logAddRangeEmindEmin =
G4Log(emin/fMinPhotonEnergy);
196 G4double logAddRangeEmaxdEmin =
G4Log(emax/fMinPhotonEnergy);
198 G4int nAddRange = (
G4int)fTimesPhotonStatistics.size();
199 for (
G4int j=0;j<nAddRange;j++)
201 if((logAddRangeEmindEmin>=fLogAddRangeEmindEmin[j]&&
202 logAddRangeEmindEmin< fLogAddRangeEmaxdEmin[j])||
203 (logAddRangeEmaxdEmin> fLogAddRangeEmindEmin[j]&&
204 logAddRangeEmaxdEmin<=fLogAddRangeEmaxdEmin[j])||
205 (logAddRangeEmindEmin<=fLogAddRangeEmindEmin[j]&&
206 logAddRangeEmaxdEmin>=fLogAddRangeEmaxdEmin[j]))
208 G4cout <<
"G4BaierKatkov model, "
209 "function AddStatisticsInPhotonEnergyRegion("
210 << emin/CLHEP::MeV <<
" MeV, "
211 << emax/CLHEP::MeV <<
" MeV, "
212 << timesPhotonStatistics <<
")" <<
G4endl;
213 G4cout <<
"Warning: the energy range intersects another "
214 "added energy range." <<
G4endl;
223 fLogAddRangeEmindEmin.push_back(logAddRangeEmindEmin);
224 fLogAddRangeEmaxdEmin.push_back(logAddRangeEmaxdEmin);
225 fTimesPhotonStatistics.push_back(timesPhotonStatistics);
227 G4cout <<
"G4BaierKatkov model: increasing the statistics of photon sampling "
228 "in Baier-Katkov with a factor of "
229 << timesPhotonStatistics <<
G4endl;
230 G4cout <<
"in the energy spectrum range: ("
231 << emin/CLHEP::MeV <<
" MeV, "
232 << emax/CLHEP::MeV <<
" MeV)" <<
G4endl;
239void G4BaierKatkov::SetPhotonSamplingParameters(
G4double ekin,
245 fLogEdEmin =
G4Log(ekin/fMinPhotonEnergy);
246 fMeanPhotonAngleX = (maxPhotonAngleX+minPhotonAngleX)/2.;
247 fParamPhotonAngleX = (maxPhotonAngleX-minPhotonAngleX)/2.;
248 fMeanPhotonAngleY = (maxPhotonAngleY+minPhotonAngleY)/2.;
249 fParamPhotonAngleY = (maxPhotonAngleY-minPhotonAngleY)/2.;
254void G4BaierKatkov::GeneratePhotonSampling()
256 fPhotonEnergyInIntegral.clear();
257 fPhotonAngleInIntegralX.clear();
258 fPhotonAngleInIntegralY.clear();
259 fPhotonAngleNormCoef.clear();
260 fInsideVirtualCollimator.clear();
261 fIBinsSpectrum.clear();
264 std::vector<G4int> moreStatistics;
265 moreStatistics.resize(fTimesPhotonStatistics.size());
266 std::fill(moreStatistics.begin(), moreStatistics.end(), 0);
267 G4int nAddRange = (
G4int)fTimesPhotonStatistics.size();
271 for (
G4int j=0;j<fNMCPhotons;j++)
274 fIBinsSpectrum.push_back((
G4int)std::trunc(
275 ksi*fNBinsSpectrum/fLogEmaxdEmin));
279 if(fIBinsSpectrum[j]<fNBinsSpectrum) {fNPhotonsPerBin[fIBinsSpectrum[j]]+=1;}
281 fPhotonEnergyInIntegral.push_back(fMinPhotonEnergy*std::exp(ksi));
283 fPhotonAngleNormCoef.push_back(1.);
285 for (
G4int j2=0;j2<nAddRange;j2++)
287 if(ksi>fLogAddRangeEmindEmin[j2]&&
288 ksi<fLogAddRangeEmaxdEmin[j2])
292 moreStatistics[j2]+=1;
293 fPhotonAngleNormCoef[j]/=fTimesPhotonStatistics[j2];
299 for (
G4int j2=0;j2<nAddRange;j2++)
301 G4int totalAddRangeStatistics = moreStatistics[j2]*fTimesPhotonStatistics[j2];
302 for (
G4int j=moreStatistics[j2];j<totalAddRangeStatistics;j++)
304 ksi = fLogAddRangeEmindEmin[j2]+
305 G4UniformRand()*(std::min(fLogAddRangeEmaxdEmin[j2],fLogEdEmin)-
306 fLogAddRangeEmindEmin[j2]);
307 fIBinsSpectrum.push_back((
G4int)std::trunc(
308 ksi*fNBinsSpectrum/fLogEmaxdEmin));
315 fPhotonEnergyInIntegral.push_back(fMinPhotonEnergy*std::exp(ksi));
317 fPhotonAngleNormCoef.push_back(1./fTimesPhotonStatistics[j2]);
323 G4double norm=std::atan(rhocut*rhocut)*
324 CLHEP::pi*fParamPhotonAngleX*fParamPhotonAngleY;
328 G4int nmctotal = (
G4int)fPhotonEnergyInIntegral.size();
329 for (
G4int j=0;j<nmctotal;j++)
341 fPhotonAngleInIntegralX.push_back(fMeanPhotonAngleX+
343 rho*std::cos(CLHEP::twopi*ksi));
344 fPhotonAngleInIntegralY.push_back(fMeanPhotonAngleY+
346 rho*std::sin(CLHEP::twopi*ksi));
347 fPhotonAngleNormCoef[j]*=(1.+rho*rho*rho*rho)*norm;
352 fInsideVirtualCollimator.push_back(fVirtualCollimatorAngularDiameter >
353 std::sqrt(fPhotonAngleInIntegralX[j]*
354 fPhotonAngleInIntegralX[j]+
355 fPhotonAngleInIntegralY[j]*
356 fPhotonAngleInIntegralY[j]));
359 fPhotonProductionCDF.resize(nmctotal+1);
360 std::fill(fPhotonProductionCDF.begin(), fPhotonProductionCDF.end(), 0.);
363 if (nmctotal>fNMCPhotons)
366 fFa.resize(nmctotal);
367 fSs.resize(nmctotal);
368 fSc.resize(nmctotal);
369 fSsx.resize(nmctotal);
370 fSsy.resize(nmctotal);
371 fScx.resize(nmctotal);
372 fScy.resize(nmctotal);
373 std::fill(fFa.begin(), fFa.end(), 0.);
374 std::fill(fSs.begin(), fSs.end(), 0.);
375 std::fill(fSc.begin(), fSc.end(), 0.);
376 std::fill(fSsx.begin(), fSsx.end(), 0.);
377 std::fill(fSsy.begin(), fSsy.end(), 0.);
378 std::fill(fScx.begin(), fScx.end(), 0.);
379 std::fill(fScy.begin(), fScy.end(), 0.);
386 std::vector<G4double> &vectorParticleAnglesX,
387 std::vector<G4double> &vectorParticleAnglesY,
388 std::vector<G4double> &vectorScatteringAnglesX,
389 std::vector<G4double> &vectorScatteringAnglesY,
390 std::vector<G4double> &vectorSteps,
398 G4double vxin =0.,vyin=0.,vxno=0.,vyno=0.;
401 G4double fa1=0.,faseBefore=0.,faseBeforedz=0.,faseBeforedzd2=0.;
402 G4double faseAfter=0.,fa2dfaseBefore2=0.;
408 std::size_t nparts=vectorParticleAnglesX.size();
410 if(imin==0) {kmin=1;}
413 G4double totalRadiationProbabilityPhj = 0.;
416 fTotalRadiationProbabilityAlongTrajectory.resize(nparts);
419 std::fill(fSpectrum.begin(), fSpectrum.end(), 0.);
422 std::vector<G4double> axt;
424 std::vector<G4double> ayt;
426 std::vector<G4double> dz;
429 for(std::size_t k=kmin;k<nparts;k++)
431 dz[k]=vectorSteps[k]/CLHEP::hbarc;
434 axt[k]=(vectorParticleAnglesX[k]-vectorScatteringAnglesX[k]-
435 vectorParticleAnglesX[k-1])/dz[k];
436 ayt[k]=(vectorParticleAnglesY[k]-vectorScatteringAnglesY[k]-
437 vectorParticleAnglesY[k-1])/dz[k];
445 G4double gammaInverse2 = mass*mass/(etotal*etotal);
447 G4double coefNormLogdNMC = fLogEdEmin/fNMCPhotons;
450 G4double coefNorm = CLHEP::fine_structure_const/(8*(CLHEP::pi2))*coefNormLogdNMC;
455 std::size_t nmctotal = fPhotonEnergyInIntegral.size();
456 for (std::size_t j=0;j<nmctotal;j++)
459 om = fPhotonEnergyInIntegral[j];
461 eprime2 = eprime*eprime;
462 e2pluseprime2 =e2+eprime2;
463 omprime=etotal*
om/eprime;
465 coefNormom2deprime2 = coefNorm*
om*
om/eprime2;
466 gammaInverse2om2 = gammaInverse2*
om*
om;
468 for(std::size_t k=kmin;k<nparts;k++)
471 vxin = vectorParticleAnglesX[k]-fPhotonAngleInIntegralX[j];
472 vyin = vectorParticleAnglesY[k]-fPhotonAngleInIntegralY[j];
474 vxno = vxin-vectorScatteringAnglesX[k];
475 vyno = vyin-vectorScatteringAnglesY[k];
478 faseBefore=omprimed2*(gammaInverse2+vxno*vxno+vyno*vyno);
480 faseBeforedz = faseBefore*dz[k];
481 faseBeforedzd2 = faseBeforedz/2.;
482 fFa[j]+=faseBeforedz;
483 fa1=fFa[j]-faseBeforedzd2;
484 dzmod=2*std::sin(faseBeforedzd2)/faseBefore;
487 fa2dfaseBefore2 = omprime*(axt[k]*vxno+ayt[k]*vyno)/(faseBefore*faseBefore);
490 faseAfter=omprimed2*(gammaInverse2+vxin*vxin+vyin*vyin);
492 skJ=1/faseAfter-1/faseBefore-fa2dfaseBefore2*dzmod;
493 skIx=vxin/faseAfter-vxno/faseBefore+dzmod*(axt[k]/faseBefore-
494 vxno*fa2dfaseBefore2);
495 skIy=vyin/faseAfter-vyno/faseBefore+dzmod*(ayt[k]/faseBefore-
496 vyno*fa2dfaseBefore2);
498 sinfa1 = std::sin(fa1);
499 cosfa1 = std::cos(fa1);
503 fSsx[j]+=sinfa1*skIx;
504 fSsy[j]+=sinfa1*skIy;
505 fScx[j]+=cosfa1*skIx;
506 fScy[j]+=cosfa1*skIy;
508 i2=fSsx[j]*fSsx[j]+fScx[j]*fScx[j]+fSsy[j]*fSsy[j]+fScy[j]*fScy[j];
509 j2=fSs[j]*fSs[j]+fSc[j]*fSc[j];
512 totalRadiationProbabilityPhj = coefNormom2deprime2*fPhotonAngleNormCoef[j]*
513 (i2*e2pluseprime2+j2*gammaInverse2om2);
514 fTotalRadiationProbabilityAlongTrajectory[k] += totalRadiationProbabilityPhj;
517 fPhotonProductionCDF[j+1] = fTotalRadiationProbabilityAlongTrajectory.back();
524 if((fIBinsSpectrum[j]<fNBinsSpectrum)&&fInsideVirtualCollimator[j])
525 {fSpectrum[fIBinsSpectrum[j]] += totalRadiationProbabilityPhj/
526 (
om*coefNormLogdNMC);}
530 fAccumSpectrum.push_back(fSpectrum);
532 return fTotalRadiationProbabilityAlongTrajectory.back();
537G4int G4BaierKatkov::FindVectorIndex(std::vector<G4double> &myvector,
G4double value)
539 auto iteratorbegin = myvector.begin();
540 auto iteratorend = myvector.end();
543 auto loweriterator = std::lower_bound(iteratorbegin, iteratorend, value);
545 return (
G4int)std::distance(iteratorbegin, loweriterator);
553 G4bool flagPhotonProduced =
false;
557 std::size_t nodeNumber = fAccumSpectrum.size()-1;
565 if (ksi< fTotalRadiationProbabilityAlongTrajectory.back())
571 G4int iphoton = FindVectorIndex(fPhotonProductionCDF,ksi1)-1;
575 fEph0 = fPhotonEnergyInIntegral[iphoton];
577 G4double photonAngleX = fPhotonAngleInIntegralX[iphoton];
578 G4double photonAngleY = fPhotonAngleInIntegralY[iphoton];
581 std::sqrt(1.+std::pow(std::tan(photonAngleX),2)+
582 std::pow(std::tan(photonAngleY),2));
585 PhMomentumDirection.set(momentumDirectionZ*std::tan(photonAngleX),
586 momentumDirectionZ*std::tan(photonAngleY),
594 std::vector<G4double> temporaryVector;
595 temporaryVector.assign(fTotalRadiationProbabilityAlongTrajectory.begin(),
596 fTotalRadiationProbabilityAlongTrajectory.end());
597 std::sort(temporaryVector.begin(), temporaryVector.end());
600 G4int iNode = FindVectorIndex(temporaryVector,ksi);
603 auto it = std::find_if(fTotalRadiationProbabilityAlongTrajectory.begin(),
604 fTotalRadiationProbabilityAlongTrajectory.end(),
606 {return std::abs(value - temporaryVector[iNode]) < DBL_EPSILON;});
607 iNode = (
G4int)std::distance(fTotalRadiationProbabilityAlongTrajectory.begin(), it);
610 nodeNumber = FindVectorIndex(fImax0,iNode*1.)-1;
615 fNewParticleEnergy = etotal-fEph0;
616 fNewParticleAngleX = fParticleAnglesX[iNode];
617 fNewParticleAngleY = fParticleAnglesY[iNode];
618 fNewGlobalTime = fGlobalTimes[iNode];
619 fNewParticleCoordinateXYZ = fParticleCoordinatesXYZ[iNode];
624 G4double pratio = fEph0/std::sqrt(etotal*etotal-mass*mass);
625 fNewParticleAngleX -= std::asin(pratio*std::sin(photonAngleX));
626 fNewParticleAngleY -= std::asin(pratio*std::sin(photonAngleY));
628 flagPhotonProduced =
true;
632 for (
G4int j=0;j<fNBinsSpectrum;j++)
634 fAccumTotalSpectrum[j] += fAccumSpectrum[nodeNumber][j];
637 if(fNPhotonsPerBin[j]==0)
639 fTotalSpectrum[j] = 0;
643 fTotalSpectrum[j] = fAccumTotalSpectrum[j]/fNPhotonsPerBin[j]*fItrajectories;
647 return flagPhotonProduced;
691 G4bool flagPhotonProduced =
false;
694 fParticleAnglesX.push_back(angleX);
695 fParticleAnglesY.push_back(angleY);
696 fScatteringAnglesX.push_back(angleScatteringX);
697 fScatteringAnglesY.push_back(angleScatteringY);
698 fSteps.push_back(step);
699 fGlobalTimes.push_back(globalTime);
700 fParticleCoordinatesXYZ.push_back(coordinateXYZ);
703 if((imax==fImin0+fNSmallTrajectorySteps)||flagEndTrajectory)
709 G4double radiationAngleLimit=fRadiationAngleFactor*mass/etotal;
711 SetPhotonSamplingParameters(etotal-mass,
712 *std::min_element(fParticleAnglesX.begin(),
713 fParticleAnglesX.end())-radiationAngleLimit,
714 *std::max_element(fParticleAnglesX.begin(),
715 fParticleAnglesX.end())+radiationAngleLimit,
716 *std::min_element(fParticleAnglesY.begin(),
717 fParticleAnglesY.end())-radiationAngleLimit,
718 *std::max_element(fParticleAnglesY.begin(),
719 fParticleAnglesY.end())+radiationAngleLimit);
723 GeneratePhotonSampling();
728 fTotalRadiationProbability = RadIntegral(etotal,mass,
729 fParticleAnglesX,fParticleAnglesY,
730 fScatteringAnglesX,fScatteringAnglesY,
735 fImax0.push_back(imax*1.);
739 if(fTotalRadiationProbability>fSinglePhotonRadiationProbabilityLimit||
744 flagPhotonProduced = SetPhotonProductionParameters(etotal,mass);
755 return flagPhotonProduced;
763 PhMomentumDirection,fEph0);
Definition of the G4BaierKatkov class This class is designed for the calculation of radiation probabi...
G4double G4Log(G4double x)
CLHEP::Hep3Vector G4ThreeVector
G4GLOB_DLL std::ostream G4cout
void GeneratePhoton(G4FastStep &fastStep)
void SetSpectrumEnergyRange(G4double emin, G4double emax, G4int numberOfBins)
void AddStatisticsInPhotonEnergyRegion(G4double emin, G4double emax, G4int timesPhotonStatistics)
G4bool DoRadiation(G4double etotal, G4double mass, G4double angleX, G4double angleY, G4double angleScatteringX, G4double angleScatteringY, G4double step, G4double globalTime, G4ThreeVector coordinateXYZ, G4bool flagEndTrajectory=false)
G4Track * CreateSecondaryTrack(const G4DynamicParticle &, G4ThreeVector, G4ThreeVector, G4double, G4bool localCoordinates=true)