Version: SMASH-3.2
smash::Grid< Options > Class Template Reference

#include <grid.h>

template<GridOptions Options = GridOptions::Normal>
class smash::Grid< Options >

Abstracts a list of cells that partition the particles in the experiment into regions of space that can interact / cannot interact.

This class is used to construct a helper data structure to reduce the combinatorics of finding particle pairs that could interact (scatter). It takes a list of ParticleData objects and sorts them in such a way that it is easy to look only at lists of particles that have a chance of interacting.

Template Parameters
OptionsThis policy parameter determines whether ghost cells are created to support periodic boundaries, or not.

Definition at line 96 of file grid.h.

Inheritance diagram for smash::Grid< Options >:
smash::GridBase

Public Member Functions

 Grid (const Particles &particles, double min_cell_length, double timestep_duration, CellNumberLimitation limit, const bool include_unformed_particles=false, CellSizeStrategy strategy=CellSizeStrategy::Optimal)
 Constructs a grid from the given particle list particles. More...
 
 Grid (const std::pair< std::array< double, 3 >, std::array< double, 3 >> &min_and_length, const Particles &particles, double min_cell_length, double timestep_duration, CellNumberLimitation limit, const bool include_unformed_particles=false, CellSizeStrategy strategy=CellSizeStrategy::Optimal)
 Constructs a grid with the given minimum grid coordinates and grid length. More...
 
void iterate_cells (const std::function< void(const ParticleList &)> &search_cell_callback, const std::function< void(const ParticleList &, const ParticleList &)> &neighbor_cell_callback) const
 Iterates over all cells in the grid and calls the callback arguments with a search cell and 0 to 13 neighbor cells. More...
 
double cell_volume () const
 
void iterate_cells (const std::function< void(const ParticleList &)> &search_cell_callback, const std::function< void(const ParticleList &, const ParticleList &)> &neighbor_cell_callback) const
 Specialization of iterate_cells. More...
 
void iterate_cells (const std::function< void(const ParticleList &)> &search_cell_callback, const std::function< void(const ParticleList &, const ParticleList &)> &neighbor_cell_callback) const
 Specialization of iterate_cells. More...
 

Private Member Functions

SizeType make_index (SizeType x, SizeType y, SizeType z) const
 
SizeType make_index (std::array< SizeType, 3 > idx) const
 

Private Attributes

const std::array< double, 3 > length_
 The 3 lengths of the complete grid. Used for periodic boundary wrapping. More...
 
double cell_volume_
 The volume of a single cell. More...
 
std::array< int, 3 > number_of_cells_
 The number of cells in x, y, and z direction. More...
 
std::vector< ParticleList > cells_
 The cell storage. More...
 

Additional Inherited Members

- Public Types inherited from smash::GridBase
typedef int SizeType
 A type to store the sizes. More...
 
- Static Protected Member Functions inherited from smash::GridBase
static std::pair< std::array< double, 3 >, std::array< double, 3 > > find_min_and_length (const Particles &particles)
 

Constructor & Destructor Documentation

◆ Grid() [1/2]

template<GridOptions Options = GridOptions::Normal>
smash::Grid< Options >::Grid ( const Particles particles,
double  min_cell_length,
double  timestep_duration,
CellNumberLimitation  limit,
const bool  include_unformed_particles = false,
CellSizeStrategy  strategy = CellSizeStrategy::Optimal 
)
inline

Constructs a grid from the given particle list particles.

It automatically determines the necessary size for the grid from the positions of the particles.

Parameters
[in]particlesThe particles to place onto the grid.
[in]min_cell_lengthThe minimal length a cell must have.
[in]timestep_durationDuration of the timestep. It is necessary for formation times treatment: if particle is fully or partially formed before the end of the timestep, it has to be on the grid.
[in]limitLimitation of cell number
[in]include_unformed_particlesinclude unformed particles from the grid (worsens runtime)
[in]strategyThe strategy for determining the cell size

Definition at line 113 of file grid.h.

