Version: SMASH-2.2
grandcan_thermalizer.h
Go to the documentation of this file.
1 /*
2  * Copyright (c) 2016-
3  * SMASH Team
4  *
5  * GNU General Public License (GPLv3 or later)
6  */
7 #ifndef SRC_INCLUDE_SMASH_GRANDCAN_THERMALIZER_H_
8 #define SRC_INCLUDE_SMASH_GRANDCAN_THERMALIZER_H_
9 
10 #include <memory>
11 #include <vector>
12 
13 #include "angles.h"
14 #include "clock.h"
15 #include "configuration.h"
16 #include "density.h"
17 #include "distributions.h"
18 #include "forwarddeclarations.h"
19 #include "hadgas_eos.h"
20 #include "lattice.h"
21 #include "particledata.h"
22 #include "quantumnumbers.h"
23 
24 namespace smash {
25 
49  public:
66  void add_particle(const ParticleData& p, double factor);
91  void set_rest_frame_quantities(double T0, double mub0, double mus0,
92  double muq0, const ThreeVector v0);
94  FourVector Tmu0() const { return Tmu0_; }
96  double nb() const { return nb_; }
98  double ns() const { return ns_; }
100  double nq() const { return nq_; }
102  double e() const { return e_; }
104  double p() const { return p_; }
106  ThreeVector v() const { return v_; }
108  double T() const { return T_; }
110  double mub() const { return mub_; }
112  double mus() const { return mus_; }
114  double muq() const { return muq_; }
115 
116  private:
120  double nb_;
122  double ns_;
124  double nq_;
126  double e_;
128  double p_;
132  double T_;
134  double mub_;
136  double mus_;
138  double muq_;
139 };
140 
147 std::ostream& operator<<(std::ostream& s, const ThermLatticeNode& node);
148 
153 enum class HadronClass {
155  Baryon = 0,
157  Antibaryon = 1,
159  PositiveSMeson = 2,
161  NegativeSMeson = 3,
167  ZeroQZeroSMeson = 6,
168 };
169 
228  public:
245  GrandCanThermalizer(const std::array<double, 3> lat_sizes,
246  const std::array<int, 3> n_cells,
247  const std::array<double, 3> origin, bool periodicity,
248  double e_critical, double t_start, double delta_t,
249  ThermalizationAlgorithm algo, bool BF_microcanonical);
252  const std::array<double, 3> lat_sizes,
253  const std::array<double, 3> origin, bool periodicity)
255  lat_sizes, conf.take({"Cell_Number"}), origin, periodicity,
256  conf.take({"Critical_Edens"}), conf.take({"Start_Time"}),
257  conf.take({"Timestep"}),
258  conf.take({"Algorithm"}, ThermalizationAlgorithm::BiasedBF),
259  conf.take({"Microcanonical"}, false)) {}
265  bool is_time_to_thermalize(std::unique_ptr<Clock>& clock) const {
266  const double t = clock->current_time();
267  const int n = static_cast<int>(std::floor((t - t_start_) / period_));
268  return (t > t_start_ &&
269  t < t_start_ + n * period_ + clock->timestep_duration());
270  }
280  void update_thermalizer_lattice(const std::vector<Particles>& ensembles,
281  const DensityParameters& par,
282  bool ignore_cells_under_threshold = true);
284  ThreeVector uniform_in_cell() const;
292  void renormalize_momenta(ParticleList& plist,
293  const FourVector required_total_momentum);
294 
295  // Functions for BF-sampling algorithm
296 
305  void sample_multinomial(HadronClass particle_class, int N);
317  void sample_in_random_cell_BF_algo(ParticleList& plist, const double time,
318  size_t type_index);
331  void thermalize_BF_algo(QuantumNumbers& conserved_initial, double time,
332  int ntest);
333 
334  // Functions for mode-sampling algorithm
335 
340  template <typename F>
341  void compute_N_in_cells_mode_algo(F&& condition) {
342  N_in_cells_.clear();
343  N_total_in_cells_ = 0.0;
344  for (auto cell_index : cells_to_sample_) {
345  const ThermLatticeNode cell = (*lat_)[cell_index];
346  const double gamma = 1.0 / std::sqrt(1.0 - cell.v().sqr());
347  double N_tot = 0.0;
348  for (ParticleTypePtr i : eos_typelist_) {
349  if (condition(i->strangeness(), i->baryon_number(), i->charge())) {
350  // N_i = n u^mu dsigma_mu = (isochronous hypersurface) n * V * gamma
351  N_tot += lat_cell_volume_ * gamma *
352  HadronGasEos::partial_density(*i, cell.T(), cell.mub(),
353  cell.mus(), 0.0);
354  }
355  }
356  N_in_cells_.push_back(N_tot);
357  N_total_in_cells_ += N_tot;
358  }
359  }
360 
371  template <typename F>
373  F&& condition) {
374  // Choose random cell, probability = N_in_cell/N_total
375  double r = random::uniform(0.0, N_total_in_cells_);
376  double partial_sum = 0.0;
377  int index_only_thermalized = -1;
378  while (partial_sum < r) {
379  index_only_thermalized++;
380  partial_sum += N_in_cells_[index_only_thermalized];
381  }
382  const int cell_index = cells_to_sample_[index_only_thermalized];
383  const ThermLatticeNode cell = (*lat_)[cell_index];
384  const ThreeVector cell_center = lat_->cell_center(cell_index);
385  const double gamma = 1.0 / std::sqrt(1.0 - cell.v().sqr());
386  const double N_in_cell = N_in_cells_[index_only_thermalized];
387  // Which sort to sample - probability N_i/N_tot
388  r = random::uniform(0.0, N_in_cell);
389  double N_sum = 0.0;
390  ParticleTypePtr type_to_sample;
391  for (ParticleTypePtr i : eos_typelist_) {
392  if (!condition(i->strangeness(), i->baryon_number(), i->charge())) {
393  continue;
394  }
395  N_sum += lat_cell_volume_ * gamma *
396  HadronGasEos::partial_density(*i, cell.T(), cell.mub(),
397  cell.mus(), 0.0);
398  if (N_sum >= r) {
399  type_to_sample = i;
400  break;
401  }
402  }
403  ParticleData particle(*type_to_sample);
404  // Note: it's pole mass for resonances!
405  const double m = type_to_sample->mass();
406  // Position
407  particle.set_4position(FourVector(time, cell_center + uniform_in_cell()));
408  // Momentum
409  double momentum_radial = sample_momenta_from_thermal(cell.T(), m);
410  Angles phitheta;
411  phitheta.distribute_isotropically();
412  particle.set_4momentum(m, phitheta.threevec() * momentum_radial);
413  particle.boost_momentum(-cell.v());
414  particle.set_formation_time(time);
415  return particle;
416  }
417 
426  void thermalize_mode_algo(QuantumNumbers& conserved_initial, double time);
434  void thermalize(const Particles& particles, double time, int ntest);
435 
442  void print_statistics(const Clock& clock) const;
446  double e_crit() const { return e_crit_; }
448  ParticleList particles_to_remove() const { return to_remove_; }
450  ParticleList particles_to_insert() const { return sampled_list_; }
451 
452  private:
457  ParticleTypePtrList list_eos_particles() const {
458  ParticleTypePtrList res;
459  for (const ParticleType& ptype : ParticleType::list_all()) {
460  if (HadronGasEos::is_eos_particle(ptype)) {
461  res.push_back(&ptype);
462  }
463  }
464  return res;
465  }
470  HadronClass get_class(size_t typelist_index) const {
471  const int B = eos_typelist_[typelist_index]->baryon_number();
472  const int S = eos_typelist_[typelist_index]->strangeness();
473  const int ch = eos_typelist_[typelist_index]->charge();
474  // clang-format off
475  return (B > 0) ? HadronClass::Baryon :
476  (B < 0) ? HadronClass::Antibaryon :
477  (S > 0) ? HadronClass::PositiveSMeson :
478  (S < 0) ? HadronClass::NegativeSMeson :
479  (ch > 0) ? HadronClass::PositiveQZeroSMeson :
480  (ch < 0) ? HadronClass::NegativeQZeroSMeson :
481  HadronClass::ZeroQZeroSMeson;
482  // clang-format on
483  }
485  double mult_class(const HadronClass cl) const {
486  return mult_classes_[static_cast<size_t>(cl)];
487  }
489  std::vector<double> N_in_cells_;
491  std::vector<size_t> cells_to_sample_;
493  HadronGasEos eos_ = HadronGasEos(true, false);
495  std::unique_ptr<RectangularLattice<ThermLatticeNode>> lat_;
497  ParticleList to_remove_;
499  ParticleList sampled_list_;
508  const ParticleTypePtrList eos_typelist_;
510  const size_t N_sorts_;
512  std::vector<double> mult_sort_;
514  std::vector<int> mult_int_;
519  std::array<double, 7> mult_classes_;
528  const double e_crit_;
530  const double t_start_;
532  const double period_;
537 };
538 
539 } // namespace smash
540 
541 #endif // SRC_INCLUDE_SMASH_GRANDCAN_THERMALIZER_H_
Angles provides a common interface for generating directions: i.e., two angles that should be interpr...
Definition: angles.h:59
ThreeVector threevec() const
Definition: angles.h:268
void distribute_isotropically()
Populate the object with a new direction.
Definition: angles.h:188
Clock tracks the time in the simulation.
Definition: clock.h:71
Interface to the SMASH configuration files.
Value take(std::initializer_list< const char * > keys)
The default interface for SMASH to read configuration values.
A class to pre-calculate and store parameters relevant for density calculation.
Definition: density.h:108
The FourVector class holds relevant values in Minkowski spacetime with (+, −, −, −) metric signature.
Definition: fourvector.h:33
The GrandCanThermalizer class implements the following functionality:
void compute_N_in_cells_mode_algo(F &&condition)
Computes average number of particles in each cell for the mode algorithm.
std::vector< double > mult_sort_
Real number multiplicity for each particle type.
std::vector< int > mult_int_
Integer multiplicity for each particle type.
GrandCanThermalizer(Configuration &conf, const std::array< double, 3 > lat_sizes, const std::array< double, 3 > origin, bool periodicity)
ParticleList to_remove_
Particles to be removed after this thermalization step.
const bool BF_enforce_microcanonical_
Enforce energy conservation as part of BF sampling algorithm or not.
std::unique_ptr< RectangularLattice< ThermLatticeNode > > lat_
The lattice on which the thermodynamic quantities are calculated.
ParticleList particles_to_insert() const
List of newly created particles to be inserted in the simulation.
double mult_class(const HadronClass cl) const
ParticleList particles_to_remove() const
List of particles to be removed from the simulation.
HadronClass get_class(size_t typelist_index) const
Defines the class of hadrons by quantum numbers.
GrandCanThermalizer(const std::array< double, 3 > lat_sizes, const std::array< int, 3 > n_cells, const std::array< double, 3 > origin, bool periodicity, double e_critical, double t_start, double delta_t, ThermalizationAlgorithm algo, bool BF_microcanonical)
Default constructor for the GranCanThermalizer to allocate the lattice.
const double t_start_
Starting time of the simulation.
const double period_
Defines periodicity of the lattice in fm.
ParticleTypePtrList list_eos_particles() const
Extracts the particles in the hadron gas equation of state from the complete list of particle types i...
const double e_crit_
Critical energy density above which cells are thermalized.
ParticleList sampled_list_
Newly generated particles by thermalizer.
std::array< double, 7 > mult_classes_
The different hadron species according to the enum defined in.
std::vector< size_t > cells_to_sample_
Cells above critical energy density.
const ThermalizationAlgorithm algorithm_
Algorithm to choose for sampling of particles obeying conservation laws.
bool is_time_to_thermalize(std::unique_ptr< Clock > &clock) const
Check that the clock is close to n * period of thermalization, since the thermalization only happens ...
RectangularLattice< ThermLatticeNode > & lattice() const
Getter function for the lattice.
double e_crit() const
Get the critical energy density.
const ParticleTypePtrList eos_typelist_
List of particle types from which equation of state is computed.
std::vector< double > N_in_cells_
Number of particles to be sampled in one cell.
ParticleData sample_in_random_cell_mode_algo(const double time, F &&condition)
Samples one particle and the species, cell, momentum and coordinate are chosen from the corresponding...
double lat_cell_volume_
Volume of a single lattice cell, necessary to convert thermal densities to actual particle numbers.
const size_t N_sorts_
Number of different species to be sampled.
double N_total_in_cells_
Total number of particles over all cells in thermalization region.
Class to handle the equation of state (EoS) of the hadron gas, consisting of all hadrons included in ...
Definition: hadgas_eos.h:125
ParticleData contains the dynamic information of a certain particle.
Definition: particledata.h:58
void set_4momentum(const FourVector &momentum_vector)
Set the particle's 4-momentum directly.
Definition: particledata.h:164
void set_4position(const FourVector &pos)
Set the particle's 4-position directly.
Definition: particledata.h:209
void set_formation_time(const double &form_time)
Set the absolute formation time.
Definition: particledata.h:251
void boost_momentum(const ThreeVector &v)
Apply a Lorentz-boost to only the momentum.
Definition: particledata.h:332
A pointer-like interface to global references to ParticleType objects.
Definition: particletype.h:671
Particle type contains the static properties of a particle species.
Definition: particletype.h:97
double mass() const
Definition: particletype.h:144
The Particles class abstracts the storage and manipulation of particles.
Definition: particles.h:33
A container for storing conserved values.
A container class to hold all the arrays on the lattice and access them.
Definition: lattice.h:47
The ThermLatticeNode class is intended to compute thermodynamical quantities in a cell given a set of...
void compute_rest_frame_quantities(HadronGasEos &eos)
Temperature, chemical potentials and rest frame velocity are calculated given the hadron gas equation...
double muq() const
Get the net charge chemical potential.
FourVector Tmu0() const
Get Four-momentum flow of the cell.
double ns_
Net strangeness density of the cell in the computational frame.
void set_rest_frame_quantities(double T0, double mub0, double mus0, double muq0, const ThreeVector v0)
Set all the rest frame quantities to some values, this is useful for testing.
double p() const
Get pressure in the rest frame.
double p_
Pressure in the rest frame.
double mus_
Net strangeness chemical potential.
ThreeVector v() const
Get 3-velocity of the rest frame.
double ns() const
Get net strangeness density of the cell in the computational frame.
double e_
Energy density in the rest frame.
double nb_
Net baryon density of the cell in the computational frame.
void add_particle(const ParticleData &p, double factor)
Add particle contribution to Tmu0, nb, ns and nq May look like unused at first glance,...
double muq_
Net charge chemical potential.
void add_particle_for_derivatives(const ParticleData &, double, ThreeVector)
dummy function for update_lattice
double nq() const
Get net charge density of the cell in the computational frame.
double mub_
Net baryon chemical potential.
FourVector Tmu0_
Four-momentum flow of the cell.
double mus() const
Get the net strangeness chemical potential.
ThreeVector v_
Velocity of the rest frame.
ThermLatticeNode()
Default constructor of thermal quantities on the lattice returning thermodynamic quantities in comput...
double mub() const
Get the net baryon chemical potential.
double nb() const
Get net baryon density of the cell in the computational frame.
double nq_
Net charge density of the cell in the computational frame.
double e() const
Get energy density in the rest frame.
double T() const
Get the temperature.
The ThreeVector class represents a physical three-vector with the components .
Definition: threevector.h:31
double sqr() const
Definition: threevector.h:259
ThermalizationAlgorithm
Defines the algorithm used for the forced thermalization.
std::ostream & operator<<(std::ostream &out, const ActionPtr &action)
Convenience: dereferences the ActionPtr to Action.
Definition: action.h:532
constexpr int n
Neutron.
T uniform(T min, T max)
Definition: random.h:88
Definition: action.h:24
double sample_momenta_from_thermal(const double temperature, const double mass)
Samples a momentum from the Maxwell-Boltzmann (thermal) distribution in a faster way,...
HadronClass
Specifier to classify the different hadron species according to their quantum numbers.
@ Antibaryon
All anti-baryons.
@ ZeroQZeroSMeson
Neutral non-strange mesons.
@ NegativeSMeson
Mesons with strangeness S < 0.
@ NegativeQZeroSMeson
Non-strange mesons (S = 0) with electric cherge Q < 0.
@ PositiveSMeson
Mesons with strangeness S > 0.
@ Baryon
All baryons.
@ PositiveQZeroSMeson
Non-strange mesons (S = 0) with electric cherge Q > 0.
#define S(x, n)
Definition: sha256.cc:54