Thermal-FIST 1.5
Package for hadron resonance gas model applications
Loading...
Searching...
No Matches
HypersurfaceSampler.cpp
Go to the documentation of this file.
1/*
2 * Thermal-FIST package
3 *
4 * Copyright (c) 2019 Volodymyr Vovchenko
5 *
6 * GNU General Public License (GPLv3 or later)
7 */
8
9#include <iostream>
10#include <stdexcept>
11
17
18using namespace std;
19
20namespace thermalfist {
21
22
27
28
30 {
31 FillProbabilities(Weights);
32 }
33
35 {
36 std::vector<double> Weights;
37 for (auto& element : (*Hypersurface)) {
38 double dVeff = 0.;
39 for (int mu = 0; mu < 4; ++mu)
40 dVeff += element.dsigma[mu] * element.u[mu];
41 Weights.push_back(dVeff);
42 }
43 FillProbabilities(Weights);
44 }
45
46 void RandomGenerators::VolumeElementSampler::FillProbabilities(const std::vector<double>& Weights)
47 {
48 m_CumulativeProbabilities = std::vector<double>(Weights.size(), 0.);
49 double totalWeight = 0.;
50 for (int i = 0; i < Weights.size(); ++i) {
51 totalWeight += Weights[i];
52 m_CumulativeProbabilities[i] += Weights[i];
53 if (i > 0)
54 m_CumulativeProbabilities[i] += m_CumulativeProbabilities[i - 1];
55 }
56 for (double& prob : m_CumulativeProbabilities) {
57 prob /= totalWeight;
58 }
59 }
60
62 {
63 double prob = rangen.rand();
64 const auto& it = std::lower_bound(m_CumulativeProbabilities.begin(), m_CumulativeProbabilities.end(), prob);
65 int tind = std::distance(m_CumulativeProbabilities.begin(), it);
66 if (tind < 0) tind = 0;
67 if (tind >= static_cast<int>(m_CumulativeProbabilities.size())) tind = m_CumulativeProbabilities.size() - 1;
68 return tind;
69 }
70
71
73 (const ParticlizationHypersurface* hypersurface,
74 const ThermalParticle* particle,
75 const VolumeElementSampler* positionsampler,
77 m_ParticlizationHypersurface(hypersurface),
78 m_Particle(particle),
79 m_VolumeElementSampler(positionsampler),
80 m_EtaSmear(config.etaSmear),
81 m_ShearCorrection(config.shearCorrection),
82 m_BulkCorrection(config.bulkCorrection),
83 m_SpeedOfSoundSquared(config.speedOfSoundSquared)
84 {
85
86 }
87
89 {
90 if (m_VolumeElementSampler == NULL || m_ParticlizationHypersurface == NULL) {
91 throw std::runtime_error("RandomGenerators::HypersurfaceMomentumGenerator::GetMomentum(double mass): Hypersurface not initialized!");
92 }
93
94 if (mass < 0.)
95 mass = Mass();
96
97 int VolumeElementIndex = m_VolumeElementSampler->SampleVolumeElement();
98
99 const ParticlizationHypersurfaceElement& elem = (*m_ParticlizationHypersurface)[VolumeElementIndex];
100
102 }
103
104 HypersurfaceEventGenerator::HypersurfaceEventGenerator(ThermalParticleSystem* TPS, const EventGeneratorConfiguration& config, const ParticlizationHypersurface* hypersurface, double etasmear, bool shear_correction, bool bulk_correction, double speed_of_sound_squared) :
106 {
107 SetConfiguration(TPS, config);
108 SetHypersurface(hypersurface);
109 SetEtaSmear(etasmear);
111 SetShearCorrection(shear_correction);
112 SetBulkCorrection(bulk_correction);
113 SetSpeedOfSoundSquared(speed_of_sound_squared);
114 //SetParameters(hypersurface, m_THM, etasmear);
115 }
116
117
119 const EventGeneratorConfiguration &config,
120 const ParticlizationHypersurface *hypersurface,
122 ) : EventGeneratorBase(), m_MomentumGeneratorConfig(configMomentumGenerator)
123 {
124 SetConfiguration(TPS, config);
125 SetHypersurface(hypersurface);
126 SetMomentumGeneratorConfig(configMomentumGenerator);
128 }
129
131 {
132 return m_FullSpaceYields;
133 }
134
136 {
137 return m_FullSpaceYields;
138 }
139
140 //void HypersurfaceEventGenerator::SetParameters(const ParticlizationHypersurface* hypersurface, ThermalModelBase* model, double etasmear)
142 {
143 if (m_RescaleTmu) {
144 // Rescale T, mu's, and P for all cells
145 RescaleHypersurfaceParametersEdens(const_cast<ParticlizationHypersurface *>(m_ParticlizationHypersurface),
146 m_THM,
147 m_edens);
148 }
151 m_ParametersSet = true;
152 }
153
155 {
156 // Densities for the volume element sampling
157 vector<vector<double>> allweights(m_THM->TPS()->ComponentsNumber(), vector<double>(m_ParticlizationHypersurface->size(), 0.));
158
159 m_FullSpaceYields = vector<double>(m_THM->TPS()->ComponentsNumber(), 0.);
160 m_Tav = 0.;
161 m_Musav = vector<double>(m_THM->TPS()->ComponentsNumber(), 0.);
162 double Veff = 0.;
163
164 // For the standard sampling
165 vector<double> FullDensities(m_THM->TPS()->ComponentsNumber(), 0.), FullDensitiesIdeal(m_THM->TPS()->ComponentsNumber(), 0.);
166
167 cout << "Processing " << m_ParticlizationHypersurface->size() << " volume elements" << endl;
168
169
170 // If rescaling T & mu, keep track how much of the energy-weighted volume correspond to given energy density
171 // This is to catch the case when the energy density is not uniform or mismatched in the input parameters
172 double rescaleTmu_EMatch = 0., rescaleTmu_Etot = 0.;
173
174 // Process all the hypersurface elements
175 for (size_t ielem = 0; ielem < m_ParticlizationHypersurface->size(); ++ielem) {
176 if (ielem % 10000 == 0) {
177 cout << ielem << " ";
178 cout.flush();
179 }
180 const auto& elem = m_ParticlizationHypersurface->operator[](ielem);
181
182 m_THM->SetTemperature(elem.T);
183 m_THM->SetBaryonChemicalPotential(elem.muB);
184 m_THM->SetElectricChemicalPotential(elem.muQ);
185 m_THM->SetStrangenessChemicalPotential(elem.muS);
186
187 if (m_Config.CFOParameters.gammaq != 1.0)
188 m_THM->SetGammaq(m_Config.CFOParameters.gammaq);
189
190 if (m_Config.CFOParameters.gammaS != 1.0)
191 m_THM->SetGammaS(m_Config.CFOParameters.gammaS);
192
193 if (m_Config.CFOParameters.gammaC != 1.0)
194 m_THM->SetGammaC(m_Config.CFOParameters.gammaC);
195
196 double dVeff = 0.;
197 for (int mu = 0; mu < 4; ++mu)
198 dVeff += elem.dsigma[mu] * elem.u[mu];
199
200 if (dVeff <= 0.) {
201 continue;
202 }
203
204 if (abs(elem.edens - m_edens) <= 1.e-3)
205 rescaleTmu_EMatch += dVeff * elem.edens;
206// else
207// cout << "Energy density mismatch: " << elem.edens << " vs " << m_edens << endl;
208 rescaleTmu_Etot += dVeff * elem.edens;
209
210 Veff += dVeff;
211 m_Tav += elem.T * dVeff;
212
213 m_THM->CalculatePrimordialDensities();
214
215 std::vector<double>* densitiesIdeal = &m_THM->Densities();
216 std::vector<double> tdens;
217 if (m_THM->TAG() != "ThermalModelIdeal") {
218 tdens = m_THM->GetIdealGasDensities();
219 densitiesIdeal = &tdens;
220 }
221
222 for (size_t ipart = 0; ipart < m_THM->TPS()->ComponentsNumber(); ++ipart) {
223 allweights[ipart][ielem] = m_THM->Densities()[ipart] * dVeff;
224
225 m_Musav[ipart] += m_THM->ChemicalPotential(ipart) * dVeff;
226 FullDensities[ipart] += m_THM->Densities()[ipart] * dVeff;
227 FullDensitiesIdeal[ipart] += densitiesIdeal->operator[](ipart) * dVeff;
228
229 //Npart += m_THM->TPS()->Particle(ipart).BaryonCharge() * m_THM->Densities()[ipart] * dVeff;
230 }
231 }
232
233 // Free memory just in case
234 std::vector<RandomGenerators::VolumeElementSampler>().swap(m_VolumeElementSamplers);
235 m_VolumeElementSamplers.clear();
236 for (size_t ipart = 0; ipart < m_THM->TPS()->ComponentsNumber(); ++ipart) {
237 m_VolumeElementSamplers.push_back(RandomGenerators::VolumeElementSampler(allweights[ipart]));
238 // Free memory
239 vector<double>().swap(allweights[ipart]);
240 }
241
242 m_FullSpaceYields = FullDensities;
243
244 m_Tav /= Veff;
245 for (size_t ipart = 0; ipart < m_THM->TPS()->ComponentsNumber(); ++ipart) {
246 m_Musav[ipart] /= Veff;
247 FullDensities[ipart] /= Veff;
248 FullDensitiesIdeal[ipart] /= Veff;
249 }
250
251 cout << endl;
252 cout << "V = " << Veff << endl;
253 cout << "<T> = " << m_Tav << endl;
254 cout << "<muB> = " << m_Musav[m_THM->TPS()->PdgToId(2112)] << endl;
255
256 // Check for energy density mismatch for T-Mu rescaling
257 if (m_RescaleTmu){
258 if (rescaleTmu_EMatch/rescaleTmu_Etot < 0.90) {
259 printf("**WARNING** Energy density mismatch for T-Mu rescaling: %lf\n", rescaleTmu_EMatch/rescaleTmu_Etot);
260 }
261 cout << "Edens match fraction = " << rescaleTmu_EMatch/rescaleTmu_Etot << endl;
262 }
263
264 // The canonical ensemble
265 // Make the canonical ensemble integers
266 // Rescale all the means to get integer baryon number
267 // Then round the other conserved charges to the nearest integer
268 if (m_Config.fEnsemble == EventGeneratorConfiguration::CE) {
269 double totB = 0., totQ = 0., totS = 0., totC = 0.;
270 for (size_t ipart = 0; ipart < m_THM->TPS()->ComponentsNumber(); ++ipart) {
271 totB += m_THM->TPS()->Particle(ipart).BaryonCharge() * m_FullSpaceYields[ipart];
272 totQ += m_THM->TPS()->Particle(ipart).ElectricCharge() * m_FullSpaceYields[ipart];
273 totS += m_THM->TPS()->Particle(ipart).Strangeness() * m_FullSpaceYields[ipart];
274 totC += m_THM->TPS()->Particle(ipart).Charm() * m_FullSpaceYields[ipart];
275 }
276
277 cout << endl;
278 cout << "Integrated values of conserved charges:" << endl;
279 cout << "B = " << totB << endl;
280 cout << "Q = " << totQ << endl;
281 cout << "S = " << totS << endl;
282 cout << "C = " << totC << endl;
283
284 double Vcorr = 1.;
285 if (m_Config.CanonicalB) {
286
287 if (abs(totB) > 1.e-6) {
288 Vcorr = round(totB) / totB;
289 Veff *= Vcorr;
290 cout << "Volume rescaling factor Vcorr = " << Vcorr << endl;
291 cout << "B: " << totB << " -> " << round(totB) << endl;
292 }
293
294 m_Config.B = round(totB);
295 }
296
297 if (m_Config.CanonicalQ) {
298 cout << "Q: " << totQ * Vcorr << " -> " << round(totQ * Vcorr) << endl;
299 m_Config.Q = round(totQ * Vcorr);
300 }
301
302 if (m_Config.CanonicalS && m_Config.S != 0) {
303 cout << "S: " << totS * Vcorr << " -> " << round(totS * Vcorr) << endl;
304 m_Config.S = round(totS * Vcorr);
305 }
306
307 if (m_Config.CanonicalC && m_Config.C != 0) {
308 cout << "C: " << totC * Vcorr << " -> " << round(totC * Vcorr) << endl;
309 m_Config.C = round(totC * Vcorr);
310 }
311 }
312
313 cout.flush();
314
315
316 m_THM->SetVolume(Veff);
317 m_THM->SetCanonicalVolume(Veff);
318 m_THM->Densities() = FullDensities;
319 m_DensitiesIdeal = FullDensitiesIdeal;
322 }
323
324 std::vector<std::vector<double>> HypersurfaceEventGenerator::CalculateTMuMap(ThermalModelBase* model, double edens, double rhomin, double rhomax, double drho)
325 {
326 cout << "Remapping T and mu along e = " << edens << " surface..." << endl;
327 vector<double> rhos, Ts, muBs, muSs, muQs, Ps;
328 vector<double> Tmusini = { 0.150, 0.100, 0.033, -0.05 };
329 for (double rho = rhomin; rho < rhomax + 1.e-9; rho += drho) {
330 rhos.push_back(rho);
331
332 if (rho == rhomin || rho - drho == rhomin) {
333 model->SetTemperature(Tmusini[0]);
334 model->SetBaryonChemicalPotential(Tmusini[1]);
335 model->SetStrangenessChemicalPotential(Tmusini[2]);
336 model->SetElectricChemicalPotential(Tmusini[3]);
337 }
338
339 auto Tmus = MatchEnergyBaryonDensities(model, edens, rho);
340 Ts.push_back(Tmus[0]);
341 muBs.push_back(Tmus[1]);
342 muSs.push_back(Tmus[2]);
343 muQs.push_back(Tmus[3]);
344 Ps.push_back(Tmus[4]);
345 }
346
347 return { rhos, Ts, muBs, muSs, muQs, Ps };
348 }
349
350
351 void HypersurfaceEventGenerator::SetRescaleTmu(bool rescale, double edens)
352 {
353 m_RescaleTmu = rescale;
354 m_edens = edens;
355 }
356
362
364 {
366 m_BWGens.resize(0);
367
368 if (m_THM != NULL) {
369 for (size_t i = 0; i < m_THM->TPS()->Particles().size(); ++i) {
370 const ThermalParticle& part = m_THM->TPS()->Particles()[i];
372 m_ParticlizationHypersurface,
373 &m_THM->TPS()->Particle(i),
374 &m_VolumeElementSamplers[i],
375 m_MomentumGeneratorConfig
376 ));
377
378 // Should not be used
379 double T = m_Tav;
380 double Mu = m_Musav[i];
381 if (m_THM->TPS()->ResonanceWidthIntegrationType() == ThermalParticle::eBW || m_THM->TPS()->ResonanceWidthIntegrationType() == ThermalParticle::eBWconstBR)
382 m_BWGens.push_back(new RandomGenerators::ThermalEnergyBreitWignerGenerator(&m_THM->TPS()->Particle(i), T, Mu));
383 else
384 m_BWGens.push_back(new RandomGenerators::ThermalBreitWignerGenerator(&m_THM->TPS()->Particle(i), T, Mu));
385 }
386 }
387 }
388
390 ThermalModelBase *model, double edens,
391 double rhomin, double rhomax, double drho,
392 double rhocrit) {
393 auto TMuMap = CalculateTMuMap(model, edens, rhomin, rhomax, drho);
394 vector<SplineFunction> SplinesTMu(5);
395 for(int i = 0; i < 5; ++i)
396 SplinesTMu[i].fill(TMuMap[0], TMuMap[1+i]);
397
398 for(auto& elem : *hypersurface) {
399 if (abs(elem.edens - edens) > 1.e-3 || elem.rhoB < 0.0 || elem.rhoB > 0.25) {
400 // Do nothing
401 }
402 else {
403 elem.T = SplinesTMu[0].f(elem.rhoB);
404 elem.muB = SplinesTMu[1].f(elem.rhoB);
405 elem.muS = SplinesTMu[2].f(elem.rhoB);
406 elem.muQ = SplinesTMu[3].f(elem.rhoB);
407 elem.P = SplinesTMu[4].f(elem.rhoB);
408 }
409 }
410 }
411
412
414 const ParticlizationHypersurface* hypersurface,
415 VolumeElementSampler* positionsampler, double Tkin, double etamax, double mass, int statistics, double mu) :
416 m_ParticlizationHypersurface(hypersurface),
417 m_VolumeElementSampler(positionsampler),
418 m_Tkin(Tkin), m_EtaMax(etamax), m_Mass(mass),
419 m_Generator(mass, statistics, Tkin, mu)
420 {
421
422 }
423
425 {
426 if (m_VolumeElementSampler == NULL || m_ParticlizationHypersurface == NULL) {
427 throw std::runtime_error("RandomGenerators::BoostInvariantHypersurfaceMomentumGenerator::GetMomentum(double mass): Hypersurface not initialized!");
428 }
429
430 if (mass < 0.)
431 mass = Mass();
432
433 std::vector<double> ret(3, 0.);
434 int VolumeElementIndex = m_VolumeElementSampler->SampleVolumeElement();
435
436 const ParticlizationHypersurfaceElement& elem = (*m_ParticlizationHypersurface)[VolumeElementIndex];
437
438 double etaF = 0.5 * log((elem.u[0] + elem.u[3]) / (elem.u[0] - elem.u[3]));
439
440
441 double vx = elem.u[1] / elem.u[0];// / cosheta;
442 double vy = elem.u[2] / elem.u[0];// / cosheta;
443 double vz = tanh(etaF);// tanh(eta);
444
445 SimpleParticle part(0., 0., 0., mass, 0);
446
447 // dsigma^\mu in the local rest frame
448 std::vector<double> dsigma_loc =
450 { elem.dsigma[0], -elem.dsigma[1], -elem.dsigma[2], -elem.dsigma[3] },
451 vx, vy, vz);
452
453 double maxWeight = 1. + std::abs(dsigma_loc[1] / dsigma_loc[0]) + std::abs(dsigma_loc[2] / dsigma_loc[0]) + std::abs(dsigma_loc[3] / dsigma_loc[0]);
454
455 while (1) {
456 double tp = m_Generator.GetP(mass);
457 double tphi = 2. * xMath::Pi() * RandomGenerators::randgenMT.rand();
458 double cthe = 2. * RandomGenerators::randgenMT.rand() - 1.;
459 double sthe = sqrt(1. - cthe * cthe);
460 part.px = tp * cos(tphi) * sthe;
461 part.py = tp * sin(tphi) * sthe;
462 part.pz = tp * cthe;
463 part.p0 = sqrt(mass * mass + tp * tp);
464
465 double p0LRF = part.p0;
466
467 double dsigmamu_pmu_loc = dsigma_loc[0] * part.p0
468 - dsigma_loc[1] * part.px - dsigma_loc[2] * part.py - dsigma_loc[3] * part.pz;
469
470
471 double dsigmamu_umu_loc = dsigma_loc[0];
472
473 double dumu_pmu_loc = p0LRF;
474
475 double Weight = dsigmamu_pmu_loc / dsigmamu_umu_loc / dumu_pmu_loc / maxWeight;
476
477 if (Weight > 1.) {
478 printf("**WARNING** BoostInvariantHypersurfaceMomentumGenerator::GetMomentum: Weight exceeds unity by %E\n",
479 Weight - 1.);
480 }
481
482 if (RandomGenerators::randgenMT.rand() < Weight)
483 break;
484 }
485
486 if (vx != 0.0 || vy != 0.0 || vz != 0.0)
487 part = ParticleDecaysMC::LorentzBoostMomentumOnly(part, -vx, -vy, -vz);
488
489 double eta = elem.eta;
490 double cosheta = cosh(eta);
491 double sinheta = sinh(eta);
492 // Smearing in eta
493 if (EtaMax() > 0.0) {
494 double deta = -EtaMax() + 2. * EtaMax() * RandomGenerators::randgenMT.rand();
495
496 double tpz = part.GetMt() * std::sinh(part.GetY() + deta);
497 double tp0 = sqrt(part.m * part.m + part.px * part.px + part.py * part.py + tpz * tpz);
498
499 part.pz = tpz;
500 part.p0 = tp0;
501
502 eta += deta;
503 cosheta = cosh(eta);
504 sinheta = sinh(eta);
505
506 //vz = tanh(eta);
507 //if (vz != 0.0)
508 // part = ParticleDecaysMC::LorentzBoost(part, 0., 0., -vz);
509 }
510
511
512 ret[0] = part.px;
513 ret[1] = part.py;
514 ret[2] = part.pz;
515
516 // Space-time coordinates
517 double tau = elem.tau;
518 double r0 = tau * cosheta;
519 double rz = tau * sinheta;
520
521 double rx = elem.x;
522 double ry = elem.y;
523
524
525
526 ret.push_back(r0);
527 ret.push_back(rx);
528 ret.push_back(ry);
529 ret.push_back(rz);
530
531 return ret;
532 }
533
534 void fillBoostMatrix(double vx, double vy, double vz, double boostMatrix[4][4])
535 // Lorentz boost matrix
536 // here in boostMatrix [0]=t, [1]=x, [2]=y, [3]=z
537 {
538 const double vv [3] = {vx, vy, vz} ;
539 const double v2 = vx*vx+vy*vy+vz*vz ;
540 const double gamma = 1.0/sqrt(1.0-v2) ;
541 if(std::isinf(gamma)||std::isnan(gamma)){ throw std::runtime_error("boost vector invalid"); }
542 boostMatrix[0][0] = gamma ;
543 boostMatrix[0][1] = boostMatrix[1][0] = vx*gamma ;
544 boostMatrix[0][2] = boostMatrix[2][0] = vy*gamma ;
545 boostMatrix[0][3] = boostMatrix[3][0] = vz*gamma ;
546 if(v2>0.0){
547 for(int i=1; i<4; i++)
548 for(int j=1; j<4; j++)
549 boostMatrix[i][j] = (gamma-1.0)*vv[i-1]*vv[j-1]/v2 ;
550 }else{
551 for(int i=1; i<4; i++)
552 for(int j=1; j<4; j++)
553 boostMatrix[i][j] = 0.0 ;
554 }
555 for(int i=1; i<4; i++) boostMatrix[i][i] += 1.0 ;
556 }
557
558 int index44(const int &i, const int &j){
559 // index44: returns an index of pi^{mu nu} mu,nu component in a plain 1D array
560 if(i>3 || j>3 || i<0 || j<0) {std::cout<<"index44: i j " <<i<<" "<<j<<endl ; exit(1) ; }
561 if(j<i) return (i*(i+1))/2 + j ;
562 else return (j*(j+1))/2 + i ;
563 }
564
565 std::vector<double> RandomGenerators::HypersurfaceMomentumGenerator::SamplePhaseSpaceCoordinateFromElement(const ParticlizationHypersurfaceElement* elem, const ThermalParticle* particle, const double& mass, const double& etasmear, const bool shear_correction, const bool bulk_correction, const double speed_of_sound_squared)
566 {
567 if (particle == NULL) {
568 throw std::runtime_error("HypersurfaceMomentumGenerator::SamplePhaseSpaceCoordinateFromElement(): Unknown particle species!");
569 }
570
571 double etaF = 0.5 * log((elem->u[0] + elem->u[3]) / (elem->u[0] - elem->u[3]));
572
573 double vx = elem->u[1] / elem->u[0];
574 double vy = elem->u[2] / elem->u[0];
575 double vz = tanh(etaF);
576
577 SimpleParticle part(0., 0., 0., mass, 0);
578
579 // dsigma^\mu in the local rest frame
580 std::vector<double> dsigma_loc =
582 { elem->dsigma[0], -elem->dsigma[1], -elem->dsigma[2], -elem->dsigma[3] },
583 vx, vy, vz);
584
585 // Maximum weight for the rejection sampling of the momentum
586 double maxWeight = 1. + std::abs(dsigma_loc[1] / dsigma_loc[0]) + std::abs(dsigma_loc[2] / dsigma_loc[0]) + std::abs(dsigma_loc[3] / dsigma_loc[0]);
587
588 // Regulating linear shear corrections
589 double Wvisc_min = 0.1, Wvisc_max = 10.0; // Lower bound consistent with smash-hadron-sampler, upper bound large enough so that it is not reached in practice
590 // Wvisc_min = 0.; Wvisc_max = 2.0; // |delta f| < feq, following https://arxiv.org/pdf/1912.08271.pdf
591
592 double T = elem->T;
593 double mu = particle->BaryonCharge() * elem->muB + particle->ElectricCharge() * elem->muQ + particle->Strangeness() * elem->muS;
594 ThermalMomentumGenerator Generator(mass, particle->Statistics(), T, mu);
595
596 // Shear correction based on smash-hadron-sampler (ideal gas type), see https://github.com/smash-transport/smash-hadron-sampler/blob/main/src/gen.cpp#L297
597 const double gmumu[4] = {1., -1., -1., -1.};
598 const double C_Feq = pow(0.5*xMath::GeVtoifm() / xMath::Pi(), 3);
599 int stat = -particle->Statistics(); // Opposite convention to smash-hadron-sampler for quantum statistics
600 // Ideal gas distribution function f0 = feq, excluded volume not included
601 // Note that feq plays no role for Maxwell-Boltzmann statistics (stat = 0)
602 const double feq = C_Feq / (exp((part.p0-mu)/T) - stat); // TODO: The possible excluded volume factor not included, effect likely small and disappears in the absence of quantum statistics
603 double pi_lrf[10];
604 double boostMatrix[4][4];
605 if (shear_correction){
606 maxWeight *= Wvisc_max;
607 // boost pi^{mu nu} into the local rest frame
608 fillBoostMatrix(-vx, -vy, -vz, boostMatrix);
609 for (int i=0; i<4; i++){
610 for (int j=0; j<4; j++){
611 pi_lrf[index44(i,j)] = 0.0;
612 for (int k=0; k<4; k++){
613 for (int l=0; l<4; l++){
614 pi_lrf[index44(i,j)] += elem->pi[index44(k,l)] * boostMatrix[i][k] * boostMatrix[j][l];
615 }
616 }
617 }
618 }
619 }
620
621 while (true) {
622 double tp = Generator.GetP(mass);
623 double tphi = 2. * xMath::Pi() * RandomGenerators::randgenMT.rand();
624 double cthe = 2. * RandomGenerators::randgenMT.rand() - 1.;
625 double sthe = sqrt(1. - cthe * cthe);
626 part.px = tp * cos(tphi) * sthe;
627 part.py = tp * sin(tphi) * sthe;
628 part.pz = tp * cthe;
629 part.p0 = sqrt(mass * mass + tp * tp);
630
631 double p0LRF = part.p0;
632
633 double dsigmamu_pmu_loc = dsigma_loc[0] * part.p0
634 - dsigma_loc[1] * part.px - dsigma_loc[2] * part.py - dsigma_loc[3] * part.pz;
635
636 double dsigmamu_umu_loc = dsigma_loc[0];
637
638 double dumu_pmu_loc = p0LRF;
639
640 double Weight = dsigmamu_pmu_loc / dsigmamu_umu_loc / dumu_pmu_loc / maxWeight;
641
642 double Weight_visc = 1.0;
643 if (shear_correction){
644 double mom[4] = {part.p0, part.px, part.py, part.pz};
645 double pipp = 0.0;
646 for (int i=0; i<4; i++){
647 for (int j=0; j<4; j++){
648 pipp += mom[i] * mom[j] * gmumu[i] * gmumu[j] * pi_lrf[index44(i,j)];
649 }
650 }
651 // this is in principle the ansatz which is also used in https://github.com/smash-transport/smash-hadron-sampler
652 // from this paper Phys.Rev.C 73 (2006) 064903
653 Weight_visc += ((1.0 + stat * feq) * pipp / (2.0 * T * T * (elem->edens + elem->P)));
654
655 }
656 if (bulk_correction){
657 // this is in principle the ansatz which is also used in https://github.com/smash-transport/smash-hadron-sampler
658 // Eq. (7) of https://arxiv.org/pdf/1509.06738 plus Eq. (4) from https://arxiv.org/pdf/1403.0962
659 // see also https://github.com/smash-transport/smash-hadron-sampler/files/14011233/bulk_corrections_note.pdf
660 double mom[4] = {part.p0, part.px, part.py, part.pz};
661 Weight_visc -= (1.0+stat*feq)*elem->Pi
662 *(mass*mass/(3*mom[0])-mom[0]*(1.0/3.0-speed_of_sound_squared))
663 /(15*(1.0/3.0-speed_of_sound_squared)*(1.0/3.0-speed_of_sound_squared)*T*(elem->edens + elem->P)) ;
664 }
665 if (bulk_correction || shear_correction){
666 if (Weight_visc<Wvisc_min) Weight_visc = Wvisc_min;
667 if (Weight_visc>Wvisc_max) Weight_visc = Wvisc_max;
668 // update weight with viscosity factor
669 Weight *= Weight_visc;
670 }
671
672
673
674 if (Weight > 1.) {
675 printf("**WARNING** HypersurfaceSampler::GetMomentum: Weight exceeds unity by %E\n",
676 Weight - 1.);
677 }
678 if (RandomGenerators::randgenMT.rand() < Weight)
679 break;
680 }
681
682 if (vx != 0.0 || vy != 0.0 || vz != 0.0)
683 part = ParticleDecaysMC::LorentzBoostMomentumOnly(part, -vx, -vy, -vz);
684
685 double eta = elem->eta;
686 double cosheta = cosh(eta);
687 double sinheta = sinh(eta);
688
689 // Smearing in eta
690 if (etasmear > 0.0) {
691 double deta = -0.5 * etasmear + 1. * etasmear * RandomGenerators::randgenMT.rand();
692
693 double tpz = part.GetMt() * std::sinh(part.GetY() + deta);
694 double tp0 = sqrt(part.m * part.m + part.px * part.px + part.py * part.py + tpz * tpz);
695
696 part.pz = tpz;
697 part.p0 = tp0;
698
699 eta += deta;
700 cosheta = cosh(eta);
701 sinheta = sinh(eta);
702 }
703
704 // Space-time coordinates
705 double tau = elem->tau;
706 double r0 = tau * cosheta;
707 double rz = tau * sinheta;
708
709 double rx = elem->x;
710 double ry = elem->y;
711
712 return { part.px, part.py, part.pz, r0, rx, ry, rz };
713 }
714
716 : m_VolumeElementSampler(NULL)
717 {
718 SetConfiguration(TPS, config);
719
720 SetParameters(etamax, hypersurface);
721 }
722
724 {
725 if (m_VolumeElementSampler != NULL)
726 delete m_VolumeElementSampler;
727 }
728
730 {
731 m_EtaMax = etamax;
732 m_ParticlizationHypersurface = hypersurface;
734 }
735
737 {
739 m_BWGens.resize(0);
740
741 if (m_VolumeElementSampler != NULL)
742 delete m_VolumeElementSampler;
743
744 m_VolumeElementSampler =
745 new RandomGenerators::VolumeElementSampler(m_ParticlizationHypersurface);
746
747
748 if (m_THM != NULL) {
749 for (size_t i = 0; i < m_THM->TPS()->Particles().size(); ++i) {
750 const ThermalParticle& part = m_THM->TPS()->Particles()[i];
752 m_ParticlizationHypersurface,
753 m_VolumeElementSampler,
754 m_Config.CFOParameters.T,
755 GetEtaMax(),
756 part.Mass(),
757 part.Statistics(),
758 m_THM->FullIdealChemicalPotential(i)
759 ));
760
761 double T = m_THM->Parameters().T;
762 double Mu = m_THM->FullIdealChemicalPotential(i);
763 if (m_THM->TPS()->ResonanceWidthIntegrationType() == ThermalParticle::eBW || m_THM->TPS()->ResonanceWidthIntegrationType() == ThermalParticle::eBWconstBR)
764 m_BWGens.push_back(new RandomGenerators::ThermalEnergyBreitWignerGenerator(&m_THM->TPS()->Particle(i), T, Mu));
765 else
766 m_BWGens.push_back(new RandomGenerators::ThermalBreitWignerGenerator(&m_THM->TPS()->Particle(i), T, Mu));
767 }
768 }
769 }
770
772 {
774
775 std::pair< std::vector<int>, double > yieldsW = SampleYields();
776 std::pair<int, int> NBBbar = ComputeNBNBbar(yieldsW.first);
777 double wgtB = EVHRGWeight( NBBbar.first, m_MeanB, m_VEff, m_b);
778 double wgtBbar = EVHRGWeight(NBBbar.second, m_MeanAB, m_VEff, m_b);
779 while (RandomGenerators::randgenMT.rand() > wgtB || RandomGenerators::randgenMT.rand() > wgtBbar) {
780 yieldsW = SampleYields();
781 NBBbar = ComputeNBNBbar(yieldsW.first);
782 wgtB = EVHRGWeight(NBBbar.first, m_MeanB, m_VEff, m_b);
783 wgtBbar = EVHRGWeight(NBBbar.second, m_MeanAB, m_VEff, m_b);
784 }
785
786 std::vector<int>& yields = yieldsW.first;
787
788 SimpleEvent ret = SampleParticles(yields);
789
790 if (DoDecays)
791 return PerformDecays(ret, m_THM->TPS());
792 else
793 return ret;
794 }
795
796 double HypersurfaceEventGeneratorEVHRG::EVHRGWeight(int sampledN, double meanN, double V, double b)
797 {
798 double nev = meanN / V;
799 return pow((1. - b * sampledN / V) / (1. - b * nev), sampledN)
800 * exp(b * nev / (1. - b * nev) * (sampledN - meanN));
801 }
802
804 {
806 m_MeanB = 0.0; m_MeanAB = 0.0;
807 m_VEff = m_THM->Volume();
808
809 for (int ipart = 0; ipart < m_THM->TPS()->ComponentsNumber(); ++ipart) {
810 const ThermalParticle& part = m_THM->TPS()->Particle(ipart);
811 if (part.BaryonCharge() == 1)
812 m_MeanB += FullSpaceYields()[ipart];
813 if (part.BaryonCharge() == -1)
814 m_MeanAB += FullSpaceYields()[ipart];
815 }
816
817 cout << "nB = " << m_MeanB / m_VEff << endl;
818 cout << "naB = " << m_MeanAB / m_VEff << endl;
819 }
820
822 {
823 SimpleEvent ret;
824
825 // Hard-core radius for (anti)baryons in the sampling procedure
826 double radB = m_rad;
827 if (radB < 0.0)
828 radB = CuteHRGHelper::rv(m_b);
829
830 // Reshuffle the order of particles to be sampled
831 std::vector<int> idsM, idsB, idsaB;
832 for (int i = 0; i < m_THM->TPS()->Particles().size(); ++i)
833 if (m_THM->TPS()->Particles()[i].BaryonCharge() != 1 && m_THM->TPS()->Particles()[i].BaryonCharge() != -1)
834 for (int part = 0; part < yields[i]; ++part)
835 idsM.push_back(i);
836 //std::random_shuffle(idsM.begin(), idsM.end()); // Removed in C++17
837 std::shuffle(idsM.begin(), idsM.end(), RandomGenerators::rng_std);
838 for (int i = 0; i < m_THM->TPS()->Particles().size(); ++i)
839 if (m_THM->TPS()->Particles()[i].BaryonCharge() == 1)
840 for (int part = 0; part < yields[i]; ++part)
841 idsB.push_back(i);
842 //std::random_shuffle(idsB.begin(), idsB.end()); // Removed in C++17
843 std::shuffle(idsB.begin(), idsB.end(), RandomGenerators::rng_std);
844 for (int i = 0; i < m_THM->TPS()->Particles().size(); ++i)
845 if (m_THM->TPS()->Particles()[i].BaryonCharge() == -1)
846 for (int part = 0; part < yields[i]; ++part)
847 idsaB.push_back(i);
848 //std::random_shuffle(idsaB.begin(), idsaB.end()); // Removed in C++17
849 std::shuffle(idsaB.begin(), idsaB.end(), RandomGenerators::rng_std);
850
851 std::vector<int> ids;
852 ids.insert(ids.end(), idsM.begin(), idsM.end());
853 ids.insert(ids.end(), idsB.begin(), idsB.end());
854 ids.insert(ids.end(), idsaB.begin(), idsaB.end());
855
856 int idBstart = idsM.size();
857 int idaBstart = idsM.size() + idsB.size();
858
859 ret.Particles.resize(ids.size());
860 for (int ip = 0; ip < ids.size(); ++ip) {
861 int pid = ids[ip];
862 const ThermalParticle& species = m_THM->TPS()->Particles()[pid];
863 SimpleParticle part = SampleParticle(pid);
864
865 if (radB > 0.0) {
866 if (species.BaryonCharge() == 1 || species.BaryonCharge() == -1) {
867 bool flOverlap = false;
868 int tip = ip - 1;
869 while (tip >= 0 && m_THM->TPS()->Particles()[ids[tip]].BaryonCharge() == species.BaryonCharge()) {
870 double dist2 = ParticleDecaysMC::ParticleDistanceSquared(ret.Particles[tip], part);
871 flOverlap |= (dist2 <= 4. * radB * radB);
872 tip--;
873 }
874
875 if (flOverlap) {
876 if (EVUseSPR()) {
877 ip--;
878 }
879 else {
880 if (species.BaryonCharge() == 1)
881 ip = idBstart - 1;
882 else
883 ip = idaBstart - 1;
884 }
885 continue;
886 }
887 }
888 }
889
890 ret.Particles[ip] = part;
891 }
892
893 ret.AllParticles = ret.Particles;
894
895 ret.DecayMap.resize(ret.Particles.size());
896 fill(ret.DecayMap.begin(), ret.DecayMap.end(), -1);
897
898 ret.DecayMapFinal.resize(ret.Particles.size());
899 for (int i = 0; i < ret.DecayMapFinal.size(); ++i)
900 ret.DecayMapFinal[i] = i;
901
902 return ret;
903 }
904
905 std::pair<int, int> HypersurfaceEventGeneratorEVHRG::ComputeNBNBbar(const std::vector<int>& yields) const
906 {
907 int NB = 0, NBbar = 0;
908 for (int ipart = 0; ipart < m_THM->TPS()->ComponentsNumber(); ++ipart) {
909 const ThermalParticle& part = m_THM->TPS()->Particle(ipart);
910 if (part.BaryonCharge() == 1)
911 NB += yields[ipart];
912 if (part.BaryonCharge() == -1)
913 NBbar += yields[ipart];
914 }
915 return std::make_pair(NB, NBbar);
916 }
917
918} // namespace thermalfist
Contains some functions to deal with excluded volumes.
BoostInvariantHypersurfaceEventGenerator(ThermalParticleSystem *TPS=NULL, const EventGeneratorConfiguration &config=EventGeneratorConfiguration(), double etamax=0.5, const ParticlizationHypersurface *hypersurface=NULL)
Construct a new BoostInvariantHypersurfaceEventGenerator object.
std::vector< RandomGenerators::ThermalBreitWignerGenerator * > m_BWGens
static SimpleEvent PerformDecays(const SimpleEvent &evtin, const ThermalParticleSystem *TPS, const DecayerFlags &decayerFlags=DecayerFlags())
Performs decays of all unstable particles until only stable ones left.
virtual std::pair< std::vector< int >, double > SampleYields() const
Samples the primordial yields for each particle species.
virtual SimpleEvent GetEvent(bool PerformDecays=true) const
Generates a single event.
std::vector< RandomGenerators::ParticleMomentumGenerator * > m_MomentumGens
Vector of momentum generators for each particle species.
virtual SimpleParticle SampleParticle(int id) const
Samples the position and momentum of a particle species i.
void ClearMomentumGenerators()
Clears the momentum generators for all particles.
EventGeneratorConfiguration m_Config
virtual void CheckSetParameters()
Sets the hypersurface parameters.
std::vector< double > m_DensitiesIdeal
Ideal gas densities used for sampling an interacting HRG.
void SetConfiguration(ThermalParticleSystem *TPS, const EventGeneratorConfiguration &config)
Sets the event generator configuration.
virtual void SetParameters()
Sets up the event generator ready for production.
static double EVHRGWeight(int sampledN, double meanN, double V, double b)
virtual SimpleEvent GetEvent(bool DoDecays=true) const
Generates a single event.
HypersurfaceEventGeneratorEVHRG(ThermalParticleSystem *TPS, const EventGeneratorConfiguration &config=EventGeneratorConfiguration(), const ParticlizationHypersurface *hypersurface=NULL, double etasmear=0.0, bool shear_correction=false)
virtual SimpleEvent SampleParticles(const std::vector< int > &yields) const
virtual void SetParameters()
Sets the hypersurface parameters.
void SetRescaleTmu(bool rescale=false, double edens=0.26)
virtual void SetParameters()
Sets the hypersurface parameters.
HypersurfaceEventGenerator(const ParticlizationHypersurface *hypersurface=NULL, ThermalModelBase *model=NULL, double etasmear=0.0, bool shear_correction=false, bool bulk_correction=false, double speed_of_sound_squared=0.15)
Construct a new HypersurfaceEventGenerator object.
static std::vector< std::vector< double > > CalculateTMuMap(ThermalModelBase *model, double edens, double rhomin=0.0, double rhomax=0.27, double drho=0.001)
Calculates the (T,muB,muS,muQ) values as function of baryon density at fixed constant energy density.
void SetHypersurface(const ParticlizationHypersurface *hypersurface)
static void RescaleHypersurfaceParametersEdens(ParticlizationHypersurface *hypersurface, ThermalModelBase *model, double edens, double rhomin=0.0, double rhomax=0.27, double drho=0.001, double rhocrit=0.16)
Rescales the hypersurface parameters to match the given energy and baryon density.
const std::vector< double > & FullSpaceYields() const
The computed grand-canonical yields in 4pi.
void SetMomentumGeneratorConfig(const RandomGenerators::HypersurfaceMomentumGenerator::HypersurfaceMomentumGeneratorConfiguration &config)
void ProcessVolumeElements()
Processes the volume elements to calculate the multinomial volume element sampling probabilities and ...
virtual SimpleEvent GetEvent(bool PerformDecays=true) const
Sets the hypersurface parameters.
void SetSpeedOfSoundSquared(double speed_of_sound_squared)
virtual std::vector< double > GCEMeanYields() const
Override.
void SetShearCorrection(bool shear_correction)
void SetMomentumGenerators()
Sets the hypersurface parameters.
Class for generating momentum of a particle from a longitudinally boost-invariant (2+1)-D hypersurfac...
BoostInvariantHypersurfaceMomentumGenerator(const ParticlizationHypersurface *hypersurface=NULL, VolumeElementSampler *positionsampler=NULL, double Tkin=0.100, double etamax=3.0, double mass=0.938, int statistics=0, double mu=0)
Construct a new BoostInvariantMomentumGenerator object.
Class for generating momentum of a particle from a hypersurface.
virtual std::vector< double > GetMomentum(double mass=-1.) const
HypersurfaceMomentumGenerator(const ParticlizationHypersurface *hypersurface=NULL, const ThermalParticle *particle=NULL, const VolumeElementSampler *positionsampler=NULL, const HypersurfaceMomentumGeneratorConfiguration &config=HypersurfaceMomentumGeneratorConfiguration())
Construct a new BoostInvariantMomentumGenerator object.
static std::vector< double > SamplePhaseSpaceCoordinateFromElement(const ParticlizationHypersurfaceElement *elem, const ThermalParticle *particle, const double &mass=-1., const double &etasmear=0., const bool shear_correction=false, const bool bulk_correction=false, const double speed_of_sound_squared=0.15)
Samples the Cartesian phase-space coordinates of a particle emmited from a hypersurface element.
Class for generating mass of resonance in accordance with the constant width Breit-Wigner distributio...
Class for generating mass of resonance in accordance with the energy-dependent Breit-Wigner distribut...
Class for generating the absolute values of the momentum of a particle in its local rest frame.
double GetP(double mass=-1.) const
Samples the momentum of a particle.
Sample the volume element on a hypersurface from a multinomial distribution.
VolumeElementSampler(const ParticlizationHypersurface *Hypersurface=NULL)
void FillProbabilities(const ParticlizationHypersurface *Hypersurface)
int SampleVolumeElement(MTRand &rangen=RandomGenerators::randgenMT) const
Abstract base class for an HRG model implementation.
virtual void SetTemperature(double T)
Set the temperature.
virtual void SetBaryonChemicalPotential(double muB)
Set the baryon chemical potential.
virtual void SetElectricChemicalPotential(double muQ)
Set the electric chemical potential.
virtual void SetStrangenessChemicalPotential(double muS)
Set the strangeness chemical potential.
Class containing all information about a particle specie.
int BaryonCharge() const
Particle's baryon number.
int Statistics() const
Particle's statistics.
double Mass() const
Particle's mass [GeV].
int Strangeness() const
Particle's strangeness.
@ eBWconstBR
Energy-dependent Breit-Wigner scheme (eBW) with constant branching ratios when evaluating feeddown.
@ eBW
Energy-dependent Breit-Wigner scheme (eBW)
int ElectricCharge() const
Particle's electric charge.
Class containing the particle list.
double rv(double v)
Computes the radius parameter from a given excluded volume parameter value.
double ParticleDistanceSquared(const SimpleParticle &part1, const SimpleParticle &part2)
Return the square of the distance between particles at equal time.
SimpleParticle LorentzBoostMomentumOnly(const SimpleParticle &part, double vx, double vy, double vz)
Lorentz boost of the 4-momentum of a particle.
MTRand randgenMT
The Mersenne Twister random number generator.
std::mt19937 rng_std
The Mersenne Twister random number generator from STD library.
constexpr double Pi()
Pi constant.
Definition xMath.h:23
constexpr double GeVtoifm()
A constant to transform GeV into fm .
Definition xMath.h:25
The main namespace where all classes and functions of the Thermal-FIST library reside.
Definition CosmicEoS.h:9
void fillBoostMatrix(double vx, double vy, double vz, double boostMatrix[4][4])
std::vector< double > LorentzBoost(const std::vector< double > &fourvector, double vx, double vy, double vz)
Performs a Lorentz boost on a four-vector.
int index44(const int &i, const int &j)
std::vector< ParticlizationHypersurfaceElement > ParticlizationHypersurface
Structure containing the thermal event generator configuration.
Structure holding information about a single event in the event generator.
Definition SimpleEvent.h:20
std::vector< SimpleParticle > Particles
Vector of all final particles in the event.
Definition SimpleEvent.h:28
std::vector< SimpleParticle > AllParticles
Vector of all particles which ever appeared in the event (including those that decay and photons/lept...
Definition SimpleEvent.h:31
std::vector< int > DecayMap
Definition SimpleEvent.h:38
std::vector< int > DecayMapFinal
Vector for each Particles element pointing to the index of the primordial resonance from which this p...
Definition SimpleEvent.h:41
Structure holding information about a single particle in the event generator.
double GetMt() const
Transverse mass (in GeV)
double p0
Energy (in GeV)
double pz
3-momentum components (in GeV)
double GetY() const
The longitudinal rapidity.