24#include <gsl/gsl_interp.h>
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"
52 Impl(std::shared_ptr<const Context> context);
54 std::shared_ptr<petsc::DM>
create_dm(
unsigned int da_dof,
unsigned int stencil_width)
const;
56 const std::vector<unsigned int> &
procs_y);
60 std::shared_ptr<const Context>
ctx;
78 std::vector<double>
x;
80 std::vector<double>
y;
82 std::vector<double>
z;
108 std::map<std::array<unsigned int, 2>, std::weak_ptr<petsc::DM> >
dms;
127 : ctx(context), mapping_info(
"mapping", ctx->unit_system()) {
135 double x0,
double y0,
unsigned int Mx,
unsigned int My,
145 double Lz =
ctx->config()->get_number(
"grid.Lz");
146 p.
z = { 0.0, 0.5 *
Lz,
Lz };
150 return std::make_shared<Grid>(
ctx, p);
186 int stencil_width = (
int)context->config()->get_number(
"grid.max_stencil_width");
189 auto tmp = this->
get_dm(1, stencil_width);
222 const Logger &log = *ctx->log();
229 if (p.
z.size() < 2) {
230 double Lz = ctx->config()->get_number(
"grid.Lz");
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);
241 return std::make_shared<Grid>(ctx, p);
243 e.
add_context(
"initializing computational grid from variable \"%s\" in \"%s\"",
244 var_name.c_str(), file.
name().c_str());
252 const std::vector<std::string> &var_names,
255 for (
const auto &name : var_names) {
262 "file %s does not have any of %s."
263 " Cannot initialize the grid.",
264 file.
name().c_str(),
join(var_names,
",").c_str());
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",
285 if (height >
Lz() + eps) {
287 "height = %5.4f is above top of computational"
288 " grid Lz = %5.4f\n",
298 const std::vector<unsigned int> &input_procs_y) {
299 if (input_procs_x.size() * input_procs_y.size() != (
size_t)
size) {
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]);
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]);
316 auto M = std::floor(2 * half_width /
dx) + (cell_centered ? 0 : 1);
318 return static_cast<unsigned int>(M);
324 return 2.0 * half_width / M;
327 return 2.0 * half_width / (M - 1);
332 double v_max,
bool cell_centered) {
334 double offset = cell_centered ? 0.5 : 0.0;
339 std::vector<double> result(M);
340 for (
unsigned int i = 0; i < M; ++i) {
341 result[i] = v_min + (i + offset) * delta;
343 result[M - 1] = v_max - offset * delta;
373 double x_min =
x0 -
Lx, x_max =
x0 +
Lx;
377 double y_min =
y0 -
Ly, y_max =
y0 +
Ly;
391 log.
message(2,
" grid size %d x %d x %d\n",
Mx(),
My(),
Mz());
394 log.
message(2,
" spatial domain %.2f km x %.2f km x %.2f m\n", km(2 *
Lx()),
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()));
402 log.
message(2,
" horizontal grid cell %.0f m x %.0f m\n",
dx(),
dy());
405 log.
message(2,
" vertical spacing in ice dz = %.3f m (equal spacing)\n",
dz_min());
407 log.
message(2,
" vertical spacing in ice uneven, %d levels, %.3f m < dz < %.3f m\n",
Mz(),
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()),
416 log.
message(3,
" x0 = %6.2f km, y0 = %6.2f km, (coordinates of center)\n", km(
x0()),
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()));
423 log.
message(3,
" Registration: %s\n",
425 log.
message(3,
" Periodicity: %s\n",
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++) {
463 i_right = i_left + 1;
464 j_top = j_bottom + 1;
466 i_left = std::max(i_left, 0);
467 i_right = std::max(i_right, 0);
469 i_left = std::min(i_left, (
int)
m_impl->
Mx - 1);
470 i_right = std::min(i_right, (
int)
m_impl->
Mx - 1);
472 j_bottom = std::max(j_bottom, 0);
473 j_top = std::max(j_top, 0);
475 j_bottom = std::min(j_bottom, (
int)
m_impl->
My - 1);
476 j_top = std::min(j_top, (
int)
m_impl->
My - 1);
480 int i_left, i_right, j_bottom, j_top;
482 return { i_left, i_right, j_bottom, j_top };
489 int i_left = 0, i_right = 0, j_bottom = 0, j_top = 0;
491 double alpha = 0.0, beta = 0.0;
495 if (i_left != i_right) {
500 if (j_bottom != j_top) {
505 return { (1.0 - alpha) * (1.0 - beta), alpha * (1.0 - beta), alpha * beta, (1.0 - alpha) * beta };
510std::shared_ptr<petsc::DM>
Grid::get_dm(
unsigned int dm_dof,
unsigned int stencil_width)
const {
512 std::array<unsigned int, 2> key{ dm_dof, stencil_width };
510std::shared_ptr<petsc::DM>
Grid::get_dm(
unsigned int dm_dof,
unsigned int stencil_width)
const {
…}
548 ctx->log()->message(3,
"* Creating a DM with dof=%d and stencil_width=%d...\n", da_dof,
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(),
559#if PETSC_VERSION_GE(3, 8, 0)
560 ierr = DMSetUp(result);
564 return std::make_shared<petsc::DM>(result);
668 double result =
m_impl->
z.back();
669 for (
unsigned int k = 0;
k <
m_impl->
z.size() - 1; ++
k) {
671 result = std::min(dz, result);
679 for (
unsigned int k = 0;
k <
m_impl->
z.size() - 1; ++
k) {
681 result = std::max(dz, result);
748 if (spacing == grid::QUADRATIC and lambda <= 0) {
752 std::vector<double> result(new_Mz);
757 double dz = new_Lz / ((
double)new_Mz - 1);
760 for (
unsigned int k = 0; k < new_Mz - 1; k++) {
761 result[k] = dz * ((
double)k);
763 result[new_Mz - 1] = new_Lz;
766 case grid::QUADRATIC: {
768 for (
unsigned int k = 0; k < new_Mz - 1; k++) {
770 result[k] = new_Lz * ((zeta / lambda) * (1.0 + (lambda - 1.0) * zeta));
772 result[new_Mz - 1] = new_Lz;
784 if (keyword ==
"none") {
788 if (keyword ==
"x") {
792 if (keyword ==
"y") {
796 if (keyword ==
"xy") {
800 throw RuntimeError::formatted(
PISM_ERROR_LOCATION,
"grid periodicity type '%s' is invalid.",
821 if (keyword ==
"quadratic") {
825 if (keyword ==
"equal") {
829 throw RuntimeError::formatted(
PISM_ERROR_LOCATION,
"ice vertical spacing type '%s' is invalid.",
845 if (keyword ==
"center") {
849 if (keyword ==
"corner") {
858 switch (registration) {
867void InputGridInfo::reset() {
882 longitude_latitude =
false;
867void InputGridInfo::reset() {
…}
886 if (longitude_latitude) {
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);
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);
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),
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),
908 log.
message(threshold,
" z: %5d points, [%10.3f, %10.3f] m\n", (
int)this->z.size(),
909 this->z_min, this->z_max);
912 log.
message(threshold,
" t: %5d records\n\n", this->t_len);
915InputGridInfo::InputGridInfo(
const File &file,
const std::string &variable,
920 filename = file.
name();
921 variable_name = variable;
926 if (not var.exists) {
931 std::string xy_units =
"meters";
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";
942 bool time_dimension_processed =
false;
943 for (
const auto &dimension_name : file.
dimensions(var.name)) {
947 std::vector<double> data;
948 double center, half_width, v_min, v_max;
955 if (
member(std_name, {
"grid_latitude",
"grid_longitude" }) or
956 member(dimension_name, {
"rlat",
"rlon" })) {
957 xy_units =
"degrees";
958 longitude_latitude =
true;
961 data = io::read_1d_variable(file, dimension_name, xy_units, unit_system);
962 if (data.size() < 2) {
964 "length(%s) in %s has to be at least 2",
965 dimension_name.c_str(), file.
name().c_str());
968 data = io::read_1d_variable(file, dimension_name,
"meters", unit_system);
973 center = 0.5 * (v_min + v_max);
975 half_width = 0.5 * (v_max - v_min);
977 auto spacing = std::abs(data[1] - data[0]);
978 half_width += 0.5 * spacing;
984 this->dimension_types[dimension_name] = dimtype;
990 this->Lx = half_width;
996 this->Ly = half_width;
1001 this->z_min = v_min;
1002 this->z_max = v_max;
1006 if (time_dimension_processed) {
1012 time_dimension_processed =
true;
1024 e.
add_context(
"getting grid information using variable '%s' in '%s'", variable.c_str(),
1025 file.
name().c_str());
915InputGridInfo::InputGridInfo(
const File &file,
const std::string &variable, {
…}
1034 for (
unsigned int k = 0; k < n_variables; ++k) {
1039 for (
unsigned int a = 0; a < n_attributes; ++a) {
1046 throw RuntimeError::formatted(
PISM_ERROR_LOCATION,
"failed to find a domain variable in '%s",
1047 file.
name().c_str());
1050Parameters Parameters::FromGridDefinition(std::shared_ptr<units::System> unit_system,
1051 const File &file,
const std::string &variable_name,
1061 std::vector<std::string> dimensions;
1063 if (variable_name.empty()) {
1070 if (not dimension_list.empty()) {
1071 dimensions =
split(dimension_list,
' ');
1077 for (
const auto &dimension_name : dimensions) {
1081 unsigned int length = 0;
1082 double half_width = 0.0;
1084 auto dimension_type = file.
dimension_type(dimension_name, unit_system);
1086 if (not(dimension_type ==
X_AXIS or dimension_type ==
Y_AXIS)) {
1092 if (not bounds_name.empty()) {
1093 auto bounds = io::read_bounds(file, bounds_name,
"meters", unit_system);
1095 if (bounds.size() < 2) {
1097 "length(%s) in '%s' has to be at least 2",
1098 bounds_name.c_str(), file.
name().c_str());
1101 v_min = bounds.front();
1102 v_max = bounds.back();
1103 length =
static_cast<unsigned int>(bounds.size()) / 2;
1105 half_width = (v_max - v_min) / 2.0;
1107 auto dimension = io::read_1d_variable(file, dimension_name,
"meters", unit_system);
1109 if (dimension.size() < 2) {
1111 "length(%s) in '%s' has to be at least 2",
1112 dimension_name.c_str(), file.
name().c_str());
1115 v_min = dimension.front();
1116 v_max = dimension.back();
1117 length =
static_cast<unsigned int>(dimension.size());
1119 half_width = (v_max - v_min) / 2.0;
1121 half_width += 0.5 * (dimension[1] - dimension[0]);
1125 double center = (v_min + v_max) / 2.0;
1127 switch (dimension_type) {
1130 result.
Lx = half_width;
1136 result.
Ly = half_width;
1146 if (result.
Mx == 0) {
1148 "failed to initialize the X grid dimension from '%s' in '%s'",
1152 if (result.
My == 0) {
1154 "failed to initialize the Y grid dimension from '%s' in '%s'",
1050Parameters Parameters::FromGridDefinition(std::shared_ptr<units::System> unit_system, {
…}
1161Parameters::Parameters(
const Config &config) {
1169 horizontal_size_and_extent_from_options(config);
1170 vertical_grid_from_options(config);
1174Parameters::Parameters(
const Config &config,
unsigned Mx_,
unsigned My_,
double Lx_,
double Ly_) {
1188 vertical_grid_from_options(config);
1174Parameters::Parameters(
const Config &config,
unsigned Mx_,
unsigned My_,
double Lx_,
double Ly_) {
…}
1192void Parameters::ownership_ranges_from_options(
const Config &config,
unsigned int size) {
1194 unsigned int Nx = 0;
1195 unsigned int Ny = 0;
1197 Nx =
static_cast<unsigned int>(config.
get_number(
"grid.Nx"));
1198 Ny =
static_cast<unsigned int>(config.
get_number(
"grid.Ny"));
1200 auto N =
nprocs(size, Mx, My);
1207 std::vector<unsigned> px, py;
1211 if ((Mx / Nx) < 2) {
1213 "Can't split %d grid points into %d parts (X-direction).", Mx,
1217 if ((My / Ny) < 2) {
1219 "Can't split %d grid points into %d parts (Y-direction).", My,
1223 if (Nx * Ny != size) {
1224 throw RuntimeError::formatted(
PISM_ERROR_LOCATION,
"Nx * Ny has to be equal to %d.", size);
1231 if (not grid_procs_x.empty()) {
1232 if (grid_procs_x.size() != (
unsigned int)Nx) {
1236 px.resize(grid_procs_x.size());
1237 for (
unsigned int k = 0; k < Nx; ++k) {
1238 px[k] = grid_procs_x[k];
1245 if (not grid_procs_y.empty()) {
1246 if (grid_procs_y.size() != (
unsigned int)Ny) {
1251 for (
unsigned int k = 0; k < Ny; ++k) {
1252 py[k] = grid_procs_y[k];
1258 if (px.size() * py.size() != size) {
1192void Parameters::ownership_ranges_from_options(
const Config &config,
unsigned int size) {
…}
1267Parameters::Parameters(std::shared_ptr<units::System> unit_system,
const File &file,
1275 Mx = input_grid.
x.size();
1276 My = input_grid.
y.size();
1279 variable_name = variable;
1267Parameters::Parameters(std::shared_ptr<units::System> unit_system,
const File &file, {
…}
1284template <
typename T>
1291 if (units !=
nullptr) {
1292 output =
static_cast<T
>(config.
get_number(name, units));
1294 output =
static_cast<T
>(config.
get_number(name));
1298void Parameters::horizontal_size_and_extent_from_options(
const Config &config) {
1306 double dx = config.
get_number(
"grid.dx",
"m");
1307 double dy = config.
get_number(
"grid.dy",
"m");
1317 Lx = (Mx - 1) * dx / 2.0;
1318 Ly = (My - 1) * dy / 2.0;
1298void Parameters::horizontal_size_and_extent_from_options(
const Config &config) {
…}
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"));
1326void Parameters::vertical_grid_from_options(
const Config &config) {
…}
1335void Parameters::validate()
const {
1338 "Mx = %d is invalid (has to be 3 or greater)", Mx);
1343 "My = %d is invalid (has to be 3 or greater)", My);
1347 throw RuntimeError::formatted(
PISM_ERROR_LOCATION,
"Lx = %f is invalid (has to be positive)",
1352 throw RuntimeError::formatted(
PISM_ERROR_LOCATION,
"Ly = %f is invalid (has to be positive)",
1361 throw RuntimeError::formatted(
PISM_ERROR_LOCATION,
"first z level is not zero: %f", z[0]);
1364 if (z.back() < 0.0) {
1365 throw RuntimeError::formatted(
PISM_ERROR_LOCATION,
"last z level is negative: %f", z.back());
1368 if (std::accumulate(procs_x.begin(), procs_x.end(), 0.0) != Mx) {
1372 if (std::accumulate(procs_y.begin(), procs_y.end(), 0.0) != My) {
1335void Parameters::validate()
const {
…}
1378 return sqrt(grid.x(i) * grid.x(i) + grid.y(j) * grid.y(j));
1382std::array<unsigned, 2>
nprocs(
unsigned int size,
unsigned int Mx,
1389 unsigned int Nx = (
unsigned int)(0.5 + sqrt(((
double)Mx) * ((
double)size) / ((
double)My)));
1390 unsigned int Ny = 0;
1398 if (Nx * Ny == (
unsigned int)size) {
1404 if (Mx > My and Nx < Ny) {
1409 if ((Mx / Nx) < 2) {
1411 "Can't split %d grid points into %d parts (X-direction).", Mx,
1415 if ((My / Ny) < 2) {
1417 "Can't split %d grid points into %d parts (Y-direction).", My,
1382std::array<unsigned, 2>
nprocs(
unsigned int size,
unsigned int Mx, {
…}
1428 std::vector<unsigned int> result(Nx);
1430 for (
unsigned int i = 0; i < Nx; i++) {
1431 result[i] = Mx / Nx +
static_cast<unsigned int>((Mx % Nx) > i);
1442 auto config =
ctx->config();
1443 auto unit_system =
ctx->unit_system();
1444 auto log =
ctx->log();
1448 bool bootstrap = config->get_flag(
"input.bootstrap");
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] :
"";
1462 P.horizontal_size_and_extent_from_options(*config);
1464 P.vertical_grid_from_options(*config);
1466 P.ownership_ranges_from_options(*
ctx->config(),
ctx->size());
1468 auto result = std::make_shared<Grid>(
ctx, P);
1471 result->set_mapping_info(mapping_info);
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());
1486 auto input_file_name = config->get_string(
"input.file");
1488 if (not input_file_name.empty()) {
1492 std::vector<std::string> candidates = {
"enthalpy",
"temp" };
1494 candidates = {
"land_ice_thickness",
"bedrock_altitude",
"thk",
"topg" };
1498 std::string variable_name;
1499 for (
const auto &name : candidates) {
1502 variable_name = V.
name;
1508 if (variable_name.empty()) {
1512 input_file_name.c_str(), list.c_str());
1529 auto result = std::make_shared<Grid>(
ctx, input_grid);
1536 result->set_mapping_info(grid_mapping);
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());
1557 result->set_mapping_info(grid_mapping);
1573 return std::make_shared<Grid>(
ctx, P);
1587 const File &input_file,
1588 const std::string &variable_name,
1593 if (levels.size() < 2) {
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;
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
std::string attribute_name(const std::string &var_name, unsigned int n) const
AxisType dimension_type(const std::string &name, units::System::Ptr unit_system) const
Get the "type" of a dimension.
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.
std::string variable_name(unsigned int id) const
bool variable_exists(const std::string &short_name) const
Checks if a variable exists.
unsigned int nattributes(const std::string &var_name) const
unsigned int dimension_length(const std::string &name) const
Get the length of a dimension.
std::vector< std::string > dimensions(const std::string &variable_name) const
std::string read_text_attribute(const std::string &var_name, const std::string &att_name) const
Get a text attribute.
High-level PISM I/O class.
double y0() const
Y-coordinate of the center of the domain.
const std::vector< double > & x() const
X-coordinates.
const std::vector< double > & y() const
Y-coordinates.
unsigned int kBelowHeight(double height) const
Return the index k into zlevels[] so that zlevels[k] <= height < zlevels[k+1] and k < Mz.
unsigned int Mz() const
Number of vertical levels.
double Ly() const
Half-width of the computational domain.
int ys() const
Global starting index of this processor's subset.
Grid(std::shared_ptr< const Context > context, const grid::Parameters &p)
Create a PISM distributed computational grid.
grid::Periodicity periodicity() const
Return grid periodicity.
int max_patch_size() const
double Lx() const
Half-width of the computational domain.
double dx() const
Horizontal grid spacing.
const std::vector< double > & z() const
Z-coordinates within the ice.
int rank() const
MPI rank.
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.
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.
Vars & variables()
Dictionary of variables (2D and 3D fields) associated with this grid.
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...
unsigned int My() const
Total grid size in the Y direction.
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).
void report_parameters() const
Report grid parameters.
std::vector< double > interpolation_weights(double x, double y) const
Compute 4 interpolation weights necessary for linear interpolation from the current grid....
double x0() const
X-coordinate of the center of the domain.
grid::Registration registration() const
std::shared_ptr< const Context > ctx() const
Return execution context this grid corresponds to.
unsigned int Mx() const
Total grid size in the X direction.
const MappingInfo & get_mapping_info() const
unsigned int size() const
MPI communicator size.
std::shared_ptr< InputInterpolation > get_interpolation(const std::vector< double > &levels, const File &input_file, const std::string &variable_name, InterpolationType type) const
std::vector< int > point_neighbors(double X, double Y) const
double Lz() const
Height of the computational domain.
double dz_min() const
Minimum vertical spacing.
double dz_max() const
Maximum vertical spacing.
double dy() const
Horizontal grid spacing.
int xs() const
Global starting index of this processor's subset.
void set_mapping_info(const MappingInfo &info)
static std::shared_ptr< Grid > FromOptions(std::shared_ptr< const Context > ctx)
Create a grid using command-line options and (possibly) an input file.
int xm() const
Width of this processor's sub-domain.
int ym() const
Width of this processor's sub-domain.
void forget_interpolations()
Describes the PISM grid and the distribution of data across processors.
void message(int threshold, const char format[],...) const __attribute__((format(printf
Print a message to the log.
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)
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...
Periodicity periodicity
Grid periodicity.
std::vector< double > z
Vertical levels.
std::string variable_name
Name of the variable used to initialize the instance (empty if not used)
void vertical_grid_from_options(const Config &config)
Process -Mz and -Lz; set z;.
double y0
Domain center in the Y direction.
double x0
Domain center in the X direction.
std::vector< unsigned int > procs_y
Processor ownership ranges in the Y direction.
void ownership_ranges_from_options(const Config &config, unsigned int size)
Re-compute ownership ranges. Uses current values of Mx and My.
std::vector< unsigned int > procs_x
Processor ownership ranges in the X direction.
void horizontal_size_and_extent_from_options(const Config &config)
Process -Lx, -Ly, -x0, -y0; set Lx, Ly, x0, y0.
Registration registration
Grid registration.
static Parameters FromGridDefinition(std::shared_ptr< units::System > unit_system, const File &file, const std::string &variable_name, Registration registration)
void validate() const
Validate data members.
unsigned int Mx
Number of grid points in the X direction.
double Ly
Domain half-width in the Y direction.
double Lx
Domain half-width in the X direction.
unsigned int My
Number of grid points in the Y direction.
Grid parameters; used to collect defaults before an Grid is allocated.
std::shared_ptr< System > Ptr
#define PISM_CHK(errcode, name)
#define PISM_ERROR_LOCATION
std::string periodicity_to_string(Periodicity p)
Convert Periodicity to a STL string.
VerticalSpacing string_to_spacing(const std::string &keyword)
Convert an STL string to SpacingType.
std::vector< unsigned int > ownership_ranges(unsigned int Mx, unsigned int Nx)
Computes processor ownership ranges corresponding to equal area distribution among processors.
Registration string_to_registration(const std::string &keyword)
std::string get_domain_variable(const File &file)
Get a list of dimensions from a grid definition file.
Periodicity string_to_periodicity(const std::string &keyword)
Convert a string to Periodicity.
static void maybe_override(const Config &config, const char *name, const char *units, T &output)
std::string spacing_to_string(VerticalSpacing s)
Convert SpacingType to an STL string.
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),...
std::string registration_to_string(Registration registration)
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.
@ PISM_READONLY
open an existing file for reading only
bool is_increasing(const std::vector< double > &a)
Checks if a vector of doubles is strictly increasing.
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).
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.
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.
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.
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....
double cell_area
cell area (meters^2)
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).
std::map< std::string, std::shared_ptr< InputInterpolation > > regridding_2d
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.
std::vector< PetscInt > procs_y
array containing lenghts (in the y-direction) of processor sub-domains
std::shared_ptr< const Context > ctx
std::vector< double > z
vertical grid levels in the ice; correspond to the storage grid
double dx
horizontal grid spacing
unsigned int Mx
number of grid points in the x-direction
std::shared_ptr< petsc::DM > dm_scalar_global
std::vector< double > y
y-coordinates of grid points
std::vector< PetscInt > procs_x
array containing lenghts (in the x-direction) of processor sub-domains
grid::Periodicity periodicity
void compute_horizontal_coordinates()
Compute horizontal spacing parameters dx and dy and grid coordinates using Mx, My,...
std::map< std::array< unsigned int, 2 >, std::weak_ptr< petsc::DM > > dms
double x0
x-coordinate of the grid center
double dy
horizontal grid spacing
grid::Registration registration
double Ly
half width of the ice model grid in y-direction (m)
unsigned int My
number of grid points in the y-direction
double Lx
half width of the ice model grid in x-direction (m)
std::vector< double > x
x-coordinates of grid points
Impl(std::shared_ptr< const Context > context)
double y0
y-coordinate of the grid center
gsl_interp_accel * bsearch_accel
GSL binary search accelerator used to speed up kBelowHeight().
Internal structures of Grid.