117  : Grid{find_min_and_length(particles),
118  std::move(particles),
119  min_cell_length,
120  timestep_duration,
121  limit,
122  include_unformed_particles,
123  strategy} {}
static std::pair< std::array< double, 3 >, std::array< double, 3 > > find_min_and_length(const Particles &particles)
Definition: grid.cc:88
Grid(const Particles &particles, double min_cell_length, double timestep_duration, CellNumberLimitation limit, const bool include_unformed_particles=false, CellSizeStrategy strategy=CellSizeStrategy::Optimal)
Constructs a grid from the given particle list particles.
Definition: grid.h:113

◆ Grid() [2/2]

template<GridOptions O>
template smash::Grid< Options >::Grid ( const std::pair< std::array< double, 3 >, std::array< double, 3 >> &  min_and_length,
const Particles particles,
double  min_cell_length,
double  timestep_duration,
CellNumberLimitation  limit,
const bool  include_unformed_particles = false,
CellSizeStrategy  strategy = CellSizeStrategy::Optimal 
)

Constructs a grid with the given minimum grid coordinates and grid length.

If you need periodic boundaries you have to use this constructor to set the correct length to use for wrapping particles around the borders.

Parameters
[in]min_and_lengthA pair consisting of the three min coordinates and the three lengths.
[in]particlesThe particles to place onto the grid.
[in]min_cell_lengthThe minimal length a cell must have.
[in]timestep_durationDuration of the timestep in fm.
[in]limitLimitation of cell number.
[in]include_unformed_particlesinclude unformed particles from the grid (worsens runtime).
[in]strategyThe strategy for determining the cell size.
Exceptions
runtime_errorif your box length is smaller than the grid length.

Definition at line 117 of file grid.cc.

