Version: SMASH-3.2
density.h
Go to the documentation of this file.
1 /*
2  *
3  * Copyright (c) 2014-2022,2024
4  * SMASH Team
5  *
6  * GNU General Public License (GPLv3 or later)
7  *
8  */
9 #ifndef SRC_INCLUDE_SMASH_DENSITY_H_
10 #define SRC_INCLUDE_SMASH_DENSITY_H_
11 
12 #include <iostream>
13 #include <tuple>
14 #include <typeinfo>
15 #include <utility>
16 #include <vector>
17 
18 #include "energymomentumtensor.h"
19 #include "experimentparameters.h"
20 #include "forwarddeclarations.h"
21 #include "fourvector.h"
22 #include "lattice.h"
23 #include "particledata.h"
24 #include "particles.h"
25 #include "pdgcode.h"
26 #include "threevector.h"
27 
28 namespace smash {
29 static constexpr int LDensity = LogArea::Density::id;
30 
38 std::ostream &operator<<(std::ostream &os, DensityType dt);
39 
52 double density_factor(const ParticleType &type, DensityType dens_type);
53 
61 inline double smearing_factor_norm(const double two_sigma_sqr) {
62  const double tmp = two_sigma_sqr * M_PI;
63  return tmp * std::sqrt(tmp);
64 }
65 
83 inline double smearing_factor_rcut_correction(const double rcut_in_sigma) {
84  const double x = rcut_in_sigma / std::sqrt(2.0);
85  return -2.0 / std::sqrt(M_PI) * x * std::exp(-x * x) + std::erf(x);
86 }
87 
93  public:
106  : sig_(par.gaussian_sigma),
107  r_cut_(par.gauss_cutoff_in_sigma * par.gaussian_sigma),
108  ntest_(par.testparticles),
109  nensembles_(par.n_ensembles),
110  derivatives_(par.derivatives_mode),
111  rho_derivatives_(par.rho_derivatives_mode),
112  smearing_(par.smearing_mode),
113  central_weight_(par.discrete_weight),
117  const double two_sig_sqr = 2 * sig_ * sig_;
118  two_sig_sqr_inv_ = 1. / two_sig_sqr;
119  const double norm = smearing_factor_norm(two_sig_sqr);
120  const double corr_factor =
122  norm_factor_sf_ = 1. / (norm * ntest_ * nensembles_ * corr_factor);
123  }
125  int ntest() const { return ntest_; }
127  int nensembles() const { return nensembles_; }
132  return rho_derivatives_;
133  }
135  SmearingMode smearing() const { return smearing_; }
137  double central_weight() const { return central_weight_; }
139  double triangular_range() const { return triangular_range_; }
141  double r_cut() const { return r_cut_; }
143  double r_cut_sqr() const { return r_cut_sqr_; }
145  double two_sig_sqr_inv() const { return two_sig_sqr_inv_; }
151  double norm_factor_sf() const { return norm_factor_sf_; }
153  bool only_participants() const { return only_participants_; }
154 
155  private:
157  const double sig_;
159  const double r_cut_;
161  double r_cut_sqr_;
167  const int ntest_;
169  const int nensembles_;
177  const double central_weight_;
179  const double triangular_range_;
182 };
183 
201 std::pair<double, ThreeVector> unnormalized_smearing_factor(
202  const ThreeVector &r, const FourVector &p, const double m_inv,
203  const DensityParameters &dens_par, const bool compute_gradient = false);
204 
261 current_eckart(const ThreeVector &r, const ParticleList &plist,
262  const DensityParameters &par, DensityType dens_type,
263  bool compute_gradient, bool smearing);
267 current_eckart(const ThreeVector &r, const Particles &plist,
268  const DensityParameters &par, DensityType dens_type,
269  bool compute_gradient, bool smearing);
270 
300  public:
303  : jmu_pos_(FourVector()),
304  jmu_neg_(FourVector()),
306  drho_dxnu_(FourVector()) {}
307 
320  void add_particle(const ParticleData &part, double FactorTimesSf) {
321  const FourVector part_four_velocity = FourVector(1.0, part.velocity());
322  if (FactorTimesSf > 0.0) {
323  jmu_pos_ += part_four_velocity * FactorTimesSf;
324  } else {
325  jmu_neg_ += part_four_velocity * FactorTimesSf;
326  }
327  }
328 
341  void add_particle_for_derivatives(const ParticleData &part, double factor,
342  ThreeVector sf_grad) {
343  const FourVector PartFourVelocity = FourVector(1.0, part.velocity());
344  for (int k = 1; k <= 3; k++) {
345  djmu_dxnu_[k] += factor * PartFourVelocity * sf_grad[k - 1];
346  djmu_dxnu_[0] -=
347  factor * PartFourVelocity * sf_grad[k - 1] * part.velocity()[k - 1];
348  }
349  }
350 
368  double rho(const double norm_factor = 1.0) {
369  return (jmu_pos_.abs() - jmu_neg_.abs()) * norm_factor;
370  }
371 
378  ThreeVector curl_vecj(const double norm_factor = 1.0) {
379  ThreeVector curl_vec_j = ThreeVector();
380  curl_vec_j.set_x1(djmu_dxnu_[2].x3() - djmu_dxnu_[3].x2());
381  curl_vec_j.set_x2(djmu_dxnu_[3].x1() - djmu_dxnu_[1].x3());
382  curl_vec_j.set_x3(djmu_dxnu_[1].x2() - djmu_dxnu_[2].x1());
383  curl_vec_j *= norm_factor;
384  return curl_vec_j;
385  }
386 
394  ThreeVector grad_j0(const double norm_factor = 1.0) {
395  ThreeVector j0_grad = ThreeVector();
396  for (int i = 1; i < 4; i++) {
397  j0_grad[i - 1] = djmu_dxnu_[i].x0() * norm_factor;
398  }
399  return j0_grad;
400  }
401 
408  ThreeVector dvecj_dt(const double norm_factor = 1.0) {
409  return djmu_dxnu_[0].threevec() * norm_factor;
410  }
411 
418  FourVector jmu_net() const { return jmu_pos_ + jmu_neg_; }
419 
424  void add_to_jmu_pos(FourVector additional_jmu_B) {
425  jmu_pos_ += additional_jmu_B;
426  }
427 
432  void add_to_jmu_neg(FourVector additional_jmu_B) {
433  jmu_neg_ += additional_jmu_B;
434  }
435 
442  FourVector drho_dxnu() const { return drho_dxnu_; }
443 
449  std::array<FourVector, 4> djmu_dxnu() const { return djmu_dxnu_; }
450 
457  const ThreeVector grad_rho = drho_dxnu_.threevec();
458  const ThreeVector vecj = jmu_net().threevec();
459  const ThreeVector Drho_cross_vecj = grad_rho.cross_product(vecj);
460 
461  return Drho_cross_vecj;
462  }
463 
468  djmu_dxnu_[0] = FourVector(0.0, 0.0, 0.0, 0.0);
469  }
470 
475 
480  void overwrite_drho_dxnu(FourVector computed_drho_dxnu) {
481  drho_dxnu_ = computed_drho_dxnu;
482  }
483 
492  FourVector djmu_dy, FourVector djmu_dz) {
493  djmu_dxnu_[0] = djmu_dt;
494  djmu_dxnu_[1] = djmu_dx;
495  djmu_dxnu_[2] = djmu_dy;
496  djmu_dxnu_[3] = djmu_dz;
497  }
498 
499  private:
505  std::array<FourVector, 4> djmu_dxnu_;
508 };
509 
512 
526 template <typename T>
528  const LatticeUpdate update,
529  const DensityType dens_type,
530  const DensityParameters &par,
531  const ParticleList &plist,
532  const bool compute_gradient,
533  const bool lattice_reset = true) {
534  // Do not proceed if lattice does not exists/update not required
535  if (lat == nullptr || lat->when_update() != update) {
536  return;
537  }
538  if (lattice_reset) {
539  lat->reset();
540  }
541  for (const ParticleData &part : plist) {
542  if (par.only_participants()) {
543  // if this conditions holds, the hadron is a spectator
544  if (part.get_history().collisions_per_particle == 0) {
545  continue;
546  }
547  }
548  const double dens_factor = density_factor(part.type(), dens_type);
549  if (std::abs(dens_factor) < really_small) {
550  continue;
551  }
552  const FourVector p_mu = part.momentum();
553  const ThreeVector pos = part.position().threevec();
554 
555  // act accordingly to which smearing is used
557  // get the normalization factor for the covariant Gaussian smearing
558  const double norm_factor_gaus = par.norm_factor_sf();
559  const double m = p_mu.abs();
560  if (unlikely(m < really_small)) {
561  logg[LDensity].warn("Gaussian smearing is undefined for momentum ",
562  p_mu);
563  continue;
564  }
565  const double m_inv = 1.0 / m;
566 
567  // unweighted contribution to density
568  const double common_weight = dens_factor * norm_factor_gaus;
569  lat->iterate_in_cube(
570  pos, par.r_cut(), [&](T &node, int ix, int iy, int iz) {
571  // find the weight for smearing
572  const ThreeVector r = lat->cell_center(ix, iy, iz);
573  const auto sf = unnormalized_smearing_factor(pos - r, p_mu, m_inv,
574  par, compute_gradient);
575  node.add_particle(part, sf.first * common_weight);
576  if (par.derivatives() == DerivativesMode::CovariantGaussian) {
577  node.add_particle_for_derivatives(part, dens_factor,
578  sf.second * norm_factor_gaus);
579  }
580  });
581  } else if (par.smearing() == SmearingMode::Discrete) {
582  // get the volume of the cell and weights for discrete smearing
583  const double V_cell = (lat->cell_sizes())[0] * (lat->cell_sizes())[1] *
584  (lat->cell_sizes())[2];
585  // weights for coarse smearing
586  const double big = par.central_weight();
587  const double small = (1.0 - big) / 6.0;
588  // unweighted contribution to density
589  const double common_weight =
590  dens_factor / (par.ntest() * par.nensembles() * V_cell);
592  pos, [&](T &node, int iterated_index, int center_index) {
593  node.add_particle(
594  part, common_weight *
595  // the contribution to density is weighted depending
596  // on what node it is added to
597  (iterated_index == center_index ? big : small));
598  });
599  } else if (par.smearing() == SmearingMode::Triangular) {
600  // get the radii for triangular smearing
601  const std::array<double, 3> triangular_radius = {
602  par.triangular_range() * (lat->cell_sizes())[0],
603  par.triangular_range() * (lat->cell_sizes())[1],
604  par.triangular_range() * (lat->cell_sizes())[2]};
605  const double prefactor_triangular =
606  1.0 /
607  (par.ntest() * par.nensembles() * triangular_radius[0] *
608  triangular_radius[0] * triangular_radius[1] * triangular_radius[1] *
609  triangular_radius[2] * triangular_radius[2]);
610  // unweighted contribution to density
611  const double common_weight = dens_factor * prefactor_triangular;
613  pos, triangular_radius, [&](T &node, int ix, int iy, int iz) {
614  // compute the position of the node
615  const ThreeVector cell_center = lat->cell_center(ix, iy, iz);
616  // compute smearing weight
617  const double weight_x =
618  triangular_radius[0] - std::abs(cell_center[0] - pos[0]);
619  const double weight_y =
620  triangular_radius[1] - std::abs(cell_center[1] - pos[1]);
621  const double weight_z =
622  triangular_radius[2] - std::abs(cell_center[2] - pos[2]);
623  // add the contribution to the node
624  node.add_particle(part,
625  common_weight * weight_x * weight_y * weight_z);
626  });
627  }
628  }
629 }
630 
643 template <typename T>
645  RectangularLattice<T> *lat, const LatticeUpdate update,
646  const DensityType dens_type, const DensityParameters &par,
647  const std::vector<Particles> &ensembles, const bool compute_gradient) {
648  // Do not proceed if lattice does not exists/update not required
649  if (lat == nullptr || lat->when_update() != update) {
650  return;
651  }
652  lat->reset();
653  for (const Particles &particles : ensembles) {
654  update_lattice_with_list_of_particles(lat, update, dens_type, par,
655  particles.copy_to_vector(),
656  compute_gradient, false);
657  }
658 }
659 
679 void update_lattice(
680  RectangularLattice<DensityOnLattice> *lat,
681  RectangularLattice<FourVector> *old_jmu,
682  RectangularLattice<FourVector> *new_jmu,
683  RectangularLattice<std::array<FourVector, 4>> *four_grad_lattice,
684  const LatticeUpdate update, const DensityType dens_type,
685  const DensityParameters &par, const std::vector<Particles> &ensembles,
686  const double time_step, const bool compute_gradient);
687 } // namespace smash
688 
689 #endif // SRC_INCLUDE_SMASH_DENSITY_H_
A class for time-efficient (time-memory trade-off) calculation of density on the lattice.
Definition: density.h:299
std::array< FourVector, 4 > djmu_dxnu() const
Return the FourGradient of the net baryon current .
Definition: density.h:449
std::array< FourVector, 4 > djmu_dxnu_
Four-gradient of the four-current density, .
Definition: density.h:505
double rho(const double norm_factor=1.0)
Compute the net Eckart density on the local lattice.
Definition: density.h:368
ThreeVector grad_j0(const double norm_factor=1.0)
Compute gradient of the the zeroth component of the four-current j^mu (that is of the computational f...
Definition: density.h:394
void overwrite_djmu_dxnu(FourVector djmu_dt, FourVector djmu_dx, FourVector djmu_dy, FourVector djmu_dz)
Overwrite all density current derivatives to provided values.
Definition: density.h:491
ThreeVector grad_rho_cross_vecj() const
Compute the cross product of and .
Definition: density.h:456
void add_particle(const ParticleData &part, double FactorTimesSf)
Adds particle to 4-current: .
Definition: density.h:320
ThreeVector dvecj_dt(const double norm_factor=1.0)
Compute time derivative of the current density on the local lattice.
Definition: density.h:408
void add_to_jmu_pos(FourVector additional_jmu_B)
Add to the positive density current.
Definition: density.h:424
FourVector drho_dxnu_
Four-gradient of the rest frame density, .
Definition: density.h:507
void add_to_jmu_neg(FourVector additional_jmu_B)
Add to the negative density current.
Definition: density.h:432
void overwrite_drho_dxnu(FourVector computed_drho_dxnu)
Overwrite the rest frame density derivatives to provided values.
Definition: density.h:480
void overwrite_djmu_dt_to_zero()
Overwrite the time derivative of the current to zero.
Definition: density.h:467
FourVector jmu_pos_
Four-current density of the positively charged particle.
Definition: density.h:501
void overwrite_drho_dt_to_zero()
Overwrite the time derivative of the rest frame density to zero.
Definition: density.h:474
DensityOnLattice()
Default constructor.
Definition: density.h:302
ThreeVector curl_vecj(const double norm_factor=1.0)
Compute curl of the current on the local lattice.
Definition: density.h:378
FourVector jmu_net() const
Definition: density.h:418
void add_particle_for_derivatives(const ParticleData &part, double factor, ThreeVector sf_grad)
Adds particle to the time and spatial derivatives of the 4-current.
Definition: density.h:341
FourVector drho_dxnu() const
Return the FourGradient of the rest frame density .
Definition: density.h:442
FourVector jmu_neg_
Four-current density of the negatively charged particle.
Definition: density.h:503
A class to pre-calculate and store parameters relevant for density calculation.
Definition: density.h:92
double r_cut_sqr_
Squared cut-off radius [fm ].
Definition: density.h:161
const double central_weight_
Weight of the central cell in the discrete smearing.
Definition: density.h:177
const double triangular_range_
Range of the triangular smearing.
Definition: density.h:179
const SmearingMode smearing_
Mode of smearing.
Definition: density.h:175
const int nensembles_
Number of ensembles.
Definition: density.h:169
double triangular_range() const
Definition: density.h:139
double r_cut() const
Definition: density.h:141
RestFrameDensityDerivativesMode rho_derivatives() const
Definition: density.h:131
SmearingMode smearing() const
Definition: density.h:135
const DerivativesMode derivatives_
Mode of calculating the gradients.
Definition: density.h:171
bool only_participants_
Flag to take into account only participants.
Definition: density.h:181
bool only_participants() const
Definition: density.h:153
const double sig_
Gaussian smearing width [fm].
Definition: density.h:157
DerivativesMode derivatives() const
Definition: density.h:129
double two_sig_sqr_inv() const
Definition: density.h:145
double central_weight() const
Definition: density.h:137
const RestFrameDensityDerivativesMode rho_derivatives_
Whether to calculate the rest frame density derivatives.
Definition: density.h:173
const int ntest_
Testparticle number.
Definition: density.h:167
double norm_factor_sf() const
Definition: density.h:151
int nensembles() const
Definition: density.h:127
double r_cut_sqr() const
Definition: density.h:143
const double r_cut_
Cut-off radius [fm].
Definition: density.h:159
double norm_factor_sf_
Normalization for Gaussian smearing factor.
Definition: density.h:165
DensityParameters(const ExperimentParameters &par)
Constructor of DensityParameters.
Definition: density.h:105
double two_sig_sqr_inv_
[fm ]
Definition: density.h:163
The FourVector class holds relevant values in Minkowski spacetime with (+, −, −, −) metric signature.
Definition: fourvector.h:33
double abs() const
calculate the lorentz invariant absolute value
Definition: fourvector.h:464
ThreeVector threevec() const
Definition: fourvector.h:329
ParticleData contains the dynamic information of a certain particle.
Definition: particledata.h:58
ThreeVector velocity() const
Get the velocity 3-vector.
Definition: particledata.h:301
Particle type contains the static properties of a particle species.
Definition: particletype.h:98
The Particles class abstracts the storage and manipulation of particles.
Definition: particles.h:33
A container class to hold all the arrays on the lattice and access them.
Definition: lattice.h:49
void reset()
Sets all values on lattice to zeros.
Definition: lattice.h:106
LatticeUpdate when_update() const
Definition: lattice.h:171
ThreeVector cell_center(int ix, int iy, int iz) const
Find the coordinates of a given cell.
Definition: lattice.h:133
void iterate_in_cube(const ThreeVector &point, const double r_cut, F &&func)
Iterates only nodes whose cell centers lie not further than r_cut in x, y, z directions from the give...
Definition: lattice.h:627
void iterate_nearest_neighbors(const ThreeVector &point, F &&func)
Iterates only over nodes corresponding to the center cell (the cell containing the given point) and i...
Definition: lattice.h:737
void iterate_in_rectangle(const ThreeVector &point, const std::array< double, 3 > &rectangle, F &&func)
Iterates only nodes whose cell centers lie not further than d_x in x-, d_y in y-, and d_z in z-direct...
Definition: lattice.h:693
const std::array< double, 3 > & cell_sizes() const
Definition: lattice.h:162
The ThreeVector class represents a physical three-vector with the components .
Definition: threevector.h:31
void set_x1(double x)
set first component
Definition: threevector.h:179
void set_x3(double z)
set third component
Definition: threevector.h:187
void set_x2(double y)
set second component
Definition: threevector.h:183
ThreeVector cross_product(const ThreeVector &b) const
Definition: threevector.h:246
SmearingMode
Modes of smearing.
RestFrameDensityDerivativesMode
Modes of calculating the gradients: whether to calculate the rest frame density derivatives.
DerivativesMode
Modes of calculating the gradients.
DensityType
Allows to choose which kind of density to calculate.
std::ostream & operator<<(std::ostream &out, const ActionPtr &action)
Convenience: dereferences the ActionPtr to Action.
Definition: action.h:546
std::array< einhard::Logger<>, std::tuple_size< LogArea::AreaTuple >::value > logg
An array that stores all pre-configured Logger objects.
Definition: logging.cc:40
#define unlikely(x)
Tell the branch predictor that this expression is likely false.
Definition: macros.h:16
constexpr int p
Proton.
Definition: action.h:24
double smearing_factor_norm(const double two_sigma_sqr)
Norm of the Gaussian smearing function.
Definition: density.h:61
std::tuple< double, FourVector, ThreeVector, ThreeVector, FourVector, FourVector, FourVector, FourVector > current_eckart(const ThreeVector &r, const ParticleList &plist, const DensityParameters &par, DensityType dens_type, bool compute_gradient, bool smearing)
Calculates Eckart rest frame density and 4-current of a given density type and optionally the gradien...
Definition: density.cc:171
void update_lattice_accumulating_ensembles(RectangularLattice< T > *lat, const LatticeUpdate update, const DensityType dens_type, const DensityParameters &par, const std::vector< Particles > &ensembles, const bool compute_gradient)
Updates the contents on the lattice when ensembles are used.
Definition: density.h:644
void update_lattice(RectangularLattice< DensityOnLattice > *lat, RectangularLattice< FourVector > *old_jmu, RectangularLattice< FourVector > *new_jmu, RectangularLattice< std::array< FourVector, 4 >> *four_grad_lattice, const LatticeUpdate update, const DensityType dens_type, const DensityParameters &par, const std::vector< Particles > &ensembles, const double time_step, const bool compute_gradient)
Updates the contents on the lattice of DensityOnLattice type.
Definition: density.cc:186
LatticeUpdate
Enumerator option for lattice updates.
Definition: lattice.h:38
double smearing_factor_rcut_correction(const double rcut_in_sigma)
Gaussians used for smearing are cut at radius for calculation speed-up.
Definition: density.h:83
std::pair< double, ThreeVector > unnormalized_smearing_factor(const ThreeVector &r, const FourVector &p, const double m_inv, const DensityParameters &dens_par, const bool compute_gradient=false)
Implements gaussian smearing for any quantity.
Definition: density.cc:38
void update_lattice_with_list_of_particles(RectangularLattice< T > *lat, const LatticeUpdate update, const DensityType dens_type, const DensityParameters &par, const ParticleList &plist, const bool compute_gradient, const bool lattice_reset=true)
Updates the contents on the lattice.
Definition: density.h:527
RectangularLattice< DensityOnLattice > DensityLattice
Conveniency typedef for lattice of density.
Definition: density.h:511
constexpr double really_small
Numerical error tolerance.
Definition: constants.h:37
double density_factor(const ParticleType &type, DensityType dens_type)
Get the factor that determines how much a particle contributes to the density type that is computed.
Definition: density.cc:17
static constexpr int LDensity
Definition: density.h:29
Helper structure for Experiment.
double gauss_cutoff_in_sigma
Distance at which gaussian is cut, i.e. set to zero, IN SIGMA (not fm)