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

#include <G4LossTableBuilder.hh>

Public Member Functions

 G4LossTableBuilder (G4bool master)
 
 ~G4LossTableBuilder ()
 
void BuildDEDXTable (G4PhysicsTable *dedxTable, const std::vector< G4PhysicsTable * > &)
 
void BuildRangeTable (const G4PhysicsTable *dedxTable, G4PhysicsTable *rangeTable)
 
void BuildInverseRangeTable (const G4PhysicsTable *rangeTable, G4PhysicsTable *invRangeTable)
 
G4PhysicsTableBuildTableForModel (G4PhysicsTable *table, G4VEmModel *model, const G4ParticleDefinition *, G4double emin, G4double emax, G4bool spline)
 
void InitialiseBaseMaterials (const G4PhysicsTable *table=nullptr)
 
void SetSplineFlag (G4bool flag)
 
void SetBaseMaterialActive (G4bool flag)
 
G4LossTableBuilderoperator= (const G4LossTableBuilder &right)=delete
 
 G4LossTableBuilder (const G4LossTableBuilder &)=delete
 

Static Public Member Functions

static const std::vector< G4int > * GetCoupleIndexes ()
 
static const std::vector< G4double > * GetDensityFactors ()
 
static G4bool GetFlag (std::size_t idx)
 
static G4bool GetBaseMaterialFlag ()
 

Detailed Description

Definition at line 59 of file G4LossTableBuilder.hh.

Constructor & Destructor Documentation

◆ G4LossTableBuilder() [1/2]

G4LossTableBuilder::G4LossTableBuilder ( G4bool master)
explicit

Definition at line 76 of file G4LossTableBuilder.cc.

77 : isInitializer(master)
78{
79 theParameters = G4EmParameters::Instance();
80 if (nullptr == theFlag) {
81 theDensityFactor = new std::vector<G4double>;
82 theDensityIdx = new std::vector<G4int>;
83 theFlag = new std::vector<G4bool>;
84 }
85}
static G4EmParameters * Instance()

Referenced by G4LossTableBuilder(), and operator=().

◆ ~G4LossTableBuilder()

G4LossTableBuilder::~G4LossTableBuilder ( )

Definition at line 89 of file G4LossTableBuilder.cc.

90{
91 if (isInitializer) {
92 delete theDensityFactor;
93 delete theDensityIdx;
94 delete theFlag;
95 theDensityFactor = nullptr;
96 theDensityIdx = nullptr;
97 theFlag = nullptr;
98 }
99}

◆ G4LossTableBuilder() [2/2]

G4LossTableBuilder::G4LossTableBuilder ( const G4LossTableBuilder & )
delete

Member Function Documentation

◆ BuildDEDXTable()

void G4LossTableBuilder::BuildDEDXTable ( G4PhysicsTable * dedxTable,
const std::vector< G4PhysicsTable * > & list )

Definition at line 132 of file G4LossTableBuilder.cc.

134{
135 InitialiseBaseMaterials(dedxTable);
136 std::size_t n_processes = list.size();
137 if(1 >= n_processes) { return; }
138
139 std::size_t nCouples = dedxTable->size();
140 //G4cout << "Nproc= " << n_processes << " nCouples=" << nCouples << " Nv= "
141 // << dedxTable->size() << G4endl;
142 if(0 >= nCouples) { return; }
143
144 for (std::size_t i=0; i<nCouples; ++i) {
145 auto pv0 = static_cast<G4PhysicsLogVector*>((*(list[0]))[i]);
146 //if (0 == i) G4cout << i << ". pv0=" << pv0 << " t:" << list[0] << G4endl;
147 if(pv0 == nullptr) { continue; }
148 std::size_t npoints = pv0->GetVectorLength();
149 auto pv = new G4PhysicsLogVector(*pv0);
150 for (std::size_t j=0; j<npoints; ++j) {
151 G4double dedx = 0.0;
152 for (std::size_t k=0; k<n_processes; ++k) {
153 const G4PhysicsVector* pv1 = (*(list[k]))[i];
154 //if (0 == i) G4cout << " " << k << ". pv1=" << pv1 << " t:" << list[k] << G4endl;
155 dedx += (*pv1)[j];
156 }
157 pv->PutValue(j, dedx);
158 }
159 if(splineFlag) { pv->FillSecondDerivatives(); }
161 }
162 //G4cout << "### G4LossTableBuilder::BuildDEDXTable " << G4endl;
163 //G4cout << *dedxTable << G4endl;
164}
double G4double
Definition G4Types.hh:83
void InitialiseBaseMaterials(const G4PhysicsTable *table=nullptr)
static void SetPhysicsVector(G4PhysicsTable *physTable, std::size_t idx, G4PhysicsVector *vec)

