Loading [MathJax]/extensions/tex2jax.js
PISM, A Parallel Ice Sheet Model 2.2.2-d6b3a29ca committed by Constantine Khrulev on 2025-03-28
All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Pages
Grid.cc
Go to the documentation of this file.
1// Copyright (C) 2004-2021, 2023, 2024, 2025 Jed Brown, Ed Bueler and Constantine Khroulev
2//
3// This file is part of PISM.
4//
5// PISM is free software; you can redistribute it and/or modify it under the
6// terms of the GNU General Public License as published by the Free Software
7// Foundation; either version 3 of the License, or (at your option) any later
8// version.
9//
10// PISM is distributed in the hope that it will be useful, but WITHOUT ANY
11// WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS
12// FOR A PARTICULAR PURPOSE. See the GNU General Public License for more
13// details.
14//
15// You should have received a copy of the GNU General Public License
16// along with PISM; if not, write to the Free Software
17// Foundation, Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA
18
19#include <cassert>
20
21#include <array>
22#include <cmath>
23#include <cstddef>
24#include <gsl/gsl_interp.h>
25#include <map>
26#include <memory>
27#include <numeric>
28#include <petscsys.h>
29#include <string>
30#include <vector>
31#include <utility> // std::swap
32
33#include "pism/util/Interpolation1D.hh"
34#include "pism/util/io/io_helpers.hh"
35#include "pism/util/InputInterpolation.hh"
36#include "pism/util/ConfigInterface.hh"
37#include "pism/util/Grid.hh"
38#include "pism/util/error_handling.hh"
39#include "pism/util/Context.hh"
40#include "pism/util/Logger.hh"
41#include "pism/util/Vars.hh"
42#include "pism/util/io/File.hh"
43#include "pism/util/petscwrappers/DM.hh"
44#include "pism/util/projection.hh"
45#include "pism/util/pism_utilities.hh"
46#include "pism/util/io/IO_Flags.hh"
47
48namespace pism {
49
50//! Internal structures of Grid.
51struct Grid::Impl {
52 Impl(std::shared_ptr<const Context> context);
53
54 std::shared_ptr<petsc::DM> create_dm(unsigned int da_dof, unsigned int stencil_width) const;
55 void set_ownership_ranges(const std::vector<unsigned int> &procs_x,
56 const std::vector<unsigned int> &procs_y);
57
59
60 std::shared_ptr<const Context> ctx;
61
63
64 // int to match types used by MPI
65 int rank;
66 int size;
67
68 //! @brief array containing lenghts (in the x-direction) of processor sub-domains
69 std::vector<PetscInt> procs_x;
70 //! @brief array containing lenghts (in the y-direction) of processor sub-domains
71 std::vector<PetscInt> procs_y;
72
74
76
77 //! x-coordinates of grid points
78 std::vector<double> x;
79 //! y-coordinates of grid points
80 std::vector<double> y;
81 //! vertical grid levels in the ice; correspond to the storage grid
82 std::vector<double> z;
83
84 int xs, xm, ys, ym;
85 //! horizontal grid spacing
86 double dx;
87 //! horizontal grid spacing
88 double dy;
89 //! cell area (meters^2)
90 double cell_area;
91 //! number of grid points in the x-direction
92 unsigned int Mx;
93 //! number of grid points in the y-direction
94 unsigned int My;
95
97
98 //! x-coordinate of the grid center
99 double x0;
100 //! y-coordinate of the grid center
101 double y0;
102
103 //! half width of the ice model grid in x-direction (m)
104 double Lx;
105 //! half width of the ice model grid in y-direction (m)
106 double Ly;
107
108 std::map<std::array<unsigned int, 2>, std::weak_ptr<petsc::DM> > dms;
109
110 // This DM is used for I/O operations and is not owned by any
111 // array::Array (so far, anyway). We keep a pointer to it here to
112 // avoid re-allocating it many times.
113 std::shared_ptr<petsc::DM> dm_scalar_global;
114
115 //! @brief A dictionary with pointers to array::Arrays, for passing
116 //! them from the one component to another (e.g. from IceModel to
117 //! surface and ocean models).
119
120 //! GSL binary search accelerator used to speed up kBelowHeight().
121 gsl_interp_accel *bsearch_accel;
122
123 std::map<std::string, std::shared_ptr<InputInterpolation>> regridding_2d;
124};
125
126Grid::Impl::Impl(std::shared_ptr<const Context> context)
127 : ctx(context), mapping_info("mapping", ctx->unit_system()) {
128 // empty
129}
130
131/*! @brief Initialize a uniform, shallow (3 z-levels) grid with half-widths (Lx,Ly) and Mx by My
132 * nodes.
133 */
134std::shared_ptr<Grid> Grid::Shallow(std::shared_ptr<const Context> ctx, double Lx, double Ly,
135 double x0, double y0, unsigned int Mx, unsigned int My,
138 try {
139 grid::Parameters p(*ctx->config(), Mx, My, Lx, Ly);
140 p.x0 = x0;
141 p.y0 = y0;
144
145 double Lz = ctx->config()->get_number("grid.Lz");
146 p.z = { 0.0, 0.5 * Lz, Lz };
147
148 p.ownership_ranges_from_options(*ctx->config(), ctx->size());
149
150 return std::make_shared<Grid>(ctx, p);
151 } catch (RuntimeError &e) {
152 e.add_context("initializing a shallow grid");
153 throw;
154 }
155}
156
157//! @brief Create a PISM distributed computational grid.
158Grid::Grid(std::shared_ptr<const Context> context, const grid::Parameters &p)
159 : com(context->com()), m_impl(new Impl(context)) {
160
161 try {
162 m_impl->bsearch_accel = gsl_interp_accel_alloc();
163 if (m_impl->bsearch_accel == NULL) {
164 throw RuntimeError(PISM_ERROR_LOCATION, "Failed to allocate a GSL interpolation accelerator");
165 }
166
167 m_impl->rank = context->rank();
168 m_impl->size = context->size();
169
170 p.validate();
171
172 m_impl->Mx = p.Mx;
173 m_impl->My = p.My;
174 m_impl->x0 = p.x0;
175 m_impl->y0 = p.y0;
176 m_impl->Lx = p.Lx;
177 m_impl->Ly = p.Ly;
180 m_impl->z = p.z;
182
184
185 {
186 int stencil_width = (int)context->config()->get_number("grid.max_stencil_width");
187
188 try {
189 auto tmp = this->get_dm(1, stencil_width);
190 } catch (RuntimeError &e) {
191 e.add_context("distributing a %d x %d grid across %d processors.", Mx(), My(), size());
192 throw;
193 }
194
195 // hold on to a DM corresponding to dof=1, stencil_width=0 (it will
196 // be needed for I/O operations)
197 m_impl->dm_scalar_global = this->get_dm(1, 0);
198
199 DMDALocalInfo info;
200 PetscErrorCode ierr = DMDAGetLocalInfo(*m_impl->dm_scalar_global, &info);
201 PISM_CHK(ierr, "DMDAGetLocalInfo");
202
203 m_impl->xs = info.xs;
204 m_impl->xm = info.xm;
205 m_impl->ys = info.ys;
206 m_impl->ym = info.ym;
207 }
208
209 int patch_size = m_impl->xm * m_impl->ym;
210 GlobalMax(com, &patch_size, &m_impl->max_patch_size, 1);
211
212 } catch (RuntimeError &e) {
213 e.add_context("allocating Grid");
214 throw;
215 }
216}
217
218//! Create a grid from a file, get information from variable `var_name`.
219static std::shared_ptr<Grid> Grid_FromFile(std::shared_ptr<const Context> ctx, const File &file,
220 const std::string &var_name, grid::Registration r) {
221 try {
222 const Logger &log = *ctx->log();
223
224 // The following call may fail because var_name does not exist. (And this is fatal!)
225 // Note that this sets defaults using configuration parameters, too.
226 grid::Parameters p(ctx->unit_system(), file, var_name, r);
227
228 // if we have no vertical grid information, create a fake 2-level vertical grid.
229 if (p.z.size() < 2) {
230 double Lz = ctx->config()->get_number("grid.Lz");
231 log.message(3,
232 "WARNING: Can't determine vertical grid information using '%s' in %s'\n"
233 " Using 2 levels and Lz of %3.3fm\n",
234 var_name.c_str(), file.name().c_str(), Lz);
235
236 p.z = { 0.0, Lz };
237 }
238
239 p.ownership_ranges_from_options(*ctx->config(), ctx->size());
240
241 return std::make_shared<Grid>(ctx, p);
242 } catch (RuntimeError &e) {
243 e.add_context("initializing computational grid from variable \"%s\" in \"%s\"",
244 var_name.c_str(), file.name().c_str());
245 throw;
246 }
247}
248
249//! Create a grid using one of variables in `var_names` in `file`.
250std::shared_ptr<Grid> Grid::FromFile(std::shared_ptr<const Context> ctx,
251 const File &file,
252 const std::vector<std::string> &var_names,
254
255 for (const auto &name : var_names) {
256 if (file.variable_exists(name)) {
257 return Grid_FromFile(ctx, file, name, r);
258 }
259 }
260
262 "file %s does not have any of %s."
263 " Cannot initialize the grid.",
264 file.name().c_str(), join(var_names, ",").c_str());
265}
266
268 gsl_interp_accel_free(m_impl->bsearch_accel);
269
270 delete m_impl;
271}
272
273
274//! Return the index `k` into `zlevels[]` so that `zlevels[k] <= height < zlevels[k+1]` and `k < Mz`.
275unsigned int Grid::kBelowHeight(double height) const {
276
277 const double eps = 1.0e-6;
278 if (height < 0.0 - eps) {
280 "height = %5.4f is below base of ice"
281 " (height must be non-negative)\n",
282 height);
283 }
284
285 if (height > Lz() + eps) {
287 "height = %5.4f is above top of computational"
288 " grid Lz = %5.4f\n",
289 height, Lz());
290 }
291
292 return gsl_interp_accel_find(m_impl->bsearch_accel, m_impl->z.data(), m_impl->z.size(), height);
293}
294
295
296//! Set processor ownership ranges. Takes care of type conversion (`unsigned int` -> `PetscInt`).
297void Grid::Impl::set_ownership_ranges(const std::vector<unsigned int> &input_procs_x,
298 const std::vector<unsigned int> &input_procs_y) {
299 if (input_procs_x.size() * input_procs_y.size() != (size_t)size) {
300 throw RuntimeError(PISM_ERROR_LOCATION, "length(procs_x) * length(procs_y) != MPI size");
301 }
302
303 procs_x.resize(input_procs_x.size());
304 for (unsigned int k = 0; k < input_procs_x.size(); ++k) {
305 procs_x[k] = static_cast<PetscInt>(input_procs_x[k]);
306 }
307
308 procs_y.resize(input_procs_y.size());
309 for (unsigned int k = 0; k < input_procs_y.size(); ++k) {
310 procs_y[k] = static_cast<PetscInt>(input_procs_y[k]);
311 }
312}
313
314//! Compute horizontal grid size. See compute_horizontal_coordinates() for more.
315static unsigned int compute_horizontal_grid_size(double half_width, double dx, bool cell_centered) {
316 auto M = std::floor(2 * half_width / dx) + (cell_centered ? 0 : 1);
317
318 return static_cast<unsigned int>(M);
319}
320
321//! Compute horizontal grid spacing. See compute_horizontal_coordinates() for more.
322static double compute_horizontal_spacing(double half_width, unsigned int M, bool cell_centered) {
323 if (cell_centered) {
324 return 2.0 * half_width / M;
325 }
326
327 return 2.0 * half_width / (M - 1);
328}
329
330//! Compute grid coordinates for one direction (X or Y).
331static std::vector<double> compute_coordinates(unsigned int M, double delta, double v_min,
332 double v_max, bool cell_centered) {
333
334 double offset = cell_centered ? 0.5 : 0.0;
335
336 // Here v_min, v_max define the extent of the computational domain,
337 // which is not necessarily the same thing as the smallest and
338 // largest values of grid coordinates.
339 std::vector<double> result(M);
340 for (unsigned int i = 0; i < M; ++i) {
341 result[i] = v_min + (i + offset) * delta;
342 }
343 result[M - 1] = v_max - offset * delta;
344
345 return result;
346}
347
348//! Compute horizontal spacing parameters `dx` and `dy` and grid coordinates using `Mx`, `My`, `Lx`, `Ly` and periodicity.
349/*!
350The grid used in PISM, in particular the PETSc DAs used here, are periodic in x and y.
351This means that the ghosted values ` foo[i+1][j], foo[i-1][j], foo[i][j+1], foo[i][j-1]`
352for all 2D Vecs, and similarly in the x and y directions for 3D Vecs, are always available.
353That is, they are available even if i,j is a point at the edge of the grid. On the other
354hand, by default, `dx` is the full width `2 * Lx` divided by `Mx - 1`.
355This means that we conceive of the computational domain as starting at the `i = 0`
356grid location and ending at the `i = Mx - 1` grid location, in particular.
357This idea is not quite compatible with the periodic nature of the grid.
358
359The upshot is that if one computes in a truly periodic way then the gap between the
360`i = 0` and `i = Mx - 1` grid points should \em also have width `dx`.
361Thus we compute `dx = 2 * Lx / Mx`.
362 */
364
365 bool cell_centered = registration == grid::CELL_CENTER;
366
367 dx = compute_horizontal_spacing(Lx, Mx, cell_centered);
368
369 dy = compute_horizontal_spacing(Ly, My, cell_centered);
370
371 cell_area = dx * dy;
372
373 double x_min = x0 - Lx, x_max = x0 + Lx;
374
375 x = compute_coordinates(Mx, dx, x_min, x_max, cell_centered);
376
377 double y_min = y0 - Ly, y_max = y0 + Ly;
378
379 y = compute_coordinates(My, dy, y_min, y_max, cell_centered);
380}
381
382//! \brief Report grid parameters.
384
385 const Logger &log = *this->ctx()->log();
386 units::System::Ptr sys = this->ctx()->unit_system();
387
388 units::Converter km(sys, "m", "km");
389
390 // report on grid
391 log.message(2, " grid size %d x %d x %d\n", Mx(), My(), Mz());
392
393 // report on computational box
394 log.message(2, " spatial domain %.2f km x %.2f km x %.2f m\n", km(2 * Lx()),
395 km(2 * Ly()), Lz());
396
397 // report on grid cell dims
398 const double one_km = 1000.0;
399 if (std::min(dx(), dy()) > one_km) {
400 log.message(2, " horizontal grid cell %.2f km x %.2f km\n", km(dx()), km(dy()));
401 } else {
402 log.message(2, " horizontal grid cell %.0f m x %.0f m\n", dx(), dy());
403 }
404 if (fabs(dz_max() - dz_min()) <= 1.0e-8) {
405 log.message(2, " vertical spacing in ice dz = %.3f m (equal spacing)\n", dz_min());
406 } else {
407 log.message(2, " vertical spacing in ice uneven, %d levels, %.3f m < dz < %.3f m\n", Mz(),
408 dz_min(), dz_max());
409 }
410
411 // if -verbose (=-verbose 3) then (somewhat redundantly) list parameters of grid
412 {
413 log.message(3, " Grid parameters:\n");
414 log.message(3, " Lx = %6.2f km, Ly = %6.2f km, Lz = %6.2f m, \n", km(Lx()), km(Ly()),
415 Lz());
416 log.message(3, " x0 = %6.2f km, y0 = %6.2f km, (coordinates of center)\n", km(x0()),
417 km(y0()));
418 log.message(3, " Mx = %d, My = %d, Mz = %d, \n", Mx(), My(), Mz());
419 log.message(3, " dx = %6.3f km, dy = %6.3f km, \n", km(dx()), km(dy()));
420 log.message(3, " Nx = %d, Ny = %d\n", (int)m_impl->procs_x.size(),
421 (int)m_impl->procs_y.size());
422
423 log.message(3, " Registration: %s\n",
424 registration_to_string(m_impl->registration).c_str());
425 log.message(3, " Periodicity: %s\n",
426 periodicity_to_string(m_impl->periodicity).c_str());
427 }
428
429 {
430 log.message(5, " REALLY verbose output on Grid:\n");
431 log.message(5, " vertical levels in ice (Mz=%d, Lz=%5.4f): ", Mz(), Lz());
432 for (unsigned int k = 0; k < Mz(); k++) {
433 log.message(5, " %5.4f, ", z(k));
434 }
435 log.message(5, "\n");
436 }
437}
438
439
440//! \brief Computes indices of grid points to the lower left and upper right from (X,Y).
441/*!
442 * \code
443 * 3 2
444 * o-------o
445 * | |
446 * | + |
447 * o-------o
448 * 0 1
449 * \endcode
450 *
451 * If "+" is the point (X,Y), then (i_left, j_bottom) corresponds to
452 * point "0" and (i_right, j_top) corresponds to point "2".
453 *
454 * Does not check if the resulting indexes are in the current
455 * processor's domain. Ensures that computed indexes are within the
456 * grid.
457 */
458void Grid::compute_point_neighbors(double X, double Y, int &i_left, int &i_right, int &j_bottom,
459 int &j_top) const {
460 i_left = (int)floor((X - m_impl->x[0]) / m_impl->dx);
461 j_bottom = (int)floor((Y - m_impl->y[0]) / m_impl->dy);
462
463 i_right = i_left + 1;
464 j_top = j_bottom + 1;
465
466 i_left = std::max(i_left, 0);
467 i_right = std::max(i_right, 0);
468
469 i_left = std::min(i_left, (int)m_impl->Mx - 1);
470 i_right = std::min(i_right, (int)m_impl->Mx - 1);
471
472 j_bottom = std::max(j_bottom, 0);
473 j_top = std::max(j_top, 0);
474
475 j_bottom = std::min(j_bottom, (int)m_impl->My - 1);
476 j_top = std::min(j_top, (int)m_impl->My - 1);
477}
478
479std::vector<int> Grid::point_neighbors(double X, double Y) const {
480 int i_left, i_right, j_bottom, j_top;
481 this->compute_point_neighbors(X, Y, i_left, i_right, j_bottom, j_top);
482 return { i_left, i_right, j_bottom, j_top };
483}
484
485//! \brief Compute 4 interpolation weights necessary for linear interpolation
486//! from the current grid. See compute_point_neighbors for the ordering of
487//! neighbors.
488std::vector<double> Grid::interpolation_weights(double X, double Y) const {
489 int i_left = 0, i_right = 0, j_bottom = 0, j_top = 0;
490 // these values (zeros) are used when interpolation is impossible
491 double alpha = 0.0, beta = 0.0;
492
493 compute_point_neighbors(X, Y, i_left, i_right, j_bottom, j_top);
494
495 if (i_left != i_right) {
496 assert(m_impl->x[i_right] - m_impl->x[i_left] != 0.0);
497 alpha = (X - m_impl->x[i_left]) / (m_impl->x[i_right] - m_impl->x[i_left]);
498 }
499
500 if (j_bottom != j_top) {
501 assert(m_impl->y[j_top] - m_impl->y[j_bottom] != 0.0);
502 beta = (Y - m_impl->y[j_bottom]) / (m_impl->y[j_top] - m_impl->y[j_bottom]);
503 }
504
505 return { (1.0 - alpha) * (1.0 - beta), alpha * (1.0 - beta), alpha * beta, (1.0 - alpha) * beta };
506}
507
508//! @brief Get a PETSc DM ("distributed array manager") object for given `dof` (number of degrees of
509//! freedom per grid point) and stencil width.
510std::shared_ptr<petsc::DM> Grid::get_dm(unsigned int dm_dof, unsigned int stencil_width) const {
511
512 std::array<unsigned int, 2> key{ dm_dof, stencil_width };
513
514 if (m_impl->dms[key].expired()) {
515 // note: here "result" is needed because m_impl->dms is a std::map of weak_ptr
516 //
517 // m_impl->dms[j] = m_impl->create_dm(dm_dof, stencil_width);
518 //
519 // would create a shared_ptr, then assign it to a weak_ptr. At this point the
520 // shared_ptr (the right hand side) will be destroyed and the corresponding weak_ptr
521 // will be a nullptr.
522 auto result = m_impl->create_dm(dm_dof, stencil_width);
523 m_impl->dms[key] = result;
524 return result;
525 }
526
527 return m_impl->dms[key].lock();
528}
529
530//! Return grid periodicity.
534
538
539//! Return execution context this grid corresponds to.
540std::shared_ptr<const Context> Grid::ctx() const {
541 return m_impl->ctx;
542}
543
544//! @brief Create a DM with the given number of `dof` (degrees of freedom per grid point) and
545//! stencil width.
546std::shared_ptr<petsc::DM> Grid::Impl::create_dm(unsigned int da_dof, unsigned int stencil_width) const {
547
548 ctx->log()->message(3, "* Creating a DM with dof=%d and stencil_width=%d...\n", da_dof,
549 stencil_width);
550
551 DM result;
552 PetscErrorCode ierr = DMDACreate2d(
553 ctx->com(), DM_BOUNDARY_PERIODIC, DM_BOUNDARY_PERIODIC, DMDA_STENCIL_BOX, (PetscInt)Mx,
554 (PetscInt)My, (PetscInt)procs_x.size(), (PetscInt)procs_y.size(), (PetscInt)da_dof,
555 (PetscInt)stencil_width, procs_x.data(), procs_y.data(), // lx, ly
556 &result);
557 PISM_CHK(ierr, "DMDACreate2d");
558
559#if PETSC_VERSION_GE(3, 8, 0)
560 ierr = DMSetUp(result);
561 PISM_CHK(ierr, "DMSetUp");
562#endif
563
564 return std::make_shared<petsc::DM>(result);
565}
566
567//! MPI rank.
568int Grid::rank() const {
569 return m_impl->rank;
570}
571
572//! MPI communicator size.
573unsigned int Grid::size() const {
574 return m_impl->size;
575}
576
577//! Dictionary of variables (2D and 3D fields) associated with this grid.
579 return m_impl->variables;
580}
581
582//! Dictionary of variables (2D and 3D fields) associated with this grid.
583const Vars &Grid::variables() const {
584 return m_impl->variables;
585}
586
587//! Global starting index of this processor's subset.
588int Grid::xs() const {
589 return m_impl->xs;
590}
591
592//! Global starting index of this processor's subset.
593int Grid::ys() const {
594 return m_impl->ys;
595}
596
597//! Width of this processor's sub-domain.
598int Grid::xm() const {
599 return m_impl->xm;
600}
601
602//! Width of this processor's sub-domain.
603int Grid::ym() const {
604 return m_impl->ym;
605}
606
607//! Total grid size in the X direction.
608unsigned int Grid::Mx() const {
609 return m_impl->Mx;
610}
611
612//! Total grid size in the Y direction.
613unsigned int Grid::My() const {
614 return m_impl->My;
615}
616
617//! Number of vertical levels.
618unsigned int Grid::Mz() const {
619 return m_impl->z.size();
620}
621
622//! X-coordinates.
623const std::vector<double> &Grid::x() const {
624 return m_impl->x;
625}
626
627//! Get a particular x coordinate.
628double Grid::x(size_t i) const {
629 return m_impl->x[i];
630}
631
632//! Y-coordinates.
633const std::vector<double> &Grid::y() const {
634 return m_impl->y;
635}
636
637//! Get a particular y coordinate.
638double Grid::y(size_t i) const {
639 return m_impl->y[i];
640}
641
642//! Z-coordinates within the ice.
643const std::vector<double> &Grid::z() const {
644 return m_impl->z;
645}
646
647//! Get a particular z coordinate.
648double Grid::z(size_t i) const {
649 return m_impl->z[i];
650}
651
652//! Horizontal grid spacing.
653double Grid::dx() const {
654 return m_impl->dx;
655}
656
657//! Horizontal grid spacing.
658double Grid::dy() const {
659 return m_impl->dy;
660}
661
662double Grid::cell_area() const {
663 return m_impl->cell_area;
664}
665
666//! Minimum vertical spacing.
667double Grid::dz_min() const {
668 double result = m_impl->z.back();
669 for (unsigned int k = 0; k < m_impl->z.size() - 1; ++k) {
670 const double dz = m_impl->z[k + 1] - m_impl->z[k];
671 result = std::min(dz, result);
672 }
673 return result;
674}
675
676//! Maximum vertical spacing.
677double Grid::dz_max() const {
678 double result = 0.0;
679 for (unsigned int k = 0; k < m_impl->z.size() - 1; ++k) {
680 const double dz = m_impl->z[k + 1] - m_impl->z[k];
681 result = std::max(dz, result);
682 }
683 return result;
684}
685
686//! Half-width of the computational domain.
687double Grid::Lx() const {
688 return m_impl->Lx;
689}
690
691//! Half-width of the computational domain.
692double Grid::Ly() const {
693 return m_impl->Ly;
694}
695
696//! Height of the computational domain.
697double Grid::Lz() const {
698 return m_impl->z.back();
699}
700
701//! X-coordinate of the center of the domain.
702double Grid::x0() const {
703 return m_impl->x0;
704}
705
706//! Y-coordinate of the center of the domain.
707double Grid::y0() const {
708 return m_impl->y0;
709}
710
711/*!
712 * Return the size of the biggest sub-domain (part owned by a MPI process)
713 */
715 return m_impl->max_patch_size;
716}
717
718
719namespace grid {
720
721//! \brief Set the vertical levels in the ice according to values in `Mz` (number of levels), `Lz`
722//! (domain height), `spacing` (quadratic or equal) and `lambda` (quadratic spacing parameter).
723/*!
724 - When `vertical_spacing == EQUAL`, the vertical grid in the ice is equally spaced:
725 `zlevels[k] = k dz` where `dz = Lz / (Mz - 1)`.
726 - When `vertical_spacing == QUADRATIC`, the spacing is a quadratic function. The intent
727 is that the spacing is smaller near the base than near the top.
728
729 In particular, if
730 \f$\zeta_k = k / (\mathtt{Mz} - 1)\f$ then `zlevels[k] = Lz *`
731 ((\f$\zeta_k\f$ / \f$\lambda\f$) * (1.0 + (\f$\lambda\f$ - 1.0)
732 * \f$\zeta_k\f$)) where \f$\lambda\f$ = 4. The value \f$\lambda\f$
733 indicates the slope of the quadratic function as it leaves the base.
734 Thus a value of \f$\lambda\f$ = 4 makes the spacing about four times finer
735 at the base than equal spacing would be.
736 */
737std::vector<double> compute_vertical_levels(double new_Lz, size_t new_Mz,
738 grid::VerticalSpacing spacing, double lambda) {
739
740 if (new_Mz < 2) {
741 throw RuntimeError(PISM_ERROR_LOCATION, "Mz must be at least 2");
742 }
743
744 if (new_Lz <= 0) {
745 throw RuntimeError(PISM_ERROR_LOCATION, "Lz must be positive");
746 }
747
748 if (spacing == grid::QUADRATIC and lambda <= 0) {
749 throw RuntimeError(PISM_ERROR_LOCATION, "lambda must be positive");
750 }
751
752 std::vector<double> result(new_Mz);
753
754 // Fill the levels in the ice:
755 switch (spacing) {
756 case grid::EQUAL: {
757 double dz = new_Lz / ((double)new_Mz - 1);
758
759 // Equal spacing
760 for (unsigned int k = 0; k < new_Mz - 1; k++) {
761 result[k] = dz * ((double)k);
762 }
763 result[new_Mz - 1] = new_Lz; // make sure it is exactly equal
764 break;
765 }
766 case grid::QUADRATIC: {
767 // this quadratic scheme is an attempt to be less extreme in the fineness near the base.
768 for (unsigned int k = 0; k < new_Mz - 1; k++) {
769 const double zeta = ((double)k) / ((double)new_Mz - 1);
770 result[k] = new_Lz * ((zeta / lambda) * (1.0 + (lambda - 1.0) * zeta));
771 }
772 result[new_Mz - 1] = new_Lz; // make sure it is exactly equal
773 break;
774 }
775 default:
776 throw RuntimeError(PISM_ERROR_LOCATION, "spacing can not be UNKNOWN");
777 }
778
779 return result;
780}
781
782//! Convert a string to Periodicity.
783Periodicity string_to_periodicity(const std::string &keyword) {
784 if (keyword == "none") {
785 return NOT_PERIODIC;
786 }
787
788 if (keyword == "x") {
789 return X_PERIODIC;
790 }
791
792 if (keyword == "y") {
793 return Y_PERIODIC;
794 }
795
796 if (keyword == "xy") {
797 return XY_PERIODIC;
798 }
799
800 throw RuntimeError::formatted(PISM_ERROR_LOCATION, "grid periodicity type '%s' is invalid.",
801 keyword.c_str());
802}
803
804//! Convert Periodicity to a STL string.
806 switch (p) {
807 case NOT_PERIODIC:
808 return "none";
809 case X_PERIODIC:
810 return "x";
811 case Y_PERIODIC:
812 return "y";
813 default:
814 case XY_PERIODIC:
815 return "xy";
816 }
817}
818
819//! Convert an STL string to SpacingType.
820VerticalSpacing string_to_spacing(const std::string &keyword) {
821 if (keyword == "quadratic") {
822 return QUADRATIC;
823 }
824
825 if (keyword == "equal") {
826 return EQUAL;
827 }
828
829 throw RuntimeError::formatted(PISM_ERROR_LOCATION, "ice vertical spacing type '%s' is invalid.",
830 keyword.c_str());
831}
832
833//! Convert SpacingType to an STL string.
835 switch (s) {
836 case EQUAL:
837 return "equal";
838 default:
839 case QUADRATIC:
840 return "quadratic";
841 }
842}
843
844Registration string_to_registration(const std::string &keyword) {
845 if (keyword == "center") {
846 return CELL_CENTER;
847 }
848
849 if (keyword == "corner") {
850 return CELL_CORNER;
851 }
852
853 throw RuntimeError::formatted(PISM_ERROR_LOCATION, "invalid grid registration: %s",
854 keyword.c_str());
855}
856
857std::string registration_to_string(Registration registration) {
858 switch (registration) {
859 case CELL_CORNER:
860 return "corner";
861 default:
862 case CELL_CENTER:
863 return "center";
864 }
865}
866
867void InputGridInfo::reset() {
868
869 filename = "";
870
871 t_len = 0;
872
873 x0 = 0;
874 Lx = 0;
875
876 y0 = 0;
877 Ly = 0;
878
879 z_min = 0;
880 z_max = 0;
881
882 longitude_latitude = false;
883}
884
885void InputGridInfo::report(const Logger &log, int threshold, units::System::Ptr s) const {
886 if (longitude_latitude) {
887 log.message(threshold,
888 " x: %5d points, [%7.3f, %7.3f] degree, x0 = %7.3f degree, Lx = %7.3f degree\n",
889 (int)this->x.size(), this->x0 - this->Lx, this->x0 + this->Lx, this->x0, this->Lx);
890 log.message(threshold,
891 " y: %5d points, [%7.3f, %7.3f] degree, y0 = %7.3f degree, Ly = %7.3f degree\n",
892 (int)this->y.size(), this->y0 - this->Ly, this->y0 + this->Ly, this->y0, this->Ly);
893 } else {
894 units::Converter km(s, "m", "km");
895
896 log.message(threshold,
897 " x: %5d points, [%10.3f, %10.3f] km, x0 = %10.3f km, Lx = %10.3f km\n",
898 (int)this->x.size(), km(this->x0 - this->Lx), km(this->x0 + this->Lx), km(this->x0),
899 km(this->Lx));
900
901 log.message(threshold,
902 " y: %5d points, [%10.3f, %10.3f] km, y0 = %10.3f km, Ly = %10.3f km\n",
903 (int)this->y.size(), km(this->y0 - this->Ly), km(this->y0 + this->Ly), km(this->y0),
904 km(this->Ly));
905 }
906
907 if (z.size() > 1) {
908 log.message(threshold, " z: %5d points, [%10.3f, %10.3f] m\n", (int)this->z.size(),
909 this->z_min, this->z_max);
910 }
911
912 log.message(threshold, " t: %5d records\n\n", this->t_len);
913}
914
915InputGridInfo::InputGridInfo(const File &file, const std::string &variable,
916 units::System::Ptr unit_system, Registration r) {
917 try {
918 reset();
919
920 filename = file.name();
921 variable_name = variable;
922
923 // try "variable" as the standard_name first, then as the short name:
924 auto var = file.find_variable(variable, variable);
925
926 if (not var.exists) {
927 throw RuntimeError::formatted(PISM_ERROR_LOCATION, "variable \"%s\" is missing",
928 variable.c_str());
929 }
930
931 std::string xy_units = "meters";
932 // Attempting to detect rotated pole grids
933 {
934 auto mapping = MappingInfo::FromFile(file, var.name, unit_system).cf_mapping;
935 std::string grid_mapping_name = mapping["grid_mapping_name"];
936 longitude_latitude = (grid_mapping_name == "rotated_latitude_longitude");
937 if (longitude_latitude) {
938 xy_units = "degrees";
939 }
940 }
941
942 bool time_dimension_processed = false;
943 for (const auto &dimension_name : file.dimensions(var.name)) {
944
945 auto dimtype = file.dimension_type(dimension_name, unit_system);
946
947 std::vector<double> data;
948 double center, half_width, v_min, v_max;
949 if (dimtype == X_AXIS or dimtype == Y_AXIS or dimtype == Z_AXIS) {
950 // horizontal dimensions
951 if (dimtype == X_AXIS or dimtype == Y_AXIS) {
952 // another attempt at detecting rotated pole grids
953 {
954 auto std_name = file.read_text_attribute(dimension_name, "standard_name");
955 if (member(std_name, { "grid_latitude", "grid_longitude" }) or
956 member(dimension_name, { "rlat", "rlon" })) {
957 xy_units = "degrees";
958 longitude_latitude = true;
959 }
960 }
961 data = io::read_1d_variable(file, dimension_name, xy_units, unit_system);
962 if (data.size() < 2) {
963 throw RuntimeError::formatted(PISM_ERROR_LOCATION,
964 "length(%s) in %s has to be at least 2",
965 dimension_name.c_str(), file.name().c_str());
966 }
967 } else {
968 data = io::read_1d_variable(file, dimension_name, "meters", unit_system);
969 }
970
971 v_min = vector_min(data);
972 v_max = vector_max(data);
973 center = 0.5 * (v_min + v_max);
974
975 half_width = 0.5 * (v_max - v_min);
976 if (r == CELL_CENTER) {
977 auto spacing = std::abs(data[1] - data[0]);
978 half_width += 0.5 * spacing;
979 }
980 }
981
982 // This has to happen *before* the switch statement below so the T_AXIS case below
983 // can override it.
984 this->dimension_types[dimension_name] = dimtype;
985
986 switch (dimtype) {
987 case X_AXIS: {
988 this->x = data;
989 this->x0 = center;
990 this->Lx = half_width;
991 break;
992 }
993 case Y_AXIS: {
994 this->y = data;
995 this->y0 = center;
996 this->Ly = half_width;
997 break;
998 }
999 case Z_AXIS: {
1000 this->z = data;
1001 this->z_min = v_min;
1002 this->z_max = v_max;
1003 break;
1004 }
1005 case T_AXIS: {
1006 if (time_dimension_processed) {
1007 // ignore the second, third, etc dimension interpreted as "time" and override
1008 // the dimension type: it is not "time" in the sense of "record dimension"
1009 this->dimension_types[dimension_name] = UNKNOWN_AXIS;
1010 } else {
1011 this->t_len = file.dimension_length(dimension_name);
1012 time_dimension_processed = true;
1013 }
1014 break;
1015 }
1016 case UNKNOWN_AXIS:
1017 default: {
1018 // ignore unknown axes
1019 break;
1020 }
1021 } // switch
1022 } // for loop
1023 } catch (RuntimeError &e) {
1024 e.add_context("getting grid information using variable '%s' in '%s'", variable.c_str(),
1025 file.name().c_str());
1026 throw;
1027 }
1028}
1029
1030//! Get a list of dimensions from a grid definition file
1031std::string get_domain_variable(const File &file) {
1032 auto n_variables = file.nvariables();
1033
1034 for (unsigned int k = 0; k < n_variables; ++k) {
1035
1036 auto variable = file.variable_name(k);
1037 auto n_attributes = file.nattributes(variable);
1038
1039 for (unsigned int a = 0; a < n_attributes; ++a) {
1040 if (file.attribute_name(variable, a) == "dimensions") {
1041 return variable;
1042 }
1043 }
1044 }
1045
1046 throw RuntimeError::formatted(PISM_ERROR_LOCATION, "failed to find a domain variable in '%s",
1047 file.name().c_str());
1048}
1049
1050Parameters Parameters::FromGridDefinition(std::shared_ptr<units::System> unit_system,
1051 const File &file, const std::string &variable_name,
1052 Registration registration) {
1053 Parameters result;
1054
1055 result.Mx = 0;
1056 result.My = 0;
1057 result.z = {};
1058 result.registration = registration;
1059 result.periodicity = NOT_PERIODIC;
1060
1061 std::vector<std::string> dimensions;
1062 {
1063 if (variable_name.empty()) {
1064 result.variable_name = get_domain_variable(file);
1065 } else {
1066 result.variable_name = variable_name;
1067 }
1068
1069 auto dimension_list = file.read_text_attribute(result.variable_name, "dimensions");
1070 if (not dimension_list.empty()) {
1071 dimensions = split(dimension_list, ' ');
1072 } else {
1073 dimensions = file.dimensions(variable_name);
1074 }
1075 }
1076
1077 for (const auto &dimension_name : dimensions) {
1078
1079 double v_min = 0.0;
1080 double v_max = 0.0;
1081 unsigned int length = 0;
1082 double half_width = 0.0;
1083
1084 auto dimension_type = file.dimension_type(dimension_name, unit_system);
1085
1086 if (not(dimension_type == X_AXIS or dimension_type == Y_AXIS)) {
1087 // use X and Y dimensions and ignore the rest
1088 continue;
1089 }
1090
1091 auto bounds_name = file.read_text_attribute(dimension_name, "bounds");
1092 if (not bounds_name.empty()) {
1093 auto bounds = io::read_bounds(file, bounds_name, "meters", unit_system);
1094
1095 if (bounds.size() < 2) {
1096 throw RuntimeError::formatted(PISM_ERROR_LOCATION,
1097 "length(%s) in '%s' has to be at least 2",
1098 bounds_name.c_str(), file.name().c_str());
1099 }
1100
1101 v_min = bounds.front();
1102 v_max = bounds.back();
1103 length = static_cast<unsigned int>(bounds.size()) / 2;
1104 // bounds set domain size regardless of grid registration
1105 half_width = (v_max - v_min) / 2.0;
1106 } else {
1107 auto dimension = io::read_1d_variable(file, dimension_name, "meters", unit_system);
1108
1109 if (dimension.size() < 2) {
1110 throw RuntimeError::formatted(PISM_ERROR_LOCATION,
1111 "length(%s) in '%s' has to be at least 2",
1112 dimension_name.c_str(), file.name().c_str());
1113 }
1114
1115 v_min = dimension.front();
1116 v_max = dimension.back();
1117 length = static_cast<unsigned int>(dimension.size());
1118 // same as in InputGridInfo, domain half-width depends on grid registration
1119 half_width = (v_max - v_min) / 2.0;
1120 if (registration == CELL_CENTER) {
1121 half_width += 0.5 * (dimension[1] - dimension[0]);
1122 }
1123 }
1124
1125 double center = (v_min + v_max) / 2.0;
1126
1127 switch (dimension_type) {
1128 case X_AXIS: {
1129 result.x0 = center;
1130 result.Lx = half_width;
1131 result.Mx = length;
1132 break;
1133 }
1134 case Y_AXIS: {
1135 result.y0 = center;
1136 result.Ly = half_width;
1137 result.My = length;
1138 break;
1139 }
1140 default: {
1141 // ignore
1142 }
1143 }
1144 }
1145
1146 if (result.Mx == 0) {
1147 throw RuntimeError::formatted(PISM_ERROR_LOCATION,
1148 "failed to initialize the X grid dimension from '%s' in '%s'",
1149 result.variable_name.c_str(), file.name().c_str());
1150 }
1151
1152 if (result.My == 0) {
1153 throw RuntimeError::formatted(PISM_ERROR_LOCATION,
1154 "failed to initialize the Y grid dimension from '%s' in '%s'",
1155 result.variable_name.c_str(), file.name().c_str());
1156 }
1157
1158 return result;
1159}
1160
1161Parameters::Parameters(const Config &config) {
1162
1163 periodicity = string_to_periodicity(config.get_string("grid.periodicity"));
1164 registration = string_to_registration(config.get_string("grid.registration"));
1165
1166 x0 = 0.0;
1167 y0 = 0.0;
1168
1169 horizontal_size_and_extent_from_options(config);
1170 vertical_grid_from_options(config);
1171 // does not set ownership ranges because we don't know if these settings are final
1172}
1173
1174Parameters::Parameters(const Config &config, unsigned Mx_, unsigned My_, double Lx_, double Ly_) {
1175
1176 periodicity = string_to_periodicity(config.get_string("grid.periodicity"));
1177 registration = string_to_registration(config.get_string("grid.registration"));
1178
1179 x0 = 0.0;
1180 y0 = 0.0;
1181
1182 Mx = Mx_;
1183 My = My_;
1184
1185 Lx = Lx_;
1186 Ly = Ly_;
1187
1188 vertical_grid_from_options(config);
1189 // does not set ownership ranges because we don't know if these settings are final
1190}
1191
1192void Parameters::ownership_ranges_from_options(const Config &config, unsigned int size) {
1193 // number of sub-domains in X and Y directions
1194 unsigned int Nx = 0;
1195 unsigned int Ny = 0;
1196 if (config.is_valid_number("grid.Nx") and config.is_valid_number("grid.Ny")) {
1197 Nx = static_cast<unsigned int>(config.get_number("grid.Nx"));
1198 Ny = static_cast<unsigned int>(config.get_number("grid.Ny"));
1199 } else {
1200 auto N = nprocs(size, Mx, My);
1201
1202 Nx = N[0];
1203 Ny = N[1];
1204 }
1205
1206 // sub-domain widths in X and Y directions
1207 std::vector<unsigned> px, py;
1208 {
1209
1210 // validate inputs
1211 if ((Mx / Nx) < 2) {
1212 throw RuntimeError::formatted(PISM_ERROR_LOCATION,
1213 "Can't split %d grid points into %d parts (X-direction).", Mx,
1214 (int)Nx);
1215 }
1216
1217 if ((My / Ny) < 2) {
1218 throw RuntimeError::formatted(PISM_ERROR_LOCATION,
1219 "Can't split %d grid points into %d parts (Y-direction).", My,
1220 (int)Ny);
1221 }
1222
1223 if (Nx * Ny != size) {
1224 throw RuntimeError::formatted(PISM_ERROR_LOCATION, "Nx * Ny has to be equal to %d.", size);
1225 }
1226
1227
1228 auto grid_procs_x = parse_integer_list(config.get_string("grid.procs_x"));
1229 auto grid_procs_y = parse_integer_list(config.get_string("grid.procs_y"));
1230
1231 if (not grid_procs_x.empty()) {
1232 if (grid_procs_x.size() != (unsigned int)Nx) {
1233 throw RuntimeError(PISM_ERROR_LOCATION, "-Nx has to be equal to the -procs_x size.");
1234 }
1235
1236 px.resize(grid_procs_x.size());
1237 for (unsigned int k = 0; k < Nx; ++k) {
1238 px[k] = grid_procs_x[k];
1239 }
1240
1241 } else {
1242 px = ownership_ranges(Mx, Nx);
1243 }
1244
1245 if (not grid_procs_y.empty()) {
1246 if (grid_procs_y.size() != (unsigned int)Ny) {
1247 throw RuntimeError(PISM_ERROR_LOCATION, "-Ny has to be equal to the -procs_y size.");
1248 }
1249
1250 py.resize(Ny);
1251 for (unsigned int k = 0; k < Ny; ++k) {
1252 py[k] = grid_procs_y[k];
1253 }
1254 } else {
1255 py = ownership_ranges(My, Ny);
1256 }
1257
1258 if (px.size() * py.size() != size) {
1259 throw RuntimeError(PISM_ERROR_LOCATION, "length(procs_x) * length(procs_y) != MPI size");
1260 }
1261 }
1262
1263 procs_x = px;
1264 procs_y = py;
1265}
1266
1267Parameters::Parameters(std::shared_ptr<units::System> unit_system, const File &file,
1268 const std::string &variable, Registration r) {
1269 InputGridInfo input_grid(file, variable, unit_system, r);
1270
1271 Lx = input_grid.Lx;
1272 Ly = input_grid.Ly;
1273 x0 = input_grid.x0;
1274 y0 = input_grid.y0;
1275 Mx = input_grid.x.size();
1276 My = input_grid.y.size();
1277 registration = r;
1278 z = input_grid.z;
1279 variable_name = variable;
1280}
1281
1282//! Set `output` if the parameter `name` is set to a "valid" number, otherwise leave
1283//! `output` unchanged.
1284template <typename T>
1285static void maybe_override(const Config &config, const char *name, const char *units, T &output) {
1286
1287 if (not config.is_valid_number(name)) {
1288 return;
1289 }
1290
1291 if (units != nullptr) {
1292 output = static_cast<T>(config.get_number(name, units));
1293 } else {
1294 output = static_cast<T>(config.get_number(name));
1295 }
1296}
1297
1298void Parameters::horizontal_size_and_extent_from_options(const Config &config) {
1299
1300 maybe_override(config, "grid.Lx", "m", Lx);
1301 maybe_override(config, "grid.Ly", "m", Ly);
1302
1303 // grid size
1304 if (config.is_valid_number("grid.dx") and config.is_valid_number("grid.dy")) {
1305
1306 double dx = config.get_number("grid.dx", "m");
1307 double dy = config.get_number("grid.dy", "m");
1308
1309 Mx = compute_horizontal_grid_size(Lx, dx, registration == CELL_CENTER);
1310 My = compute_horizontal_grid_size(Ly, dy, registration == CELL_CENTER);
1311
1312 // re-compute Lx and Ly
1313 if (registration == CELL_CENTER) {
1314 Lx = Mx * dx / 2.0;
1315 Ly = My * dy / 2.0;
1316 } else {
1317 Lx = (Mx - 1) * dx / 2.0;
1318 Ly = (My - 1) * dy / 2.0;
1319 }
1320 } else {
1321 maybe_override(config, "grid.Mx", nullptr, Mx);
1322 maybe_override(config, "grid.My", nullptr, My);
1323 }
1324}
1325
1326void Parameters::vertical_grid_from_options(const Config &config) {
1327 double Lz = (not z.empty()) ? z.back() : config.get_number("grid.Lz");
1328 size_t Mz = (not z.empty()) ? z.size() : static_cast<size_t>(config.get_number("grid.Mz"));
1329
1330 z = compute_vertical_levels(Lz, Mz,
1331 string_to_spacing(config.get_string("grid.ice_vertical_spacing")),
1332 config.get_number("grid.lambda"));
1333}
1334
1335void Parameters::validate() const {
1336 if (Mx < 3) {
1337 throw RuntimeError::formatted(PISM_ERROR_LOCATION,
1338 "Mx = %d is invalid (has to be 3 or greater)", Mx);
1339 }
1340
1341 if (My < 3) {
1342 throw RuntimeError::formatted(PISM_ERROR_LOCATION,
1343 "My = %d is invalid (has to be 3 or greater)", My);
1344 }
1345
1346 if (Lx <= 0.0) {
1347 throw RuntimeError::formatted(PISM_ERROR_LOCATION, "Lx = %f is invalid (has to be positive)",
1348 Lx);
1349 }
1350
1351 if (Ly <= 0.0) {
1352 throw RuntimeError::formatted(PISM_ERROR_LOCATION, "Ly = %f is invalid (has to be positive)",
1353 Ly);
1354 }
1355
1356 if (not is_increasing(z)) {
1357 throw RuntimeError(PISM_ERROR_LOCATION, "z levels are not increasing");
1358 }
1359
1360 if (z[0] > 1e-6) {
1361 throw RuntimeError::formatted(PISM_ERROR_LOCATION, "first z level is not zero: %f", z[0]);
1362 }
1363
1364 if (z.back() < 0.0) {
1365 throw RuntimeError::formatted(PISM_ERROR_LOCATION, "last z level is negative: %f", z.back());
1366 }
1367
1368 if (std::accumulate(procs_x.begin(), procs_x.end(), 0.0) != Mx) {
1369 throw RuntimeError(PISM_ERROR_LOCATION, "procs_x don't sum up to Mx");
1370 }
1371
1372 if (std::accumulate(procs_y.begin(), procs_y.end(), 0.0) != My) {
1373 throw RuntimeError(PISM_ERROR_LOCATION, "procs_y don't sum up to My");
1374 }
1375}
1376
1377double radius(const Grid &grid, int i, int j) {
1378 return sqrt(grid.x(i) * grid.x(i) + grid.y(j) * grid.y(j));
1379}
1380
1381//! \brief Computes the number of processors in the X- and Y-directions.
1382std::array<unsigned, 2> nprocs(unsigned int size, unsigned int Mx,
1383 unsigned int My) {
1384
1385 if (My <= 0) {
1386 throw RuntimeError(PISM_ERROR_LOCATION, "'My' is invalid.");
1387 }
1388
1389 unsigned int Nx = (unsigned int)(0.5 + sqrt(((double)Mx) * ((double)size) / ((double)My)));
1390 unsigned int Ny = 0;
1391
1392 if (Nx == 0) {
1393 Nx = 1;
1394 }
1395
1396 while (Nx > 0) {
1397 Ny = size / Nx;
1398 if (Nx * Ny == (unsigned int)size) {
1399 break;
1400 }
1401 Nx--;
1402 }
1403
1404 if (Mx > My and Nx < Ny) {
1405 // Swap Nx and Ny
1406 std::swap(Nx, Ny);
1407 }
1408
1409 if ((Mx / Nx) < 2) { // note: integer division
1410 throw RuntimeError::formatted(PISM_ERROR_LOCATION,
1411 "Can't split %d grid points into %d parts (X-direction).", Mx,
1412 (int)Nx);
1413 }
1414
1415 if ((My / Ny) < 2) { // note: integer division
1416 throw RuntimeError::formatted(PISM_ERROR_LOCATION,
1417 "Can't split %d grid points into %d parts (Y-direction).", My,
1418 (int)Ny);
1419 }
1420
1421 return {Nx, Ny};
1422}
1423
1424//! \brief Computes processor ownership ranges corresponding to equal area
1425//! distribution among processors.
1426std::vector<unsigned int> ownership_ranges(unsigned int Mx, unsigned int Nx) {
1427
1428 std::vector<unsigned int> result(Nx);
1429
1430 for (unsigned int i = 0; i < Nx; i++) {
1431 result[i] = Mx / Nx + static_cast<unsigned int>((Mx % Nx) > i);
1432 }
1433 return result;
1434}
1435
1436} // namespace grid
1437
1438//! Create a grid using command-line options and (possibly) an input file.
1439/** Processes options -i, -bootstrap, -Mx, -My, -Mz, -Lx, -Ly, -Lz.
1440 */
1441std::shared_ptr<Grid> Grid::FromOptions(std::shared_ptr<const Context> ctx) {
1442 auto config = ctx->config();
1443 auto unit_system = ctx->unit_system();
1444 auto log = ctx->log();
1445
1446 auto r = grid::string_to_registration(config->get_string("grid.registration"));
1447
1448 bool bootstrap = config->get_flag("input.bootstrap");
1449
1450 auto grid_file_name = config->get_string("grid.file");
1451 if (bootstrap and not grid_file_name.empty()) {
1452 auto parts = split(grid_file_name, ':');
1453 auto file_name = parts[0];
1454 std::string variable_name = parts.size() == 2 ? parts[1] : "";
1455
1456 File grid_file(ctx->com(), file_name, io::PISM_NETCDF3, io::PISM_READONLY);
1457
1458 auto P = grid::Parameters::FromGridDefinition(unit_system, grid_file, variable_name, r);
1459
1460 // process configuration parameters controlling grid size and extent, overriding
1461 // values read from a file *if* configuration parameters are set to "valid" numbers
1462 P.horizontal_size_and_extent_from_options(*config);
1463 // process configuration parameters controlling vertical grid size and extent
1464 P.vertical_grid_from_options(*config);
1465 // process configuration parameters controlling grid ownership ranges
1466 P.ownership_ranges_from_options(*ctx->config(), ctx->size());
1467
1468 auto result = std::make_shared<Grid>(ctx, P);
1469
1470 auto mapping_info = MappingInfo::FromFile(grid_file, P.variable_name, unit_system);
1471 result->set_mapping_info(mapping_info);
1472
1473 units::Converter km(unit_system, "m", "km");
1474
1475 log->message(
1476 2,
1477 " setting computational box for ice from variable '%s' in grid definition file '%s'\n"
1478 " and user options: [%6.2f km, %6.2f km] x [%6.2f km, %6.2f km] x [0 m, %6.2f m]\n",
1479 P.variable_name.c_str(), grid_file_name.c_str(), km(result->x0() - result->Lx()),
1480 km(result->x0() + result->Lx()), km(result->y0() - result->Ly()),
1481 km(result->y0() + result->Ly()), result->Lz());
1482
1483 return result;
1484 }
1485
1486 auto input_file_name = config->get_string("input.file");
1487
1488 if (not input_file_name.empty()) {
1489 File input_file(ctx->com(), input_file_name, io::PISM_NETCDF3, io::PISM_READONLY);
1490
1491 // list of variables to try getting grid information from
1492 std::vector<std::string> candidates = { "enthalpy", "temp" };
1493 if (bootstrap) {
1494 candidates = { "land_ice_thickness", "bedrock_altitude", "thk", "topg" };
1495 }
1496
1497 // loop over candidates and save the name of the first variable we found
1498 std::string variable_name;
1499 for (const auto &name : candidates) {
1500 auto V = input_file.find_variable(name, name);
1501 if (V.exists) {
1502 variable_name = V.name;
1503 break;
1504 }
1505 }
1506
1507 // stop with an error message if we could not find anything
1508 if (variable_name.empty()) {
1509 auto list = pism::join(candidates, ", ");
1511 PISM_ERROR_LOCATION, "no geometry information found in '%s' (checked variables '%s')",
1512 input_file_name.c_str(), list.c_str());
1513 }
1514
1515 if (bootstrap) {
1516 // bootstrapping; get domain size defaults from an input file, allow overriding all grid
1517 // parameters using command-line options
1518
1519 grid::Parameters input_grid(unit_system, input_file, variable_name, r);
1520
1521 // process configuration parameters controlling grid size and extent, overriding
1522 // values read from a file *if* configuration parameters are set to "valid" numbers
1523 input_grid.horizontal_size_and_extent_from_options(*config);
1524 // process configuration parameters controlling vertical grid size and extent
1525 input_grid.vertical_grid_from_options(*config);
1526 // process configuration parameters controlling grid ownership ranges
1527 input_grid.ownership_ranges_from_options(*ctx->config(), ctx->size());
1528
1529 auto result = std::make_shared<Grid>(ctx, input_grid);
1530
1531 units::Converter km(unit_system, "m", "km");
1532
1533 // get grid projection info
1534 auto grid_mapping = MappingInfo::FromFile(input_file, variable_name, unit_system);
1535
1536 result->set_mapping_info(grid_mapping);
1537
1538 // report on resulting computational box
1539 log->message(
1540 2,
1541 " setting computational box for ice from variable '%s' in '%s'\n"
1542 " and user options: [%6.2f km, %6.2f km] x [%6.2f km, %6.2f km] x [0 m, %6.2f m]\n",
1543 variable_name.c_str(), input_file_name.c_str(), km(result->x0() - result->Lx()),
1544 km(result->x0() + result->Lx()), km(result->y0() - result->Ly()),
1545 km(result->y0() + result->Ly()), result->Lz());
1546
1547 return result;
1548 }
1549
1550 {
1551 // get grid from a PISM input file
1552 auto result = Grid::FromFile(ctx, input_file, candidates, r);
1553
1554 // get grid projection info
1555 auto grid_mapping = MappingInfo::FromFile(input_file, variable_name, unit_system);
1556
1557 result->set_mapping_info(grid_mapping);
1558
1559 return result;
1560 }
1561 }
1562
1563 {
1564 // This covers the two remaining cases "-i is not set, -bootstrap is set" and "-i is
1565 // not set, -bootstrap is not set either".
1566
1567 // Use defaults from the configuration database
1568 grid::Parameters P(*ctx->config());
1570 P.vertical_grid_from_options(*ctx->config());
1571 P.ownership_ranges_from_options(*ctx->config(), ctx->size());
1572
1573 return std::make_shared<Grid>(ctx, P);
1574 }
1575}
1576
1578 return m_impl->mapping_info;
1579}
1580
1582 m_impl->mapping_info = info;
1583 // FIXME: re-compute lat/lon coordinates
1584}
1585
1586std::shared_ptr<InputInterpolation> Grid::get_interpolation(const std::vector<double> &levels,
1587 const File &input_file,
1588 const std::string &variable_name,
1589 InterpolationType type) const {
1590
1591 auto name = grid_name(input_file, variable_name, ctx()->unit_system(), type == PIECEWISE_CONSTANT);
1592
1593 if (levels.size() < 2) {
1594 if (m_impl->regridding_2d[name] == nullptr) {
1595 m_impl->regridding_2d[name] =
1596 InputInterpolation::create(*this, levels, input_file, variable_name, type);
1597 }
1598
1599 return m_impl->regridding_2d[name];
1600 }
1601
1602 return InputInterpolation::create(*this, levels, input_file, variable_name, type);
1603}
1604
1608
1609PointsWithGhosts::PointsWithGhosts(const Grid &grid, unsigned int stencil_width) {
1610 int W = static_cast<int>(stencil_width);
1611 m_i_first = grid.xs() - W;
1612 m_i_last = grid.xs() + grid.xm() + W - 1;
1613 m_j_first = grid.ys() - W;
1614 m_j_last = grid.ys() + grid.ym() + W - 1;
1615
1616 m_i = m_i_first;
1617 m_j = m_j_first;
1618 m_done = false;
1619}
1620
1621} // end of namespace pism
double get_number(const std::string &name, UseFlag flag=REMEMBER_THIS_USE) const
bool is_valid_number(const std::string &name) const
std::string get_string(const std::string &name, UseFlag flag=REMEMBER_THIS_USE) const
A class for storing and accessing PISM configuration flags and parameters.
unsigned int nvariables() const
Definition File.cc:742
std::string attribute_name(const std::string &var_name, unsigned int n) const
Definition File.cc:675
AxisType dimension_type(const std::string &name, units::System::Ptr unit_system) const
Get the "type" of a dimension.
Definition File.cc:460
VariableLookupData find_variable(const std::string &short_name, const std::string &std_name) const
Find a variable using its standard name and/or short name.
Definition File.cc:328
std::string variable_name(unsigned int id) const
Definition File.cc:755
bool variable_exists(const std::string &short_name) const
Checks if a variable exists.
Definition File.cc:378
std::string name() const
Definition File.cc:274
unsigned int nattributes(const std::string &var_name) const
Definition File.cc:663
unsigned int dimension_length(const std::string &name) const
Get the length of a dimension.
Definition File.cc:420
std::vector< std::string > dimensions(const std::string &variable_name) const
Definition File.cc:390
std::string read_text_attribute(const std::string &var_name, const std::string &att_name) const
Get a text attribute.
Definition File.cc:645
High-level PISM I/O class.
Definition File.hh:55
double y0() const
Y-coordinate of the center of the domain.
Definition Grid.cc:707
const std::vector< double > & x() const
X-coordinates.
Definition Grid.cc:623
const std::vector< double > & y() const
Y-coordinates.
Definition Grid.cc:633
unsigned int kBelowHeight(double height) const
Return the index k into zlevels[] so that zlevels[k] <= height < zlevels[k+1] and k < Mz.
Definition Grid.cc:275
unsigned int Mz() const
Number of vertical levels.
Definition Grid.cc:618
double cell_area() const
Definition Grid.cc:662
double Ly() const
Half-width of the computational domain.
Definition Grid.cc:692
int ys() const
Global starting index of this processor's subset.
Definition Grid.cc:593
Grid(std::shared_ptr< const Context > context, const grid::Parameters &p)
Create a PISM distributed computational grid.
Definition Grid.cc:158
grid::Periodicity periodicity() const
Return grid periodicity.
Definition Grid.cc:531
int max_patch_size() const
Definition Grid.cc:714
double Lx() const
Half-width of the computational domain.
Definition Grid.cc:687
double dx() const
Horizontal grid spacing.
Definition Grid.cc:653
const std::vector< double > & z() const
Z-coordinates within the ice.
Definition Grid.cc:643
int rank() const
MPI rank.
Definition Grid.cc:568
static std::shared_ptr< Grid > FromFile(std::shared_ptr< const Context > ctx, const File &file, const std::vector< std::string > &var_names, grid::Registration r)
Create a grid using one of variables in var_names in file.
Definition Grid.cc:250
static std::shared_ptr< Grid > Shallow(std::shared_ptr< const Context > ctx, double Lx, double Ly, double x0, double y0, unsigned int Mx, unsigned int My, grid::Registration r, grid::Periodicity p)
Initialize a uniform, shallow (3 z-levels) grid with half-widths (Lx,Ly) and Mx by My nodes.
Definition Grid.cc:134
Vars & variables()
Dictionary of variables (2D and 3D fields) associated with this grid.
Definition Grid.cc:578
std::shared_ptr< petsc::DM > get_dm(unsigned int dm_dof, unsigned int stencil_width) const
Get a PETSc DM ("distributed array manager") object for given dof (number of degrees of freedom per g...
Definition Grid.cc:510
unsigned int My() const
Total grid size in the Y direction.
Definition Grid.cc:613
void compute_point_neighbors(double X, double Y, int &i_left, int &i_right, int &j_bottom, int &j_top) const
Computes indices of grid points to the lower left and upper right from (X,Y).
Definition Grid.cc:458
void report_parameters() const
Report grid parameters.
Definition Grid.cc:383
std::vector< double > interpolation_weights(double x, double y) const
Compute 4 interpolation weights necessary for linear interpolation from the current grid....
Definition Grid.cc:488
double x0() const
X-coordinate of the center of the domain.
Definition Grid.cc:702
grid::Registration registration() const
Definition Grid.cc:535
Impl * m_impl
Definition Grid.hh:381
std::shared_ptr< const Context > ctx() const
Return execution context this grid corresponds to.
Definition Grid.cc:540
unsigned int Mx() const
Total grid size in the X direction.
Definition Grid.cc:608
const MappingInfo & get_mapping_info() const
Definition Grid.cc:1577
unsigned int size() const
MPI communicator size.
Definition Grid.cc:573
std::shared_ptr< InputInterpolation > get_interpolation(const std::vector< double > &levels, const File &input_file, const std::string &variable_name, InterpolationType type) const
Definition Grid.cc:1586
std::vector< int > point_neighbors(double X, double Y) const
Definition Grid.cc:479
const MPI_Comm com
Definition Grid.hh:370
double Lz() const
Height of the computational domain.
Definition Grid.cc:697
double dz_min() const
Minimum vertical spacing.
Definition Grid.cc:667
double dz_max() const
Maximum vertical spacing.
Definition Grid.cc:677
double dy() const
Horizontal grid spacing.
Definition Grid.cc:658
int xs() const
Global starting index of this processor's subset.
Definition Grid.cc:588
void set_mapping_info(const MappingInfo &info)
Definition Grid.cc:1581
static std::shared_ptr< Grid > FromOptions(std::shared_ptr< const Context > ctx)
Create a grid using command-line options and (possibly) an input file.
Definition Grid.cc:1441
int xm() const
Width of this processor's sub-domain.
Definition Grid.cc:598
int ym() const
Width of this processor's sub-domain.
Definition Grid.cc:603
void forget_interpolations()
Definition Grid.cc:1605
Describes the PISM grid and the distribution of data across processors.
Definition Grid.hh:290
static std::shared_ptr< InputInterpolation > create(const Grid &target_grid, const std::vector< double > &levels, const File &input_file, const std::string &variable_name, InterpolationType type)
void message(int threshold, const char format[],...) const __attribute__((format(printf
Print a message to the log.
Definition Logger.cc:49
A basic logging class.
Definition Logger.hh:40
static MappingInfo FromFile(const File &input_file, const std::string &variable_name, units::System::Ptr unit_system)
Get projection info from a file.
PointsWithGhosts(const Grid &grid, unsigned int stencil_width=1)
Definition Grid.cc:1609
void add_context(const std::string &message)
Add a message providing some context. This way we can (sort of) get a stack trace even though C++ exc...
static RuntimeError formatted(const ErrorLocation &location, const char format[],...) __attribute__((format(printf
build a RuntimeError with a formatted message
A class for passing PISM variables from the core to other parts of the code (such as climate couplers...
Definition Vars.hh:42
std::vector< double > y
y coordinates
Definition Grid.hh:93
double Lx
domain half-width
Definition Grid.hh:82
double Ly
domain half-height
Definition Grid.hh:84
double y0
y-coordinate of the domain center
Definition Grid.hh:80
double x0
x-coordinate of the domain center
Definition Grid.hh:78
std::vector< double > z
z coordinates
Definition Grid.hh:95
std::vector< double > x
x coordinates
Definition Grid.hh:91
Contains parameters of an input file grid.
Definition Grid.hh:68
Periodicity periodicity
Grid periodicity.
Definition Grid.hh:163
std::vector< double > z
Vertical levels.
Definition Grid.hh:165
std::string variable_name
Name of the variable used to initialize the instance (empty if not used)
Definition Grid.hh:172
void vertical_grid_from_options(const Config &config)
Process -Mz and -Lz; set z;.
Definition Grid.cc:1326
double y0
Domain center in the Y direction.
Definition Grid.hh:155
double x0
Domain center in the X direction.
Definition Grid.hh:153
std::vector< unsigned int > procs_y
Processor ownership ranges in the Y direction.
Definition Grid.hh:169
void ownership_ranges_from_options(const Config &config, unsigned int size)
Re-compute ownership ranges. Uses current values of Mx and My.
Definition Grid.cc:1192
std::vector< unsigned int > procs_x
Processor ownership ranges in the X direction.
Definition Grid.hh:167
void horizontal_size_and_extent_from_options(const Config &config)
Process -Lx, -Ly, -x0, -y0; set Lx, Ly, x0, y0.
Definition Grid.cc:1298
Registration registration
Grid registration.
Definition Grid.hh:161
static Parameters FromGridDefinition(std::shared_ptr< units::System > unit_system, const File &file, const std::string &variable_name, Registration registration)
Definition Grid.cc:1050
void validate() const
Validate data members.
Definition Grid.cc:1335
unsigned int Mx
Number of grid points in the X direction.
Definition Grid.hh:157
double Ly
Domain half-width in the Y direction.
Definition Grid.hh:151
double Lx
Domain half-width in the X direction.
Definition Grid.hh:149
unsigned int My
Number of grid points in the Y direction.
Definition Grid.hh:159
Grid parameters; used to collect defaults before an Grid is allocated.
Definition Grid.hh:123
std::shared_ptr< System > Ptr
Definition Units.hh:47
#define PISM_CHK(errcode, name)
#define PISM_ERROR_LOCATION
VerticalSpacing
Definition Grid.hh:53
@ EQUAL
Definition Grid.hh:53
@ QUADRATIC
Definition Grid.hh:53
std::string periodicity_to_string(Periodicity p)
Convert Periodicity to a STL string.
Definition Grid.cc:805
VerticalSpacing string_to_spacing(const std::string &keyword)
Convert an STL string to SpacingType.
Definition Grid.cc:820
std::vector< unsigned int > ownership_ranges(unsigned int Mx, unsigned int Nx)
Computes processor ownership ranges corresponding to equal area distribution among processors.
Definition Grid.cc:1426
Periodicity
Definition Grid.hh:54
@ XY_PERIODIC
Definition Grid.hh:54
@ Y_PERIODIC
Definition Grid.hh:54
@ X_PERIODIC
Definition Grid.hh:54
@ NOT_PERIODIC
Definition Grid.hh:54
Registration string_to_registration(const std::string &keyword)
Definition Grid.cc:844
Registration
Definition Grid.hh:56
@ CELL_CENTER
Definition Grid.hh:56
@ CELL_CORNER
Definition Grid.hh:56
std::string get_domain_variable(const File &file)
Get a list of dimensions from a grid definition file.
Definition Grid.cc:1031
Periodicity string_to_periodicity(const std::string &keyword)
Convert a string to Periodicity.
Definition Grid.cc:783
static void maybe_override(const Config &config, const char *name, const char *units, T &output)
Definition Grid.cc:1285
std::string spacing_to_string(VerticalSpacing s)
Convert SpacingType to an STL string.
Definition Grid.cc:834
std::vector< double > compute_vertical_levels(double new_Lz, size_t new_Mz, grid::VerticalSpacing spacing, double lambda)
Set the vertical levels in the ice according to values in Mz (number of levels), Lz (domain height),...
Definition Grid.cc:737
std::string registration_to_string(Registration registration)
Definition Grid.cc:857
std::array< unsigned, 2 > nprocs(unsigned int size, unsigned int Mx, unsigned int My)
Computes the number of processors in the X- and Y-directions.
Definition Grid.cc:1382
@ PISM_NETCDF3
Definition IO_Flags.hh:57
@ PISM_READONLY
open an existing file for reading only
Definition IO_Flags.hh:68
bool is_increasing(const std::vector< double > &a)
Checks if a vector of doubles is strictly increasing.
@ UNKNOWN_AXIS
Definition IO_Flags.hh:33
@ T_AXIS
Definition IO_Flags.hh:33
@ X_AXIS
Definition IO_Flags.hh:33
@ Z_AXIS
Definition IO_Flags.hh:33
@ Y_AXIS
Definition IO_Flags.hh:33
@ PIECEWISE_CONSTANT
static std::vector< double > compute_coordinates(unsigned int M, double delta, double v_min, double v_max, bool cell_centered)
Compute grid coordinates for one direction (X or Y).
Definition Grid.cc:331
std::vector< long > parse_integer_list(const std::string &input)
void GlobalMax(MPI_Comm comm, double *local, double *result, int count)
static double compute_horizontal_spacing(double half_width, unsigned int M, bool cell_centered)
Compute horizontal grid spacing. See compute_horizontal_coordinates() for more.
Definition Grid.cc:322
static unsigned int compute_horizontal_grid_size(double half_width, double dx, bool cell_centered)
Compute horizontal grid size. See compute_horizontal_coordinates() for more.
Definition Grid.cc:315
static const double k
Definition exactTestP.cc:42
double vector_min(const std::vector< double > &input)
std::string grid_name(const pism::File &file, const std::string &variable_name, pism::units::System::Ptr sys, bool piecewise_constant)
bool member(const std::string &string, const std::set< std::string > &set)
std::string join(const std::vector< std::string > &strings, const std::string &separator)
Concatenate strings, inserting separator between elements.
static std::shared_ptr< Grid > Grid_FromFile(std::shared_ptr< const Context > ctx, const File &file, const std::string &var_name, grid::Registration r)
Create a grid from a file, get information from variable var_name.
Definition Grid.cc:219
double vector_max(const std::vector< double > &input)
std::vector< std::string > split(const std::string &input, char separator)
Transform a separator-separated list (a string) into a vector of strings.
Vars variables
A dictionary with pointers to array::Arrays, for passing them from the one component to another (e....
Definition Grid.cc:118
MappingInfo mapping_info
Definition Grid.cc:62
double cell_area
cell area (meters^2)
Definition Grid.cc:90
void set_ownership_ranges(const std::vector< unsigned int > &procs_x, const std::vector< unsigned int > &procs_y)
Set processor ownership ranges. Takes care of type conversion (unsigned int -> PetscInt).
Definition Grid.cc:297
std::map< std::string, std::shared_ptr< InputInterpolation > > regridding_2d
Definition Grid.cc:123
std::shared_ptr< petsc::DM > create_dm(unsigned int da_dof, unsigned int stencil_width) const
Create a DM with the given number of dof (degrees of freedom per grid point) and stencil width.
Definition Grid.cc:546
std::vector< PetscInt > procs_y
array containing lenghts (in the y-direction) of processor sub-domains
Definition Grid.cc:71
std::shared_ptr< const Context > ctx
Definition Grid.cc:60
std::vector< double > z
vertical grid levels in the ice; correspond to the storage grid
Definition Grid.cc:82
double dx
horizontal grid spacing
Definition Grid.cc:86
unsigned int Mx
number of grid points in the x-direction
Definition Grid.cc:92
std::shared_ptr< petsc::DM > dm_scalar_global
Definition Grid.cc:113
std::vector< double > y
y-coordinates of grid points
Definition Grid.cc:80
std::vector< PetscInt > procs_x
array containing lenghts (in the x-direction) of processor sub-domains
Definition Grid.cc:69
grid::Periodicity periodicity
Definition Grid.cc:73
int max_patch_size
Definition Grid.cc:96
void compute_horizontal_coordinates()
Compute horizontal spacing parameters dx and dy and grid coordinates using Mx, My,...
Definition Grid.cc:363
std::map< std::array< unsigned int, 2 >, std::weak_ptr< petsc::DM > > dms
Definition Grid.cc:108
double x0
x-coordinate of the grid center
Definition Grid.cc:99
double dy
horizontal grid spacing
Definition Grid.cc:88
grid::Registration registration
Definition Grid.cc:75
double Ly
half width of the ice model grid in y-direction (m)
Definition Grid.cc:106
unsigned int My
number of grid points in the y-direction
Definition Grid.cc:94
double Lx
half width of the ice model grid in x-direction (m)
Definition Grid.cc:104
std::vector< double > x
x-coordinates of grid points
Definition Grid.cc:78
Impl(std::shared_ptr< const Context > context)
Definition Grid.cc:126
double y0
y-coordinate of the grid center
Definition Grid.cc:101
gsl_interp_accel * bsearch_accel
GSL binary search accelerator used to speed up kBelowHeight().
Definition Grid.cc:121
Internal structures of Grid.
Definition Grid.cc:51
std::string name
Definition File.hh:47
const double radius
Definition test_cube.c:18