Thermal-FIST 1.5
Package for hadron resonance gas model applications
Loading...
Searching...
No Matches
HypersurfaceSampler.h
Go to the documentation of this file.
1#ifndef HYPERSURFACESAMPLER_H
2#define HYPERSURFACESAMPLER_H
3
4/*
5 * Thermal-FIST package
6 *
7 * Copyright (c) 2021 Volodymyr Vovchenko
8 *
9 * GNU General Public License (GPLv3 or later)
10 */
11
17
18namespace thermalfist {
19
21 double tau, x, y, eta;
22 double dsigma[4];
23 double u[4];
24 double T, muB, muQ, muS;
25 double edens, rhoB;
26 double pi[10];
27 double Pi;
28 double P;
29 };
30
31 typedef std::vector<ParticlizationHypersurfaceElement> ParticlizationHypersurface;
32
33 namespace RandomGenerators {
34
40 std::vector<double> m_CumulativeProbabilities;
41 public:
42 VolumeElementSampler(const ParticlizationHypersurface* Hypersurface = NULL);
43 VolumeElementSampler(const std::vector<double>& Weights);
44 void FillProbabilities(const ParticlizationHypersurface* Hypersurface);
45 void FillProbabilities(const std::vector<double>& Weights);
46 void SetProbabilities(const std::vector<double>& CumulativeProbabilities) { m_CumulativeProbabilities = CumulativeProbabilities; }
47 int SampleVolumeElement(MTRand& rangen = RandomGenerators::randgenMT) const;
48 };
49
50
61 {
62 public:
63
78 static std::vector<double> SamplePhaseSpaceCoordinateFromElement(
80 const ThermalParticle* particle,
81 const double& mass = -1.,
82 const double& etasmear = 0.,
83 const bool shear_correction = false,
84 const bool bulk_correction = false,
85 const double speed_of_sound_squared = 0.15
86 );
87
100 double etaSmear;
104 HypersurfaceMomentumGeneratorConfiguration(double etasmear = 0.0, bool shear_correction = false, bool bulk_correction = false, double speed_of_sound_squared = 0.15) :
105 etaSmear(etasmear), shearCorrection(shear_correction), bulkCorrection(bulk_correction), speedOfSoundSquared(speed_of_sound_squared) {}
106 };
107
117 const ParticlizationHypersurface* hypersurface = NULL,
118 const ThermalParticle* particle = NULL,
119 const VolumeElementSampler* positionsampler = NULL,
120 const HypersurfaceMomentumGeneratorConfiguration& config = HypersurfaceMomentumGeneratorConfiguration());
121
128
129 double EtaSmear() const { return m_EtaSmear; }
130 double Mass() const { return m_Particle->Mass(); }
131 bool ShearCorrection() const { return m_ShearCorrection; }
132 bool BulkCorrection() const { return m_BulkCorrection; }
133 double SpeedOfSoundSquared() const { return m_SpeedOfSoundSquared; }
134
135 // Override functions begin
136
137 virtual std::vector<double> GetMomentum(double mass = -1.) const;
138
139 // Override functions end
140
141
142 protected:
143
144 private:
145 const ParticlizationHypersurface* m_ParticlizationHypersurface;
146 const ThermalParticle* m_Particle;
147 const VolumeElementSampler* m_VolumeElementSampler;
148 double m_EtaSmear;
149 bool m_ShearCorrection;
150 bool m_BulkCorrection;
151 double m_SpeedOfSoundSquared;
152 };
153
154
162 {
163 public:
164
165
178 const ParticlizationHypersurface* hypersurface = NULL,
179 VolumeElementSampler* positionsampler = NULL,
180 double Tkin = 0.100, double etamax = 3.0, double mass = 0.938, int statistics = 0, double mu = 0);
181
188
189 double EtaMax() const { return m_EtaMax; }
190 double Mass() const { return m_Mass; }
191
192 // Override functions begin
193
194 virtual std::vector<double> GetMomentum(double mass = -1.) const;
195
196 // Override functions end
197
198
199 protected:
200
201 private:
202 const ParticlizationHypersurface* m_ParticlizationHypersurface;
203 VolumeElementSampler* m_VolumeElementSampler;
204 ThermalMomentumGenerator m_Generator;
205 double m_Tkin;
206 double m_EtaMax;
207 double m_Mass;
208 };
209
210 }
211
212
213
221 {
222 public:
223
232 const ParticlizationHypersurface* hypersurface = NULL,
233 ThermalModelBase* model = NULL,
234 double etasmear = 0.0, bool shear_correction = false, bool bulk_correction = false, double speed_of_sound_squared = 0.15) : EventGeneratorBase()
235 {
236 SetHypersurface(hypersurface);
237 SetEtaSmear(etasmear);
239 SetShearCorrection(shear_correction);
240 SetBulkCorrection(bulk_correction);
241 SetSpeedOfSoundSquared(speed_of_sound_squared);
242 m_THM = model;
243 //SetParameters(hypersurface, model, etasmear);
244 }
245
257 const ParticlizationHypersurface* hypersurface = NULL,
259
260
274 const EventGeneratorConfiguration& config,
275 const ParticlizationHypersurface* hypersurface,
276 double etasmear, bool shear_correction = false, bool bulk_correction = false, double speed_of_sound_squared = 0.15);
277
279
281
282 //virtual std::pair< std::vector<int>, double > SampleYields() const { exit(1); return std::pair< std::vector<int>, double >(); }
283 //virtual SimpleEvent GetEvent(bool PerformDecays = true) const { exit(1); return SimpleEvent(); }
284 virtual std::vector<double> GCEMeanYields() const;
285 virtual std::vector<double>& GCEMeanYields();
286
288
289
290
291 void SetModel(ThermalModelBase* model) { m_THM = model; m_ParametersSet = false; }
292
293 void SetHypersurface(const ParticlizationHypersurface* hypersurface) { m_ParticlizationHypersurface = hypersurface; m_ParametersSet = false; }
294
297
298 void SetEtaSmear(double etaSmear) { m_MomentumGeneratorConfig.etaSmear = etaSmear; m_ParametersSet = false; }
299 double GetEtaSmear() const { return m_MomentumGeneratorConfig.etaSmear; }
300
301 void SetShearCorrection(bool shear_correction) { m_MomentumGeneratorConfig.shearCorrection = shear_correction; }
302 bool GetShearCorrection() { return m_MomentumGeneratorConfig.shearCorrection; }
303
304 void SetBulkCorrection(bool bulk_correction) { m_MomentumGeneratorConfig.bulkCorrection = bulk_correction; }
305 bool GetBulkCorrection() { return m_MomentumGeneratorConfig.bulkCorrection; }
306
307 void SetSpeedOfSoundSquared(double speed_of_sound_squared) { m_MomentumGeneratorConfig.speedOfSoundSquared = speed_of_sound_squared; }
308 double GetSpeedOfSoundSquared() { return m_MomentumGeneratorConfig.speedOfSoundSquared; }
309
310 void SetRescaleTmu(bool rescale = false, double edens = 0.26);
311
313 //void SetParameters(const ParticlizationHypersurface* hypersurface, ThermalModelBase* model, double etasmear = 0.0);
314 //virtual void SetParameters();
315
326 virtual SimpleEvent GetEvent(bool PerformDecays = true) const;
327
328
330 //virtual void CheckSetParameters() { if (!m_ParametersSet) SetParameters(); }
331
332 protected:
336
339
341 static std::vector<std::vector<double>> CalculateTMuMap(ThermalModelBase* model, double edens, double rhomin = 0.0, double rhomax = 0.27, double drho = 0.001);
342
344 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);
345
347 //void SetParameters(const ParticlizationHypersurface* hypersurface, ThermalModelBase* model, double etasmear = 0.0);
348 virtual void SetParameters();
349
351 const std::vector<double>& FullSpaceYields() const { return m_FullSpaceYields; }
352
353 //bool m_ParametersSet;
354
355 private:
356 const ParticlizationHypersurface* m_ParticlizationHypersurface;
357 std::vector<RandomGenerators::VolumeElementSampler> m_VolumeElementSamplers;
358 std::vector<double> m_FullSpaceYields;
359 double m_Tav;
360 std::vector<double> m_Musav;
361 bool m_RescaleTmu;
363 double m_edens;
364 std::vector<SplineFunction> m_SplinesTMu;
365
366 // Find T and muB = 0 to match energy density
367 class BroydenEquationsTen : public BroydenEquations
368 {
369 public:
370 BroydenEquationsTen(ThermalModelBase* model, double edens = 0.5) : BroydenEquations(),
371 m_THM(model), m_edens(edens) {
372 m_N = 1;
373 }
374
375 std::vector<double> Equations(const std::vector<double>& x) {
376 const double& T = x[0];
377
378 m_THM->SetTemperature(T);
383
384 double en = m_THM->EnergyDensity();
385
386 std::vector<double> ret(1, 0);
387 ret[0] = (en / m_edens - 1.);
388
389 return ret;
390 }
391 private:
392 ThermalModelBase* m_THM;
393 double m_edens;
394 };
395
396 // Find T,muB to match energy and baryon densities
397 class BroydenEquationsTmuB : public BroydenEquations
398 {
399 public:
400 BroydenEquationsTmuB(ThermalModelBase* model, double edens = 0.5, double rhoB = 0.16, int zeroMuBmode = 0) : BroydenEquations(),
401 m_THM(model), m_edens(edens), m_rhoB(rhoB), m_zeroMuBmode(zeroMuBmode)
402 {
403 //m_N = 2;
404 m_N = 4;
405 }
406 std::vector<double> Equations(const std::vector<double>& x) {
407 const double& T = x[0];
408 const double& muB = x[1];
409 const double& muS = x[2];
410 const double& muQ = x[3];
411
412 //m_THM->SetQoverB(0.4);
413 //m_THM->ConstrainMuQ(true);
414 //m_THM->ConstrainMuS(true);
415
416 m_THM->SetTemperature(T);
417 if (!m_zeroMuBmode) {
418 //m_THM->SetBaryonChemicalPotential(muB);
419 //m_THM->ConstrainChemicalPotentials(false);
420 m_THM->SetBaryonChemicalPotential(muB);
421 m_THM->SetStrangenessChemicalPotential(muS);
422 m_THM->SetElectricChemicalPotential(muQ);
423 m_THM->CalculatePrimordialDensities();
424 }
425 else {
426 m_THM->SetBaryonChemicalPotential(0.);
427 m_THM->SetElectricChemicalPotential(0.);
428 m_THM->SetStrangenessChemicalPotential(0.);
429 m_THM->CalculatePrimordialDensities();
430 }
431
432 double en = m_THM->EnergyDensity();
433 double rhoB = m_THM->BaryonDensity();
434
435 std::vector<double> ret(4, 0);
436 ret[0] = (en / m_edens - 1.);
437
438 if (!m_zeroMuBmode) {
439 ret[1] = rhoB / m_rhoB - 1.;
440 ret[2] = m_THM->StrangenessDensity() / m_THM->AbsoluteStrangenessDensity();
441 ret[3] = m_THM->ElectricChargeDensity() / m_THM->BaryonDensity() / 0.4 - 1.;
442 }
443 else {
444 ret[1] = 0.;
445 ret[2] = 0.;
446 ret[3] = 0.;
447 }
448 return ret;
449 }
450 private:
451 ThermalModelBase* m_THM;
452 double m_edens, m_rhoB;
453 int m_zeroMuBmode;
454 };
455
456 // returns (T,muB,muS,muQ) from given energy and baryon densities, assuming Q/B = 0.4, S = 0
457 static std::vector<double> MatchEnergyBaryonDensities(ThermalModelBase* model, double edens, double rhoB) {
458 if (edens == 0.0)
459 return { 0.,0.,0.,0. };
460
461 int zeromuBmode = 0;
462 if (rhoB == 0.0)
463 zeromuBmode = 1;
464
465 if (!zeromuBmode) {
466 BroydenEquationsTmuB eqs(model, edens, rhoB, zeromuBmode);
467 Broyden broydn(&eqs);
468 if (model->Parameters().muB == 0.0)
469 model->SetBaryonChemicalPotential(0.010);
470 //broydn.Solve({ model->Parameters().T, model->Parameters().muB });
471 broydn.Solve({ model->Parameters().T, model->Parameters().muB, model->Parameters().muS, model->Parameters().muQ });
472 }
473 else {
474 BroydenEquationsTen eqs(model, edens);
475 Broyden broydn(&eqs);
476 broydn.Solve({ model->Parameters().T });
477 }
478
479 return {
480 model->Parameters().T,
481 model->Parameters().muB,
482 model->Parameters().muS,
483 model->Parameters().muQ,
484 model->Pressure()
485 };
486 }
487 };
488
496 {
497 public:
501 const ParticlizationHypersurface* hypersurface = NULL,
502 double etasmear = 0.0, bool shear_correction = false) : HypersurfaceEventGenerator(TPS, config, hypersurface, etasmear, shear_correction) {
503 m_b = 0.0;
504 m_rad = 0.0;
505 m_MeanB = m_MeanAB = m_VEff = 0.0;
506 }
507
518 virtual SimpleEvent GetEvent(bool DoDecays = true) const;
519
520 void SetExcludedVolume(double b) { m_b = b; m_ParametersSet = false; }
521 void SetBaryonRadius(double r) { m_rad = r; m_ParametersSet = false; }
522 protected:
523 static double EVHRGWeight(int sampledN, double meanN, double V, double b);
524 virtual void SetParameters();
525
526 virtual SimpleEvent SampleParticles(const std::vector<int>& yields) const;
527
528 private:
529
530 std::pair<int, int> ComputeNBNBbar(const std::vector<int>& yields) const;
531
532 double m_b, m_rad;
533 double m_MeanB, m_MeanAB, m_VEff;
534 };
535
539 {
540 public:
541
551 double etamax = 0.5,
552 const ParticlizationHypersurface* hypersurface = NULL);
553
555
557 void SetParameters(double etamax, const ParticlizationHypersurface* hypersurface);
558
559 double GetEtaMax() const { return m_EtaMax; }
560
561 protected:
565
566 private:
567 double m_EtaMax;
568 const ParticlizationHypersurface* m_ParticlizationHypersurface;
569 RandomGenerators::VolumeElementSampler* m_VolumeElementSampler;
570 };
571
572} // namespace thermalfist
573
574#endif
BoostInvariantHypersurfaceEventGenerator(ThermalParticleSystem *TPS=NULL, const EventGeneratorConfiguration &config=EventGeneratorConfiguration(), double etamax=0.5, const ParticlizationHypersurface *hypersurface=NULL)
Construct a new BoostInvariantHypersurfaceEventGenerator object.
Abstract class which defines the system of non-linear equations to be solved by the Broyden's method.
Definition Broyden.h:32
int m_N
The number of equations.
Definition Broyden.h:66
BroydenEquations()=default
Default constructor. Does nothing.
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 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.
void SetModel(ThermalModelBase *model)
End override.
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.
RandomGenerators::HypersurfaceMomentumGenerator::HypersurfaceMomentumGeneratorConfiguration GetMomentumGeneratorConfig() const
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.
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.
virtual ~BoostInvariantHypersurfaceMomentumGenerator()
BoostInvariantMomentumGenerator desctructor.
virtual std::vector< double > GetMomentum(double mass=-1.) const
virtual ~HypersurfaceMomentumGenerator()
BoostInvariantMomentumGenerator desctructor.
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 the absolute values of the momentum of a particle in its local rest frame.
Sample the volume element on a hypersurface from a multinomial distribution.
void SetProbabilities(const std::vector< double > &CumulativeProbabilities)
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 CalculatePrimordialDensities()=0
Calculates the primordial densities of all species.
virtual void SetStrangenessChemicalPotential(double muS)
Set the strangeness chemical potential.
Class containing all information about a particle specie.
Class containing the particle list.
Contains random generator functions used in the Monte Carlo Thermal Event Generator.
MTRand randgenMT
The Mersenne Twister random number generator.
The main namespace where all classes and functions of the Thermal-FIST library reside.
Definition CosmicEoS.h:9
std::vector< ParticlizationHypersurfaceElement > ParticlizationHypersurface
Structure containing the thermal event generator configuration.
HypersurfaceMomentumGeneratorConfiguration(double etasmear=0.0, bool shear_correction=false, bool bulk_correction=false, double speed_of_sound_squared=0.15)
Structure holding information about a single event in the event generator.
Definition SimpleEvent.h:20