57const std::vector<G4double>* G4DNARuddIonisationExtendedModel::fpWaterDensity =
nullptr;
61 const G4double scaleFactor = CLHEP::m*CLHEP::m;
62 const G4double tolerance = 1*CLHEP::eV;
66 const G4double Bj[5] = {12.60*CLHEP::eV, 14.70*CLHEP::eV, 18.40*CLHEP::eV,
67 32.20*CLHEP::eV, 539*CLHEP::eV};
78 fLowestEnergy = 100*CLHEP::eV;
79 fLimitEnergy = 1*CLHEP::keV;
87 if (
nullptr == xshelium) { LoadData(); }
95 for(
auto & i : xsdata) {
delete i; }
101void G4DNARuddIonisationExtendedModel::LoadData()
105 G4String filename(
"dna/sigma_ionisation_h_rudd");
109 filename =
"dna/sigma_ionisation_p_rudd";
113 filename =
"dna/sigma_ionisation_alphaplusplus_rudd";
117 filename =
"dna/sigma_ionisation_li_rudd";
121 filename =
"dna/sigma_ionisation_be_rudd";
125 filename =
"dna/sigma_ionisation_b_rudd";
129 filename =
"dna/sigma_ionisation_c_rudd";
133 filename =
"dna/sigma_ionisation_n_rudd";
137 filename =
"dna/sigma_ionisation_o_rudd";
141 filename =
"dna/sigma_ionisation_si_rudd";
145 filename =
"dna/sigma_ionisation_fe_rudd";
149 filename =
"dna/sigma_ionisation_alphaplus_rudd";
153 filename =
"dna/sigma_ionisation_he_rudd";
168 if (p != fParticle) { SetParticle(p); }
176 if (!isInitialised) {
177 isInitialised =
true;
178 const G4String& pname = fParticle->GetParticleName();
179 if (pname ==
"proton") {
181 xscurrent = xsdata[1];
182 fElow = fLowestEnergy;
183 }
else if (pname ==
"hydrogen") {
185 xscurrent = xsdata[0];
186 fElow = fLowestEnergy;
187 }
else if (pname ==
"alpha") {
189 xscurrent = xsdata[2];
191 fElow = fLimitEnergy;
192 }
else if (pname ==
"alpha+") {
195 xscurrent = xsalphaplus;
196 fElow = fLimitEnergy;
198 slaterEffectiveCharge[0]=2.0;
199 slaterEffectiveCharge[1]=2.0;
200 slaterEffectiveCharge[2]=2.0;
202 sCoefficient[1]=0.15;
203 sCoefficient[2]=0.15;
204 }
else if (pname ==
"helium") {
207 fElow = fLimitEnergy;
208 xscurrent = xshelium;
209 slaterEffectiveCharge[0]=1.7;
210 slaterEffectiveCharge[1]=1.15;
211 slaterEffectiveCharge[2]=1.15;
213 sCoefficient[1]=0.25;
214 sCoefficient[2]=0.25;
218 xscurrent = xsdata[1];
219 fElow = fLowestEnergy;
228 G4cout <<
"### G4DNARuddIonisationExtendedModel::Initialise(..) " << pname
229 <<
"/n idx=" << idx <<
" isIon=" << isIon
230 <<
" isHelium=" << isHelium <<
G4endl;
241 fMassRate = (isIon) ? CLHEP::proton_mass_c2/fMass : 1.0;
254 ? (*fpWaterDensity)[material->
GetIndex()] : 0.0;
255 if (0.0 == density) {
return 0.0; }
258 if (fParticle != part) { SetParticle(part); }
261 if (kinE < fLowestEnergy) {
return DBL_MAX; }
265 G4double sigma = (e > fElow) ? xscurrent->FindValue(e)
266 : xscurrent->FindValue(fElow) * e / fElow;
269 sigma *= fEmCorrections->EffectiveChargeSquareRatio(part, material, kinE);
276 <<
" Ekin(keV)=" << kinE/CLHEP::keV
277 <<
" sigma(cm^2)=" << sigma/CLHEP::cm2 <<
G4endl;
291 if (fParticle != pd) { SetParticle(pd); }
296 if (kinE <= fLowestEnergy) {
303 G4int shell = SelectShell(kinE*fMassRate);
304 G4double bindingEnergy = (useDNAWaterStructure)
305 ? waterStructure.IonisationEnergy(shell) : Bj[shell];
308 if (kinE < bindingEnergy) {
return; }
310 G4double esec = SampleElectronEnergy(kinE, shell);
321 if(fAtomDeexcitation !=
nullptr && shell == 4) {
323 auto ashell = fAtomDeexcitation->GetAtomicShell(Z, as);
324 fAtomDeexcitation->GenerateParticles(fvect, ashell, Z, 0, 0);
327 for (
auto const & ptr : *fvect) {
328 esum += ptr->GetKineticEnergy();
333 G4double exc = bindingEnergy - esum;
336 G4double scatteredEnergy = kinE - bindingEnergy - esec;
337 if(scatteredEnergy < -tolerance || exc < -tolerance) {
338 G4cout <<
"G4DNARuddIonisationExtendedModel::SampleSecondaries: "
339 <<
"negative final E(keV)=" << scatteredEnergy/CLHEP::keV <<
" Ein(keV)="
341 <<
" Edelta(keV)=" << esec/CLHEP::keV <<
" MeV, Exc(keV)=" << exc/CLHEP::keV
356 fvect->push_back(dp);
366G4int G4DNARuddIonisationExtendedModel::SelectShell(
G4double e)
370 for (
G4int i=0; i<5; ++i) {
372 xs = (e > fElow) ? ptr->
FindValue(e) : ptr->FindValue(fElow)*e/fElow;
377 for (
G4int i=0; i<5; ++i) {
378 if (sum <= fTemp[i]) {
return i; }
390 G4double emax = 2.0*CLHEP::electron_mass_c2*tau*(tau + 2.0);
424 wc = 4.*v2 - 2.*v - 0.25*u;
426 G4double L1 = (
C1 * fGpow->powA(v, D1)) / (1. + E1 * fGpow->powA(v, (D1 + 4.)));
429 G4double H2 = (A2 / v2) + (B2 / (v2 * v2));
432 F2 = (L2 * H2) / (L2 + H2);
438G4double G4DNARuddIonisationExtendedModel::SampleElectronEnergy(
G4double kine,
441 G4double emax = MaxEnergy(kine, shell);
445 nn = std::min(std::max(nn, 10), 100);
449 G4double pmax = ProbabilityFunction(kine, 0.0, shell);
466 p = ProbabilityFunction(kine, e, shell);
479 if (std::abs(e - emax) < step) {
483 p = ProbabilityFunction(kine, e, shell);
494 if (std::abs(e - emax) < step) {
498 p = ProbabilityFunction(kine, e, shell);
510 G4double s2 = s1 + p2 * (emax - e2);
511 s0 = (
s0 == s1) ? 1.0 :
s0 / s2;
512 s1 = (s1 == s2) ? 1.0 : s1 / s2;
520 for (
G4int i = 0; i<100000; ++i) {
524 deltae = e1 * q /
s0;
525 }
else if (q <= s1) {
527 deltae = e1 + (e2 - e1) * (q - s0) / (s1 -
s0);
530 deltae = e2 + (emax - e2) * (q - s1) / (1.0 - s1);
532 y = ProbabilityFunction(kine, deltae, shell);
535 if (y > ymax && count < 10) {
537 G4cout <<
"G4DNARuddIonisationExtendedModel::SampleElectronEnergy warning: "
538 << fParticle->GetParticleName() <<
" E(keV)=" << kine/CLHEP::keV
539 <<
" Edelta(keV)=" << deltae/CLHEP::keV
540 <<
" y=" << y <<
" ymax=" << ymax <<
" n=" << i <<
G4endl;
546 deltae = std::min(e0 + step, 0.5*emax);
552G4double G4DNARuddIonisationExtendedModel::ProbabilityFunction(
G4double kine,
575 G4double res = CorrectionFactor(kine, shell) * (F1 + w*F2) /
576 (fGpow->powN((1. + w)/u, 3) * y);
579 G4double energyTransfer = deltae + bEnergy;
581 (sCoefficient[0] * S_1s(kine, energyTransfer, slaterEffectiveCharge[0], 1.) +
582 sCoefficient[1] * S_2s(kine, energyTransfer, slaterEffectiveCharge[1], 2.) +
583 sCoefficient[2] * S_2p(kine, energyTransfer, slaterEffectiveCharge[2], 2.) );
587 return std::max(res, 0.0);
595 if (fParticle != p) { SetParticle(p); }
597 return ProbabilityFunction(e, deltae, shell);
610 G4double r = Rh(kine, energyTransfer, slaterEffCharge, shellNumber);
611 G4double value = 1. -
G4Exp(-2 * r) * ( ( 2. * r + 2. ) * r + 1. );
625 G4double r = Rh(kine, energyTransfer, slaterEffCharge, shellNumber);
627 1. -
G4Exp(-2 * r) * (((2. * r * r + 2.) * r + 2.) * r + 1.);
642 G4double r = Rh(kine, energyTransfer, slaterEffCharge, shellNumber);
644 1. -
G4Exp(-2 * r) * (((( 2./3. * r + 4./3.) * r + 2.) * r + 2.) * r + 1.);
657 G4double escaled = CLHEP::electron_mass_c2/fMass * ekin;
658 const G4double H = 13.60569172 * CLHEP::eV;
659 G4double value = 2.0*std::sqrt(escaled / H)*q*H /(etrans*shell);
667G4DNARuddIonisationExtendedModel::CorrectionFactor(
G4double kine,
G4int shell)
671 if (shell < 4 && 0 != idx) {
672 const G4double ln10 = fGpow->logZ(10);
675 res = 0.6/(1.0 +
G4Exp(x)) + 0.9;
G4double G4Exp(G4double initial_x)
Exponential Function double precision.
G4double G4Log(G4double x)
CLHEP::Hep3Vector G4ThreeVector
G4GLOB_DLL std::ostream G4cout
static G4DNAChemistryManager * Instance()
void CreateWaterMolecule(ElectronicModification, G4int, const G4Track *)
G4bool LoadData(const G4String &argFileName) override
const G4VEMDataSet * GetComponent(G4int componentId) const override
const std::vector< G4double > * GetNumMolPerVolTableFor(const G4Material *) const
Retrieve a table of molecular densities (number of molecules per unit volume) in the G4 unit system f...
static G4DNAMolecularMaterial * Instance()
G4double CrossSectionPerVolume(const G4Material *material, const G4ParticleDefinition *p, G4double ekin, G4double emin, G4double emax) override
G4ParticleChangeForGamma * fParticleChangeForGamma
void SampleSecondaries(std::vector< G4DynamicParticle * > *, const G4MaterialCutsCouple *, const G4DynamicParticle *, G4double tmin, G4double maxEnergy) override
G4double ComputeProbabilityFunction(const G4ParticleDefinition *, G4double kine, G4double deltae, G4int shell)
G4DNARuddIonisationExtendedModel(const G4ParticleDefinition *p=nullptr, const G4String &nam="DNARuddIonisationExtendedModel")
~G4DNARuddIonisationExtendedModel() override
void Initialise(const G4ParticleDefinition *, const G4DataVector &) override
G4ParticleDefinition * GetDefinition() const
G4double GetKineticEnergy() const
static G4Electron * Electron()
static G4EmParameters * Instance()
G4bool DNAStationary() const
static G4LossTableManager * Instance()
G4VAtomDeexcitation * AtomDeexcitation()
G4EmCorrections * EmCorrections()
const G4Material * GetMaterial() const
std::size_t GetIndex() const
G4Material * FindMaterial(const G4String &name) const
static G4NistManager * Instance()
G4double GetPDGMass() const
const G4String & GetParticleName() const
static G4Pow * GetInstance()
virtual G4double FindValue(G4double x, G4int componentId=0) const =0
virtual G4ThreeVector & SampleDirectionForShell(const G4DynamicParticle *dp, G4double finalTotalEnergy, G4int Z, G4int shellID, const G4Material *)
G4VEmAngularDistribution * GetAngularDistribution()
G4ParticleChangeForGamma * GetParticleChangeForGamma()
void SetDeexcitationFlag(G4bool val)
G4VEmModel(const G4String &nam)
void SetAngularDistribution(G4VEmAngularDistribution *)