122  : length_(min_and_length.second) {
123  const auto min_position = min_and_length.first;
124  const SizeType particle_count = particles.size();
125 
126  // very simple setup for non-periodic boundaries and largest cellsize strategy
127  if (O == GridOptions::Normal && strategy == CellSizeStrategy::Largest) {
128  number_of_cells_ = {1, 1, 1};
129  cell_volume_ = length_[0] * length_[1] * length_[2];
130  cells_.clear();
131  cells_.reserve(1);
132  cells_.emplace_back(particles.copy_to_vector());
133  return;
134  }
135 
136  // The number of cells is determined by the min and max coordinates where
137  // particles are positioned and the maximal interaction length (which equals
138  // the length of a cell).
139  // But don't let the number of cells exceed the actual number of particles.
140  // That would be overkill. Let max_cells³ ≤ particle_count (conversion to
141  // int truncates). Limit only applied for geometric criteiron, where grid
142  // is an optimisation and cells can be made larger.
143  const int max_cells = numeric_cast<int>(
144  (O == GridOptions::Normal)
145  ? std::floor(std::cbrt(particle_count))
146  : std::max(2., std::floor(std::cbrt(particle_count))));
147 
148  // This normally equals 1/max_interaction_length. If the number of cells
149  // is reduced (because of low density) then this value is smaller. If only
150  // one cell is used than this value might also be larger.
151  std::array<double, 3> index_factor = {1. / max_interaction_length,
152  1. / max_interaction_length,
153  1. / max_interaction_length};
154  for (std::size_t i = 0; i < number_of_cells_.size(); ++i) {
155  if (strategy == CellSizeStrategy::Largest) {
156  number_of_cells_[i] = 2;
157  } else if (unlikely(length_[i] >
158  std::numeric_limits<int>::max() / index_factor[i])) {
159  throw std::overflow_error(
160  "An integer overflow would occur constructing the system grid.\n"
161  "Impossible to (further) simulate the provided system using "
162  "SMASH.\n"
163  "Refer to the user guide for more information (see the Modi "
164  "page).");
165  } else {
166  number_of_cells_[i] =
167  static_cast<int>(std::floor(length_[i] * index_factor[i]));
168  }
170  // In case of zero cells, make at least one cell that is then smaller than
171  // the minimal cell length. This is ok for all setups, since all particles
172  // are inside the same cell, except for the box with periodic boundary
173  // conditions, where we need a 2x2x2 grid.
174  number_of_cells_[i] = 1;
175  } else if (number_of_cells_[i] < 2 &&
177  // Double the minimal cell length exceeds the length of the box, but we
178  // need at least 2x2x2 cells for periodic boundaries.
179  std::string error_box_too_small =
180  "Input error: With the chosen time step (Delta_Time), your box is\n"
181  "too small for the grid. Using the provided time step, the minimal\n"
182  "length of the box should be " +
183  std::to_string(2 * max_interaction_length) +
184  "fm. Using a smaller time step\n"
185  "will reduce the minimal needed box size. The use of test particles\n"
186  "also helps reducing the minimum needed size. Have a look to the\n"
187  "user guide (e.g. box modus page) for further information.\n"
188  "Please, adjust your config file and run SMASH again.";
189  throw std::runtime_error(error_box_too_small);
190  } else if (limit == CellNumberLimitation::ParticleNumber &&
191  number_of_cells_[i] > max_cells) {
192  number_of_cells_[i] = max_cells;
193  }
194  // Only bother rescaling the index_factor if the grid length is large enough
195  // for 1 full min. cell length, since all particles are anyway placed in the
196  // first cell along the i-th axis
197  if (length_[i] >= max_interaction_length) {
198  index_factor[i] = number_of_cells_[i] / length_[i];
199  // std::nextafter implements a safety margin so that no valid position
200  // inside the grid can reference an out-of-bounds cell
201  while (index_factor[i] * length_[i] >= number_of_cells_[i]) {
202  index_factor[i] = std::nextafter(index_factor[i], 0.);
203  }
204  assert(index_factor[i] * length_[i] < number_of_cells_[i]);
205  }
206  }
207  if (O == GridOptions::Normal &&
208  all_of(number_of_cells_, [](SizeType n) { return n <= 2; })) {
209  // dilute limit:
210  // the grid would have <= 2x2x2 cells, meaning every particle has to be
211  // compared with every other particle anyway. Then we can just as well
212  // fall back to not using the grid at all
213  // For a grid with periodic boundaries the situation is different and we
214  // never want to have a grid smaller than 2x2x2.
215  logg[LGrid].debug(
216  "There would only be ", number_of_cells_,
217  " cells. Therefore the Grid falls back to a single cell / "
218  "particle list.");
219  number_of_cells_ = {1, 1, 1};
220  cell_volume_ = length_[0] * length_[1] * length_[2];
221  if (include_unformed_particles) {
222  cells_.clear();
223  cells_.reserve(1);
224  cells_.emplace_back(particles.copy_to_vector());
225  } else {
226  // filter out the particles that can not interact
227  cells_.resize(1);
228  cells_.front().reserve(particles.size());
229  std::copy_if(particles.begin(), particles.end(),
230  std::back_inserter(cells_.front()),
231  [&](const ParticleData &p) {
232  return p.xsec_scaling_factor(timestep_duration) > 0.0;
233  });
234  }
235  } else {
236  // construct a normal grid
237 
239  (length_[1] / number_of_cells_[1]) *
240  (length_[2] / number_of_cells_[2]);
241 
242  logg[LGrid].debug("min: ", min_position, "\nlength: ", length_,
243  "\ncell_volume: ", cell_volume_,
244  "\ncells: ", number_of_cells_,
245  "\nindex_factor: ", index_factor);
246 
247  // After the grid parameters are determined, we can start placing the
248  // particles in cells.
249  cells_.resize(number_of_cells_[0] * number_of_cells_[1] *
250  number_of_cells_[2]);
251 
252  // Returns the one-dimensional cell-index from the position vector inside
253  // the grid.
254  // This simply calculates the distance to min_position and multiplies it
255  // with index_factor to determine the 3 x,y,z indexes to pass to make_index.
256  auto &&cell_index_for = [&](const ParticleData &p) {
257  return make_index(
258  numeric_cast<SizeType>(std::floor(
259  (p.position()[1] - min_position[0]) * index_factor[0])),
260  numeric_cast<SizeType>(std::floor(
261  (p.position()[2] - min_position[1]) * index_factor[1])),
262  numeric_cast<SizeType>(std::floor(
263  (p.position()[3] - min_position[2]) * index_factor[2])));
264  };
265  for (const auto &p : particles) {
266  if (!include_unformed_particles &&
267  (p.xsec_scaling_factor(timestep_duration) <= 0.0)) {
268  continue;
269  }
270  const auto idx = cell_index_for(p);
271 #ifndef NDEBUG
272  if (idx >= SizeType(cells_.size())) {
273  logg[LGrid].fatal(
275  "\nan out-of-bounds access would be necessary for the "
276  "particle ",
277  p,
278  "\nfor a grid with the following parameters:\nmin: ", min_position,
279  "\nlength: ", length_, "\ncells: ", number_of_cells_,
280  "\nindex_factor: ", index_factor, "\ncells_.size: ", cells_.size(),
281  "\nrequested index: ", idx);
282  throw std::runtime_error("out-of-bounds grid access on construction");
283  }
284 #endif
285  cells_[idx].push_back(p);
286  }
287  }
288 
289  logg[LGrid].debug(cells_);
290 }
int SizeType
A type to store the sizes.
Definition: grid.h:70
const std::array< double, 3 > length_
The 3 lengths of the complete grid. Used for periodic boundary wrapping.
Definition: grid.h:190
std::array< int, 3 > number_of_cells_
The number of cells in x, y, and z direction.
Definition: grid.h:196
double cell_volume_
The volume of a single cell.
Definition: grid.h:193
std::vector< ParticleList > cells_
The cell storage.
Definition: grid.h:199
SizeType make_index(SizeType x, SizeType y, SizeType z) const
Definition: grid.cc:293
#define SMASH_SOURCE_LOCATION
Hackery that is required to output the location in the source code where the log statement occurs.
Definition: logging.h:153
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.
constexpr int n
Neutron.
@ ParticleNumber
Limit the number of cells to the number of particles.
bool all_of(Container &&c, UnaryPredicate &&p)
Convenience wrapper for std::all_of that operates on a complete container.
Definition: algorithms.h:80
@ Normal
Without ghost cells.
@ PeriodicBoundaries
With ghost cells for periodic boundaries.
static constexpr int LGrid
Definition: grid.cc:82
@ Largest
Make cells as large as possible.