◆ BuildInverseRangeTable()

void G4LossTableBuilder::BuildInverseRangeTable ( const G4PhysicsTable * rangeTable,
G4PhysicsTable * invRangeTable )

Definition at line 250 of file G4LossTableBuilder.cc.

253{
254 std::size_t nCouples = rangeTable->size();
255 if(0 >= nCouples) { return; }
256
257 for (std::size_t i=0; i<nCouples; ++i) {
258 G4PhysicsVector* pv = (*rangeTable)[i];
259 if((pv == nullptr) || (isBaseMatActive && !(*theFlag)[i])) { continue; }
260 std::size_t npoints = pv->GetVectorLength();
261
262 delete (*invRangeTable)[i];
263 auto v = new G4PhysicsFreeVector(npoints, splineFlag);
264
265 for (std::size_t j=0; j<npoints; ++j) {
266 G4double e = pv->Energy(j);
267 G4double r = (*pv)[j];
268 v->PutValues(j,r,e);
269 }
270 if (splineFlag) { v->FillSecondDerivatives(); }
271 v->EnableLogBinSearch(theParameters->NumberForFreeVector());
272
273 G4PhysicsTableHelper::SetPhysicsVector(invRangeTable, i, v);
274 }
275 //G4cout << "### Inverse range table" << G4endl;
276 //G4cout << *invRangeTable << G4endl;
277}
G4double Energy(const std::size_t index) const
std::size_t GetVectorLength() const

◆ BuildRangeTable()

void G4LossTableBuilder::BuildRangeTable ( const G4PhysicsTable * dedxTable,
G4PhysicsTable * rangeTable )

Definition at line 168 of file G4LossTableBuilder.cc.

171{
172 //G4cout << "### G4LossTableBuilder::BuildRangeTable: DEDX table" << G4endl;
173 //G4cout << *const_cast<G4PhysicsTable*>(dedxTable) << G4endl;
174 const std::size_t nCouples = dedxTable->size();
175 if(0 >= nCouples) { return; }
176
177 const std::size_t n = 100;
178 const G4double del = 1.0/(G4double)n;
179
180 for (std::size_t i=0; i<nCouples; ++i) {
181 auto pv = static_cast<G4PhysicsLogVector*>((*dedxTable)[i]);
182 if((pv == nullptr) || (isBaseMatActive && !(*theFlag)[i])) { continue; }
183 std::size_t npoints = pv->GetVectorLength();
184 std::size_t bin0 = 0;
185 G4double elow = pv->Energy(0);
186 G4double ehigh = pv->Energy(npoints-1);
187 G4double dedx1 = (*pv)[0];
188
189 // protection for specific cases dedx=0
190 if(dedx1 == 0.0) {
191 for (std::size_t k=1; k<npoints; ++k) {
192 ++bin0;
193 elow = pv->Energy(k);
194 dedx1 = (*pv)[k];
195 if(dedx1 > 0.0) { break; }
196 }
197 npoints -= bin0;
198 }
199
200 // initialisation of a new vector
201 if(npoints < 3) { npoints = 3; }
202
203 delete (*rangeTable)[i];
204 G4PhysicsLogVector* v;
205 if(0 == bin0) { v = new G4PhysicsLogVector(*pv); }
206 else { v = new G4PhysicsLogVector(elow, ehigh, npoints-1, splineFlag); }
207
208 // assumed dedx proportional to beta
209 G4double energy1 = v->Energy(0);
210 G4double range = 2.*energy1/dedx1;
211 /*
212 G4cout << "New Range vector Npoints=" << v->GetVectorLength()
213 << " coupleIdx=" << i << " spline=" << v->GetSpline()
214 << " Elow=" << v->GetMinEnergy() <<" Ehigh=" << v->GetMinEnergy()
215 << " DEDX(Elow)=" << dedx1 << " R(Elow)=" << range << G4endl;
216 */
217 v->PutValue(0,range);
218
219 for (std::size_t j=1; j<npoints; ++j) {
220
221 G4double energy2 = v->Energy(j);
222 G4double de = (energy2 - energy1) * del;
223 G4double energy = energy2 + de*0.5;
224 G4double sum = 0.0;
225 std::size_t idx = j - 1;
226 for (std::size_t k=0; k<n; ++k) {
227 energy -= de;
228 dedx1 = pv->Value(energy, idx);
229 if(dedx1 > 0.0) { sum += de/dedx1; }
230 }
231 range += sum;
232 /*
233 if(energy < 10.)
234 G4cout << "j= " << j << " e1= " << energy1 << " e2= " << energy2
235 << " n= " << n << " range=" << range<< G4endl;
236 */
237 v->PutValue(j,range);
238 energy1 = energy2;
239 }
240 if(splineFlag) { v->FillSecondDerivatives(); }
242 }
243 //G4cout << "### Range table" << G4endl;
244 //G4cout << *rangeTable << G4endl;
245}
void PutValue(const std::size_t index, const G4double value)
void FillSecondDerivatives(const G4SplineType=G4SplineType::Base, const G4double dir1=0.0, const G4double dir2=0.0)
G4double energy(const ThreeVector &p, const G4double m)

