23#include "pism/geometry/Geometry.hh"
24#include "pism/stressbalance/StressBalance.hh"
25#include "pism/stressbalance/ssa/SSAFD.hh"
26#include "pism/util/Grid.hh"
27#include "pism/util/array/CellType.hh"
28#include "pism/util/petscwrappers/DM.hh"
29#include "pism/util/petscwrappers/Vec.hh"
30#include "pism/util/pism_options.hh"
31#include "pism/util/pism_utilities.hh"
34namespace stressbalance {
60 .
long_name(
"old SSA velocity field; used for re-trying with a different epsilon")
64 .
long_name(
"ice thickness times effective viscosity (before an update)")
75 ierr = DMSetMatType(*dm, MATAIJ);
84 ierr = KSPSetOptionsPrefix(
m_KSP,
"ssafd_");
85 PISM_CHK(ierr,
"KSPSetOptionsPrefix");
89 ierr = KSPSetInitialGuessNonzero(
m_KSP, PETSC_TRUE);
90 PISM_CHK(ierr,
"KSPSetInitialGuessNonzero");
93 ierr = KSPConvergedDefaultSetUIRNorm(
m_KSP);
94 PISM_CHK(ierr,
"KSPConvergedDefaultSetUIRNorm");
103 ierr = KSPSetType(
m_KSP, KSPGMRES);
110 ierr = KSPGetPC(
m_KSP, &pc);
114 ierr = PCSetType(pc, PCBJACOBI);
118 ierr = KSPSetFromOptions(
m_KSP);
119 PISM_CHK(ierr,
"KSPSetFromOptions");
130 ierr = KSPSetType(
m_KSP, KSPGMRES);
137 ierr = KSPSetNormType(
m_KSP, KSP_NORM_UNPRECONDITIONED);
141 ierr = KSPSetPCSide(
m_KSP, PC_RIGHT);
145 ierr = KSPGetPC(
m_KSP, &pc);
149 ierr = PCSetType(pc, PCASM);
157 ierr = PCASMGetSubKSP(pc, NULL, NULL, &sub_ksp);
160 ierr = KSPSetType(*sub_ksp, KSPPREONLY);
164 ierr = KSPGetPC(*sub_ksp, &sub_pc);
167 ierr = PCSetType(sub_pc, PCLU);
172 ierr = KSPSetFromOptions(
m_KSP);
173 PISM_CHK(ierr,
"KSPSetFromOptions");
179 m_log->message(2,
" [using the KSP-based finite difference implementation]\n");
181 int nuh_viewer_size =
182 static_cast<int>(
m_config->get_number(
"stress_balance.ssa.fd.nuH_viewer_size"));
184 if (nuh_viewer_size > 0) {
189 if (
m_config->get_flag(
"stress_balance.calving_front_stress_bc")) {
190 m_log->message(2,
" using PISM-PIK calving-front stress boundary condition ...\n");
270 for (
unsigned int k = 0;
k < 3; ++
k) {
280 const double underrelax =
281 m_config->get_number(
"stress_balance.ssa.fd.nuH_iter_failure_underrelaxation");
283 1,
" re-trying with effective viscosity under-relaxation (parameter = %.2f) ...\n",
304 if (
m_config->get_flag(
"stress_balance.ssa.fd.extrapolate_at_margins")) {
309 if (
m_config->get_flag(
"stress_balance.ssa.fd.brutal_sliding")) {
310 const double brutal_sliding_scaleFactor =
311 m_config->get_number(
"stress_balance.ssa.fd.brutal_sliding_scale");
319 double nuH_iter_failure_underrelax) {
326 picard_manager(inputs, nuH_regularization, nuH_iter_failure_underrelax);
332 m_log->message(1,
" re-trying using the Additive Schwarz preconditioner...\n");
338 picard_manager(inputs, nuH_regularization, nuH_iter_failure_underrelax);
345 picard_manager(inputs, nuH_regularization, nuH_iter_failure_underrelax);
351 double nuH_iter_failure_underrelax) {
355 PetscInt ksp_iterations, ksp_iterations_total = 0, outer_iterations;
356 KSPConvergedReason reason;
359 static_cast<int>(
m_config->get_number(
"stress_balance.ssa.fd.max_iterations"));
360 double ssa_relative_tolerance =
361 m_config->get_number(
"stress_balance.ssa.fd.relative_convergence");
362 bool verbose =
m_log->get_threshold() >= 2, very_verbose =
m_log->get_threshold() > 2;
372 nuH_regularization,
m_nuH);
380 for (
int k = 0;
k < max_iterations; ++
k) {
401 ierr = KSPGetConvergedReason(
m_KSP, &reason);
402 PISM_CHK(ierr,
"KSPGetConvergedReason");
406 m_log->message(1,
"PISM WARNING: KSPSolve() reports 'diverged'; reason = %d = '%s'\n",
407 reason, KSPConvergedReasons[reason]);
413 throw KSPFailure(KSPConvergedReasons[reason]);
417 ierr = KSPGetIterationNumber(
m_KSP, &ksp_iterations);
418 PISM_CHK(ierr,
"KSPGetIterationNumber");
420 ksp_iterations_total += ksp_iterations;
428 auto max_speed =
m_config->get_number(
"stress_balance.ssa.fd.max_speed",
"m second-1");
429 int high_speed_counter = 0;
433 for (
auto p =
m_grid->points(); p; p.next()) {
434 const int i = p.i(), j = p.j();
438 if (speed > max_speed) {
440 high_speed_counter += 1;
446 if (high_speed_counter > 0) {
447 m_log->message(2,
" SSA speed was capped at %d locations\n", high_speed_counter);
457 double nuH_norm = 0.0, nuH_norm_change = 0.0;
465 nuH_regularization,
m_nuH);
468 if (nuH_iter_failure_underrelax != 1.0) {
474 nuH_norm_change = norm[1];
483 nuH_norm_change / nuH_norm);
492 outer_iterations =
k + 1;
495 if (nuH_norm == 0 || nuH_norm_change / nuH_norm < ssa_relative_tolerance) {
504 "with nuH_regularization=%8.2e.",
505 max_iterations, nuH_regularization));
511 pism::printf(
"... =%5d outer iterations, ~%3.1f KSP iterations each\n",
512 (
int)outer_iterations, ((
double)ksp_iterations_total) / outer_iterations);
514 }
else if (verbose) {
517 pism::printf(
"%5d outer iterations, ~%3.1f KSP iterations each\n", (
int)outer_iterations,
518 ((
double)ksp_iterations_total) / outer_iterations);
531 const double DEFAULT_EPSILON_MULTIPLIER_SSA = 4.0;
532 double nuH_regularization =
m_config->get_number(
"stress_balance.ssa.epsilon");
533 unsigned int k = 0, max_tries = 5;
535 if (nuH_regularization <= 0.0) {
536 throw PicardFailure(
"will not attempt over-regularization of nuH\n"
537 "because nuH_regularization == 0.0.");
540 while (
k < max_tries) {
542 m_log->message(1,
" re-trying with nuH_regularization multiplied by %8.2f...\n",
543 DEFAULT_EPSILON_MULTIPLIER_SSA);
545 nuH_regularization *= DEFAULT_EPSILON_MULTIPLIER_SSA;
555 if (
k == max_tries) {
556 throw PicardFailure(
"exceeded the max. number of nuH over-regularization attempts");
580 const double area =
m_grid->cell_area();
581 const NormType MY_NORM = NORM_1;
584 nuH_old.
add(-1, nuH);
586 std::vector<double> nuNorm = nuH.
norm(MY_NORM), nuChange = nuH_old.
norm(MY_NORM);
593 double norm_change = sqrt(PetscSqr(nuChange[0]) + PetscSqr(nuChange[1]));
594 double norm = sqrt(PetscSqr(nuNorm[0]) + PetscSqr(nuNorm[1]));
596 return { norm, norm_change };
609 .
long_name(
"log10 of (viscosity * thickness)")
614 for (
auto p =
m_grid->points(); p; p.next()) {
615 const int i = p.i(), j = p.j();
617 double avg_nuH = 0.5 * (nuH(i,j,0) + nuH(i,j,1));
618 if (avg_nuH > 1.0e14) {
619 tmp(i,j) = log10(avg_nuH);
632 std::string filename =
"SSAFD_" + namepart +
".petsc";
634 " writing linear system to PETSc binary file %s ...\n", filename.c_str());
637 ierr = PetscViewerBinaryOpen(
m_grid->com, filename.c_str(), FILE_MODE_WRITE,
639 PISM_CHK(ierr,
"PetscViewerBinaryOpen");
641 ierr = MatView(
m_A, viewer);
644 ierr = VecView(
m_rhs.
vec(), viewer);
const Config::ConstPtr m_config
configuration database used by this component
const Logger::ConstPtr m_log
logger (for easy access)
const std::shared_ptr< const Grid > m_grid
grid used by this component
array::CellType2 cell_type
array::Scalar2 ice_thickness
Makes sure that we call begin_access() and end_access() for all accessed array::Arrays.
void copy_from(const Array2D< T > &source)
void scale(double alpha)
Result: v <- v * alpha. Calls VecScale.
void view(std::vector< std::shared_ptr< petsc::Viewer > > viewers) const
View a 2D vector field using existing PETSc viewers.
std::shared_ptr< petsc::DM > dm() const
void add(double alpha, const Array &x)
Result: v <- v + alpha * x. Calls VecAXPY.
std::vector< double > norm(int n) const
Computes the norm of all the components of an Array.
void update_ghosts()
Updates ghost points.
SpatialVariableMetadata & metadata(unsigned int N=0)
Returns a reference to the SpatialVariableMetadata object containing metadata for the compoment N.
void copy_from(const array::Staggered &input)
A class for storing and accessing internal staggered-grid 2D fields. Uses dof=2 storage....
array::Staggered m_hardness
ice hardness
void fd_operator(const Geometry &geometry, const array::Scalar *bc_mask, double bc_scaling, const array::Scalar &basal_yield_stress, IceBasalResistancePlasticLaw *basal_sliding_law, const pism::Vector2d *const *velocity, const array::Staggered1 &nuH, const array::CellType1 &cell_type, Mat *A, Vector2d **Ax) const
Assemble the left-hand side matrix for the KSP-based, Picard iteration, and finite difference impleme...
void initialize_iterations(const Inputs &inputs)
array::Staggered1 m_nuH
viscosity times thickness
array::CellType2 m_cell_type
const double m_bc_scaling
scaling used for diagonal matrix elements at Dirichlet BC locations
array::Vector m_rhs
right hand side
void compute_nuH(const array::Scalar1 &ice_thickness, const array::CellType2 &cell_type, const pism::Vector2d *const *velocity, const array::Staggered &hardness, double nuH_regularization, array::Staggered1 &result)
KSPFailure(const char *reason)
PicardFailure(const std::string &message)
void assemble_matrix(const Inputs &inputs, const array::Vector1 &velocity, const array::Staggered1 &nuH, const array::CellType1 &cell_type, Mat A)
void init_impl()
Initialize a generic regular-grid SSA solver.
void picard_strategy_regularization(const Inputs &inputs)
Old SSAFD recovery strategy: increase the SSA regularization parameter.
std::shared_ptr< petsc::Viewer > m_nuh_viewer
array::Vector1 m_velocity_old
SSAFD(std::shared_ptr< const Grid > g, bool regional_mode)
void solve(const Inputs &inputs)
Compute the vertically-averaged horizontal velocity from the shallow shelf approximation.
void write_system_petsc(const std::string &namepart)
unsigned int m_default_pc_failure_max_count
void update_nuH_viewers(const array::Staggered &nuH)
Update the nuH viewer, which shows log10(nu H).
std::array< double, 2 > compute_nuH_norm(const array::Staggered &nuH, array::Staggered &nuH_old)
Compute the norm of nu H and the norm of the change in nu H.
void picard_iteration(const Inputs &inputs, double nuH_regularization, double nuH_iter_failure_underrelax)
void picard_manager(const Inputs &inputs, double nuH_regularization, double nuH_iter_failure_underrelax)
Manages the Picard iteration loop.
unsigned int m_default_pc_failure_count
array::Staggered1 m_nuH_old
array::Vector m_velocity_global
void extrapolate_velocity(const array::CellType1 &cell_type, array::Vector1 &velocity) const
virtual void init_impl()
Initialize a generic regular-grid SSA solver.
const array::Vector1 & velocity() const
Get the thickness-advective 2D velocity.
IceBasalResistancePlasticLaw * m_basal_sliding_law
array::Vector2 m_velocity
#define PISM_CHK(errcode, name)
#define PISM_ERROR_LOCATION
std::string printf(const char *format,...)
void GlobalSum(MPI_Comm comm, double *local, double *result, int count)