Geant4 11.3.0
Toolkit for the simulation of the passage of particles through matter
Loading...
Searching...
No Matches
G4DNADoubleIonisationModel Class Reference

#include <G4DNADoubleIonisationModel.hh>

+ Inheritance diagram for G4DNADoubleIonisationModel:

Public Member Functions

 G4DNADoubleIonisationModel (const G4ParticleDefinition *p=nullptr, const G4String &model_name="G4DNADoubleIonisationModel")
 
 ~G4DNADoubleIonisationModel () override
 
G4DNADoubleIonisationModeloperator= (const G4DNADoubleIonisationModel &)=delete
 
 G4DNADoubleIonisationModel (const G4DNADoubleIonisationModel &)=delete
 
void Initialise (const G4ParticleDefinition *particle, const G4DataVector &) override
 
G4double CrossSectionPerVolume (const G4Material *material, const G4ParticleDefinition *pdef, G4double ekin, G4double, G4double) override
 
void SampleSecondaries (std::vector< G4DynamicParticle * > *vsec, const G4MaterialCutsCouple *couple, const G4DynamicParticle *particle, G4double, G4double) override
 
void SelectStationary (G4bool in)
 
void SelectVerboseLevel (G4int in)
 
void UseChampionAlphaParameter (G4bool in)
 
void SetMultipleIonisationEnergy (G4double in)
 
- Public Member Functions inherited from G4VEmModel
 G4VEmModel (const G4String &nam)
 
virtual ~G4VEmModel ()
 
virtual void InitialiseLocal (const G4ParticleDefinition *, G4VEmModel *masterModel)
 
virtual void InitialiseForMaterial (const G4ParticleDefinition *, const G4Material *)
 
virtual void InitialiseForElement (const G4ParticleDefinition *, G4int Z)
 
virtual G4double ComputeDEDXPerVolume (const G4Material *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy=DBL_MAX)
 
virtual G4double GetPartialCrossSection (const G4Material *, G4int level, const G4ParticleDefinition *, G4double kineticEnergy)
 