◆ BuildTableForModel()

G4PhysicsTable * G4LossTableBuilder::BuildTableForModel ( G4PhysicsTable * table,
G4VEmModel * model,
const G4ParticleDefinition * part,
G4double emin,
G4double emax,
G4bool spline )

Definition at line 357 of file G4LossTableBuilder.cc.

362{
363 // check input
364 G4PhysicsTable* table = G4PhysicsTableHelper::PreparePhysicsTable(aTable);
365 if (nullptr == table) { return table; }
366 if (aTable != nullptr && aTable != table) {
367 aTable->clearAndDestroy();
368 delete aTable;
369 }
370
372 G4int nbins = theParameters->NumberOfBinsPerDecade();
373
374 // Access to materials
375 const G4ProductionCutsTable* theCoupleTable=
377 std::size_t numOfCouples = theCoupleTable->GetTableSize();
378 /*
379 G4cout << " G4LossTableBuilder::BuildTableForModel Ncouple=" << numOfCouples
380 << " isMaster=" << isInitializer << " model:" << model->GetName()
381 << " " << part->GetParticleName() << G4endl;
382 */
383 G4PhysicsLogVector* aVector = nullptr;
384
385 for(G4int i=0; i<(G4int)numOfCouples; ++i) {
386 //G4cout << i << ". " << (*theFlag)[i] << " " << table->GetFlag(i) << G4endl;
387 if (table->GetFlag(i)) {
388
389 // create physics vector and fill it
390 auto couple = theCoupleTable->GetMaterialCutsCouple(i);
391 delete (*table)[i];
392
393 // if start from zero then change the scale
394 const G4Material* mat = couple->GetMaterial();
395
396 G4double tmin = std::max(emin, model->MinPrimaryEnergy(mat,part));
397 if(0.0 >= tmin) { tmin = CLHEP::eV; }
398 G4int n = nbins;
399
400 if(tmin >= emax) {
401 aVector = nullptr;
402 } else {
403 n *= G4lrint(std::log10(emax/tmin));
404 n = std::max(n, 3);
405 aVector = new G4PhysicsLogVector(tmin, emax, n, spline);
406 }
407
408 if(nullptr != aVector) {
409 //G4cout << part->GetParticleName() << " in " << mat->GetName()
410 // << " emin= " << tmin << " emax=" << emax << " n=" << n << G4endl;
411 for(G4int j=0; j<=n; ++j) {
412 G4double e = aVector->Energy(j);
413 G4double y = model->Value(couple, part, e);
414 //G4cout << " " << j << ") E=" << e << " y=" << y << G4endl;
415 aVector->PutValue(j, y);
416 }
417 if(spline) { aVector->FillSecondDerivatives(); }
418 }
420 }
421 }
422 /*
423 G4cout << "G4LossTableBuilder::BuildTableForModel done for "
424 << part->GetParticleName() << " and "<< model->GetName()
425 << " " << table << G4endl;
426 */
427 //G4cout << *table << G4endl;
428 return table;
429}
int G4int
Definition G4Types.hh:85
const G4Material * GetMaterial() const
static G4PhysicsTable * PreparePhysicsTable(G4PhysicsTable *physTable)
G4bool GetFlag(std::size_t i) const
const G4MaterialCutsCouple * GetMaterialCutsCouple(G4int i) const
std::size_t GetTableSize() const
static G4ProductionCutsTable * GetProductionCutsTable()
virtual G4double MinPrimaryEnergy(const G4Material *, const G4ParticleDefinition *, G4double cut=0.0)
virtual G4double Value(const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy)
int G4lrint(double ad)
Definition templates.hh:134

Referenced by G4EmTableUtil::BuildMscProcess().

◆ GetBaseMaterialFlag()

◆ GetCoupleIndexes()

const std::vector< G4int > * G4LossTableBuilder::GetCoupleIndexes ( )
static