Member Function Documentation

◆ iterate_cells() [1/3]

template<GridOptions Options = GridOptions::Normal>
void smash::Grid< Options >::iterate_cells ( const std::function< void(const ParticleList &)> &  search_cell_callback,
const std::function< void(const ParticleList &, const ParticleList &)> &  neighbor_cell_callback 
) const

Iterates over all cells in the grid and calls the callback arguments with a search cell and 0 to 13 neighbor cells.

The neighbor cells are constructed like this:

  • one cell at x+1
  • three cells (x-1,x,x+1) at y+1
  • nine cells (x-1, y-1)...(x+1, y+1) at z+1
Parameters
[in]search_cell_callbackA callable called for/with every non-empty cell in the grid.
[in]neighbor_cell_callbackA callable called for/with every non-empty cell and adjacent cell combination. For a periodic grid, the first argument will be adjusted to wrap around the grid.

◆ cell_volume()

template<GridOptions Options = GridOptions::Normal>
double smash::Grid< Options >::cell_volume ( ) const
inline
Returns
the volume of a single grid cell

Definition at line 172 of file grid.h.

172 { return cell_volume_; }

◆ make_index() [1/2]

template<GridOptions Options>
Grid< Options >::SizeType smash::Grid< Options >::make_index ( SizeType  x,
SizeType  y,
SizeType  z 
) const
inlineprivate
Returns
the one-dimensional cell-index from the 3-dim index x, y, z.

Definition at line 293 of file grid.cc.

294  {
295  return (z * number_of_cells_[1] + y) * number_of_cells_[0] + x;
296 }

◆ make_index() [2/2]

template<GridOptions Options = GridOptions::Normal>
SizeType smash::Grid< Options >::make_index ( std::array< SizeType, 3 >  idx) const
inlineprivate
Returns
the one-dimensional cell-index from the 3-dim index idx. This is a convenience overload for the above function.

Definition at line 185 of file grid.h.

185  {
186  return make_index(idx[0], idx[1], idx[2]);
187  }

◆ iterate_cells() [2/3]

void smash::Grid< GridOptions::Normal >::iterate_cells ( const std::function< void(const ParticleList &)> &  search_cell_callback,
const std::function< void(const ParticleList &, const ParticleList &)> &  neighbor_cell_callback 
) const

Specialization of iterate_cells.

Definition at line 306 of file grid.cc.

309  {
310  std::array<SizeType, 3> search_index;
311  SizeType &x = search_index[0];
312  SizeType &y = search_index[1];
313  SizeType &z = search_index[2];
314  SizeType search_cell_index = 0;
315  for (z = 0; z < number_of_cells_[2]; ++z) {
316  for (y = 0; y < number_of_cells_[1]; ++y) {
317  for (x = 0; x < number_of_cells_[0]; ++x, ++search_cell_index) {
318  assert(search_cell_index == make_index(search_index));
319  assert(search_cell_index >= 0);
320  assert(search_cell_index < SizeType(cells_.size()));
321  const ParticleList &search = cells_[search_cell_index];
322  search_cell_callback(search);
323 
324  const auto &dz_list = z == number_of_cells_[2] - 1 ? ZERO : ZERO_ONE;
325  const auto &dy_list = number_of_cells_[1] == 1 ? ZERO
326  : y == 0 ? ZERO_ONE
327  : y == number_of_cells_[1] - 1
330  const auto &dx_list = number_of_cells_[0] == 1 ? ZERO
331  : x == 0 ? ZERO_ONE
332  : x == number_of_cells_[0] - 1
335  for (SizeType dz : dz_list) {
336  for (SizeType dy : dy_list) {
337  for (SizeType dx : dx_list) {
338  const auto di = make_index(dx, dy, dz);
339  if (di > 0) {
340  neighbor_cell_callback(search, cells_[search_cell_index + di]);
341  }
342  }
343  }
344  }
345  }
346  }
347  }
348 }
static const std::initializer_list< GridBase::SizeType > ZERO_ONE
Definition: grid.cc:299
static const std::initializer_list< GridBase::SizeType > MINUS_ONE_ZERO
Definition: grid.cc:300
static const std::initializer_list< GridBase::SizeType > ZERO
Definition: grid.cc:298
static const std::initializer_list< GridBase::SizeType > MINUS_ONE_ZERO_ONE
Definition: grid.cc:301

◆ iterate_cells() [3/3]

void smash::Grid< GridOptions::PeriodicBoundaries >::iterate_cells ( const std::function< void(const ParticleList &)> &  search_cell_callback,
const std::function< void(const ParticleList &, const ParticleList &)> &  neighbor_cell_callback 
) const

Specialization of iterate_cells.

Definition at line 370 of file grid.cc.

373  {
374  std::array<SizeType, 3> search_index;
375  SizeType &x = search_index[0];
376  SizeType &y = search_index[1];
377  SizeType &z = search_index[2];
378  SizeType search_cell_index = 0;
379 
380  // defaults:
381  std::array<NeighborLookup, 2> dz_list;
382  std::array<NeighborLookup, 3> dy_list;
383  std::array<NeighborLookup, 3> dx_list;
384 
385  assert(number_of_cells_[2] >= 2);
386  assert(number_of_cells_[1] >= 2);
387  assert(number_of_cells_[0] >= 2);
388 
389  for (z = 0; z < number_of_cells_[2]; ++z) {
390  dz_list[0].index = z;
391  dz_list[1].index = z + 1;
392  if (dz_list[1].index == number_of_cells_[2]) {
393  dz_list[1].index = 0;
394  // last z in the loop, so no need to reset wrap again
395  dz_list[1].wrap = NeedsToWrap::MinusLength;
396  }
397  for (y = 0; y < number_of_cells_[1]; ++y) {
398  dy_list[0].index = y;
399  dy_list[1].index = y - 1;
400  dy_list[2].index = y + 1;
401  dy_list[2].wrap = NeedsToWrap::No;
402  if (y == 0) {
403  dy_list[1] = dy_list[2];
404  dy_list[2].index = number_of_cells_[1] - 1;
405  dy_list[2].wrap = NeedsToWrap::PlusLength;
406  } else if (dy_list[2].index == number_of_cells_[1]) {
407  dy_list[2].index = 0;
408  dy_list[2].wrap = NeedsToWrap::MinusLength;
409  }
410  for (x = 0; x < number_of_cells_[0]; ++x, ++search_cell_index) {
411  dx_list[0].index = x;
412  dx_list[1].index = x - 1;
413  dx_list[2].index = x + 1;
414  dx_list[2].wrap = NeedsToWrap::No;
415  if (x == 0) {
416  dx_list[1] = dx_list[2];
417  dx_list[2].index = number_of_cells_[0] - 1;
418  dx_list[2].wrap = NeedsToWrap::PlusLength;
419  } else if (dx_list[2].index == number_of_cells_[0]) {
420  dx_list[2].index = 0;
421  dx_list[2].wrap = NeedsToWrap::MinusLength;
422  }
423 
424  assert(search_cell_index == make_index(search_index));
425  assert(search_cell_index >= 0);
426  assert(search_cell_index < SizeType(cells_.size()));
427  ParticleList search = cells_[search_cell_index];
428  search_cell_callback(search);
429 
430  auto virtual_search_index = search_index;
431  ThreeVector wrap_vector = {}; // no change
432  auto current_wrap_vector = wrap_vector;
433 
434  for (const auto &dz : dz_list) {
435  if (dz.wrap == NeedsToWrap::MinusLength) {
436  // last dz in the loop, so no need to undo the wrap
437  wrap_vector[2] = -length_[2];
438  virtual_search_index[2] = -1;
439  }
440  for (const auto &dy : dy_list) {
441  // only the last dy in dy_list can wrap
442  if (dy.wrap == NeedsToWrap::MinusLength) {
443  wrap_vector[1] = -length_[1];
444  virtual_search_index[1] = -1;
445  } else if (dy.wrap == NeedsToWrap::PlusLength) {
446  wrap_vector[1] = length_[1];
447  virtual_search_index[1] = number_of_cells_[1];
448  }
449  for (const auto &dx : dx_list) {
450  // only the last dx in dx_list can wrap
451  if (dx.wrap == NeedsToWrap::MinusLength) {
452  wrap_vector[0] = -length_[0];
453  virtual_search_index[0] = -1;
454  } else if (dx.wrap == NeedsToWrap::PlusLength) {
455  wrap_vector[0] = length_[0];
456  virtual_search_index[0] = number_of_cells_[0];
457  }
458  assert(dx.index >= 0);
459  assert(dx.index < number_of_cells_[0]);
460  assert(dy.index >= 0);
461  assert(dy.index < number_of_cells_[1]);
462  assert(dz.index >= 0);
463  assert(dz.index < number_of_cells_[2]);
464  const auto neighbor_cell_index =
465  make_index(dx.index, dy.index, dz.index);
466  assert(neighbor_cell_index >= 0);
467  assert(neighbor_cell_index < SizeType(cells_.size()));
468  if (neighbor_cell_index <= make_index(virtual_search_index)) {
469  continue;
470  }
471 
472  if (wrap_vector != current_wrap_vector) {
473  logg[LGrid].debug("translating search cell by ",
474  wrap_vector - current_wrap_vector);
475  for_each(search, [&](ParticleData &p) {
476  p = p.translated(wrap_vector - current_wrap_vector);
477  });
478  current_wrap_vector = wrap_vector;
479  }
480  neighbor_cell_callback(search, cells_[neighbor_cell_index]);
481  }
482  virtual_search_index[0] = search_index[0];
483  wrap_vector[0] = 0;
484  }
485  virtual_search_index[1] = search_index[1];
486  wrap_vector[1] = 0;
487  }
488  }
489  }
490  }
491 }
UnaryFunction for_each(Container &&c, UnaryFunction &&f)
Convenience wrapper for std::for_each that operates on a complete container.
Definition: algorithms.h:96

Member Data Documentation

◆ length_

template<GridOptions Options = GridOptions::Normal>
const std::array<double, 3> smash::Grid< Options >::length_
private

The 3 lengths of the complete grid. Used for periodic boundary wrapping.

Definition at line 190 of file grid.h.

◆ cell_volume_

template<GridOptions Options = GridOptions::Normal>
double smash::Grid< Options >::cell_volume_
private

The volume of a single cell.

Definition at line 193 of file grid.h.

◆ number_of_cells_

template<GridOptions Options = GridOptions::Normal>
std::array<int, 3> smash::Grid< Options >::number_of_cells_
private

The number of cells in x, y, and z direction.

Definition at line 196 of file grid.h.

◆ cells_

template<GridOptions Options = GridOptions::Normal>
std::vector<ParticleList> smash::Grid< Options >::cells_
private

The cell storage.

Definition at line 199 of file grid.h.


The documentation for this class was generated from the following files: