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

#include <G4PreCompoundModel.hh>

+ Inheritance diagram for G4PreCompoundModel:

Public Member Functions

 G4PreCompoundModel (G4ExcitationHandler *ptr=nullptr)
 
virtual ~G4PreCompoundModel ()
 
virtual G4HadFinalStateApplyYourself (const G4HadProjectile &thePrimary, G4Nucleus &theNucleus) final
 
virtual G4ReactionProductVectorDeExcite (G4Fragment &aFragment) final
 
virtual void BuildPhysicsTable (const G4ParticleDefinition &) final
 
virtual void InitialiseModel () final
 
virtual void ModelDescription (std::ostream &outFile) const final
 
virtual void DeExciteModelDescription (std::ostream &outFile) const final
 
void UseHETCEmission ()
 
void UseDefaultEmission ()
 
void UseGNASHTransition ()
 
void UseDefaultTransition ()
 
void SetOPTxs (G4int opt)
 
void UseSICB ()
 
void UseNGB ()
 
void UseSCO ()
 
void UseCEMtr ()
 
- Public Member Functions inherited from G4VPreCompoundModel
 G4VPreCompoundModel (G4ExcitationHandler *ptr=nullptr, const G4String &modelName="PrecompoundModel")
 
virtual ~G4VPreCompoundModel ()
 
virtual G4ReactionProductVectorDeExcite (G4Fragment &aFragment)=0
 
virtual void DeExciteModelDescription (std::ostream &outFile) const =0
 
void SetExcitationHandler (G4ExcitationHandler *ptr)
 
G4ExcitationHandlerGetExcitationHandler () const
 
 G4VPreCompoundModel (const G4VPreCompoundModel &)=delete
 
const G4VPreCompoundModeloperator= (const G4VPreCompoundModel &right)=delete
 
G4bool operator== (const G4VPreCompoundModel &right) const =delete
 
G4bool operator!= (const G4VPreCompoundModel &right) const =delete
 
- Public Member Functions inherited from G4HadronicInteraction
 G4HadronicInteraction (const G4String &modelName="HadronicModel")
 
virtual ~G4HadronicInteraction ()
 
virtual G4HadFinalStateApplyYourself (const G4HadProjectile &aTrack, G4Nucleus &targetNucleus)
 
virtual G4double SampleInvariantT (const G4ParticleDefinition *p, G4double plab, G4int Z, G4int A)
 
virtual G4bool IsApplicable (const G4HadProjectile &aTrack, G4Nucleus &targetNucleus)
 
G4double GetMinEnergy () const
 
G4double GetMinEnergy (const G4Material *aMaterial, const G4Element *anElement) const
 
void SetMinEnergy (G4double anEnergy)
 
void SetMinEnergy (G4double anEnergy, const G4Element *anElement)
 
void SetMinEnergy (G4double anEnergy, const G4Material *aMaterial)
 
G4double GetMaxEnergy () const
 
G4double GetMaxEnergy (const G4Material *aMaterial, const G4Element *anElement) const
 
void SetMaxEnergy (const G4double anEnergy)
 
void SetMaxEnergy (G4double anEnergy, const G4Element *anElement)
 
void SetMaxEnergy (G4double anEnergy, const G4Material *aMaterial)
 
G4int GetVerboseLevel () const
 
void SetVerboseLevel (G4int value)
 
const G4StringGetModelName () const
 
void DeActivateFor (const G4Material *aMaterial)
 
void ActivateFor (const G4Material *aMaterial)
 
void DeActivateFor (const G4Element *anElement)
 
void ActivateFor (const G4Element *anElement)
 
G4bool IsBlocked (const G4Material *aMaterial) const
 
G4bool IsBlocked (const G4Element *anElement) const
 
void SetRecoilEnergyThreshold (G4double val)
 
G4double GetRecoilEnergyThreshold () const
 
virtual const std::pair< G4double, G4doubleGetFatalEnergyCheckLevels () const
 
virtual std::pair< G4double, G4doubleGetEnergyMomentumCheckLevels () const
 
void SetEnergyMomentumCheckLevels (G4double relativeLevel, G4double absoluteLevel)
 
virtual void ModelDescription (std::ostream &outFile) const
 
virtual void BuildPhysicsTable (const G4ParticleDefinition &)
 
virtual void InitialiseModel ()
 
 G4HadronicInteraction (const G4HadronicInteraction &right)=delete
 
const G4HadronicInteractionoperator= (const G4HadronicInteraction &right)=delete
 
G4bool operator== (const G4HadronicInteraction &right) const =delete
 
G4bool operator!= (const G4HadronicInteraction &right) const =delete
 

Additional Inherited Members

- Protected Member Functions inherited from G4HadronicInteraction
void SetModelName (const G4String &nam)
 
G4bool IsBlocked () const
 
void Block ()
 
- Protected Attributes inherited from G4HadronicInteraction
G4HadFinalState theParticleChange
 
G4int verboseLevel
 
G4double theMinEnergy
 
G4double theMaxEnergy
 
G4bool isBlocked
 

Detailed Description

Definition at line 62 of file G4PreCompoundModel.hh.

Constructor & Destructor Documentation

◆ G4PreCompoundModel()

G4PreCompoundModel::G4PreCompoundModel ( G4ExcitationHandler ptr = nullptr)
explicit

Definition at line 69 of file G4PreCompoundModel.cc.

70 : G4VPreCompoundModel(ptr,"PRECO"),theEmission(nullptr),theTransition(nullptr),
71 useSCO(false),isInitialised(false),isActive(true),minZ(3),minA(5)
72{
73 //G4cout << "### NEW PrecompoundModel " << this << G4endl;
74 if(!ptr) { SetExcitationHandler(new G4ExcitationHandler()); }
75
77 proton = G4Proton::Proton();
78 neutron = G4Neutron::Neutron();
79 fLowLimitExc = 0.0;
80 fHighLimitExc = DBL_MAX;
81}
static G4Neutron * Neutron()
Definition: G4Neutron.cc:103
static G4NuclearLevelData * GetInstance()
static G4Proton * Proton()
Definition: G4Proton.cc:92
void SetExcitationHandler(G4ExcitationHandler *ptr)
#define DBL_MAX
Definition: templates.hh:62

◆ ~G4PreCompoundModel()

G4PreCompoundModel::~G4PreCompoundModel ( )
virtual

Definition at line 85 of file G4PreCompoundModel.cc.

86{
87 delete theEmission;
88 delete theTransition;
89 delete GetExcitationHandler();
90}
G4ExcitationHandler * GetExcitationHandler() const

Member Function Documentation

◆ ApplyYourself()

G4HadFinalState * G4PreCompoundModel::ApplyYourself ( const G4HadProjectile thePrimary,
G4Nucleus theNucleus 
)
finalvirtual

Reimplemented from G4HadronicInteraction.

Definition at line 136 of file G4PreCompoundModel.cc.

138{
139 const G4ParticleDefinition* primary = thePrimary.GetDefinition();
140 if(primary != neutron && primary != proton) {
142 ed << "G4PreCompoundModel is used for ";
143 if(primary) { ed << primary->GetParticleName(); }
144 G4Exception("G4PreCompoundModel::ApplyYourself()","had0033",FatalException,
145 ed,"");
146 return nullptr;
147 }
148
149 G4int Zp = 0;
150 G4int Ap = 1;
151 if(primary == proton) { Zp = 1; }
152
153 G4double timePrimary=thePrimary.GetGlobalTime();
154
155 G4int A = theNucleus.GetA_asInt();
156 G4int Z = theNucleus.GetZ_asInt();
157
158 //G4cout << "### G4PreCompoundModel::ApplyYourself: A= " << A << " Z= " << Z
159 // << " Ap= " << Ap << " Zp= " << Zp << G4endl;
160 // 4-Momentum
161 G4LorentzVector p = thePrimary.Get4Momentum();
163 p += G4LorentzVector(0.0,0.0,0.0,mass);
164 //G4cout << "Primary 4-mom " << p << " mass= " << mass << G4endl;
165
166 // prepare fragment
167 G4Fragment anInitialState(A + Ap, Z + Zp, p);
168 anInitialState.SetNumberOfExcitedParticle(2, 1);
169 anInitialState.SetNumberOfHoles(1,0);
170 anInitialState.SetCreationTime(thePrimary.GetGlobalTime());
171
172 // call excitation handler
173 G4ReactionProductVector * result = DeExcite(anInitialState);
174
175 // fill particle change
176 theResult.Clear();
177 theResult.SetStatusChange(stopAndKill);
178 for(G4ReactionProductVector::iterator i= result->begin();
179 i != result->end(); ++i)
180 {
181 G4DynamicParticle * aNewDP =
182 new G4DynamicParticle((*i)->GetDefinition(),
183 (*i)->GetTotalEnergy(),
184 (*i)->GetMomentum());
185 G4HadSecondary aNew = G4HadSecondary(aNewDP);
186 G4double time=(*i)->GetFormationTime();
187 if(time < 0.0) { time = 0.0; }
188 aNew.SetTime(timePrimary + time);
189 aNew.SetCreatorModelType((*i)->GetCreatorModel());
190 delete (*i);
191 theResult.AddSecondary(aNew);
192 }
193 delete result;
194
195 //return the filled particle change
196 return &theResult;
197}
double A(double temperature)
@ FatalException
void G4Exception(const char *originOfException, const char *exceptionCode, G4ExceptionSeverity severity, const char *description)
Definition: G4Exception.cc:35
std::ostringstream G4ExceptionDescription
Definition: G4Exception.hh:40
@ stopAndKill
CLHEP::HepLorentzVector G4LorentzVector
std::vector< G4ReactionProduct * > G4ReactionProductVector
double G4double
Definition: G4Types.hh:83
int G4int
Definition: G4Types.hh:85
void SetStatusChange(G4HadFinalStateStatus aS)
void AddSecondary(G4DynamicParticle *aP, G4int mod=-1)
const G4ParticleDefinition * GetDefinition() const
const G4LorentzVector & Get4Momentum() const
G4double GetGlobalTime() const
void SetTime(G4double aT)
void SetCreatorModelType(G4int idx)
static G4double GetNuclearMass(const G4double A, const G4double Z)
G4int GetA_asInt() const
Definition: G4Nucleus.hh:109
G4int GetZ_asInt() const
Definition: G4Nucleus.hh:115
const G4String & GetParticleName() const
virtual G4ReactionProductVector * DeExcite(G4Fragment &aFragment) final

◆ BuildPhysicsTable()

void G4PreCompoundModel::BuildPhysicsTable ( const G4ParticleDefinition )
finalvirtual

Reimplemented from G4HadronicInteraction.

Definition at line 94 of file G4PreCompoundModel.cc.

95{
97}
virtual void InitialiseModel() final

◆ DeExcite()

G4ReactionProductVector * G4PreCompoundModel::DeExcite ( G4Fragment aFragment)
finalvirtual

Implements G4VPreCompoundModel.

Definition at line 201 of file G4PreCompoundModel.cc.