◆ GetDensityFactors()

const std::vector< G4double > * G4LossTableBuilder::GetDensityFactors ( )
static

Definition at line 110 of file G4LossTableBuilder.cc.

111{
112 return theDensityFactor;
113}

Referenced by G4VEmModel::G4VEmModel(), G4VEmProcess::G4VEmProcess(), and G4VEnergyLossProcess::G4VEnergyLossProcess().

◆ GetFlag()

G4bool G4LossTableBuilder::GetFlag ( std::size_t idx)
static

◆ InitialiseBaseMaterials()

void G4LossTableBuilder::InitialiseBaseMaterials ( const G4PhysicsTable * table = nullptr)

Definition at line 281 of file G4LossTableBuilder.cc.

282{
283 if(!isInitializer) { return; }
284 const G4ProductionCutsTable* theCoupleTable=
286 std::size_t nCouples = theCoupleTable->GetTableSize();
287 std::size_t nFlags = theFlag->size();
288 /*
289 G4cout << "### InitialiseBaseMaterials: nCouples=" << nCouples
290 << " nFlags=" << nFlags << " isInit:" << isInitialized
291 << " baseMat:" << baseMatFlag << G4endl;
292 */
293 // define base material flag
294 if(isBaseMatActive && !baseMatFlag) {
295 for(G4int i=0; i<(G4int)nCouples; ++i) {
296 if(nullptr != theCoupleTable->GetMaterialCutsCouple(i)->GetMaterial()->GetBaseMaterial()) {
297 baseMatFlag = true;
298 isInitialized = false;
299 break;
300 }
301 }
302 }
303
304 if(nFlags != nCouples) { isInitialized = false; }
305 if(isInitialized) { return; }
306
307 // reserve memory
308 theFlag->resize(nCouples, true);
309 theDensityFactor->resize(nCouples,1.0);
310 theDensityIdx->resize(nCouples, 0);
311
312 // define default flag and index of used material cut couple
313 for (G4int i=0; i<(G4int)nCouples; ++i) {
314 (*theFlag)[i] = (nullptr == table) ? true : table->GetFlag(i);
315 (*theDensityIdx)[i] = i;
316 }
317 isInitialized = true;
318 if (!baseMatFlag) { return; }
319
320 // use base materials
321 for (G4int i=0; i<(G4int)nCouples; ++i) {
322 // base material is needed only for a couple which is not
323 // initialised and for which tables will be computed
324 auto couple = theCoupleTable->GetMaterialCutsCouple(i);
325 auto pcuts = couple->GetProductionCuts();
326 auto mat = couple->GetMaterial();
327 auto bmat = mat->GetBaseMaterial();
328
329 // base material exists - find it and check if it can be reused
330 if(nullptr != bmat) {
331 for(G4int j=0; j<(G4int)nCouples; ++j) {
332 if(j == i) { continue; }
333 auto bcouple = theCoupleTable->GetMaterialCutsCouple(j);
334
335 if(bcouple->GetMaterial() == bmat &&
336 bcouple->GetProductionCuts() == pcuts) {
337
338 // based couple exist in the same region
339 (*theDensityFactor)[i] = mat->GetDensity()/bmat->GetDensity();
340 (*theDensityIdx)[i] = j;
341 (*theFlag)[i] = false;
342
343 // ensure that there will no double initialisation
344 (*theDensityFactor)[j] = 1.0;
345 (*theDensityIdx)[j] = j;
346 (*theFlag)[j] = true;
347 break;
348 }
349 }
350 }
351 }
352}
static G4bool GetFlag(std::size_t idx)
G4ProductionCuts * GetProductionCuts() const
const G4Material * GetBaseMaterial() const

Referenced by BuildDEDXTable(), BuildTableForModel(), G4GammaGeneralProcess::PreparePhysicsTable(), G4TransportationWithMsc::PreparePhysicsTable(), G4VEmProcess::PreparePhysicsTable(), and G4VEnergyLossProcess::PreparePhysicsTable().

◆ operator=()

G4LossTableBuilder & G4LossTableBuilder::operator= ( const G4LossTableBuilder & right)
delete

◆ SetBaseMaterialActive()

void G4LossTableBuilder::SetBaseMaterialActive ( G4bool flag)
inline

Definition at line 131 of file G4LossTableBuilder.hh.

132{
133 isBaseMatActive = flag;
134}

◆ SetSplineFlag()

void G4LossTableBuilder::SetSplineFlag ( G4bool flag)
inline

Definition at line 121 of file G4LossTableBuilder.hh.

122{
123 splineFlag = flag;
124}

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