Geant4 11.1.1
Toolkit for the simulation of the passage of particles through matter
All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Pages
G4Abla.hh
Go to the documentation of this file.
1//
2// ********************************************************************
3// * License and Disclaimer *
4// * *
5// * The Geant4 software is copyright of the Copyright Holders of *
6// * the Geant4 Collaboration. It is provided under the terms and *
7// * conditions of the Geant4 Software License, included in the file *
8// * LICENSE and available at http://cern.ch/geant4/license . These *
9// * include a list of copyright holders. *
10// * *
11// * Neither the authors of this software system, nor their employing *
12// * institutes,nor the agencies providing financial support for this *
13// * work make any representation or warranty, express or implied, *
14// * regarding this software system or assume any liability for its *
15// * use. Please see the license in the file LICENSE and URL above *
16// * for the full disclaimer and the limitation of liability. *
17// * *
18// * This code implementation is the result of the scientific and *
19// * technical work of the GEANT4 collaboration. *
20// * By using, copying, modifying or distributing the software (or *
21// * any work based on the software) you agree to acknowledge its *
22// * use in resulting scientific publications, and indicate your *
23// * acceptance of all terms of the Geant4 Software license. *
24// ********************************************************************
25//
26// ABLAXX statistical de-excitation model
27// Jose Luis Rodriguez, GSI (translation from ABLA07 and contact person)
28// Pekka Kaitaniemi, HIP (initial translation of ablav3p)
29// Aleksandra Kelic, GSI (ABLA07 code)
30// Davide Mancusi, CEA (contact person INCL)
31// Aatos Heikkinen, HIP (project coordination)
32//
33#define ABLAXX_IN_GEANT4_MODE 1
34
35#include "globals.hh"
36
37#ifndef G4Abla_hh
38#define G4Abla_hh 1
39
40#ifdef ABLAXX_IN_GEANT4_MODE
41#include "globals.hh"
42#else
43#include "G4INCLGeant4Compat.hh"
44#include "G4INCLConfig.hh"
45#endif
46
47#include "G4AblaRandom.hh"
48#include "G4AblaDataDefs.hh"
49
50/**
51 * Class containing ABLA++ de-excitation code.
52 */
53
54class G4Abla {
55
56public:
57 /**
58 * This constructor is used by standalone test driver and the Geant4 interface.
59 *
60 * @param aHazard random seeds
61 * @param aVolant data structure for ABLA output
62 * @param aVarNtp data structure for transfering ABLA output to Geant4 interface
63 */
64#ifdef ABLAXX_IN_GEANT4_MODE
65 G4Abla(G4Volant *aVolant, G4VarNtp *aVarntp);
66#else
67 G4Abla(G4INCL::Config *config, G4Volant *aVolant, G4VarNtp *aVarntp);
68#endif
69
70 /**
71 * Basic destructor.
72 */
73 ~G4Abla();
74
75 /// \brief Dummy copy constructor
76 G4Abla(G4Abla const &other);
77
78 /// \brief Dummy assignment operator
79 G4Abla &operator=(G4Abla const &other);
80
81 /**
82 * Set verbosity level.
83 */
84 void setVerboseLevel(G4int level);
85
86 /**
87 * Get the internal output data structure pointer.
88 */
90 return volant;
91 }
92
93 /**
94 * Main interface to the de-excitation code.
95 *
96 * @param nucleusA mass number of the nucleus
97 * @param nucleusZ charge number of the nucleus
98 * @param excitationEnergy excitation energy of the nucleus
99 * @param angularMomentum angular momentum of the nucleus (produced as output by INCL4)
100 * @param momX momentum x-component
101 * @param momY momentum y-component
102 * @param momZ momentum z-component
103 * @param eventnumber number of the event
104 */
105 void DeexcitationAblaxx(G4int nucleusA, G4int nucleusZ, G4double excitationEnergy, G4double angularMomentum, G4double momX, G4double momY, G4double momZ, G4int eventnumber);
106
107 /**
108 * Main interface to the de-excitation code for hyper-nuclei.
109 *
110 * @param nucleusA mass number of the nucleus
111 * @param nucleusZ charge number of the nucleus
112 * @param excitationEnergy excitation energy of the nucleus
113 * @param angularMomentum angular momentum of the nucleus (produced as output by INCL)
114 * @param momX momentum x-component
115 * @param momY momentum y-component
116 * @param momZ momentum z-component
117 * @param eventnumber number of the event
118 * @param nucleusS is the strange number
119 */
120 void DeexcitationAblaxx(G4int nucleusA, G4int nucleusZ, G4double excitationEnergy, G4double angularMomentum, G4double momX, G4double momY, G4double momZ, G4int eventnumber, G4int nucleusS);
121
122 // Evaporation
123public:
124 /**
125 * Initialize ABLA evaporation code.
126 *
127 */
128 void initEvapora();
129
130 /**
131 * Initialize ABLA parameters.
132 *
133 */
134 void SetParameters();
135 void SetParametersG4(G4int z, G4int a);
136
137 /**
138 * Coefficient of collective enhancement including damping
139 * Input: z,a,bet,sig,u
140 * Output: qr - collective enhancement factor
141 * See junghans et al., nucl. phys. a 629 (1998) 635
142 * @param z charge number
143 * @param a mass number
144 * @param bet beta deformation
145 * @param sig perpendicular spin cut-off factor
146 * @param u Energy
147 * @return Coefficient of collective enhancement
148 */
149 void qrot(G4double z, G4double a, G4double bet, G4double sig, G4double u, G4double *qr);
150
151 /**
152 * Model de la goutte liquide de c. f. weizsacker.
153 * usually an obsolete option
154 */
155 void mglw(G4double a, G4double z, G4double *el);
156
157 /**
158 * Mglms
159 */
160 void mglms(G4double a, G4double z, G4int refopt4, G4double *el);
161
162 /**
163 *
164 */
165 G4double spdef(G4int a, G4int z, G4int optxfis);
166
167 /**
168 * Calculation of fissility parameter
169 */
170 G4double fissility(G4int a, G4int z, G4int ny, G4double sn, G4double slam, G4int optxfis);
171
172 /**
173 * Main evaporation routine.
174 */
175 void evapora(G4double zprf, G4double aprf, G4double *ee_par, G4double jprf,
176 G4double *zf_par, G4double *af_par, G4double *mtota_par,
177 G4double *vleva_par, G4double *vxeva_par, G4double *vyeva_par,
178 G4int *ff_par, G4int *fimf_par, G4double *fzimf, G4double *faimf, G4double *tkeimf_par,G4double *jprfout,G4int *inttype_par, G4int *inum_par,G4double EV_TEMP[200][6],G4int *iev_tab_temp_par, G4int *nblam0);
179
180
181 /**
182 * Calculation of particle emission probabilities.
183 */
184 void direct(G4double zprf, G4double a, G4double ee, G4double jprf, G4double *probp_par, G4double *probd_par, G4double *probt_par, G4double *probn_par, G4double *probhe_par, G4double *proba_par, G4double *probg_par,G4double *probimf_par,G4double *probf_par,G4double *problamb0_par, G4double *ptotl_par, G4double *sn_par, G4double *sbp_par, G4double *sbd_par, G4double *sbt_par, G4double *sbhe_par, G4double *sba_par,G4double *slamb0_par, G4double *ecn_par, G4double *ecp_par, G4double *ecd_par, G4double *ect_par,G4double *eche_par,G4double *eca_par, G4double *ecg_par, G4double *eclamb0_par, G4double *bp_par, G4double *bd_par, G4double *bt_par, G4double *bhe_par, G4double *ba_par,G4double *sp_par,G4double *sd_par,G4double *st_par,G4double *she_par,G4double *sa_par, G4double *ef_par,G4double *ts1_par, G4int, G4int inum, G4int itest, G4int *sortie, G4double *tcn,G4double *jprfn_par, G4double *jprfp_par, G4double *jprfd_par, G4double *jprft_par, G4double *jprfhe_par, G4double *jprfa_par, G4double *jprflamb0_par, G4double *tsum_par, G4int NbLam0);
185
186
187 /**
188 * Calculation of fission and the particle emission probabilities after fission.
189 */
190void fission(G4double AF,G4double ZF,G4double EE,G4double JPRF,
191 G4double *VX1_FISSION,G4double *VY1_FISSION,G4double *VZ1_FISSION,
192 G4double *VX2_FISSION,G4double *VY2_FISSION,G4double *VZ2_FISSION,
193 G4int *ZFP1,G4int *AFP1,G4int *SFP1,G4int *ZFP2,G4int *AFP2,G4int *SFP2,G4int *imode,
194 G4double *VX_EVA_SC, G4double *VY_EVA_SC, G4double *VZ_EVA_SC,
195 G4double EV_TEMP[200][6],G4int *IEV_TAB_FIS,G4int *NbLam0);
196
197
198 /**
199 * Calculation of lorentz's boost
200 */
201void lorentz_boost(G4double VXRIN,G4double VYRIN,G4double VZRIN,G4double VXIN,G4double VYIN,G4double VZIN,G4double *VXOUT,G4double *VYOUT,G4double *VZOUT);
202
203 /**
204 * Calculation of unstable nuclei
205 */
206void unstable_nuclei(G4int AFP,G4int ZFP,G4int *AFPNEW,G4int *ZFPNEW,G4int &IOUNSTABLE,G4double VX,G4double VY,G4double VZ,G4double *VP1X,G4double *VP1Y,G4double *VP1Z,G4double BU_TAB_TEMP[200][6],G4int *ILOOP);
207
208 /**
209 * Calculation of unstable nuclei tke
210 */
211void unstable_tke(G4double AIN,G4double ZIN,G4double ANEW,G4double ZNEW,G4double VXIN,G4double VYIN,G4double VZIN,G4double *V1X,G4double *V1Y,G4double *V1Z,G4double *V2X,G4double *V2Y,G4double *V2Z);
212
213 /**
214 * Calculation of tke for breakup fragments
215 */
217
218 /**
219 * Calculation of the angular momentum of breakup fragments
220 * according to Goldhaber model
221 */
222void AMOMENT(G4double AABRA,G4double APRF,G4int IMULTIFR,G4double *PX,G4double *PY,G4double *PZ);
223
224 /**
225 * Calculation of particle emission barriers.
226 */
227 void barrs(G4int Z1,G4int A1,G4int Z2,G4int A2,G4double *sBARR,G4double *sOMEGA);
228
229 /**
230 * Calculation of particle emission between the saddle and scission point.
231 */
232 void evap_postsaddle(G4double A, G4double Z, G4double E_scission_pre, G4double *E_scission_post, G4double *A_scission, G4double *Z_scission,
233G4double &vx_eva,G4double &vy_eva,G4double &vz_eva,G4int *NbLam0_par);
234
235 /**
236 * Calculation of imfs.
237 */
238 void imf(G4double ACN,G4double ZCN,G4double TEMP,G4double EE,G4double *ZIMF,G4double *AIMF,G4double *BIMF,G4double *SBIMF,G4double *TIMF,G4double JPRF);
239
240 /**
241 * Calculation of omega at saddle point.
242 */
243 void fomega_sp(G4double AF,G4double Y,G4double *MFCD,G4double *sOMEGA,G4double *sHOMEGA);
244
245 /**
246 * Calculation of omega at ground state.
247 */
248 void fomega_gs(G4double AF,G4double ZF,G4double *K1,G4double *sOMEGA,G4double *sHOMEGA);
249
250 /**
251 * Calculation of tunnelling effect in fission.
252 */
254
255 /**
256 * Calculation of fission width at the saddle point according to B&W.
257 */
258 void fission_width(G4double ZPRF,G4double A,G4double EE,G4double BS,G4double BK,G4double EF,G4double Y,G4double *GF,G4double *TEMP,G4double JPR,G4int IEROT,G4int FF_ALLOWED,G4int OPTCOL,G4int OPTSHP,G4double DENSG);
259
260 /**
261 * Calculation of unbound nuclei.
262 */
263void unbound(G4double SN,G4double SP,G4double SD,G4double ST,G4double SHE,G4double SA,G4double BP,G4double BD,G4double BT,G4double BHE,G4double BA,G4double *PROBF,G4double *PROBN,G4double *PROBP,G4double *PROBD,G4double *PROBT,G4double *PROBHE,G4double *PROBA,G4double *PROBIMF,G4double *PROBG,G4double *ECN,G4double *ECP,G4double *ECD,G4double *ECT,G4double *ECHE,G4double *ECA);
264
265 /**
266 * Calculation of the fission distribution.
267 */
269 G4double &a1,G4double &z1,G4double &e1,G4double &v1,
270 G4double &a2,G4double &z2,G4double &e2,G4double &v2,
271 G4double &vx_eva_sc,G4double &vy_eva_sc,
272 G4double &vz_eva_sc,G4int *NbLam0_par);
273
274 /**
275 * Calculation of even-odd effects in fission.
276 */
277 void even_odd(G4double r_origin,G4double r_even_odd,G4int &i_out);
278
279 /**
280 * Functions for the fission model.
281 */
284 G4double Uwash(G4double E, G4double Ecrit,G4double Freduction,G4double gamma);
288 G4double haz(G4int k);
289
290 /**
291 * Level density parameters.
292 */
293 void densniv(G4double a, G4double z, G4double ee, G4double ef, G4double *dens, G4double bshell, G4double bs, G4double bk,
294 G4double *temp, G4int optshp, G4int optcol, G4double defbet, G4double *ecor, G4double jprf, G4int ifis,G4double *qr);
295
296 /**
297 * Calculation of the fission probability modified by transient time effects.
298 */
299 void part_fiss(G4double BET,G4double GP,G4double GF,G4double Y,G4double TAUF,G4double TS1,G4double TSUM,G4int *CHOICE,G4double ZF,G4double AF,G4double FT,G4double *T_LAPSE,G4double *GF_LOC);
300
302
303 /**
304 * This subroutine calculates the ordinary legendre polynomials of
305 * order 0 to n-1 of argument x and stores them in the vector pl.
306 * They are calculated by recursion relation from the first two
307 * polynomials.
308 * Written by A.J.Sierk LANL t-9 February, 1984
309 */
310 void lpoly(G4double x, G4int n, G4double pl[]);
311
312 /**
313 * This function will calculate the liquid-drop nuclear mass for spheri
314 * configuration according to the preprint NUCLEAR GROUND-STATE
315 * MASSES and DEFORMATIONS by P. Mo"ller et al. from August 16, 1993 p.
316 * All constants are taken from this publication for consistency.
317 */
318 G4double eflmac(G4int ia, G4int iz, G4int flag, G4int optshp);
319
320 /**
321 * Procedure for calculating the pairing correction to the binding
322 * energy of a specific nucleus.
323 */
324 void appariem(G4double a, G4double z, G4double *del);
325
326 /**
327 * PROCEDURE FOR CALCULATING THE PARITY OF THE NUMBER N.
328 * RETURNS -1 IF N IS ODD AND +1 IF N IS EVEN
329 */
330 void parite(G4double n, G4double *par);
331
332 /**
333 * RISE TIME IN WHICH THE FISSION WIDTH HAS REACHED
334 * 90 PERCENT OF ITS FINAL VALUE
335 */
336 G4double tau(G4double bet, G4double homega, G4double ef, G4double t);
337
338 /**
339 * KRAMERS FAKTOR - REDUCTION OF THE FISSION PROBABILITY
340 * INDEPENDENT OF EXCITATION ENERGY
341 */
342 G4double cram(G4double bet, G4double homega);
343
344 /**
345 * CALCULATION OF THE SURFACE BS OR CURVATURE BK OF A NUCLEUS
346 * RELATIVE TO THE SPHERICAL CONFIGURATION
347 * BASED ON MYERS, DROPLET MODEL FOR ARBITRARY SHAPES
348 */
349 G4double bipol(G4int iflag, G4double y);
350
351 /**
352 * THIS SUBROUTINE RETURNS THE BARRIER HEIGHT BFIS, THE
353 * GROUND-STATE ENERGY SEGS, IN MEV, AND THE ANGULAR MOMENTUM
354 * AT WHICH THE FISSION BARRIER DISAPPEARS, LMAX, IN UNITS OF
355 * H-BAR, WHEN CALLED WITH INTEGER AGUMENTS IZ, THE ATOMIC
356 * NUMBER, IA, THE ATOMIC MASS NUMBER, AND IL, THE ANGULAR
357 * MOMENTUM IN UNITS OF H-BAR. (PLANCK'S CONSTANT DIVIDED BY
358 * 2*PI).
359 */
360 void barfit(G4int iz, G4int ia, G4int il, G4double *sbfis, G4double *segs, G4double *selmax);
361
362 /**
363 * Calculation of decay widths for light particles.
364 */
365 G4double width(G4double AMOTHER,G4double ZMOTHER,G4double APART,G4double ZPART,G4double TEMP,G4double B1,G4double SB1,G4double EXC);
366
367 /**
368 * Calculation of penetration factors for light charged particles.
369 */
371
372 /**
373 * Calculation of mean value of orbital angular momentum.
374 */
375 void lorb(G4double AMOTHER,G4double ADAUGHTER,G4double LMOTHER,G4double EEFINAL,G4double *LORBITAL,G4double *SIGMA_LORBITAL);
376
377 /**
378 * Calculation of BS and BK for the nuclear-level density.
379 */
381
382 /**
383 * Special functions used for the emission of particles.
384 */
386
388
389 void gcf(G4double *gammcf,G4double a,G4double x,G4double gln);
390
391 void gser(G4double *gamser,G4double a,G4double x,G4double gln);
392
394
396
397 /**
398 * Random numbers.
399 */
400 void standardRandom(G4double *rndm, G4long *seed);
401
402 /**
403 * LOGARITHM OF THE GAMM FUNCTION
404 */
406
407 /**
408 * DISTRIBUTION DE MAXWELL
409 */
411
412 /**
413 *FONCTION INTEGRALE DE FD(E)
414 */
416
417 /**
418 * tirage aleatoire dans une maxwellienne
419 */
421
422 /**
423 * tirage aleatoire dans une maxwellienne
424 */
426
427 /**
428 * Random generator according to the
429 powerfunction y = x**(lambda) in the range from xmin to xmax
430 */
431 G4int IPOWERLIMHAZ(G4double lambda,G4int xmin,G4int xmax);
432
433 /**
434 *
435 */
437
438 /**
439 *
440 */
441 void guet(G4double *x_par, G4double *z_par, G4double *find_par);
442
443 /**
444 * Limits of existing nuclei
445 */
446 void isostab_lim(G4int z, G4int *nmin, G4int *nmax);
447
448 /**
449 * Fill the data array for INCL
450 */
451 void FillData(G4int IMULTBU,G4int IEV_TAB);
452
453 /**
454 * Separation energies of lambda
455 */
457
458 /**
459 * Separation energies of for other particles for hypernuclei
460 */
463
464public:
465 // Utils
466 G4int min(G4int a, G4int b);
468 G4int max(G4int a, G4int b);
471 G4int ISIGN(G4int a, G4int b);
472 G4int nint(G4double number);
473 G4int secnds(G4int x);
474 G4int mod(G4int a, G4int b);
478 G4int idnint(G4double value);
482 return ec2sub;
483 }
484
485private:
486 G4int verboseLevel;
487 G4int ilast;
488 G4double T_freeze_out_in;
489 G4int IEV_TAB_SSC;
490 G4double BU_TAB[200][12],EV_TAB[200][6],EV_TAB_SSC[200][6];
491 G4int gammaemission;
492 G4double T_freeze_out;
493 G4Pace *pace;
494 G4Ald *ald;
495 G4Eenuc *eenuc;
496 G4Ec2sub *ec2sub;
497 G4Ecld *ecld;
498 G4Mexp *masses;
499 G4Fb *fb;
500 G4Fiss *fiss;
501 G4Opt *opt;
502 G4Volant *volant;
503 G4VarNtp *varntp;
504 G4int Ainit,Zinit,Sinit;
505#ifndef ABLAXX_IN_GEANT4_MODE
506 G4INCL::Config *theConfig;
507#endif
508};
509
510#endif
G4double Y(G4double density)
double G4double
Definition: G4Types.hh:83
long G4long
Definition: G4Types.hh:87
int G4int
Definition: G4Types.hh:85
const G4int Z[17]
const G4double A[17]
Definition: G4Abla.hh:54
G4double eflmac(G4int ia, G4int iz, G4int flag, G4int optshp)
Definition: G4Abla.cc:4989
G4double func_trans(G4double TIME, G4double ZF, G4double AF, G4double BET, G4double Y, G4double FT, G4double T_0)
Definition: G4Abla.cc:6509
void part_fiss(G4double BET, G4double GP, G4double GF, G4double Y, G4double TAUF, G4double TS1, G4double TSUM, G4int *CHOICE, G4double ZF, G4double AF, G4double FT, G4double *T_LAPSE, G4double *GF_LOC)
Definition: G4Abla.cc:6606
void initEvapora()
Definition: G4Abla.cc:2133
G4int IPOWERLIMHAZ(G4double lambda, G4int xmin, G4int xmax)
Definition: G4Abla.cc:10253
void imf(G4double ACN, G4double ZCN, G4double TEMP, G4double EE, G4double *ZIMF, G4double *AIMF, G4double *BIMF, G4double *SBIMF, G4double *TIMF, G4double JPRF)
Definition: G4Abla.cc:7031
G4double fvmaxhaz_neut(G4double x)
Definition: G4Abla.cc:7026
G4double tau(G4double bet, G4double homega, G4double ef, G4double t)
Definition: G4Abla.cc:5197
G4double fmaxhaz(G4double T)
Definition: G4Abla.cc:5824
G4double gammp(G4double a, G4double x)
Definition: G4Abla.cc:5714
void isostab_lim(G4int z, G4int *nmin, G4int *nmax)
Definition: G4Abla.cc:7350
void barrs(G4int Z1, G4int A1, G4int Z2, G4int A2, G4double *sBARR, G4double *sOMEGA)
Definition: G4Abla.cc:5345
void even_odd(G4double r_origin, G4double r_even_odd, G4int &i_out)
Definition: G4Abla.cc:8922
G4double DSIGN(G4double a, G4double b)
Definition: G4Abla.cc:6132
G4double fvmaxhaz(G4double T)
Definition: G4Abla.cc:6500
G4double gethyperseparation(G4double A, G4double Z, G4int ny)
Definition: G4Abla.cc:7792
G4int nint(G4double number)
Definition: G4Abla.cc:6156
G4double gammln(G4double xx)
Definition: G4Abla.cc:5790
void fomega_gs(G4double AF, G4double ZF, G4double *K1, G4double *sOMEGA, G4double *sHOMEGA)
Definition: G4Abla.cc:5323
G4double tunnelling(G4double A, G4double ZPRF, G4double Y, G4double EE, G4double EF, G4double TEMP, G4double DENSG, G4double DENSF, G4double ENH_FACT)
Definition: G4Abla.cc:6809
G4int ISIGN(G4int a, G4int b)
Definition: G4Abla.cc:6144
G4double fmaxhaz_old(G4double T)
Definition: G4Abla.cc:5829
void evap_postsaddle(G4double A, G4double Z, G4double E_scission_pre, G4double *E_scission_post, G4double *A_scission, G4double *Z_scission, G4double &vx_eva, G4double &vy_eva, G4double &vz_eva, G4int *NbLam0_par)
Definition: G4Abla.cc:7474
G4double pace2(G4double a, G4double z)
Definition: G4Abla.cc:5890
void mglw(G4double a, G4double z, G4double *el)
Definition: G4Abla.cc:2387
G4double dmin1(G4double a, G4double b, G4double c)
Definition: G4Abla.cc:6248
G4int mod(G4int a, G4int b)
Definition: G4Abla.cc:6200
void SetParameters()
Definition: G4Abla.cc:2320
void unstable_tke(G4double AIN, G4double ZIN, G4double ANEW, G4double ZNEW, G4double VXIN, G4double VYIN, G4double VZIN, G4double *V1X, G4double *V1Y, G4double *V1Z, G4double *V2X, G4double *V2Y, G4double *V2Z)
Definition: G4Abla.cc:9880
void parite(G4double n, G4double *par)
Definition: G4Abla.cc:5172
G4double fissility(G4int a, G4int z, G4int ny, G4double sn, G4double slam, G4int optxfis)
Definition: G4Abla.cc:2511
void unbound(G4double SN, G4double SP, G4double SD, G4double ST, G4double SHE, G4double SA, G4double BP, G4double BD, G4double BT, G4double BHE, G4double BA, G4double *PROBF, G4double *PROBN, G4double *PROBP, G4double *PROBD, G4double *PROBT, G4double *PROBHE, G4double *PROBA, G4double *PROBIMF, G4double *PROBG, G4double *ECN, G4double *ECP, G4double *ECD, G4double *ECT, G4double *ECHE, G4double *ECA)
Definition: G4Abla.cc:7884
G4double cram(G4double bet, G4double homega)
Definition: G4Abla.cc:5225
void AMOMENT(G4double AABRA, G4double APRF, G4int IMULTIFR, G4double *PX, G4double *PY, G4double *PZ)
Definition: G4Abla.cc:10263
void unstable_nuclei(G4int AFP, G4int ZFP, G4int *AFPNEW, G4int *ZFPNEW, G4int &IOUNSTABLE, G4double VX, G4double VY, G4double VZ, G4double *VP1X, G4double *VP1Y, G4double *VP1Z, G4double BU_TAB_TEMP[200][6], G4int *ILOOP)
Definition: G4Abla.cc:9194
void tke_bu(G4double Z, G4double A, G4double ZALL, G4double AAL, G4double *VX, G4double *VY, G4double *VZ)
Definition: G4Abla.cc:10188
G4double haz(G4int k)
Definition: G4Abla.cc:10218
void mglms(G4double a, G4double z, G4int refopt4, G4double *el)
Definition: G4Abla.cc:2414
G4double f(G4double E)
Definition: G4Abla.cc:5818
void barfit(G4int iz, G4int ia, G4int il, G4double *sbfis, G4double *segs, G4double *selmax)
Definition: G4Abla.cc:5388
G4double dint(G4double a)
Definition: G4Abla.cc:6210
G4double umass(G4double z, G4double n, G4double beta)
Definition: G4Abla.cc:8982
G4int idnint(G4double value)
Definition: G4Abla.cc:6240
void appariem(G4double a, G4double z, G4double *del)
Definition: G4Abla.cc:5142
void gser(G4double *gamser, G4double a, G4double x, G4double gln)
Definition: G4Abla.cc:5762
G4double spdef(G4int a, G4int z, G4int optxfis)
Definition: G4Abla.cc:2469
void qrot(G4double z, G4double a, G4double bet, G4double sig, G4double u, G4double *qr)
Definition: G4Abla.cc:4893
G4double utilabs(G4double a)
Definition: G4Abla.cc:6262
void direct(G4double zprf, G4double a, G4double ee, G4double jprf, G4double *probp_par, G4double *probd_par, G4double *probt_par, G4double *probn_par, G4double *probhe_par, G4double *proba_par, G4double *probg_par, G4double *probimf_par, G4double *probf_par, G4double *problamb0_par, G4double *ptotl_par, G4double *sn_par, G4double *sbp_par, G4double *sbd_par, G4double *sbt_par, G4double *sbhe_par, G4double *sba_par, G4double *slamb0_par, G4double *ecn_par, G4double *ecp_par, G4double *ecd_par, G4double *ect_par, G4double *eche_par, G4double *eca_par, G4double *ecg_par, G4double *eclamb0_par, G4double *bp_par, G4double *bd_par, G4double *bt_par, G4double *bhe_par, G4double *ba_par, G4double *sp_par, G4double *sd_par, G4double *st_par, G4double *she_par, G4double *sa_par, G4double *ef_par, G4double *ts1_par, G4int, G4int inum, G4int itest, G4int *sortie, G4double *tcn, G4double *jprfn_par, G4double *jprfp_par, G4double *jprfd_par, G4double *jprft_par, G4double *jprfhe_par, G4double *jprfa_par, G4double *jprflamb0_par, G4double *tsum_par, G4int NbLam0)
Definition: G4Abla.cc:3107
G4Volant * getVolant()
Definition: G4Abla.hh:89
void standardRandom(G4double *rndm, G4long *seed)
void lpoly(G4double x, G4int n, G4double pl[])
Definition: G4Abla.cc:4972
void fission_width(G4double ZPRF, G4double A, G4double EE, G4double BS, G4double BK, G4double EF, G4double Y, G4double *GF, G4double *TEMP, G4double JPR, G4int IEROT, G4int FF_ALLOWED, G4int OPTCOL, G4int OPTSHP, G4double DENSG)
Definition: G4Abla.cc:6879
G4double Uwash(G4double E, G4double Ecrit, G4double Freduction, G4double gamma)
Definition: G4Abla.cc:9040
G4int max(G4int a, G4int b)
Definition: G4Abla.cc:6122
G4int min(G4int a, G4int b)
Definition: G4Abla.cc:6102
void fissionDistri(G4double &a, G4double &z, G4double &e, G4double &a1, G4double &z1, G4double &e1, G4double &v1, G4double &a2, G4double &z2, G4double &e2, G4double &v2, G4double &vx_eva_sc, G4double &vy_eva_sc, G4double &vz_eva_sc, G4int *NbLam0_par)
Definition: G4Abla.cc:8004
G4double width(G4double AMOTHER, G4double ZMOTHER, G4double APART, G4double ZPART, G4double TEMP, G4double B1, G4double SB1, G4double EXC)
Definition: G4Abla.cc:6268
~G4Abla()
Definition: G4Abla.cc:82
G4double gethyperbinding(G4double A, G4double Z, G4int ny)
Definition: G4Abla.cc:7860
void guet(G4double *x_par, G4double *z_par, G4double *find_par)
Definition: G4Abla.cc:5928
G4double eflmac_profi(G4double a, G4double z)
Definition: G4Abla.cc:9086
G4double pen(G4double A, G4double ap, G4double omega, G4double T)
Definition: G4Abla.cc:6454
G4double ecoul(G4double z1, G4double n1, G4double beta1, G4double z2, G4double n2, G4double beta2, G4double d)
Definition: G4Abla.cc:9012
G4double gausshaz(G4int k, G4double xmoy, G4double sig)
Definition: G4Abla.cc:10361
G4double bipol(G4int iflag, G4double y)
Definition: G4Abla.cc:5242
void DeexcitationAblaxx(G4int nucleusA, G4int nucleusZ, G4double excitationEnergy, G4double angularMomentum, G4double momX, G4double momY, G4double momZ, G4int eventnumber)
Definition: G4Abla.cc:96
void densniv(G4double a, G4double z, G4double ee, G4double ef, G4double *dens, G4double bshell, G4double bs, G4double bk, G4double *temp, G4int optshp, G4int optcol, G4double defbet, G4double *ecor, G4double jprf, G4int ifis, G4double *qr)
Definition: G4Abla.cc:4471
void fomega_sp(G4double AF, G4double Y, G4double *MFCD, G4double *sOMEGA, G4double *sHOMEGA)
Definition: G4Abla.cc:5297
G4int secnds(G4int x)
Definition: G4Abla.cc:6184
G4Abla(G4Abla const &other)
Dummy copy constructor.
void evapora(G4double zprf, G4double aprf, G4double *ee_par, G4double jprf, G4double *zf_par, G4double *af_par, G4double *mtota_par, G4double *vleva_par, G4double *vxeva_par, G4double *vyeva_par, G4int *ff_par, G4int *fimf_par, G4double *fzimf, G4double *faimf, G4double *tkeimf_par, G4double *jprfout, G4int *inttype_par, G4int *inum_par, G4double EV_TEMP[200][6], G4int *iev_tab_temp_par, G4int *nblam0)
Definition: G4Abla.cc:2566
G4double getdeltabinding(G4double a, G4int nblamb)
Definition: G4Abla.cc:7786
void FillData(G4int IMULTBU, G4int IEV_TAB)
Definition: G4Abla.cc:5999
G4int idint(G4double a)
Definition: G4Abla.cc:6229
G4Ec2sub * getFrldmTable()
Definition: G4Abla.hh:481
void SetParametersG4(G4int z, G4int a)
Definition: G4Abla.cc:2300
void bsbkbc(G4double A, G4double Z, G4double *BS, G4double *BK, G4double *BC)
Definition: G4Abla.cc:6479
void fission(G4double AF, G4double ZF, G4double EE, G4double JPRF, G4double *VX1_FISSION, G4double *VY1_FISSION, G4double *VZ1_FISSION, G4double *VX2_FISSION, G4double *VY2_FISSION, G4double *VZ2_FISSION, G4int *ZFP1, G4int *AFP1, G4int *SFP1, G4int *ZFP2, G4int *AFP2, G4int *SFP2, G4int *imode, G4double *VX_EVA_SC, G4double *VY_EVA_SC, G4double *VZ_EVA_SC, G4double EV_TEMP[200][6], G4int *IEV_TAB_FIS, G4int *NbLam0)
Definition: G4Abla.cc:10007
G4double erf(G4double x)
Definition: G4Abla.cc:5702
void gcf(G4double *gammcf, G4double a, G4double x, G4double gln)
Definition: G4Abla.cc:5730
G4double fd(G4double E)
Definition: G4Abla.cc:5811
void lorentz_boost(G4double VXRIN, G4double VYRIN, G4double VZRIN, G4double VXIN, G4double VYIN, G4double VZIN, G4double *VXOUT, G4double *VYOUT, G4double *VZOUT)
Definition: G4Abla.cc:9960
void lorb(G4double AMOTHER, G4double ADAUGHTER, G4double LMOTHER, G4double EEFINAL, G4double *LORBITAL, G4double *SIGMA_LORBITAL)
Definition: G4Abla.cc:6987
void setVerboseLevel(G4int level)
Definition: G4Abla.cc:77
G4Abla & operator=(G4Abla const &other)
Dummy assignment operator.
G4double dmod(G4double a, G4double b)
G4double frldm(G4double z, G4double n, G4double beta)
Definition: G4Abla.cc:9055
@ TIME
Definition: inflate.h:23