202{
203 if(!isInitialised) { InitialiseModel(); }
204
206 G4double U = aFragment.GetExcitationEnergy();
207 G4int Z = aFragment.GetZ_asInt();
208 G4int A = aFragment.GetA_asInt();
209
210 //G4cout << "### G4PreCompoundModel::DeExcite" << G4endl;
211 //G4cout << aFragment << G4endl;
212
213 // Perform Equilibrium Emission
214 if (!isActive || (Z < minZ && A < minA) ||
215 U < fLowLimitExc*A || U > A*fHighLimitExc) {
216 PerformEquilibriumEmission(aFragment, Result);
217 return Result;
218 }
219
220 // main loop
221 G4int count = 0;
222 const G4double ldfact = 12.0/CLHEP::pi2;
223 const G4int countmax = 1000;
224 for (;;) {
225 //G4cout << "### PreCompound loop over fragment" << G4endl;
226 //G4cout << aFragment << G4endl;
227 U = aFragment.GetExcitationEnergy();
228 Z = aFragment.GetZ_asInt();
229 A = aFragment.GetA_asInt();
230 G4int eqExcitonNumber =
231 G4lrint(std::sqrt(ldfact*U*fNuclData->GetLevelDensity(Z, A, U)));
232 //
233 // G4cout<<"Neq="<<EquilibriumExcitonNumber<<G4endl;
234 //
235 // J. M. Quesada (Jan. 08) equilibrium hole number could be used as preeq.
236 // evap. delimiter (IAEA report)
237
238 // Loop for transitions, it is performed while there are
239 // preequilibrium transitions.
240 G4bool isTransition = false;
241
242 // G4cout<<"----------------------------------------"<<G4endl;
243 // G4double NP=aFragment.GetNumberOfParticles();
244 // G4double NH=aFragment.GetNumberOfHoles();
245 // G4double NE=aFragment.GetNumberOfExcitons();
246 // G4cout<<" Ex. Energy="<<aFragment.GetExcitationEnergy()<<G4endl;
247 // G4cout<<"N. excitons="<<NE<<" N. Part="<<NP<<"N. Holes ="<<NH<<G4endl;
248 do {
249 ++count;
250 //G4cout<<"transition number .."<<count
251 // <<" n ="<<aFragment.GetNumberOfExcitons()<<G4endl;
252 // soft cutoff criterium as an "ad-hoc" solution to force
253 // increase in evaporation
254 G4int ne = aFragment.GetNumberOfExcitons();
255 G4bool go_ahead = (ne <= eqExcitonNumber);
256
257 //J. M. Quesada (Apr. 08): soft-cutoff switched off by default
258 if (useSCO && go_ahead) {
259 G4double x = (G4double)(ne - eqExcitonNumber)/(G4double)eqExcitonNumber;
260 if( G4UniformRand() < 1.0 - G4Exp(-x*x/0.32) ) { go_ahead = false; }
261 }
262
263 // JMQ: WARNING: CalculateProbability MUST be called prior to Get!!
264 // (O values would be returned otherwise)
265 G4double transProbability = theTransition->CalculateProbability(aFragment);
266 G4double P1 = theTransition->GetTransitionProb1();
267 G4double P2 = theTransition->GetTransitionProb2();
268 G4double P3 = theTransition->GetTransitionProb3();
269 //G4cout<<"#0 P1="<<P1<<" P2="<<P2<<" P3="<<P3<<G4endl;
270
271 //J.M. Quesada (May 2008) Physical criterium (lamdas) PREVAILS over
272 // approximation (critical exciton number)
273 //V.Ivanchenko (May 2011) added check on number of nucleons
274 // to send a fragment to FermiBreakUp
275 // or check on limits of excitation
276 if(!go_ahead || P1 <= P2+P3 || Z < minZ || A < minA ||
277 U <= fLowLimitExc*A || U > A*fHighLimitExc ||
278 aFragment.GetNumberOfExcitons() <= 0) {
279 //G4cout<<"#4 EquilibriumEmission"<<G4endl;
280 PerformEquilibriumEmission(aFragment,Result);
281 return Result;
282 }
283 G4double emissionProbability = theEmission->GetTotalProbability(aFragment);
284
285 //G4cout<<"#1 TotalEmissionProbability="<<TotalEmissionProbability
286 // <<" Nex= " <<aFragment.GetNumberOfExcitons()<<G4endl;
287 //J.M.Quesada (May 08) this has already been done in order to decide
288 // what to do (preeq-eq)
289 // Sum of all probabilities
290 G4double TotalProbability = emissionProbability + transProbability;
291
292 // Select subprocess
293 if (TotalProbability*G4UniformRand() > emissionProbability) {
294 //G4cout<<"#2 Transition"<<G4endl;
295 // It will be transition to state with a new number of excitons
296 isTransition = true;
297 // Perform the transition
298 theTransition->PerformTransition(aFragment);
299 } else {
300 //G4cout<<"#3 Emission"<<G4endl;
301 // It will be fragment emission
302 isTransition = false;
303 Result->push_back(theEmission->PerformEmission(aFragment));
304 }
305 // Loop checking, 05-Aug-2015, Vladimir Ivanchenko
306 } while (isTransition); // end of do loop
307
308 // stop if too many iterations
309 if(count >= countmax) {
311 ed << "G4PreCompoundModel loop over " << countmax << " iterations; "
312 << "current G4Fragment: \n" << aFragment;
313 G4Exception("G4PreCompoundModel::DeExcite()","had0034",JustWarning,
314 ed,"");
315 PerformEquilibriumEmission(aFragment, Result);
316 return Result;
317 }
318 } // end of for (;;) loop
319 return Result;
320}
@ JustWarning
G4double G4Exp(G4double initial_x)
Exponential Function double precision.
Definition: G4Exp.hh:179
bool G4bool
Definition: G4Types.hh:86
#define G4UniformRand()
Definition: Randomize.hh:52
G4double GetExcitationEnergy() const
Definition: G4Fragment.hh:275
G4int GetZ_asInt() const
Definition: G4Fragment.hh:263
G4int GetNumberOfExcitons() const
Definition: G4Fragment.hh:332
G4int GetA_asInt() const
Definition: G4Fragment.hh:258
G4double GetLevelDensity(G4int Z, G4int A, G4double U)
G4ReactionProduct * PerformEmission(G4Fragment &aFragment)
G4double GetTotalProbability(const G4Fragment &aFragment)
virtual G4double CalculateProbability(const G4Fragment &aFragment)=0
virtual void PerformTransition(G4Fragment &aFragment)=0
int G4lrint(double ad)
Definition: templates.hh:134

Referenced by G4LowEGammaNuclearModel::ApplyYourself(), G4LowEIonFragmentation::ApplyYourself(), ApplyYourself(), and G4NeutrinoNucleusModel::RecoilDeexcitation().

◆ DeExciteModelDescription()

void G4PreCompoundModel::DeExciteModelDescription ( std::ostream &  outFile) const
finalvirtual

Implements G4VPreCompoundModel.

Definition at line 409 of file G4PreCompoundModel.cc.

410{
411 outFile << "description of precompound model as used with DeExcite()" << "\n";
412}

◆ InitialiseModel()

void G4PreCompoundModel::InitialiseModel ( )
finalvirtual

Reimplemented from G4HadronicInteraction.

Definition at line 101 of file G4PreCompoundModel.cc.

102{
103 if(isInitialised) { return; }
104 isInitialised = true;
105
106 //G4cout << "G4PreCompoundModel::InitialiseModel() started" << G4endl;
107
108 G4DeexPrecoParameters* param = fNuclData->GetParameters();
109
110 fLowLimitExc = param->GetPrecoLowEnergy();
111 fHighLimitExc = param->GetPrecoHighEnergy();
112
113 useSCO = param->UseSoftCutoff();
114
115 minZ = param->GetMinZForPreco();
116 minA = param->GetMinAForPreco();
117
118 theEmission = new G4PreCompoundEmission();
119 if(param->UseHETC()) { theEmission->SetHETCModel(); }
120 //else { theEmission->SetDefaultModel(); }
121 theEmission->SetOPTxs(param->GetPrecoModelType());
122
123 if(param->UseGNASH()) { theTransition = new G4GNASHTransitions; }
124 else { theTransition = new G4PreCompoundTransitions(); }
125 theTransition->UseNGB(param->NeverGoBack());
126 theTransition->UseCEMtr(param->UseCEM());
127
128 if(param->PrecoDummy()) { isActive = false; }
129
131}
G4double GetPrecoLowEnergy() const
G4double GetPrecoHighEnergy() const
G4DeexPrecoParameters * GetParameters()

Referenced by BuildPhysicsTable(), and DeExcite().

◆ ModelDescription()

void G4PreCompoundModel::ModelDescription ( std::ostream &  outFile) const
finalvirtual

Reimplemented from G4HadronicInteraction.

Definition at line 385 of file G4PreCompoundModel.cc.

386{
387 outFile
388 << "The GEANT4 precompound model is considered as an extension of the\n"
389 << "hadron kinetic model. It gives a possibility to extend the low energy range\n"
390 << "of the hadron kinetic model for nucleon-nucleus inelastic collision and it \n"
391 << "provides a ”smooth” transition from kinetic stage of reaction described by the\n"
392 << "hadron kinetic model to the equilibrium stage of reaction described by the\n"
393 << "equilibrium deexcitation models.\n"
394 << "The initial information for calculation of pre-compound nuclear stage\n"
395 << "consists of the atomic mass number A, charge Z of residual nucleus, its\n"
396 << "four momentum P0 , excitation energy U and number of excitons n, which equals\n"
397 << "the sum of the number of particles p (from them p_Z are charged) and the number of\n"
398 << "holes h.\n"
399 << "At the preequilibrium stage of reaction, we follow the exciton model approach in ref. [1],\n"
400 << "taking into account the competition among all possible nuclear transitions\n"
401 << "with ∆n = +2, −2, 0 (which are defined by their associated transition probabilities) and\n"
402 << "the emission of neutrons, protons, deuterons, thritium and helium nuclei (also defined by\n"
403 << "their associated emission probabilities according to exciton model)\n"
404 << "\n"
405 << "[1] K.K. Gudima, S.G. Mashnik, V.D. Toneev, Nucl. Phys. A401 329 (1983)\n"
406 << "\n";
407}

◆ SetOPTxs()

void G4PreCompoundModel::SetOPTxs ( G4int  opt)

Definition at line 346 of file G4PreCompoundModel.cc.

347{
348 PrintWarning("UseOPTxs");
349}

◆ UseCEMtr()

void G4PreCompoundModel::UseCEMtr ( )

Definition at line 366 of file G4PreCompoundModel.cc.

367{
368 PrintWarning("UseCEMtr");
369}

◆ UseDefaultEmission()

void G4PreCompoundModel::UseDefaultEmission ( )

Definition at line 331 of file G4PreCompoundModel.cc.

332{
333 PrintWarning("UseDefaultEmission");
334}

◆ UseDefaultTransition()

void G4PreCompoundModel::UseDefaultTransition ( )

Definition at line 341 of file G4PreCompoundModel.cc.

342{
343 PrintWarning("UseDefaultTransition");
344}

◆ UseGNASHTransition()

void G4PreCompoundModel::UseGNASHTransition ( )

Definition at line 336 of file G4PreCompoundModel.cc.

337{
338 PrintWarning("UseGNASHTransition");
339}

◆ UseHETCEmission()

void G4PreCompoundModel::UseHETCEmission ( )

Definition at line 326 of file G4PreCompoundModel.cc.

327{
328 PrintWarning("UseHETCEmission");
329}

◆ UseNGB()

void G4PreCompoundModel::UseNGB ( )

Definition at line 356 of file G4PreCompoundModel.cc.

357{
358 PrintWarning("UseNGB");
359}

◆ UseSCO()

void G4PreCompoundModel::UseSCO ( )

Definition at line 361 of file G4PreCompoundModel.cc.

362{
363 PrintWarning("UseSCO");
364}

◆ UseSICB()

void G4PreCompoundModel::UseSICB ( )

Definition at line 351 of file G4PreCompoundModel.cc.

352{
353 PrintWarning("UseSICB");
354}

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