1#ifndef HYPERSURFACESAMPLER_H
2#define HYPERSURFACESAMPLER_H
40 std::vector<double> m_CumulativeProbabilities;
46 void SetProbabilities(
const std::vector<double>& CumulativeProbabilities) { m_CumulativeProbabilities = CumulativeProbabilities; }
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
120 const HypersurfaceMomentumGeneratorConfiguration& config = HypersurfaceMomentumGeneratorConfiguration());
130 double Mass()
const {
return m_Particle->Mass(); }
137 virtual std::vector<double>
GetMomentum(
double mass = -1.)
const;
149 bool m_ShearCorrection;
150 bool m_BulkCorrection;
151 double m_SpeedOfSoundSquared;
180 double Tkin = 0.100,
double etamax = 3.0,
double mass = 0.938,
int statistics = 0,
double mu = 0);
189 double EtaMax()
const {
return m_EtaMax; }
190 double Mass()
const {
return m_Mass; }
194 virtual std::vector<double>
GetMomentum(
double mass = -1.)
const;
234 double etasmear = 0.0,
bool shear_correction =
false,
bool bulk_correction =
false,
double speed_of_sound_squared = 0.15) :
EventGeneratorBase()
276 double etasmear,
bool shear_correction =
false,
bool bulk_correction =
false,
double speed_of_sound_squared = 0.15);
299 double GetEtaSmear()
const {
return m_MomentumGeneratorConfig.etaSmear; }
301 void SetShearCorrection(
bool shear_correction) { m_MomentumGeneratorConfig.shearCorrection = shear_correction; }
304 void SetBulkCorrection(
bool bulk_correction) { m_MomentumGeneratorConfig.bulkCorrection = bulk_correction; }
307 void SetSpeedOfSoundSquared(
double speed_of_sound_squared) { m_MomentumGeneratorConfig.speedOfSoundSquared = speed_of_sound_squared; }
310 void SetRescaleTmu(
bool rescale =
false,
double edens = 0.26);
341 static std::vector<std::vector<double>>
CalculateTMuMap(
ThermalModelBase* model,
double edens,
double rhomin = 0.0,
double rhomax = 0.27,
double drho = 0.001);
357 std::vector<RandomGenerators::VolumeElementSampler> m_VolumeElementSamplers;
358 std::vector<double> m_FullSpaceYields;
360 std::vector<double> m_Musav;
364 std::vector<SplineFunction> m_SplinesTMu;
371 m_THM(model), m_edens(edens) {
375 std::vector<double> Equations(
const std::vector<double>& x) {
376 const double& T = x[0];
384 double en = m_THM->EnergyDensity();
386 std::vector<double> ret(1, 0);
387 ret[0] = (en / m_edens - 1.);
392 ThermalModelBase* m_THM;
397 class BroydenEquationsTmuB :
public BroydenEquations
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)
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];
416 m_THM->SetTemperature(T);
417 if (!m_zeroMuBmode) {
420 m_THM->SetBaryonChemicalPotential(muB);
421 m_THM->SetStrangenessChemicalPotential(muS);
422 m_THM->SetElectricChemicalPotential(muQ);
423 m_THM->CalculatePrimordialDensities();
426 m_THM->SetBaryonChemicalPotential(0.);
427 m_THM->SetElectricChemicalPotential(0.);
428 m_THM->SetStrangenessChemicalPotential(0.);
429 m_THM->CalculatePrimordialDensities();
432 double en = m_THM->EnergyDensity();
433 double rhoB = m_THM->BaryonDensity();
435 std::vector<double> ret(4, 0);
436 ret[0] = (en / m_edens - 1.);
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.;
451 ThermalModelBase* m_THM;
452 double m_edens, m_rhoB;
457 static std::vector<double> MatchEnergyBaryonDensities(ThermalModelBase* model,
double edens,
double rhoB) {
459 return { 0.,0.,0.,0. };
466 BroydenEquationsTmuB eqs(model, edens, rhoB, zeromuBmode);
467 Broyden broydn(&eqs);
468 if (model->Parameters().muB == 0.0)
469 model->SetBaryonChemicalPotential(0.010);
471 broydn.Solve({ model->Parameters().T, model->Parameters().muB, model->Parameters().muS, model->Parameters().muQ });
474 BroydenEquationsTen eqs(model, edens);
475 Broyden broydn(&eqs);
476 broydn.Solve({ model->Parameters().T });
480 model->Parameters().T,
481 model->Parameters().muB,
482 model->Parameters().muS,
483 model->Parameters().muQ,
502 double etasmear = 0.0,
bool shear_correction =
false) :
HypersurfaceEventGenerator(TPS, config, hypersurface, etasmear, shear_correction) {
505 m_MeanB = m_MeanAB = m_VEff = 0.0;
523 static double EVHRGWeight(
int sampledN,
double meanN,
double V,
double b);
530 std::pair<int, int> ComputeNBNBbar(
const std::vector<int>& yields)
const;
533 double m_MeanB, m_MeanAB, m_VEff;
BoostInvariantHypersurfaceEventGenerator(ThermalParticleSystem *TPS=NULL, const EventGeneratorConfiguration &config=EventGeneratorConfiguration(), double etamax=0.5, const ParticlizationHypersurface *hypersurface=NULL)
Construct a new BoostInvariantHypersurfaceEventGenerator object.
virtual ~BoostInvariantHypersurfaceEventGenerator()
void SetMomentumGenerators()
Abstract class which defines the system of non-linear equations to be solved by the Broyden's method.
int m_N
The number of equations.
BroydenEquations()=default
Default constructor. Does nothing.
EventGeneratorBase()
Constructor.
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
void SetBaryonRadius(double r)
void SetExcludedVolume(double b)
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 SetEtaSmear(double etaSmear)
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.
double GetSpeedOfSoundSquared()
RandomGenerators::HypersurfaceMomentumGenerator::HypersurfaceMomentumGeneratorConfiguration GetMomentumGeneratorConfig() const
void SetBulkCorrection(bool bulk_correction)
virtual ~HypersurfaceEventGenerator()
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.
bool GetShearCorrection()
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.
double GetEtaSmear() const
void SetShearCorrection(bool shear_correction)
void SetMomentumGenerators()
Sets the hypersurface parameters.
virtual std::vector< double > GetMomentum(double mass=-1.) const
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
bool ShearCorrection() const
double SpeedOfSoundSquared() 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.
bool BulkCorrection() const
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.
ParticleMomentumGenerator()
Default constructor.
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.
std::vector< ParticlizationHypersurfaceElement > ParticlizationHypersurface
Structure containing the thermal event generator configuration.
Configuration structure for the HypersurfaceMomentumGenerator.
double speedOfSoundSquared
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.