virtual G4double ComputeCrossSectionPerAtom (const G4ParticleDefinition *, G4double kinEnergy, G4double Z, G4double A=0., G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
 
virtual G4double ComputeCrossSectionPerShell (const G4ParticleDefinition *, G4int Z, G4int shellIdx, G4double kinEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
 
virtual G4double ChargeSquareRatio (const G4Track &)
 
virtual G4double GetChargeSquareRatio (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
 
virtual G4double GetParticleCharge (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
 
virtual void StartTracking (G4Track *)
 
virtual void CorrectionsAlongStep (const G4MaterialCutsCouple *, const G4DynamicParticle *, const G4double &length, G4double &eloss)
 
virtual G4double Value (const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy)
 
virtual G4double MinPrimaryEnergy (const G4Material *, const G4ParticleDefinition *, G4double cut=0.0)
 
virtual G4double MinEnergyCut (const G4ParticleDefinition *, const G4MaterialCutsCouple *)
 
virtual void SetupForMaterial (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
 
virtual void DefineForRegion (const G4Region *)
 
virtual void FillNumberOfSecondaries (G4int &numberOfTriplets, G4int &numberOfRecoil)
 
virtual void ModelDescription (std::ostream &outFile) const
 
void InitialiseElementSelectors (const G4ParticleDefinition *, const G4DataVector &)
 
std::vector< G4EmElementSelector * > * GetElementSelectors ()
 
void SetElementSelectors (std::vector< G4EmElementSelector * > *)
 
G4double ComputeDEDX (const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy=DBL_MAX)
 
G4double CrossSection (const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
 
G4double ComputeMeanFreePath (const G4ParticleDefinition *, G4double kineticEnergy, const G4Material *, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
 
G4double ComputeCrossSectionPerAtom (const G4ParticleDefinition *, const G4Element *, G4double kinEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
 
const G4ElementSelectRandomAtom (const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
 
const G4ElementSelectTargetAtom (const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy, G4double logKineticEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
 
const G4ElementSelectRandomAtom (const G4Material *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
 
const G4ElementGetCurrentElement (const G4Material *mat=nullptr) const
 
G4int SelectRandomAtomNumber (const G4Material *) const
 
const G4IsotopeGetCurrentIsotope (const G4Element *elm=nullptr) const
 
G4int SelectIsotopeNumber (const G4Element *) const
 
void SetParticleChange (G4VParticleChange *, G4VEmFluctuationModel *f=nullptr)
 
void SetCrossSectionTable (G4PhysicsTable *, G4bool isLocal)
 
G4ElementDataGetElementData ()
 
G4PhysicsTableGetCrossSectionTable ()
 
G4VEmFluctuationModelGetModelOfFluctuations ()
 
G4VEmAngularDistributionGetAngularDistribution ()
 
G4VEmModelGetTripletModel ()
 
void SetTripletModel (G4VEmModel *)
 
void SetAngularDistribution (G4VEmAngularDistribution *)
 
G4double HighEnergyLimit () const
 
G4double LowEnergyLimit () const
 
G4double HighEnergyActivationLimit () const
 
G4double LowEnergyActivationLimit () const
 
G4double PolarAngleLimit () const
 
G4double SecondaryThreshold () const
 
G4bool DeexcitationFlag () const
 
G4bool ForceBuildTableFlag () const
 
G4bool UseAngularGeneratorFlag () const
 
void SetAngularGeneratorFlag (G4bool)
 
void SetHighEnergyLimit (G4double)
 
void SetLowEnergyLimit (G4double)
 
void SetActivationHighEnergyLimit (G4double)
 
void SetActivationLowEnergyLimit (G4double)
 
G4bool IsActive (G4double kinEnergy) const
 
void SetPolarAngleLimit (G4double)
 
void SetSecondaryThreshold (G4double)
 
void SetDeexcitationFlag (G4bool val)
 
void SetForceBuildTable (G4bool val)
 
void SetFluctuationFlag (G4bool val)
 
G4bool IsMaster () const
 
void SetUseBaseMaterials (G4bool val)
 
G4bool UseBaseMaterials () const
 
G4double MaxSecondaryKinEnergy (const G4DynamicParticle *dynParticle)
 
const G4StringGetName () const
 
void SetCurrentCouple (const G4MaterialCutsCouple *)
 
G4bool IsLocked () const
 
void SetLocked (G4bool)
 
void SetLPMFlag (G4bool)
 
void SetMasterThread (G4bool)
 
G4VEmModeloperator= (const G4VEmModel &right)=delete
 
 G4VEmModel (const G4VEmModel &)=delete
 

Protected Member Functions

G4double RandomizeEjectedElectronEnergy (G4ParticleDefinition *pdef, G4double ekin, G4int shell)
 
G4int RandomSelect (G4double energy, G4double scale_param, const G4String &pname)
 
G4double GenerateSecondaries (std::vector< G4DynamicParticle * > *vsec, const G4MaterialCutsCouple *couple, const G4DynamicParticle *particle, G4int ioni_shell, G4double &theta, G4double &phi, G4double &shell_energy)
 
G4double GetLowEnergyLimit (const G4String &pname)
 
G4double GetUppEnergyLimit (const G4String &pname)
 
- Protected Member Functions inherited from G4VEmModel
G4ParticleChangeForLossGetParticleChangeForLoss ()
 
G4ParticleChangeForGammaGetParticleChangeForGamma ()
 
virtual G4double MaxSecondaryEnergy (const G4ParticleDefinition *, G4double kineticEnergy)
 
const G4MaterialCutsCoupleCurrentCouple () const
 
void SetCurrentElement (const G4Element *)
 

Protected Attributes

G4ParticleChangeForGammaparticle_change_ = nullptr
 
G4bool stat_code_
 
G4VAtomDeexcitationatom_deex_
 
EnergyLimitTable elow_tab_
 
EnergyLimitTable eupp_tab_
 
CrossSectionDataTable xs_tab_
 
G4ParticleDefinitionproton_def_ {nullptr}
 
G4ParticleDefinitionalpha_def_ {nullptr}
 
G4ParticleDefinitioncarbon_def_ {nullptr}
 
const std::vector< G4double > * water_density_
 
G4bool is_initialized_
 
G4int verbose_level_
 
std::map< G4double, G4doublemodel_elow_tab_
 
G4DNAMultipleIonisationManagermioni_manager_ {nullptr}
 
G4bool use_champion_param_
 
G4double energy_threshold_
 
- Protected Attributes inherited from G4VEmModel
G4ElementDatafElementData = nullptr
 
G4VParticleChangepParticleChange = nullptr
 
G4PhysicsTablexSectionTable = nullptr
 
const G4MaterialpBaseMaterial = nullptr
 
const std::vector< G4double > * theDensityFactor = nullptr
 
const std::vector< G4int > * theDensityIdx = nullptr
 
G4double inveplus
 
G4double pFactor = 1.0
 
std::size_t currentCoupleIndex = 0
 
std::size_t basedCoupleIndex = 0
 
G4bool lossFlucFlag = true
 

Detailed Description

Definition at line 59 of file G4DNADoubleIonisationModel.hh.

Constructor & Destructor Documentation

◆ G4DNADoubleIonisationModel() [1/2]

G4DNADoubleIonisationModel::G4DNADoubleIonisationModel ( const G4ParticleDefinition * p = nullptr,
const G4String & model_name = "G4DNADoubleIonisationModel" )

Definition at line 215 of file G4DNADoubleIonisationModel.cc.

217 : G4VEmModel(model_name),
218 is_initialized_(false)
219{
220 water_density_ = nullptr;
221
222 model_elow_tab_[1] = 100 * eV;
223 model_elow_tab_[4] = 1.0 * keV;
224 model_elow_tab_[5] = 0.5 * MeV; // For A = 3 or above, limit is MeV/uma
225
226 verbose_level_ = 0;
227
228 // Define default angular generator
229 SetAngularDistribution(new G4DNARuddAngle());
230
231 // Mark this model as "applicable" for atomic deexcitation
233 atom_deex_ = nullptr;
234 particle_change_ = nullptr;
235
236 // Selection of stationary mode
237 stat_code_ = false;
238
239 // True if use champion alpha parameter
240 use_champion_param_ = false;
241
242 // Double-ionization energy
243 energy_threshold_ = 40.0 * eV;
244}
std::map< G4double, G4double > model_elow_tab_
const std::vector< G4double > * water_density_
G4ParticleChangeForGamma * particle_change_
void SetDeexcitationFlag(G4bool val)
G4VEmModel(const G4String &nam)
Definition G4VEmModel.cc:67
void SetAngularDistribution(G4VEmAngularDistribution *)

Referenced by G4DNADoubleIonisationModel(), G4DNAQuadrupleIonisationModel::G4DNAQuadrupleIonisationModel(), G4DNATripleIonisationModel::G4DNATripleIonisationModel(), and operator=().

◆ ~G4DNADoubleIonisationModel()

G4DNADoubleIonisationModel::~G4DNADoubleIonisationModel ( )
override

Definition at line 247 of file G4DNADoubleIonisationModel.cc.

248{
249 for (const auto& x : xs_tab_) {
250 G4DNACrossSectionDataSet* table = x.second;
251 if (table) { delete table; }
252 }
253}

◆ G4DNADoubleIonisationModel() [2/2]

G4DNADoubleIonisationModel::G4DNADoubleIonisationModel ( const G4DNADoubleIonisationModel & )
delete

Member Function Documentation

◆ CrossSectionPerVolume()

G4double G4DNADoubleIonisationModel::CrossSectionPerVolume ( const G4Material * material,
const G4ParticleDefinition * pdef,
G4double ekin,
G4double ,
G4double  )
overridevirtual

Reimplemented from G4VEmModel.

Reimplemented in G4DNAQuadrupleIonisationModel, and G4DNATripleIonisationModel.

Definition at line 397 of file G4DNADoubleIonisationModel.cc.

400{
401
402 if (verbose_level_ > 3) {
403 G4cout << "Calling G4DNADoubleIonisationModel::CrossSectionPerVolume()"
404 << G4endl;
405 }
406
407 // Calculate total cross section for model
408
409 if (pdef != proton_def_ && pdef != alpha_def_ && pdef != carbon_def_) {
410 return 0.0;
411 }
412
413 static G4double water_dens = (*water_density_)[material->GetIndex()];
414
415 const auto& pname = pdef->GetParticleName();
416
417 const auto low_energy_lim = GetLowEnergyLimit(pname);
418 const auto upp_energy_lim = GetUppEnergyLimit(pname);
419
420 G4double sigma{0.0};
421 if (ekin <= upp_energy_lim) {
422
423 if (ekin < low_energy_lim) { ekin = low_energy_lim; }
424
425 CrossSectionDataTable::iterator pos = xs_tab_.find(pname);
426 if (pos == xs_tab_.end()) {
427 G4Exception("G4DNADoubleIonisationModel::CrossSectionPerVolume",
428 "em0002", FatalException,
429 "Model not applicable to particle type.");
430 }
431
432 G4DNACrossSectionDataSet* table = pos->second;
433 if (table != nullptr) {
434 const auto a = mioni_manager_->GetAlphaParam(ekin);
435 sigma = table->FindValue(ekin) * a;
436 }
437
438 }
439
440 if (verbose_level_ > 2) {
441
442 std::stringstream msg;
443
444 msg << "----------------------------------------------------------------\n";
445 msg << " G4DNADoubleIonisationModel - XS INFO START\n";
446 msg << " - Kinetic energy(eV): " << ekin/eV << ", Particle : "
447 << pdef->GetParticleName() << "\n";
448 msg << " - Cross section per water molecule (cm^2): "
449 << sigma / cm / cm << "\n";
450 msg << " - Cross section per water molecule (cm^-1): "
451 << sigma * water_dens / (1.0 / cm) << "\n";
452 msg << " G4DNADoubleIonisationModel - XS INFO END\n";
453 msg << "----------------------------------------------------------------\n";
454
455 G4cout << msg.str() << G4endl;
456
457 }
458
459 return (sigma * water_dens);
460
461}
@ FatalException
void G4Exception(const char *originOfException, const char *exceptionCode, G4ExceptionSeverity severity, const char *description)
double G4double
Definition G4Types.hh:83
#define G4endl
Definition G4ios.hh:67
G4GLOB_DLL std::ostream G4cout
G4double FindValue(G4double e, G4int componentId=0) const override
G4DNAMultipleIonisationManager * mioni_manager_
G4double GetUppEnergyLimit(const G4String &pname)
G4double GetLowEnergyLimit(const G4String &pname)
std::size_t GetIndex() const
const G4String & GetParticleName() const

◆ GenerateSecondaries()

G4double G4DNADoubleIonisationModel::GenerateSecondaries ( std::vector< G4DynamicParticle * > * vsec,
const G4MaterialCutsCouple * couple,
const G4DynamicParticle * particle,
G4int ioni_shell,
G4double & theta,
G4double & phi,
G4double & shell_energy )
protected

Definition at line 464 of file G4DNADoubleIonisationModel.cc.

468{
469 auto pdef = particle->GetDefinition();
470
471 // get kinetic energy for a parent particle
472 auto ekin1 = particle->GetKineticEnergy();
473
474 // sample kinetic energy for a secondary electron
475 auto ekin2 = RandomizeEjectedElectronEnergy(pdef, ekin1, ioni_shell);
476
477 // sample momentum direction for a secondary electron
478 auto sample_electron_direction = [this](
479 const G4DynamicParticle* dp, G4double _ekin2, G4int _Z, G4int _ioni_shell,
480 const G4MaterialCutsCouple* mcc, G4double& _theta, G4double& _phi) {
481
482 G4ThreeVector locdir;
483
484 if (_theta > 0.0) {
485
486 auto costh = std::cos(_theta);
487 auto sinth = std::sqrt((1.0 - costh) * (1.0 + costh));
488 locdir.set(sinth * std::cos(_phi), sinth * std::sin(_phi), costh);
489 locdir.rotateUz(dp->GetMomentumDirection());
490
491 } else {
492
494 dp, _ekin2, _Z, _ioni_shell, mcc->GetMaterial());
495 _theta = locdir.theta();
496 _phi = locdir.phi();
497
498 }
499
500 return locdir;
501 };
502
503 constexpr G4int Z = 8;
504 auto delta_dir = sample_electron_direction(
505 particle, ekin2, Z, ioni_shell, couple, theta, phi);
506
507 // generate a secondary electron and put it into the stack
508 auto dp = new G4DynamicParticle(G4Electron::Electron(), delta_dir, ekin2);
509 vsec->push_back(dp);
510
511 if (!atom_deex_ || ioni_shell != 4) { return ekin2; }
512
513 // ***************************************************************************
514 // Only atomic deexcitation from K shell is considered
515
516 constexpr auto k_shell = G4AtomicShellEnumerator(0);
517 const auto shell = atom_deex_->GetAtomicShell(Z, k_shell);
518
519 // get number of secondary electrons in the stack
520 // before processing atomic deescitation
521 const auto num_sec_init = vsec->size();
522
523 // perform atomic deexcitation process
524 atom_deex_->GenerateParticles(vsec, shell, Z, 0, 0);
525
526 // get number of secondary electrons in the stack
527 // after processing atomic deescitation
528 const auto num_sec_final = vsec->size();
529
530 if (num_sec_final == num_sec_init) { return ekin2; }
531
532 for (auto i = num_sec_init; i < num_sec_final; i++) {
533
534 auto e = ((*vsec)[i])->GetKineticEnergy();
535
536 // Check if there is enough residual energy
537 if (shell_energy < e) {
538
539 // Invalid secondary: not enough energy to create it!
540 // Keep its energy in the local deposit
541 delete (*vsec)[i];
542 (*vsec)[i] = 0;
543
544 continue;
545
546 }
547
548 // Ok, this is a valid secondary: keep it
549 shell_energy -= e;
550 }
551
552 // ***************************************************************************
553
554 return ekin2;
555}
CLHEP::Hep3Vector G4ThreeVector
int G4int
Definition G4Types.hh:85
double phi() const
double theta() const
void set(double x, double y, double z)
Hep3Vector & rotateUz(const Hep3Vector &)
G4double RandomizeEjectedElectronEnergy(G4ParticleDefinition *pdef, G4double ekin, G4int shell)
const G4ThreeVector & GetMomentumDirection() const
G4ParticleDefinition * GetDefinition() const
G4double GetKineticEnergy() const
static G4Electron * Electron()
Definition G4Electron.cc:91
virtual G4ThreeVector & SampleDirectionForShell(const G4DynamicParticle *dp, G4double finalTotalEnergy, G4int Z, G4int shellID, const G4Material *)
G4VEmAngularDistribution * GetAngularDistribution()

Referenced by SampleSecondaries(), G4DNAQuadrupleIonisationModel::SampleSecondaries(), and G4DNATripleIonisationModel::SampleSecondaries().

◆ GetLowEnergyLimit()

G4double G4DNADoubleIonisationModel::GetLowEnergyLimit ( const G4String & pname)
protected

Definition at line 375 of file G4DNADoubleIonisationModel.cc.

376{
377 G4double elim{0.0};
378
379 EnergyLimitTable::iterator itr = elow_tab_.find(pname);
380 if (itr != elow_tab_.end()) { elim = itr->second; }
381
382 return elim;
383}

Referenced by CrossSectionPerVolume(), G4DNAQuadrupleIonisationModel::CrossSectionPerVolume(), G4DNATripleIonisationModel::CrossSectionPerVolume(), SampleSecondaries(), G4DNAQuadrupleIonisationModel::SampleSecondaries(), and G4DNATripleIonisationModel::SampleSecondaries().

◆ GetUppEnergyLimit()

G4double G4DNADoubleIonisationModel::GetUppEnergyLimit ( const G4String & pname)
protected

Definition at line 386 of file G4DNADoubleIonisationModel.cc.

387{
388 G4double elim{0.0};
389
390 EnergyLimitTable::iterator itr = eupp_tab_.find(pname);
391 if (itr != eupp_tab_.end()) { elim = itr->second; }
392
393 return elim;
394}

Referenced by CrossSectionPerVolume(), G4DNAQuadrupleIonisationModel::CrossSectionPerVolume(), and G4DNATripleIonisationModel::CrossSectionPerVolume().

◆ Initialise()

void G4DNADoubleIonisationModel::Initialise ( const G4ParticleDefinition * particle,
const G4DataVector &  )
overridevirtual

Implements G4VEmModel.

Reimplemented in G4DNAQuadrupleIonisationModel, and G4DNATripleIonisationModel.

Definition at line 256 of file G4DNADoubleIonisationModel.cc.

258{
259 if (verbose_level_ > 3) {
260 G4cout << "Calling G4DNADoubleIonisationModel::Initialise()" << G4endl;
261 }
262
266
267 constexpr G4double kScaleFactor = 1.0 * m * m;
268
269 mioni_manager_ = new G4DNAMultipleIonisationManager();
270
271 G4double Z{0.0}, A{0.0};
272 G4String alpha_param_file{"dna/multipleionisation_alphaparam_champion.dat"};
273
274 if (particle == proton_def_) {
275
276 // *************************************************************************
277 // for protons
278 const auto& proton = proton_def_->GetParticleName();
280 eupp_tab_[proton] = 3.0 * MeV;
281
282 // load cross-section data for single ionization process
283 auto xs_proton = new G4DNACrossSectionDataSet(
284 new G4LogLogInterpolation, eV, kScaleFactor);
285 xs_proton->LoadData("dna/sigma_ionisation_p_rudd");
286 xs_tab_[proton] = xs_proton;
287
288 // set energy limits
291
292 if (!use_champion_param_) {
293 alpha_param_file = "dna/multipleionisation_alphaparam_p.dat";
294 }
295
296 Z = static_cast<G4double>(proton_def_->GetAtomicNumber());
297 A = static_cast<G4double>(proton_def_->GetAtomicMass());
298
299 } else if (particle == alpha_def_) {
300
301 //**************************************************************************
302 // for alpha particles
303 const auto& alpha = alpha_def_->GetParticleName();
305 eupp_tab_[alpha] = 23.0 * MeV;
306
307 // load cross-section data for single ionization process
308 auto xs_alpha = new G4DNACrossSectionDataSet(
309 new G4LogLogInterpolation, eV, kScaleFactor);
310 xs_alpha->LoadData("dna/sigma_ionisation_alphaplusplus_rudd");
311 xs_tab_[alpha] = xs_alpha;
312
313 // set energy limits
316
317 if (!use_champion_param_) {
318 alpha_param_file = "dna/multipleionisation_alphaparam_alphaplusplus.dat";
319 }
320
321 Z = static_cast<G4double>(alpha_def_->GetAtomicNumber());
322 A = static_cast<G4double>(alpha_def_->GetAtomicMass());
323
324 } else if (particle == G4GenericIon::GenericIonDefinition()) {
325
326 // *************************************************************************
327 // for carbon ions
328 const auto& carbon = carbon_def_->GetParticleName();
329 elow_tab_[carbon] = model_elow_tab_[5] * carbon_def_->GetAtomicMass();
330 eupp_tab_[carbon] = 120.0 * MeV;
331
332 // load cross-section data for single ionization process
333 auto xs_carbon = new G4DNACrossSectionDataSet(
334 new G4LogLogInterpolation, eV, kScaleFactor);
335 xs_carbon->LoadData("dna/sigma_ionisation_c_rudd");
336 xs_tab_[carbon] = xs_carbon;
337
338 // set energy limits
341
342 if (!use_champion_param_) {
343 alpha_param_file = "dna/multipleionisation_alphaparam_c.dat";
344 }
345
346 Z = static_cast<G4double>(carbon_def_->GetAtomicNumber());
347 A = static_cast<G4double>(carbon_def_->GetAtomicMass());
348
349 }
350
351 // load alpha parameter
352 mioni_manager_->LoadAlphaParam(alpha_param_file, Z, A);
353
354 if (verbose_level_ > 0) {
355 G4cout << "G4DNADoubleIonisationModel is initialized " << G4endl
356 << "Energy range: "
357 << LowEnergyLimit() / eV << " eV - "
358 << HighEnergyLimit() / keV << " keV for "
359 << particle->GetParticleName()
360 << G4endl;
361 }
362
364 G4Material::GetMaterial("G4_WATER"));
365
367
368 if (is_initialized_) { return; }
369
371 is_initialized_ = true;
372}
const G4double A[17]
static G4DNAGenericIonsManager * Instance()
G4ParticleDefinition * GetIon(const G4String &name)
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()
static G4GenericIon * GenericIonDefinition()
G4ParticleDefinition * GetIon(G4int Z, G4int A, G4int lvl=0)
static G4IonTable * GetIonTable()
static G4LossTableManager * Instance()
G4VAtomDeexcitation * AtomDeexcitation()
static G4Material * GetMaterial(const G4String &name, G4bool warning=true)
static G4Proton * ProtonDefinition()
Definition G4Proton.cc:85
void SetHighEnergyLimit(G4double)
G4ParticleChangeForGamma * GetParticleChangeForGamma()
G4double LowEnergyLimit() const
G4double HighEnergyLimit() const
void SetLowEnergyLimit(G4double)

◆ operator=()

G4DNADoubleIonisationModel & G4DNADoubleIonisationModel::operator= ( const G4DNADoubleIonisationModel & )
delete

◆ RandomizeEjectedElectronEnergy()

G4double G4DNADoubleIonisationModel::RandomizeEjectedElectronEnergy ( G4ParticleDefinition * pdef,
G4double ekin,
G4int shell )
protected

Definition at line 651 of file G4DNADoubleIonisationModel.cc.

653{
654
655 //
656 // based on RandomizeEjectedElectronEnergy()
657 // of G4DNARuddIonisationExtendedModel
658 //
659
660 ::FuncParams par;
661 ::setup_rejection_function(pdef, ekin, shell, par);
662
663 // calculate maximum value
664 G4double emax{0.0}, val;
665 for (G4double en = 0.0; en < 20.0; en += 1.0) {
666 val = ::rejection_function(pdef, shell, par, en);
667 if (val <= emax) { continue; }
668 emax = val;
669 }
670
671 G4double proposed_energy, rand;
672 do {
673 // Proposed energy by inverse function sampling
674 proposed_energy = ::proposed_sampled_energy(par);
675 rand = G4UniformRand() * emax;
676 val = ::rejection_function(pdef, shell, par, proposed_energy);
677 } while (rand > val);
678
679 return proposed_energy;
680}
#define G4UniformRand()
Definition Randomize.hh:52

Referenced by GenerateSecondaries().

◆ RandomSelect()

G4int G4DNADoubleIonisationModel::RandomSelect ( G4double energy,
G4double scale_param,
const G4String & pname )
protected

Definition at line 683 of file G4DNADoubleIonisationModel.cc.

685{
686
687 //
688 // based on RandomSelect() of G4DNARuddIonisationExtendedModel
689 //
690
691 // Retrieve data table corresponding to the current particle type
692 CrossSectionDataTable::iterator pos = xs_tab_.find(pname);
693
694 if (pos == xs_tab_.end()) {
695 G4Exception("G4DNADoubleIonisationModel::RandomSelect", "em0002",
696 FatalException, "Model not applicable to particle type.");
697 }
698
699 G4DNACrossSectionDataSet* table = pos->second;
700
701 if (table != nullptr) {
702
703 // get total number of energy level
704 const auto num_component = table->NumberOfComponents();
705
706 auto* valuesBuffer = new G4double[num_component];
707
708 auto shell = num_component;
709 G4double value = 0.0;
710
711 while (shell > 0) {
712 shell--;
713 valuesBuffer[shell] = table->GetComponent((G4int)shell)->FindValue(ekin)
714 * scale_param;
715 value += valuesBuffer[shell];
716 }
717
718 value *= G4UniformRand();
719
720 shell = num_component;
721
722 while (shell > 0) {
723 shell--;
724 if (valuesBuffer[shell] > value) {
725 delete [] valuesBuffer;
726 return (G4int)shell;
727 }
728 value -= valuesBuffer[shell];
729 }
730
731 delete [] valuesBuffer;
732 }
733
734 return 0;
735}
size_t NumberOfComponents() const override
const G4VEMDataSet * GetComponent(G4int componentId) const override
virtual G4double FindValue(G4double x, G4int componentId=0) const =0

Referenced by SampleSecondaries(), G4DNAQuadrupleIonisationModel::SampleSecondaries(), and G4DNATripleIonisationModel::SampleSecondaries().

◆ SampleSecondaries()

void G4DNADoubleIonisationModel::SampleSecondaries ( std::vector< G4DynamicParticle * > * vsec,
const G4MaterialCutsCouple * couple,
const G4DynamicParticle * particle,
G4double ,
G4double  )
overridevirtual

Implements G4VEmModel.

Reimplemented in G4DNAQuadrupleIonisationModel, and G4DNATripleIonisationModel.

Definition at line 558 of file G4DNADoubleIonisationModel.cc.

561{
562
563 if (verbose_level_ > 3) {
564 G4cout << "Calling SampleSecondaries() of G4DNADoubleIonisationModel"
565 << G4endl;
566 }
567
568 // get the definition for this parent particle
569 auto pdef = particle->GetDefinition();
570
571 // get kinetic energy
572 auto ekin = particle->GetKineticEnergy();
573
574 // get particle name
575 const auto& pname = pdef->GetParticleName();
576
577 // get energy limits
578 const auto low_energy_lim = GetLowEnergyLimit(pname);
579
580 // ***************************************************************************
581 // stop the transportation process of this parent particle
582 // if its kinetic energy is below the lower limit
583 if (ekin < low_energy_lim) {
584 particle_change_->SetProposedKineticEnergy(0.0);
585 particle_change_->ProposeTrackStatus(fStopAndKill);
586 particle_change_->ProposeLocalEnergyDeposit(ekin);
587 return;
588 }
589 // ***************************************************************************
590
591 constexpr G4int kNumSecondaries = 2;
592 constexpr G4double kDeltaTheta = pi;
593
594 G4int ioni_shell[kNumSecondaries];
595 G4double shell_energy[kNumSecondaries];
596
597 const auto scale_param = mioni_manager_->GetAlphaParam(ekin);
598 G4double tot_ioni_energy{0.0};
599 for (G4int i = 0; i < kNumSecondaries; i++) {
600 ioni_shell[i] = RandomSelect(ekin, scale_param, pname);
601 shell_energy[i] = ::water_structure.IonisationEnergy(ioni_shell[i]);
602 tot_ioni_energy += shell_energy[i];
603 }
604
605 if (ekin < tot_ioni_energy || tot_ioni_energy < energy_threshold_) {
606 return;
607 }
608
609 // generate secondary electrons
610 G4double theta{0.0}, phi{0.0}, tot_ekin2{0.0};
611 for (G4int i = 0; i < kNumSecondaries; i++) {
612 tot_ekin2 += GenerateSecondaries(vsec, couple, particle, ioni_shell[i],
613 theta, phi, shell_energy[i]);
614 theta += kDeltaTheta;
615 }
616
617 // This should never happen
618 if (mioni_manager_->CheckShellEnergy(eDoubleIonisedMolecule, shell_energy)) {
619 G4Exception("G4DNADoubleIonisatioModel::SampleSecondaries()",
620 "em2050", FatalException, "Negative local energy deposit");
621 }
622
623 // ***************************************************************************
624 // update kinematics for this parent particle
625 const auto primary_dir = particle->GetMomentumDirection();
626 particle_change_->ProposeMomentumDirection(primary_dir);
627
628 const auto scattered_energy = ekin - tot_ioni_energy - tot_ekin2;
629
630 // update total amount of shell energy
631 tot_ioni_energy = shell_energy[0] + shell_energy[1];
632
633 if (stat_code_) {
634 particle_change_->SetProposedKineticEnergy(ekin);
635 particle_change_->ProposeLocalEnergyDeposit(ekin - scattered_energy);
636 } else {
637 particle_change_->SetProposedKineticEnergy(scattered_energy);
638 particle_change_->ProposeLocalEnergyDeposit(tot_ioni_energy);
639 }
640
641 // ***************************************************************************
642 // generate double-ionized water molecules (H2O^2+)
643 const auto the_track = particle_change_->GetCurrentTrack();
644 mioni_manager_->CreateMultipleIonisedWaterMolecule(
645 eDoubleIonisedMolecule, ioni_shell, the_track);
646 // ***************************************************************************
647
648}
@ fStopAndKill
G4int RandomSelect(G4double energy, G4double scale_param, const G4String &pname)
G4double GenerateSecondaries(std::vector< G4DynamicParticle * > *vsec, const G4MaterialCutsCouple *couple, const G4DynamicParticle *particle, G4int ioni_shell, G4double &theta, G4double &phi, G4double &shell_energy)
const G4double pi

◆ SelectStationary()

void G4DNADoubleIonisationModel::SelectStationary ( G4bool in)
inline

Definition at line 142 of file G4DNADoubleIonisationModel.hh.

143{
144 stat_code_ = in;
145}

◆ SelectVerboseLevel()

void G4DNADoubleIonisationModel::SelectVerboseLevel ( G4int in)
inline

Definition at line 148 of file G4DNADoubleIonisationModel.hh.

149{
150 verbose_level_ = in;
151}

◆ SetMultipleIonisationEnergy()

void G4DNADoubleIonisationModel::SetMultipleIonisationEnergy ( G4double in)
inline

Definition at line 160 of file G4DNADoubleIonisationModel.hh.

161{
163}

◆ UseChampionAlphaParameter()

void G4DNADoubleIonisationModel::UseChampionAlphaParameter ( G4bool in)
inline

Definition at line 154 of file G4DNADoubleIonisationModel.hh.

155{
157}

Member Data Documentation

◆ alpha_def_

◆ atom_deex_

◆ carbon_def_

◆ elow_tab_

◆ energy_threshold_

◆ eupp_tab_

◆ is_initialized_

G4bool G4DNADoubleIonisationModel::is_initialized_
protected

◆ mioni_manager_

◆ model_elow_tab_

std::map<G4double, G4double> G4DNADoubleIonisationModel::model_elow_tab_
protected

◆ particle_change_

◆ proton_def_

◆ stat_code_

◆ use_champion_param_

◆ verbose_level_

◆ water_density_

const std::vector<G4double>* G4DNADoubleIonisationModel::water_density_
protected

◆ xs_tab_


The documentation for this class was generated from the following files: