10 #ifdef MOOSE_KOKKOS_ENABLED 126 #include "libmesh/exodusII_io.h" 127 #include "libmesh/quadrature.h" 128 #include "libmesh/coupling_matrix.h" 129 #include "libmesh/nonlinear_solver.h" 130 #include "libmesh/sparse_matrix.h" 131 #include "libmesh/string_to_enum.h" 132 #include "libmesh/fe_interface.h" 133 #include "libmesh/enum_norm_type.h" 134 #include "libmesh/petsc_solver_exception.h" 136 #include "metaphysicl/dualnumber.h" 162 params.
addParam<
unsigned int>(
"null_space_dimension", 0,
"The dimension of the nullspace");
164 "transpose_null_space_dimension", 0,
"The dimension of the transpose nullspace");
166 "near_null_space_dimension", 0,
"The dimension of the near nullspace");
169 "Whether or not to actually solve the Nonlinear system. " 170 "This is handy in the case that all you want to do is " 171 "execute AuxKernels, Transfers, etc. without actually " 173 params.
addParam<
bool>(
"use_nonlinear",
175 "Determines whether to use a Nonlinear vs a " 176 "Eigenvalue system (Automatically determined based " 178 params.
addParam<
bool>(
"error_on_jacobian_nonzero_reallocation",
179 "This causes PETSc to error if it had to reallocate memory in the Jacobian " 180 "matrix due to not having enough nonzeros");
181 params.
addParam<
bool>(
"ignore_zeros_in_jacobian",
183 "Do not explicitly store zero values in " 184 "the Jacobian matrix if true");
185 params.
addParam<
bool>(
"force_restart",
187 "EXPERIMENTAL: If true, a sub_app may use a " 188 "restart file instead of using of using the master " 192 "True to skip additional data in equation system for restart.",
193 "This parameter is no longer used, as we do not load additional " 194 "vectors by default with restart");
195 params.
addParam<
bool>(
"skip_nl_system_check",
197 "True to skip the NonlinearSystem check for work to do (e.g. Make sure " 198 "that there are variables to solve for).");
199 params.
addParam<
bool>(
"allow_initial_conditions_with_restart",
201 "True to allow the user to specify initial conditions when restarting. " 202 "Initial conditions can override any restarted field");
204 auto coverage_check_description = [](std::string scope, std::string list_param_name)
206 return "Controls, if and how a " + scope +
207 " subdomain coverage check is performed. " 208 "With 'TRUE' or 'ON' all subdomains are checked (the default). Setting 'FALSE' or 'OFF' " 209 "will disable the check for all subdomains. " 210 "To exclude a predefined set of subdomains 'SKIP_LIST' is to " 211 "be used, while the subdomains to skip are to be defined in the parameter '" +
213 "'. To limit the check to a list of subdomains, 'ONLY_LIST' is to " 214 "be used (again, using the parameter '" +
215 list_param_name +
"').";
218 params.
addParam<std::vector<SubdomainName>>(
221 "List of subdomains for kernel coverage and material coverage checks. Setting this parameter " 222 "is equivalent to setting 'kernel_coverage_block_list' and 'material_coverage_block_list' as " 223 "well as using 'ONLY_LIST' as the coverage check mode.");
225 MooseEnum kernel_coverage_check_modes(
"FALSE TRUE OFF ON SKIP_LIST ONLY_LIST",
"TRUE");
227 kernel_coverage_check_modes,
228 coverage_check_description(
"kernel",
"kernel_coverage_block_list"));
229 params.
addParam<std::vector<SubdomainName>>(
230 "kernel_coverage_block_list",
232 "List of subdomains for kernel coverage check. The meaning of this list is controlled by the " 233 "parameter 'kernel_coverage_check' (whether this is the list of subdomains to be checked, " 234 "not to be checked or not taken into account).");
236 "boundary_restricted_node_integrity_check",
238 "Set to false to disable checking of boundary restricted nodal object variable dependencies, " 239 "e.g. are the variable dependencies defined on the selected boundaries?");
240 params.
addParam<
bool>(
"boundary_restricted_elem_integrity_check",
242 "Set to false to disable checking of boundary restricted elemental object " 243 "variable dependencies, e.g. are the variable dependencies defined on the " 244 "selected boundaries?");
245 MooseEnum material_coverage_check_modes(
"FALSE TRUE OFF ON SKIP_LIST ONLY_LIST",
"TRUE");
247 "material_coverage_check",
248 material_coverage_check_modes,
249 coverage_check_description(
"material",
"material_coverage_block_list"));
250 params.
addParam<std::vector<SubdomainName>>(
251 "material_coverage_block_list",
253 "List of subdomains for material coverage check. The meaning of this list is controlled by " 254 "the parameter 'material_coverage_check' (whether this is the list of subdomains to be " 255 "checked, not to be checked or not taken into account).");
257 params.
addParam<
bool>(
"fv_bcs_integrity_check",
259 "Set to false to disable checking of overlapping Dirichlet and Flux BCs " 260 "and/or multiple DirichletBCs per sideset");
263 "material_dependency_check",
true,
"Set to false to disable material dependency check");
264 params.
addParam<
bool>(
"parallel_barrier_messaging",
266 "Displays messaging from parallel " 267 "barrier notifications when executing " 268 "or transferring to/from Multiapps " 271 MooseEnum verbosity(
"false true extra",
"false");
274 "Set to 'true' to have the problem report on any object created. Set " 275 "to 'extra' to also display all parameters.");
276 params.
addParam<
bool>(
"verbose_multiapps",
278 "Set to True to enable verbose screen printing related to MultiApps");
282 "Set to True to enable verbose screen printing related to solution restoration");
284 params.
addParam<FileNameNoExtension>(
"restart_file_base",
285 "File base name used for restart (e.g. " 286 "<path>/<filebase> or <path>/LATEST to " 287 "grab the latest file available)");
289 params.
addParam<std::vector<std::vector<TagName>>>(
292 "Extra vectors to add to the system that can be filled by objects which compute residuals " 293 "and Jacobians (Kernels, BCs, etc.) by setting tags on them. The outer index is for which " 294 "nonlinear system the extra tag vectors should be added for");
296 params.
addParam<std::vector<std::vector<TagName>>>(
297 "not_zeroed_tag_vectors",
299 "Extra vector tags which the sytem will not zero when other vector tags are zeroed. " 300 "The outer index is for which nonlinear system the extra tag vectors should be added for");
302 params.
addParam<std::vector<std::vector<TagName>>>(
303 "extra_tag_matrices",
305 "Extra matrices to add to the system that can be filled " 306 "by objects which compute residuals and Jacobians " 307 "(Kernels, BCs, etc.) by setting tags on them. The outer index is for which " 308 "nonlinear system the extra tag vectors should be added for");
310 params.
addParam<std::vector<TagName>>(
311 "extra_tag_solutions",
313 "Extra solution vectors to add to the system that can be used by " 314 "objects for coupling variable values stored in them.");
316 params.
addParam<
bool>(
"previous_nl_solution_required",
318 "True to indicate that this calculation requires a solution vector for " 319 "storing the previous nonlinear iteration.");
321 params.
addParam<std::vector<NonlinearSystemName>>(
322 "nl_sys_names", std::vector<NonlinearSystemName>{
"nl0"},
"The nonlinear system names");
324 params.
addParam<std::vector<LinearSystemName>>(
"linear_sys_names", {},
"The linear system names");
326 params.
addParam<
bool>(
"check_uo_aux_state",
328 "True to turn on a check that no state presents during the evaluation of " 329 "user objects and aux kernels");
336 "allow_invalid_solution",
338 "Set to true to allow convergence even though the solution has been marked as 'invalid'");
339 params.
addParam<
bool>(
"show_invalid_solution_console",
341 "Set to true to show the invalid solution occurance summary in console");
342 params.
addParam<
bool>(
"immediately_print_invalid_solution",
344 "Whether or not to report invalid solution warnings at the time the " 345 "warning is produced instead of after the calculation");
348 "identify_variable_groups_in_nl",
350 "Whether to identify variable groups in nonlinear systems. This affects dof ordering");
353 "regard_general_exceptions_as_errors",
355 "If we catch an exception during residual/Jacobian evaluaton for which we don't have " 356 "specific handling, immediately error instead of allowing the time step to be cut");
358 params.
addParam<
bool>(
"use_hash_table_matrix_assembly",
360 "Whether to assemble matrices using hash tables instead of preallocating " 361 "matrix memory. This can be a good option if the sparsity pattern changes " 362 "throughout the course of the simulation.");
364 "restore_original_nonzero_pattern",
365 "Whether we should reset matrix memory for every Jacobian evaluation. This option is useful " 366 "if the sparsity pattern is constantly changing and you are using hash table assembly or if " 367 "you wish to continually restore the matrix to the originally preallocated sparsity pattern " 368 "computed by relationship managers.");
371 "skip_nl_system_check kernel_coverage_check kernel_coverage_block_list " 372 "boundary_restricted_node_integrity_check " 373 "boundary_restricted_elem_integrity_check material_coverage_check " 374 "material_coverage_block_list fv_bcs_integrity_check " 375 "material_dependency_check check_uo_aux_state error_on_jacobian_nonzero_reallocation",
376 "Simulation checks");
378 "ignore_zeros_in_jacobian identify_variable_groups_in_nl " 379 "use_hash_table_matrix_assembly restore_original_nonzero_pattern",
380 "Nonlinear system(s)");
382 "restart_file_base force_restart allow_initial_conditions_with_restart",
"Restart");
384 "verbose_setup verbose_multiapps verbose_restore parallel_barrier_messaging",
"Verbosity");
386 "null_space_dimension transpose_null_space_dimension near_null_space_dimension",
387 "Null space removal");
389 "extra_tag_vectors extra_tag_matrices extra_tag_solutions not_zeroed_tag_vectors",
390 "Contribution to tagged field data");
392 "allow_invalid_solution show_invalid_solution_console immediately_print_invalid_solution",
393 "Solution validity control");
401 _mesh(*getCheckedPointerParam<
MooseMesh *>(
"mesh")),
403 "equation_systems", nullptr, _mesh)),
405 _solve(getParam<bool>(
"solve")),
407 _time(declareRestartableData<
Real>(
"time")),
408 _time_old(declareRestartableData<
Real>(
"time_old")),
409 _t_step(declareRecoverableData<
int>(
"t_step")),
410 _dt(declareRestartableData<
Real>(
"dt")),
411 _dt_old(declareRestartableData<
Real>(
"dt_old")),
412 _need_to_add_default_nonlinear_convergence(false),
413 _need_to_add_default_multiapp_fixed_point_convergence(false),
414 _need_to_add_default_steady_state_convergence(false),
415 _linear_sys_names(getParam<
std::vector<LinearSystemName>>(
"linear_sys_names")),
416 _num_linear_sys(_linear_sys_names.size()),
417 _linear_systems(_num_linear_sys, nullptr),
418 _current_linear_sys(nullptr),
419 _using_default_nl(!isParamSetByUser(
"nl_sys_names")),
420 _nl_sys_names(!_using_default_nl || (_using_default_nl && !_linear_sys_names.size())
421 ? getParam<
std::vector<NonlinearSystemName>>(
"nl_sys_names")
422 :
std::vector<NonlinearSystemName>()),
423 _num_nl_sys(_nl_sys_names.size()),
424 _nl(_num_nl_sys, nullptr),
425 _current_nl_sys(nullptr),
426 _solver_systems(_num_nl_sys + _num_linear_sys, nullptr),
429 #ifdef MOOSE_KOKKOS_ENABLED
430 _kokkos_assembly(*this),
432 _mesh_divisions(true),
434 "material_props", &_mesh, _material_prop_registry, *this)),
436 "bnd_material_props", &_mesh, _material_prop_registry, *this)),
438 "neighbor_material_props", &_mesh, _material_prop_registry, *this)),
439 #ifdef MOOSE_KOKKOS_ENABLED
440 _kokkos_material_props(
442 "kokkos_material_props", &_mesh, _material_prop_registry, *this)),
443 _kokkos_bnd_material_props(
445 "kokkos_bnd_material_props", &_mesh, _material_prop_registry, *this)),
446 _kokkos_neighbor_material_props(
448 "kokkos_neighbor_material_props", &_mesh, _material_prop_registry, *this)),
450 _reporter_data(_app),
452 _all_user_objects(_app.getExecuteOnEnum()),
453 _multi_apps(_app.getExecuteOnEnum()),
454 _transient_multi_apps(_app.getExecuteOnEnum()),
455 _transfers(_app.getExecuteOnEnum(), false),
456 _to_multi_app_transfers(_app.getExecuteOnEnum(), false),
457 _from_multi_app_transfers(_app.getExecuteOnEnum(), false),
458 _between_multi_app_transfers(_app.getExecuteOnEnum(), false),
459 #ifdef LIBMESH_ENABLE_AMR
461 _cycles_completed(0),
463 _displaced_mesh(nullptr),
464 _geometric_search_data(*this, _mesh),
466 _reinit_displaced_elem(false),
467 _reinit_displaced_face(false),
468 _reinit_displaced_neighbor(false),
469 _input_file_saved(false),
471 _has_constraints(false),
472 _snesmf_reuse_base(true),
473 _skip_exception_check(false),
474 _snesmf_reuse_base_set_by_user(false),
475 _has_initialized_stateful(false),
476 _const_jacobian(false),
477 _has_jacobian(false),
478 _needs_old_newton_iter(false),
479 _previous_nl_solution_required(getParam<bool>(
"previous_nl_solution_required")),
480 _has_nonlocal_coupling(false),
481 _calculate_jacobian_in_uo(false),
482 _kernel_coverage_check(
484 _kernel_coverage_blocks(getParam<
std::vector<SubdomainName>>(
"kernel_coverage_block_list")),
485 _boundary_restricted_node_integrity_check(
486 getParam<bool>(
"boundary_restricted_node_integrity_check")),
487 _boundary_restricted_elem_integrity_check(
488 getParam<bool>(
"boundary_restricted_elem_integrity_check")),
489 _material_coverage_check(
491 _material_coverage_blocks(getParam<
std::vector<SubdomainName>>(
"material_coverage_block_list")),
492 _fv_bcs_integrity_check(getParam<bool>(
"fv_bcs_integrity_check")),
493 _material_dependency_check(getParam<bool>(
"material_dependency_check")),
494 _uo_aux_state_check(getParam<bool>(
"check_uo_aux_state")),
495 _max_qps(
std::numeric_limits<unsigned
int>::
max()),
497 _has_time_integrator(false),
498 _has_exception(false),
499 _parallel_barrier_messaging(getParam<bool>(
"parallel_barrier_messaging")),
500 _verbose_setup(getParam<
MooseEnum>(
"verbose_setup")),
501 _verbose_multiapps(getParam<bool>(
"verbose_multiapps")),
502 _verbose_restore(getParam<bool>(
"verbose_restore")),
504 _control_warehouse(_app.getExecuteOnEnum(), false),
505 _is_petsc_options_inserted(false),
506 _line_search(nullptr),
507 _using_ad_mat_props(false),
508 _current_ic_state(0),
509 _use_hash_table_matrix_assembly(getParam<bool>(
"use_hash_table_matrix_assembly")),
510 _error_on_jacobian_nonzero_reallocation(
511 isParamValid(
"error_on_jacobian_nonzero_reallocation")
512 ? getParam<bool>(
"error_on_jacobian_nonzero_reallocation")
513 : _app.errorOnJacobianNonzeroReallocation()),
514 _restore_original_nonzero_pattern(isParamValid(
"restore_original_nonzero_pattern")
515 ? getParam<bool>(
"restore_original_nonzero_pattern")
516 : _use_hash_table_matrix_assembly),
517 _ignore_zeros_in_jacobian(getParam<bool>(
"ignore_zeros_in_jacobian")),
518 _preserve_matrix_sparsity_pattern(true),
519 _force_restart(getParam<bool>(
"force_restart")),
520 _allow_ics_during_restart(getParam<bool>(
"allow_initial_conditions_with_restart")),
521 _skip_nl_system_check(getParam<bool>(
"skip_nl_system_check")),
522 _fail_next_system_convergence_check(false),
523 _allow_invalid_solution(getParam<bool>(
"allow_invalid_solution")),
524 _show_invalid_solution_console(getParam<bool>(
"show_invalid_solution_console")),
525 _immediately_print_invalid_solution(getParam<bool>(
"immediately_print_invalid_solution")),
526 _started_initial_setup(false),
527 _has_internal_edge_residual_objects(false),
528 _u_dot_requested(false),
529 _u_dotdot_requested(false),
530 _u_dot_old_requested(false),
531 _u_dotdot_old_requested(false),
534 _print_execution_on(),
535 _identify_variable_groups_in_nl(getParam<bool>(
"identify_variable_groups_in_nl")),
536 _regard_general_exceptions_as_errors(getParam<bool>(
"regard_general_exceptions_as_errors")),
537 _requires_nonlocal_coupling(false)
539 auto checkCoverageCheckConflict =
540 [
this](
const std::string & coverage_check,
542 const std::vector<SubdomainName> & coverage_blocks) ->
void 546 if (coverage_blocks.size() > 1)
547 if (
std::find(coverage_blocks.begin(), coverage_blocks.end(),
"ANY_BLOCK_ID") !=
548 coverage_blocks.end())
550 "The list of blocks used for ",
552 " cannot contain 'ANY_BLOCK_ID' along with other blocks. ");
555 checkCoverageCheckConflict(
557 checkCoverageCheckConflict(
563 ADReal::do_derivatives =
true;
627 std::string restart_file_base = getParam<FileNameNoExtension>(
"restart_file_base");
634 if (restart_file_base.size())
652 #if !PETSC_RELEASE_LESS_THAN(3, 12, 0) 671 mooseWarning(
"Displaced mesh was requested but the displaced problem does not exist. " 672 "Regular mesh will be returned");
680 auto & vectors = getParam<std::vector<std::vector<TagName>>>(
"extra_tag_vectors");
682 for (
auto & vector : vectors[sys_num])
688 auto & not_zeroed_vectors = getParam<std::vector<std::vector<TagName>>>(
"not_zeroed_tag_vectors");
689 for (
const auto sys_num :
index_range(not_zeroed_vectors))
690 for (
auto & vector : not_zeroed_vectors[sys_num])
701 auto & matrices = getParam<std::vector<std::vector<TagName>>>(
"extra_tag_matrices");
703 for (
auto & matrix : matrices[sys_num])
710 sys->sizeVariableMatrixData();
711 _aux->sizeVariableMatrixData();
717 for (
auto & vector :
getParam<std::vector<TagName>>(
"extra_tag_solutions"))
736 sys->associateVectorToTag(*sys->system().current_local_solution.get(), tag);
737 _aux->associateVectorToTag(*
_aux->system().current_local_solution.get(), tag);
744 sys->needSolutionState(state, iteration_type);
745 _aux->needSolutionState(state, iteration_type);
756 _assembly[i].resize(solver_systems.size());
758 _assembly[i][j] = std::make_unique<Assembly>(*solver_systems[j], i);
764 std::vector<std::shared_ptr<NonlinearSystemBase>> & nls)
766 TIME_SECTION(
"initNullSpaceVectors", 5,
"Initializing Null Space Vectors");
768 unsigned int dimNullSpace =
parameters.
get<
unsigned int>(
"null_space_dimension");
769 unsigned int dimTransposeNullSpace =
770 parameters.
get<
unsigned int>(
"transpose_null_space_dimension");
771 unsigned int dimNearNullSpace =
parameters.
get<
unsigned int>(
"near_null_space_dimension");
772 for (
unsigned int i = 0; i < dimNullSpace; ++i)
774 std::ostringstream oss;
778 for (
auto & nl : nls)
782 for (
unsigned int i = 0; i < dimTransposeNullSpace; ++i)
784 std::ostringstream oss;
788 for (
auto & nl : nls)
792 for (
unsigned int i = 0; i < dimNearNullSpace; ++i)
794 std::ostringstream oss;
798 for (
auto & nl : nls)
813 for (
unsigned int i = 0; i <
n_threads; i++)
829 #if !PETSC_RELEASE_LESS_THAN(3, 12, 0) 834 CHKERRABORT(this->
comm().
get(), ierr);
843 TIME_SECTION(
"setCoordSystem", 5,
"Setting Coordinate System");
858 std::vector<const DofMap *> dof_maps(
es().n_systems());
862 dof_maps[i] = &sys.get_dof_map();
865 std::make_unique<ConstElemRange>(
_mesh.
getMesh().multi_evaluable_elements_begin(dof_maps),
866 _mesh.
getMesh().multi_evaluable_elements_end(dof_maps));
876 std::vector<const DofMap *> dof_maps(
_nl.size());
878 dof_maps[i] = &
_nl[i]->dofMap();
880 std::make_unique<ConstElemRange>(
_mesh.
getMesh().multi_evaluable_elements_begin(dof_maps),
881 _mesh.
getMesh().multi_evaluable_elements_end(dof_maps));
890 TIME_SECTION(
"initialSetup", 2,
"Performing Initial Setup");
895 mooseError(
"Checkpoint recovery and restart and exodus restart are all mutually exclusive.");
898 mooseWarning(
"MOOSE may fail to catch an exception when the \"skip_exception_check\" parameter " 899 "is used. If you receive a terse MPI error during execution, remove this " 900 "parameter and rerun your simulation");
915 _aux->initSolutionState();
928 TIME_SECTION(
"computingMaxDofs", 3,
"Computing Max Dofs Per Element");
932 max_var_n_dofs_per_elem = mvndpe.
max();
937 max_var_n_dofs_per_node = mvndpn.
max();
939 global_max_var_n_dofs_per_elem =
940 std::max(global_max_var_n_dofs_per_elem, max_var_n_dofs_per_elem);
944 TIME_SECTION(
"assignMaxDofs", 5,
"Assigning Maximum Dofs Per Elem");
946 sys.assignMaxVarNDofsPerElem(max_var_n_dofs_per_elem);
949 displaced_problem->solverSys(i).assignMaxVarNDofsPerElem(max_var_n_dofs_per_elem);
951 sys.assignMaxVarNDofsPerNode(max_var_n_dofs_per_node);
953 displaced_problem->solverSys(i).assignMaxVarNDofsPerNode(max_var_n_dofs_per_node);
958 TIME_SECTION(
"resizingVarValues", 5,
"Resizing Variable Values");
962 _phi_zero[tid].resize(global_max_var_n_dofs_per_elem, std::vector<Real>(
getMaxQps(), 0.));
983 props->setRecovering();
985 #ifdef MOOSE_KOKKOS_ENABLED 988 props->setRecovering();
992 TIME_SECTION(
"restore", 3,
"Restoring from backup");
1019 TIME_SECTION(
"copyingFromExodus", 3,
"Copying Variables From Exodus");
1022 sys->copyVars(*reader);
1023 _aux->copyVars(*reader);
1028 mooseError(
"Need Exodus reader to restart variables but the reader is not available\n" 1029 "Use either FileMesh with an Exodus mesh file or FileMeshGenerator with an " 1030 "Exodus mesh file and with use_for_exodus_restart equal to true");
1046 mooseError(
"Stateful neighbor material properties do not work with mesh adaptivity");
1062 "Doing extra refinements when restarting is NOT supported for sub-apps of a MultiApp");
1072 TIME_SECTION(
"convergenceInitialSetup", 5,
"Initializing Convergence objects");
1080 std::set<std::string> depend_objects_aux =
_aux->getDependObjects();
1084 std::vector<UserObject *> userobjs;
1089 std::map<int, std::vector<UserObject *>> group_userobjs;
1090 for (
auto obj : userobjs)
1091 group_userobjs[obj->getParam<
int>(
"execution_order_group")].push_back(obj);
1093 for (
auto & [group, objs] : group_userobjs)
1094 for (
auto obj : objs)
1095 obj->initialSetup();
1107 TIME_SECTION(
"initializingFunctions", 5,
"Initializing Functions");
1117 #ifdef MOOSE_KOKKOS_ENABLED 1123 TIME_SECTION(
"initializingRandomObjects", 5,
"Initializing Random Objects");
1135 TIME_SECTION(
"ICinitialSetup", 5,
"Setting Up Initial Conditions");
1149 TIME_SECTION(
"materialInitialSetup", 3,
"Setting Up Materials");
1170 #ifdef MOOSE_KOKKOS_ENABLED 1175 TIME_SECTION(
"computingInitialStatefulProps", 3,
"Computing Initial Material Values");
1182 #ifdef MOOSE_KOKKOS_ENABLED 1197 props->setRestartInPlace();
1198 props->setRecovering();
1209 #ifdef LIBMESH_ENABLE_AMR 1215 mooseError(
"Cannot perform initial adaptivity during restart on sub-apps of a MultiApp!");
1220 #endif // LIBMESH_ENABLE_AMR 1231 unsigned short ic_state_max = 0;
1233 auto findMax = [&ic_state_max](
const auto & obj_list)
1235 for (
auto ic : obj_list.getActiveObjects())
1236 ic_state_max =
std::max(ic_state_max, ic->getState());
1243 if (ic_state_max > 0)
1247 std::vector<std::unique_ptr<NumericVector<Real>>> state0_sys_buffers(
_solver_systems.size());
1248 std::unique_ptr<NumericVector<Real>> state0_aux_buffer;
1254 state0_aux_buffer =
_aux->solutionState(0).clone();
1275 _aux->solutionState(0) = *state0_aux_buffer;
1276 _aux->solutionState(0).close();
1289 sys->initialSetup();
1292 _aux->initialSetup();
1299 sys->setSolution(*(sys->system().current_local_solution.get()));
1329 const auto & tis = sys->getTimeIntegrators();
1332 TIME_SECTION(
"timeIntegratorInitialSetup", 5,
"Initializing Time Integrator");
1333 for (
auto & ti : tis)
1344 TIME_SECTION(
"initialSetupMultiApps", 2,
"Initializing MultiApps",
false);
1350 TIME_SECTION(
"initialSetupTransfers", 2,
"Initializing Transfers");
1356 for (
const auto & transfer : to_multi_app_objects)
1358 transfer->setCurrentDirection(Transfer::DIRECTION::TO_MULTIAPP);
1359 transfer->initialSetup();
1364 for (
const auto & transfer : from_multi_app_objects)
1366 transfer->setCurrentDirection(Transfer::DIRECTION::FROM_MULTIAPP);
1367 transfer->initialSetup();
1372 for (
const auto & transfer : between_multi_app_objects)
1374 transfer->setCurrentDirection(Transfer::DIRECTION::BETWEEN_MULTIAPP);
1375 transfer->initialSetup();
1381 TIME_SECTION(
"BoundaryRestrictedNodeIntegrityCheck", 5);
1386 Threads::parallel_reduce(bnd_nodes, bnict);
1390 for (
const auto & bnode : bnd_nodes)
1392 const auto boundary_id = bnode->_bnd_id;
1393 const Node *
const node = bnode->_node;
1400 const Elem *
const an_elem =
1407 for (
auto & nl :
_nl)
1409 const auto & nodal_bcs = nl->getNodalBCWarehouse();
1410 if (!nodal_bcs.hasBoundaryObjects(boundary_id, 0))
1413 const auto & bnd_objects = nodal_bcs.getBoundaryObjects(boundary_id, 0);
1414 for (
const auto & bnd_object : bnd_objects)
1417 if (!bnd_object->requiresGeometricSearch() &&
1418 bnd_object->checkVariableBoundaryIntegrity())
1420 std::set<MooseVariableFieldBase *> vars_to_omit = {
1425 *bnd_object, bnd_object->checkAllVariables(*node, vars_to_omit), bnd_name);
1433 TIME_SECTION(
"BoundaryRestrictedElemIntegrityCheck", 5);
1438 Threads::parallel_reduce(bnd_elems, beict);
1447 mooseError(
"failed to converge initial MultiApp");
1480 TIME_SECTION(
"computeMaterials", 2,
"Computing Initial Material Properties");
1484 #ifdef MOOSE_KOKKOS_ENABLED 1489 TIME_SECTION(
"computeMaterials", 2,
"Computing Initial Material Properties");
1500 for (
unsigned int tid = 0; tid <
n_threads; tid++)
1518 TIME_SECTION(
"lineSearchInitialSetup", 5,
"Initializing Line Search");
1540 "\" has the same name as a scalar variable in the system.");
1551 std::unique_ptr<libMesh::MeshRefinement> displaced_mesh_refinement(
nullptr);
1553 displaced_mesh_refinement = std::make_unique<libMesh::MeshRefinement>(*_displaced_mesh);
1569 displaced_mesh_refinement->uniformly_coarsen();
1617 #ifdef MOOSE_KOKKOS_ENABLED 1621 _aux->timestepSetup();
1623 sys->timestepSetup();
1636 std::vector<UserObject *> userobjs;
1638 for (
auto obj : userobjs)
1639 obj->timestepSetup();
1666 TIME_SECTION(
"checkNonlocalCoupling", 5,
"Checking Nonlocal Coupling");
1669 for (
auto & nl :
_nl)
1671 const auto & all_kernels = nl->getKernelWarehouse();
1672 const auto & kernels = all_kernels.getObjects(tid);
1673 for (
const auto & kernel : kernels)
1675 std::shared_ptr<NonlocalKernel> nonlocal_kernel =
1677 if (nonlocal_kernel)
1685 nl->getIntegratedBCWarehouse();
1686 const auto & integrated_bcs = all_integrated_bcs.
getObjects(tid);
1687 for (
const auto & integrated_bc : integrated_bcs)
1689 std::shared_ptr<NonlocalIntegratedBC> nonlocal_integrated_bc =
1691 if (nonlocal_integrated_bc)
1704 std::set<const MooseVariableFEBase *> uo_jacobian_moose_vars;
1706 std::vector<ShapeElementUserObject *> objs;
1710 .condition<AttribThread>(tid)
1713 for (
const auto & uo : objs)
1716 const auto & mv_deps = uo->jacobianMooseVariables();
1717 uo_jacobian_moose_vars.insert(mv_deps.begin(), mv_deps.end());
1721 std::vector<ShapeSideUserObject *> objs;
1725 .condition<AttribThread>(tid)
1727 for (
const auto & uo : objs)
1730 const auto & mv_deps = uo->jacobianMooseVariables();
1731 uo_jacobian_moose_vars.insert(mv_deps.begin(), mv_deps.end());
1743 for (
unsigned int i = 0; i < moose_vars.size(); ++i)
1745 VariableName var_name = moose_vars[i]->name();
1747 sys->setVariableGlobalDoFs(var_name);
1765 _assembly[tid][i]->prepareJacobianBlock();
1788 for (
auto & nl :
_nl)
1789 nl->prepareFace(tid,
true);
1790 _aux->prepareFace(tid,
false);
1800 const std::vector<dof_id_type> & dof_indices,
1806 _nl[i]->prepare(tid);
1811 _assembly[tid][current_nl_sys_num]->prepareBlock(ivar, jvar, dof_indices);
1816 _assembly[tid][current_nl_sys_num]->prepareBlockNonlocal(
1838 _assembly[tid][i]->setCurrentSubdomainID(did);
1851 _assembly[tid][i]->setCurrentNeighborSubdomainID(did);
1864 _assembly[tid][i]->setCurrentNeighborSubdomainID(did);
2066 std::vector<dof_id_type> & dof_indices,
2067 const std::set<TagID> & tags,
2090 _displaced_problem->addJacobianBlockTags(jacobian, ivar, jvar, dof_map, dof_indices, tags, tid);
2096 jacobian, ivar, jvar, dof_map, dof_indices, jv.
allDofIndices(), tags, tid);
2106 std::vector<dof_id_type> & dof_indices,
2107 std::vector<dof_id_type> & neighbor_dof_indices,
2108 const std::set<TagID> & tags,
2116 neighbor_dof_indices,
2121 jacobian, ivar, jvar, dof_map, dof_indices, neighbor_dof_indices, tags, tid);
2160 TIME_SECTION(
"ghostGhostedBoundaries", 3,
"Ghosting Ghosted Boundaries");
2172 "This function is deprecated and no longer performs any function. Please do not call it."));
2180 unsigned int n_points = points.size();
2197 _zero[tid].resize(max_qpts, 0);
2207 _assembly[tid][i]->reinitAtPhysical(elem, points);
2208 _nl[i]->prepare(tid);
2219 bool have_points = n_points > 0;
2234 sys->reinitElem(elem, tid);
2235 _aux->reinitElem(elem, tid);
2243 const std::vector<Point> & phys_points_in_elem,
2247 "Are you calling this method with a displaced mesh element?");
2251 _assembly[tid][i]->reinitAtPhysical(elem, phys_points_in_elem);
2264 const unsigned int side,
2269 "reinitElemFace with a BoundaryID argument is deprecated because the boundary id was never " 2270 "used. Please call reinitElemFace without the BoundaryID argument instead");
2283 _aux->reinitElemFace(elem, side, tid);
2292 const std::vector<Point> *
const pts,
2293 const std::vector<Real> *
const weights)
2311 _nl[i]->reinitNode(node, tid);
2313 _aux->reinitNode(node, tid);
2325 _nl[i]->reinitNodeFace(node, bnd_id, tid);
2327 _aux->reinitNodeFace(node, bnd_id, tid);
2336 for (
auto & nl :
_nl)
2337 nl->reinitNodes(nodes, tid);
2338 _aux->reinitNodes(nodes, tid);
2347 for (
auto & nl :
_nl)
2348 nl->reinitNodesNeighbor(nodes, tid);
2349 _aux->reinitNodesNeighbor(nodes, tid);
2355 TIME_SECTION(
"reinitScalars", 3,
"Reinitializing Scalar Variables");
2360 for (
auto & nl :
_nl)
2361 nl->reinitScalars(tid, reinit_for_derivative_reordering);
2362 _aux->reinitScalars(tid, reinit_for_derivative_reordering);
2387 _assembly[tid][i]->reinitElemAndNeighbor(elem, side, neighbor, neighbor_side);
2388 _nl[i]->prepareNeighbor(tid);
2392 _aux->prepareNeighbor(tid);
2394 for (
auto & nl :
_nl)
2396 nl->reinitElemFace(elem, side, tid);
2397 nl->reinitNeighborFace(neighbor, neighbor_side, tid);
2399 _aux->reinitElemFace(elem, side, tid);
2400 _aux->reinitNeighborFace(neighbor, neighbor_side, tid);
2409 const auto & displaced_ref_pts =
_assembly[tid][0]->qRuleNeighbor()->get_points();
2429 auto & neighbor =
_assembly[tid][0]->neighbor();
2430 auto & neighbor_side =
_assembly[tid][0]->neighborSide();
2432 if (lower_d_elem_neighbor &&
2435 auto qps =
_assembly[tid][0]->qPointsFaceNeighbor().stdVector();
2436 std::vector<Point> reference_points;
2438 lower_d_elem_neighbor->
dim(), lower_d_elem_neighbor, qps, reference_points);
2450 unsigned int neighbor_side,
2451 const std::vector<Point> & physical_points,
2455 "Are you calling this method with a displaced mesh element?");
2460 _assembly[tid][i]->reinitNeighborAtPhysical(neighbor, neighbor_side, physical_points);
2463 _nl[i]->prepareNeighbor(tid);
2465 _aux->prepareNeighbor(tid);
2471 for (
auto & nl :
_nl)
2472 nl->reinitNeighborFace(neighbor, neighbor_side, tid);
2473 _aux->reinitNeighborFace(neighbor, neighbor_side, tid);
2478 const std::vector<Point> & physical_points,
2482 "Are you calling this method with a displaced mesh element?");
2487 _assembly[tid][i]->reinitNeighborAtPhysical(neighbor, physical_points);
2490 _nl[i]->prepareNeighbor(tid);
2492 _aux->prepareNeighbor(tid);
2498 for (
auto & nl :
_nl)
2499 nl->reinitNeighbor(neighbor, tid);
2500 _aux->reinitNeighbor(neighbor, tid);
2511 std::set<const Elem *> displaced_elements;
2516 for (
const auto & elem : displaced_elements)
2539 for (
auto & nl :
_nl)
2540 nl->subdomainSetup(subdomain, tid);
2554 const std::string & name,
2557 parallel_object_only();
2574 mooseError(
"Unrecognized function functor type");
2580 const std::string & name,
2583 parallel_object_only();
2595 const std::string class_name =
"DefaultNonlinearConvergence";
2599 params.
set<
bool>(
"added_as_default") =
true;
2607 const std::string class_name =
"DefaultMultiAppFixedPointConvergence";
2611 params.
set<
bool>(
"added_as_default") =
true;
2618 const std::string class_name =
"DefaultSteadyStateConvergence";
2622 params.
set<
bool>(
"added_as_default") =
true;
2642 std::istringstream ss(
name);
2646 if (ss >> real_value && ss.eof())
2649 params.
set<
Real>(
"value") = real_value;
2650 addFunction(
"ConstantFunction", ss.str(), params);
2655 std::string
vars =
"x,y,z,t,NaN,pi,e";
2660 params.
set<std::string>(
"expression") =
name;
2688 mooseError(
"The Convergence object '",
name,
"' does not exist.");
2693 const std::vector<std::shared_ptr<Convergence>> &
2701 const std::string & name,
2704 parallel_object_only();
2719 mooseError(
"No MeshDivision object named ",
name,
" of appropriate type");
2732 mooseDeprecated(
"FEProblemBase::getNonlinearSystem() is deprecated, please use " 2733 "FEProblemBase::getNonlinearSystemBase() \n");
2735 mooseAssert(sys_num <
_nl.size(),
"System number greater than the number of nonlinear systems");
2746 const std::string & name,
2756 std::vector<Distribution *> objs;
2760 .condition<AttribName>(
name)
2763 mooseError(
"Unable to find Distribution with name '" +
name +
"'");
2769 const std::string & name,
2773 for (
auto & sampler : samplers)
2780 std::vector<Sampler *> objs;
2784 .condition<AttribThread>(tid)
2789 "Unable to find Sampler with name '" +
name +
2790 "', if you are attempting to access this object in the constructor of another object then " 2791 "the object being retrieved must occur prior to the caller within the input file.");
2799 const std::set<SubdomainID> *
const active_subdomains)
2801 std::set<SubdomainID> subdomainIDs;
2802 if (active_subdomains->size() == 0)
2805 subdomainIDs.insert(subdomains.begin(), subdomains.end());
2808 subdomainIDs.insert(active_subdomains->begin(), active_subdomains->end());
2814 std::string error_prefix =
"";
2817 curr_sys_ptr =
_aux.get();
2818 other_sys_ptr = sys.get();
2819 error_prefix =
"aux";
2823 mooseError(
"Cannot have an auxiliary variable and a solver variable with the same name: ",
2834 const auto stringifyType = [](
FEType t)
2837 mooseError(
"Mismatching types are specified for ",
2839 "variable with name '",
2842 stringifyType(var.
type()),
2844 stringifyType(
type),
2852 std::set<SubdomainID> varSubdomainIDs;
2853 if (varActiveSubdomains.size() == 0)
2856 varSubdomainIDs.insert(subdomains.begin(), subdomains.end());
2859 varSubdomainIDs.insert(varActiveSubdomains.begin(), varActiveSubdomains.end());
2863 const auto isSubset = std::includes(varSubdomainIDs.begin(),
2864 varSubdomainIDs.end(),
2865 subdomainIDs.begin(),
2866 subdomainIDs.end());
2871 const auto stringifySubdomains = [
this](std::set<SubdomainID> subdomainIDs)
2873 std::stringstream s;
2874 for (
auto const i : subdomainIDs)
2882 if (subdomainName.empty())
2885 s << subdomainName <<
" (" << i <<
")";
2890 const std::string msg =
"Mismatching block-restrictions are specified for " +
2891 error_prefix +
"variable with name '" + var_name +
"': {" +
2892 stringifySubdomains(varSubdomainIDs) +
"} and {" +
2893 stringifySubdomains(subdomainIDs) +
"}";
2908 const std::string & var_name,
2911 parallel_object_only();
2913 const auto order = Utility::string_to_enum<Order>(params.
get<
MooseEnum>(
"order"));
2914 const auto family = Utility::string_to_enum<FEFamily>(params.
get<
MooseEnum>(
"family"));
2915 const auto fe_type =
FEType(order, family);
2917 const auto active_subdomains_vector =
2919 const std::set<SubdomainID> active_subdomains(active_subdomains_vector.begin(),
2920 active_subdomains_vector.end());
2927 SolverSystemName sys_name = params.
get<SolverSystemName>(
"solver_sys");
2929 const auto solver_system_number =
solverSysNum(sys_name);
2930 logAdd(
"Variable", var_name, var_type, params);
2931 _solver_systems[solver_system_number]->addVariable(var_type, var_name, params);
2941 std::pair<bool, unsigned int>
2943 const bool error_if_not_found)
const 2950 "If the variable is in our FEProblem solver system map, then it must be in the " 2951 "solver system we expect");
2952 else if (error_if_not_found)
2954 if (
_aux->hasVariable(var_name) ||
_aux->hasScalarVariable(var_name))
2957 " found. Did you specify an auxiliary variable when you meant to specify a " 2958 "solver variable?");
2962 "'. It does not exist in the solver system(s) or auxiliary system");
2970 const std::string & name,
2972 const unsigned int nl_sys_num,
2973 const std::string & base_name,
2974 bool & reinit_displaced)
2980 reinit_displaced =
true;
3003 const std::string & name,
3005 const std::string & base_name)
3012 if (!
parameters.
get<std::vector<BoundaryName>>(
"boundary").empty())
3039 const std::string & name,
3042 parallel_object_only();
3045 mooseError(
"You are trying to add a Kernel to a linear variable/system, which is not " 3046 "supported at the moment!");
3055 const std::string & name,
3058 parallel_object_only();
3061 mooseError(
"You are trying to add a HDGKernel to a linear variable/system, which is not " 3062 "supported at the moment!");
3071 const std::string & name,
3074 parallel_object_only();
3104 const std::string & name,
3107 parallel_object_only();
3111 mooseError(
"You are trying to add a ScalarKernel to a linear variable/system, which is not " 3112 "supported at the moment!");
3141 const std::string & name,
3144 parallel_object_only();
3149 "You are trying to add a BoundaryCondition to a linear variable/system, which is not " 3150 "supported at the moment!");
3159 const std::string & name,
3162 parallel_object_only();
3166 auto determine_var_param_name = [&
parameters,
this]()
3175 if (!has_secondary_var && !has_primary_var)
3177 "Either a 'secondary_variable' or 'primary_variable' parameter must be supplied for '",
3180 return has_secondary_var ?
"secondary_variable" :
"primary_variable";
3184 const auto nl_sys_num =
3187 mooseError(
"You are trying to add a Constraint to a linear variable/system, which is not " 3188 "supported at the moment!");
3212 const std::string & var_name,
3215 parallel_object_only();
3217 const auto order = Utility::string_to_enum<Order>(params.
get<
MooseEnum>(
"order"));
3218 const auto family = Utility::string_to_enum<FEFamily>(params.
get<
MooseEnum>(
"family"));
3219 const auto fe_type =
FEType(order, family);
3221 const auto active_subdomains_vector =
3223 const std::set<SubdomainID> active_subdomains(active_subdomains_vector.begin(),
3224 active_subdomains_vector.end());
3232 logAdd(
"AuxVariable", var_name, var_type, params);
3233 _aux->addVariable(var_type, var_name, params);
3244 const std::set<SubdomainID> *
const active_subdomains)
3246 parallel_object_only();
3248 mooseDeprecated(
"Please use the addAuxVariable(var_type, var_name, params) API instead");
3253 std::string var_type;
3255 var_type =
"MooseVariableConstMonomial";
3257 var_type =
"MooseVariableScalar";
3259 var_type =
"VectorMooseVariable";
3261 var_type =
"MooseVariable";
3269 if (active_subdomains)
3273 logAdd(
"AuxVariable", var_name, var_type, params);
3274 _aux->addVariable(var_type, var_name, params);
3284 unsigned int components,
3285 const std::set<SubdomainID> *
const active_subdomains)
3287 parallel_object_only();
3289 mooseDeprecated(
"Please use the addAuxVariable(var_type, var_name, params) API instead");
3299 params.
set<
unsigned int>(
"components") = components;
3301 if (active_subdomains)
3305 logAdd(
"Variable", var_name,
"ArrayMooseVariable", params);
3306 _aux->addVariable(
"ArrayMooseVariable", var_name, params);
3317 const std::set<SubdomainID> *
const active_subdomains)
3319 parallel_object_only();
3321 mooseDeprecated(
"Please use the addAuxVariable(var_type, var_name, params) API instead");
3336 params.
set<std::vector<Real>>(
"scaling") = {1};
3337 if (active_subdomains)
3341 logAdd(
"ScalarVariable", var_name,
"MooseVariableScalar", params);
3342 _aux->addVariable(
"MooseVariableScalar", var_name, params);
3349 const std::string & name,
3352 parallel_object_only();
3361 const std::string & name,
3364 parallel_object_only();
3393 const std::string & name,
3396 parallel_object_only();
3400 mooseError(
"You are trying to add a DiracKernel to a linear variable/system, which is not " 3401 "supported at the moment!");
3433 const std::string & name,
3436 parallel_object_only();
3440 mooseError(
"You are trying to add a DGKernel to a linear variable/system, which is not " 3441 "supported at the moment!");
3473 const std::string & name,
3487 const std::string & name,
3495 const std::string & name,
3500 addObject<FVInterfaceKernel>(
3506 const std::string & name,
3514 const std::string & name,
3524 const std::string & name,
3527 parallel_object_only();
3531 mooseError(
"You are trying to add a InterfaceKernel to a linear variable/system, which is not " 3532 "supported at the moment!");
3564 const std::string & name,
3565 const VariableName & var_name)
3569 std::string restart_method =
"";
3572 "a checkpoint restart, by IC object '" + ic_name +
"' for variable '" +
name +
"'";
3578 restarted_vars.insert(restarted_vars.end(), nodal_vars.begin(), nodal_vars.end());
3579 restarted_vars.insert(restarted_vars.end(), global_vars.begin(), global_vars.end());
3581 if (
std::find(restarted_vars.begin(), restarted_vars.end(), var_name) != restarted_vars.end())
3582 restart_method =
"an Exodus restart, by IC object '" + ic_name +
"' for variable '" +
name +
3583 "' that is also being restarted";
3585 if (!restart_method.empty())
3587 "Initial conditions have been specified during ",
3589 ".\nThis is only allowed if you specify 'allow_initial_conditions_with_restart' to " 3590 "the [Problem], as initial conditions can override restarted fields");
3596 const std::string & name,
3599 parallel_object_only();
3603 const std::string & var_name =
parameters.
get<VariableName>(
"variable");
3618 std::shared_ptr<InitialConditionBase> ic;
3619 if (dynamic_cast<MooseVariable *>(&var))
3621 else if (dynamic_cast<VectorMooseVariable *>(&var))
3623 else if (dynamic_cast<ArrayMooseVariable *>(&var))
3625 else if (dynamic_cast<MooseVariableFVReal *>(&var))
3627 else if (dynamic_cast<MooseLinearVariableFVReal *>(&var))
3630 mooseError(
"Your FE variable in initial condition ",
3632 " must be either of scalar or vector type");
3643 std::shared_ptr<ScalarInitialCondition> ic =
3651 "Variable '", var_name,
"' requested in initial condition '",
name,
"' does not exist.");
3656 const std::string & name,
3659 parallel_object_only();
3663 const std::string & var_name =
parameters.
get<VariableName>(
"variable");
3678 std::shared_ptr<FVInitialConditionBase> ic;
3683 "Your variable for an FVInitialCondition needs to be an a finite volume variable!");
3690 "' requested in finite volume initial condition '",
3692 "' does not exist.");
3698 TIME_SECTION(
"projectSolution", 2,
"Projecting Initial Solutions")
3704 Threads::parallel_reduce(elem_range, cic);
3712 Threads::parallel_reduce(elem_info_range, cfvic);
3716 for (
auto & nl :
_nl)
3717 nl->solution().close();
3718 _aux->solution().close();
3723 Threads::parallel_reduce(bnd_nodes, cbic);
3725 for (
auto & nl :
_nl)
3726 nl->solution().close();
3727 _aux->solution().close();
3735 for (
const auto & ic : ics)
3743 const unsigned int n_scalar_dofs = var.
dofIndices().size();
3744 for (
unsigned int i = 0; i < n_scalar_dofs; i++)
3746 const auto global_index = var.
dofIndices()[i];
3755 sys->solution().close();
3756 sys->solution().localize(*sys->system().current_local_solution, sys->dofMap().get_send_list());
3759 _aux->solution().close();
3760 _aux->solution().localize(*
_aux->sys().current_local_solution,
_aux->dofMap().get_send_list());
3767 const std::optional<std::set<VariableName>> & target_vars)
3772 Threads::parallel_reduce(elem_range, cic);
3777 Threads::parallel_reduce(elem_range, cic);
3781 for (
auto & nl :
_nl)
3782 nl->solution().close();
3783 _aux->solution().close();
3788 Threads::parallel_reduce(bnd_nodes, cbic);
3793 Threads::parallel_reduce(bnd_nodes, cbic);
3796 for (
auto & nl :
_nl)
3797 nl->solution().close();
3798 _aux->solution().close();
3806 for (
const auto & ic : ics)
3810 if (target_vars && !target_vars->count(var.
name()))
3818 const unsigned int n_scalar_dofs = var.
dofIndices().size();
3819 for (
unsigned int i = 0; i < n_scalar_dofs; i++)
3821 const auto global_index = var.
dofIndices()[i];
3828 for (
auto & nl :
_nl)
3830 nl->solution().close();
3831 nl->solution().localize(*nl->system().current_local_solution, nl->dofMap().get_send_list());
3834 _aux->solution().close();
3835 _aux->solution().localize(*
_aux->sys().current_local_solution,
_aux->dofMap().get_send_list());
3840 Number (*func)(
const Point &,
3842 const std::string &,
3843 const std::string &),
3846 const std::string &,
3847 const std::string &),
3849 const VariableName & target_var)
3851 mooseAssert(!Threads::in_threads,
3852 "We're performing a projection based on data from just the thread 0 variable, so any " 3853 "modifications to the variable solution must have been thread joined already");
3856 const auto var_num = var.number();
3867 DofMap & dof_map = sys.dofMap();
3868 std::set<dof_id_type> dof_indices;
3869 std::vector<dof_id_type> elem_dof_indices;
3871 for (
const auto & elem : elem_range)
3873 dof_map.
dof_indices(elem, elem_dof_indices, var_num);
3874 dof_indices.insert(elem_dof_indices.begin(), elem_dof_indices.end());
3876 std::vector<dof_id_type> dof_indices_v(dof_indices.begin(), dof_indices.end());
3879 std::vector<Real> dof_vals;
3880 temp_vec->get(dof_indices_v, dof_vals);
3881 mooseAssert(sys.solution().closed(),
3882 "The solution should be closed before mapping our projection");
3883 sys.solution().insert(dof_vals, dof_indices_v);
3884 sys.solution().close();
3888 std::shared_ptr<MaterialBase>
3897 name +=
"_neighbor";
3910 "), but its compute flag is set to true. This indicates that MOOSE is " 3911 "computing this property which may not be desired and produce un-expected " 3940 mooseError(
"FEProblemBase::getMaterialData(): Invalid MaterialDataType ",
type);
3943 const std::set<const MooseObject *> &
3958 mooseError(
"FEProblemBase::getMaterialPropertyStorageConsumers(): Invalid MaterialDataType ",
3967 "ignore_zeros_in_jacobian",
3968 "We likely cannot preserve the sparsity pattern if ignoring zeros in the Jacobian, which " 3969 "leads to removing those entries from the Jacobian sparsity pattern");
3982 const std::string & name,
3985 parallel_object_only();
3987 auto add_functor_materials = [&](
const auto &
parameters,
const auto &
name)
3992 std::shared_ptr<MaterialBase> material =
4006 add_functor_materials(disp_params,
name +
"_displaced");
4012 const std::string & name,
4020 const std::string & name,
4028 const std::string & mat_name,
4029 const std::string & name,
4032 parallel_object_only();
4057 std::shared_ptr<MaterialBase> material =
4060 bool discrete = !material->getParam<
bool>(
"compute");
4064 if (material->boundaryRestricted() ||
dynamic_cast<FunctorMaterial *
>(material.get()))
4070 for (
auto && warehouse : warehouses)
4071 warehouse->addObject(material, tid);
4083 std::string object_name;
4092 object_name =
name +
"_face";
4093 std::shared_ptr<MaterialBase> face_material =
4099 current_parameters.set<
bool>(
"_neighbor") =
true;
4100 object_name =
name +
"_neighbor";
4101 std::shared_ptr<MaterialBase> neighbor_material =
4110 for (
auto && warehouse : warehouses)
4111 warehouse->addObjects(material, neighbor_material, face_material, tid);
4116 const auto param_names =
4121 for (
const auto & p_name : param_names)
4124 p_name.parameter());
4126 p_name.parameter());
4128 p_name.parameter());
4130 primary_name, face_name,
false);
4132 primary_name, neighbor_name,
false);
4143 std::set<MooseVariableFEBase *> needed_moose_vars;
4144 std::unordered_set<unsigned int> needed_mat_props;
4153 for (
const auto id : ids)
4160 needed_moose_vars.insert(current_active_elemental_moose_variables.begin(),
4161 current_active_elemental_moose_variables.end());
4163 needed_mat_props.insert(consumer_needed_mat_props.begin(), consumer_needed_mat_props.end());
4174 auto && elem =
_assembly[tid][0]->elem();
4175 unsigned int n_points =
_assembly[tid][0]->qRule()->n_points();
4178 material_data.
resize(n_points);
4182 material_data.swap(*elem);
4195 const bool swap_stateful,
4196 const std::deque<MaterialBase *> *
const reinit_mats)
4202 auto && elem =
_assembly[tid][0]->elem();
4203 unsigned int side =
_assembly[tid][0]->side();
4204 unsigned int n_points =
_assembly[tid][0]->qRuleFace()->n_points();
4207 bnd_material_data.
resize(n_points);
4209 if (swap_stateful && !bnd_material_data.isSwapped())
4210 bnd_material_data.swap(*elem, side);
4213 bnd_material_data.reset(
4217 bnd_material_data.reinit(*reinit_mats);
4219 bnd_material_data.reinit(
4228 const bool swap_stateful,
4229 const std::deque<MaterialBase *> *
const reinit_mats)
4235 const auto *
const elem =
_assembly[tid][0]->elem();
4236 unsigned int side =
_assembly[tid][0]->side();
4237 unsigned int n_points =
_assembly[tid][0]->qRuleFace()->n_points();
4240 bnd_material_data.
resize(n_points);
4242 if (swap_stateful && !bnd_material_data.isSwapped())
4243 bnd_material_data.swap(*elem, side);
4246 bnd_material_data.reset(
4250 bnd_material_data.reinit(*reinit_mats);
4252 bnd_material_data.reinit(
4262 const bool swap_stateful,
4263 const std::deque<MaterialBase *> *
const reinit_mats)
4277 const bool swap_stateful,
4278 const std::deque<MaterialBase *> *
const reinit_mats)
4288 mooseAssert(neighbor,
"neighbor should be non-null");
4290 "The provided blk_id " << blk_id <<
" and neighbor subdomain ID " 4293 unsigned int n_points =
_assembly[tid][0]->qRuleNeighbor()->n_points();
4296 neighbor_material_data.
resize(n_points);
4300 neighbor_material_data.swap(*neighbor, neighbor_side);
4303 neighbor_material_data.reset(
4307 neighbor_material_data.reinit(*reinit_mats);
4309 neighbor_material_data.reinit(
4317 const bool swap_stateful,
4318 const std::deque<MaterialBase *> *
const reinit_mats)
4322 auto && elem =
_assembly[tid][0]->elem();
4323 unsigned int side =
_assembly[tid][0]->side();
4324 unsigned int n_points =
_assembly[tid][0]->qRuleFace()->n_points();
4327 bnd_material_data.
resize(n_points);
4329 if (swap_stateful && !bnd_material_data.isSwapped())
4330 bnd_material_data.swap(*elem, side);
4336 bnd_material_data.reinit(*reinit_mats);
4350 unsigned int side =
_assembly[tid][0]->side();
4351 unsigned int n_points =
_assembly[tid][0]->qRuleFace()->n_points();
4354 bnd_material_data.
resize(n_points);
4356 if (swap_stateful && !bnd_material_data.isSwapped())
4357 bnd_material_data.swap(*elem, side);
4367 auto && elem =
_assembly[tid][0]->elem();
4374 auto && elem =
_assembly[tid][0]->elem();
4375 unsigned int side =
_assembly[tid][0]->side();
4384 unsigned int neighbor_side =
4398 neighbor_side =
_assembly[tid][0]->side();
4399 mooseAssert(neighbor,
"We should have an appropriate value for elem coming from Assembly");
4410 const std::string & name,
4411 const std::string & type,
4415 _console <<
"[DBG] Adding " << system <<
" '" <<
name <<
"' of type " <<
type << std::endl;
4422 const std::string & object_name,
4423 const std::string & var_param_name)
4429 unsigned int sys_num = 0;
4438 const auto var_sys_num = sys_num;
4441 mooseError(
"We dont support setting 'variable' to a variable that is not set to the same " 4442 "system as the 'solver_sys' parameter");
4449 if (sys_num ==
_aux->number())
4465 if (sys_num ==
_aux->number())
4474 const std::string & name,
4481 " already exists. You may not add a Postprocessor by the same name.");
4488 const std::string & name,
4495 " already exists. You may not add a VectorPostprocessor by the same name.");
4502 const std::string & name,
4509 " already exists. You may not add a Reporter by the same name.");
4514 std::vector<std::shared_ptr<UserObject>>
4516 const std::string & name,
4519 parallel_object_only();
4521 std::vector<std::shared_ptr<UserObject>> uos;
4529 std::shared_ptr<UserObject> user_object =
4532 uos.push_back(user_object);
4535 user_object->setPrimaryThreadCopy(uos[0].
get());
4564 if (euo || nuo || duo)
4566 if (suo || duo || isuo || iuo)
4568 if (iuo || duo || isuo)
4573 if ((guo && !tguo) || muo)
4582 const decltype(uos)::size_type uo_index = uos.front()->needThreadedCopy() ? tid : 0;
4597 std::vector<UserObject *> objs;
4601 .condition<AttribThread>(tid)
4605 mooseError(
"Unable to find user object with name '" +
name +
"'");
4606 mooseAssert(objs.size() == 1,
"Should only find one UO");
4613 std::vector<Positions *> objs;
4617 .condition<AttribName>(
name)
4620 mooseError(
"Unable to find Positions object with name '" +
name +
"'");
4621 mooseAssert(objs.size() == 1,
"Should only find one Positions");
4628 std::vector<UserObject *> objs;
4632 .condition<AttribThread>(0)
4635 return !objs.empty();
4646 std::size_t t_index)
const 4655 std::size_t t_index)
4664 mooseDeprecated(
"FEProblemBase::hasPostprocssor is being removed; use " 4665 "hasPostprocessorValueByName instead.");
4671 const std::string & vector_name,
4672 std::size_t t_index)
const 4680 const std::string & vector_name,
4682 std::size_t t_index)
4692 return getUserObject<VectorPostprocessor>(object_name, tid);
4700 const auto & objects = it.second.getActiveObjects();
4701 for (
const auto & obj : objects)
4702 obj->parentOutputPositionChanged();
4719 TIME_SECTION(
"computeIndicators", 1,
"Computing Indicators");
4723 const auto old_do_derivatives = ADReal::do_derivatives;
4724 ADReal::do_derivatives =
false;
4726 std::vector<std::string>
fields;
4730 for (
const auto & indicator : indicators)
4731 fields.push_back(indicator->name());
4735 for (
const auto & internal_indicator : internal_indicators)
4736 fields.push_back(internal_indicator->name());
4743 _aux->solution().close();
4748 _aux->solution().close();
4751 ADReal::do_derivatives = old_do_derivatives;
4760 TIME_SECTION(
"computeMarkers", 1,
"Computing Markers");
4762 std::vector<std::string>
fields;
4766 for (
const auto & marker : markers)
4767 fields.push_back(marker->name());
4776 for (
const auto & marker : markers)
4777 marker->markerSetup();
4783 _aux->solution().close();
4820 #ifdef MOOSE_KOKKOS_ENABLED 4824 _aux->customSetup(exec_type);
4825 for (
auto & nl :
_nl)
4826 nl->customSetup(exec_type);
4838 std::vector<UserObject *> userobjs;
4840 for (
auto obj : userobjs)
4841 obj->customSetup(exec_type);
4893 std::unique_ptr<NumericVector<Number>> x =
_aux->currentSolution()->clone();
4901 const Real check_tol = 1e-8;
4903 const Real xnorm = x->l2_norm();
4904 *x -= *
_aux->currentSolution();
4905 if (x->l2_norm() > check_tol * xnorm)
4907 const auto & sys =
_aux->system();
4908 const unsigned int n_vars = sys.n_vars();
4909 std::multimap<Real, std::string, std::greater<Real>> ordered_map;
4913 ordered_map.emplace(vnorm, sys.variable_name(i));
4916 std::ostringstream oss;
4917 for (
const auto & [error_norm, var_name] : ordered_map)
4918 oss <<
" {" << var_name <<
", " << error_norm <<
"},\n";
4920 mooseError(
"Aux kernels, user objects appear to have states for aux variables on ",
4922 ".\nVariable error norms in descending order:\n",
4927 if (pp_values.
size() != new_pp_values.
size())
4928 mooseError(
"Second execution for uo/aux state check should not change the number of " 4929 "real reporter values");
4932 pp_values -= new_pp_values;
4933 if (pp_values.
l2_norm() > check_tol * ppnorm)
4936 std::multimap<Real, std::string, std::greater<Real>> ordered_map;
4938 ordered_map.emplace(
std::abs(pp_values(i)), pp_names[i]);
4940 std::ostringstream oss;
4941 for (
const auto & [error_norm, pp_name] : ordered_map)
4942 oss <<
" {" << pp_name <<
", " << error_norm <<
"},\n";
4944 mooseError(
"Aux kernels, user objects appear to have states for real reporter values on ",
4946 ".\nErrors of real reporter values in descending order:\n",
4956 std::vector<UserObject *> objs;
4957 query.queryInto(objs);
4962 for (
auto obj : objs)
4963 if (obj->primaryThreadCopy())
4964 obj->primaryThreadCopy()->threadJoin(*obj);
4970 for (
auto obj : objs)
4972 if (isgen && dynamic_cast<ThreadedGeneralUserObject *>(obj))
4978 _console <<
"[DBG] Initializing, executing & finalizing general UO '" << obj->name()
5003 auto reporter =
dynamic_cast<Reporter *
>(obj);
5012 const std::string & name)
5019 .condition<AttribExecOns>(
type)
5040 TIME_SECTION(
"computeUserObjects", 1,
"Computing User Objects");
5051 std::vector<UserObject *> uos;
5053 std::set<int> execution_groups;
5054 for (
const auto & uo : uos)
5055 execution_groups.insert(uo->getParam<
int>(
"execution_order_group"));
5058 for (
const auto execution_group : execution_groups)
5062 std::vector<GeneralUserObject *> genobjs;
5065 std::vector<UserObject *> userobjs;
5071 .queryInto(userobjs);
5073 std::vector<UserObject *> tgobjs;
5078 std::vector<UserObject *> nodal;
5081 std::vector<MortarUserObject *> mortar;
5084 if (userobjs.empty() && genobjs.empty() && tgobjs.empty() && nodal.empty() && mortar.empty())
5093 for (
auto obj : userobjs)
5094 obj->residualSetup();
5095 for (
auto obj : nodal)
5096 obj->residualSetup();
5097 for (
auto obj : mortar)
5098 obj->residualSetup();
5099 for (
auto obj : tgobjs)
5100 obj->residualSetup();
5101 for (
auto obj : genobjs)
5102 obj->residualSetup();
5106 for (
auto obj : userobjs)
5107 obj->jacobianSetup();
5108 for (
auto obj : nodal)
5109 obj->jacobianSetup();
5110 for (
auto obj : mortar)
5111 obj->jacobianSetup();
5112 for (
auto obj : tgobjs)
5113 obj->jacobianSetup();
5114 for (
auto obj : genobjs)
5115 obj->jacobianSetup();
5118 for (
auto obj : userobjs)
5122 if (!userobjs.empty())
5141 for (
const auto & uo : userobjs)
5142 if (
auto euo = dynamic_cast<const ElementUserObject *>(uo);
5143 euo && euo->hasWritableCoupledVariables())
5145 _aux->solution().close();
5146 _aux->system().update();
5154 for (
auto obj : nodal)
5164 for (
const auto & uo : nodal)
5165 if (
auto nuo = dynamic_cast<const NodalUserObject *>(uo);
5166 nuo && nuo->hasWritableCoupledVariables())
5168 _aux->solution().close();
5169 _aux->system().update();
5175 for (
auto obj : mortar)
5177 if (!mortar.empty())
5179 auto create_and_run_mortar_functors = [
this,
type, &mortar](
const bool displaced)
5183 for (
const auto & [primary_secondary_boundary_pair, mortar_generation_ptr] :
5186 auto mortar_uos_to_execute =
5188 primary_secondary_boundary_pair.second,
5192 auto *
const subproblem = displaced
5194 : static_cast<SubProblem *>(
this);
5196 *mortar_generation_ptr,
5200 subproblem->assembly(0, 0));
5206 create_and_run_mortar_functors(
false);
5208 create_and_run_mortar_functors(
true);
5210 for (
auto obj : mortar)
5215 for (
auto obj : tgobjs)
5217 std::vector<GeneralUserObject *> tguos_zero;
5221 .queryInto(tguos_zero);
5222 for (
auto obj : tguos_zero)
5224 std::vector<GeneralUserObject *> tguos;
5225 auto q =
query.clone()
5251 TIME_SECTION(
"executeControls", 1,
"Executing Controls");
5257 for (
const auto & it : controls_wh.getActiveObjects())
5262 std::vector<std::string> & dependent_controls = it->getDependencies();
5263 for (
const auto & depend_name : dependent_controls)
5265 if (controls_wh.hasActiveObject(depend_name))
5267 auto dep_control = controls_wh.getActiveObject(depend_name);
5268 resolver.
addEdge(dep_control, it);
5273 "\" was not created, did you make a " 5274 "spelling mistake or forget to include it " 5275 "in your input file?");
5281 if (!ordered_controls.empty())
5285 for (
const auto & control : ordered_controls)
5298 std::vector<Sampler *> objects;
5302 .condition<AttribThread>(tid)
5304 .queryInto(objects);
5306 if (!objects.empty())
5308 TIME_SECTION(
"executeSamplers", 1,
"Executing Samplers");
5309 FEProblemBase::objectSetupHelper<Sampler>(objects, exec_type);
5310 FEProblemBase::objectExecuteHelper<Sampler>(objects);
5318 TIME_SECTION(
"updateActiveObjects", 5,
"Updating Active Objects");
5322 for (
auto & nl :
_nl)
5323 nl->updateActive(tid);
5324 _aux->updateActive(tid);
5341 #ifdef MOOSE_KOKKOS_ENABLED 5355 TIME_SECTION(
"reinitBecauseOfGhostingOrNewGeomObjects",
5357 "Reinitializing Because of Geometric Search Objects");
5366 (
_mortar_data->hasDisplacedObjects() && mortar_changed)));
5381 const std::string & name,
5384 parallel_object_only();
5386 const auto nl_sys_num =
5392 mooseError(
"You are trying to add a DGKernel to a linear variable/system, which is not " 5393 "supported at the moment!");
5406 for (
auto & nl :
_nl)
5412 const std::string & name,
5415 parallel_object_only();
5441 std::shared_ptr<Indicator> indicator =
5444 std::shared_ptr<InternalSideIndicatorBase> isi =
5455 const std::string & name,
5458 parallel_object_only();
5492 const std::string & name,
5495 parallel_object_only();
5523 multi_app->setupPositions();
5528 std::shared_ptr<TransientMultiApp> trans_multi_app =
5530 if (trans_multi_app)
5546 std::shared_ptr<MultiApp>
5557 std::string string_direction;
5559 string_direction =
" To ";
5560 else if (from_multiapp)
5561 string_direction =
" From ";
5563 string_direction =
" Between ";
5571 TIME_SECTION(
"execMultiAppTransfers", 1,
"Executing Transfers");
5578 <<
"MultiApps" << COLOR_DEFAULT <<
":" << std::endl;
5581 {
"Name",
"Type",
"From",
"To"});
5584 for (
const auto & transfer : transfers)
5588 table.addRow(multiapp_transfer->name(),
5589 multiapp_transfer->type(),
5590 multiapp_transfer->getFromName(),
5591 multiapp_transfer->getToName());
5598 for (
const auto & transfer : transfers)
5601 transfer->execute();
5608 << COLOR_DEFAULT << std::endl;
5615 << COLOR_DEFAULT << std::endl;
5619 std::vector<std::shared_ptr<Transfer>>
5630 std::vector<std::shared_ptr<Transfer>>
5656 const std::vector<MooseSharedPointer<MultiApp>> & multi_apps =
5660 for (
const auto & multi_app : multi_apps)
5661 multi_app->preTransfer(
_dt,
_time);
5670 if (multi_apps.size())
5672 TIME_SECTION(
"execMultiApps", 1,
"Executing MultiApps",
false);
5676 << COLOR_DEFAULT << std::endl;
5678 bool success =
true;
5680 for (
const auto & multi_app : multi_apps)
5682 success = multi_app->solveStep(
_dt,
_time, auto_advance);
5697 << COLOR_DEFAULT << std::endl;
5712 for (
const auto & multi_app : multi_apps)
5713 multi_app->finalize();
5721 for (
const auto & multi_app : multi_apps)
5722 multi_app->postExecute();
5730 if (multi_apps.size())
5731 for (
const auto & multi_app : multi_apps)
5732 multi_app->incrementTStep(
_time);
5740 if (multi_apps.size())
5743 _console << COLOR_CYAN <<
"\nAdvancing MultiApps on " <<
type.name() << COLOR_DEFAULT
5746 for (
const auto & multi_app : multi_apps)
5747 multi_app->finishStep(recurse_through_multiapp_levels);
5752 _console << COLOR_CYAN <<
"Finished Advancing MultiApps on " <<
type.name() <<
"\n" 5753 << COLOR_DEFAULT << std::endl;
5762 if (multi_apps.size())
5764 TIME_SECTION(
"backupMultiApps", 5,
"Backing Up MultiApp");
5767 _console << COLOR_CYAN <<
"\nBacking Up MultiApps on " <<
type.name() << COLOR_DEFAULT
5770 for (
const auto & multi_app : multi_apps)
5771 multi_app->backup();
5776 _console << COLOR_CYAN <<
"Finished Backing Up MultiApps on " <<
type.name() <<
"\n" 5777 << COLOR_DEFAULT << std::endl;
5786 if (multi_apps.size())
5791 _console << COLOR_CYAN <<
"\nRestoring Multiapps on " <<
type.name()
5792 <<
" because of solve failure!" << COLOR_DEFAULT << std::endl;
5794 _console << COLOR_CYAN <<
"\nRestoring MultiApps on " <<
type.name() << COLOR_DEFAULT
5798 for (
const auto & multi_app : multi_apps)
5799 multi_app->restore(force);
5804 _console << COLOR_CYAN <<
"Finished Restoring MultiApps on " <<
type.name() <<
"\n" 5805 << COLOR_DEFAULT << std::endl;
5816 for (
const auto & multi_app : multi_apps)
5817 smallest_dt =
std::min(smallest_dt, multi_app->computeDT());
5827 TIME_SECTION(
"execTransfers", 3,
"Executing Transfers");
5831 for (
const auto & transfer : transfers)
5832 transfer->execute();
5838 const std::string & name,
5841 parallel_object_only();
5872 std::shared_ptr<MultiApp> multiapp;
5885 exec_enum = multiapp->getParam<
ExecFlagEnum>(
"execute_on");
5893 std::shared_ptr<MultiAppTransfer> multi_app_transfer =
5895 if (multi_app_transfer)
5912 if (sys->hasVariable(var_name))
5914 if (
_aux->hasVariable(var_name))
5924 if (sys->hasVariable(var_name))
5932 const std::string & var_name,
5944 if (sys->hasVariable(var_name))
5945 return sys->getFieldVariable<
Real>(tid, var_name);
5946 if (
_aux->hasVariable(var_name))
5947 return _aux->getFieldVariable<
Real>(tid, var_name);
5956 if (sys->hasVariable(var_name))
5957 return sys->getActualFieldVariable<
Real>(tid, var_name);
5958 if (
_aux->hasVariable(var_name))
5959 return _aux->getActualFieldVariable<
Real>(tid, var_name);
5968 if (sys->hasVariable(var_name))
5970 if (
_aux->hasVariable(var_name))
5980 if (sys->hasVariable(var_name))
5982 if (
_aux->hasVariable(var_name))
5992 if (sys->hasScalarVariable(var_name))
5994 if (
_aux->hasScalarVariable(var_name))
6004 if (sys->hasScalarVariable(var_name))
6005 return sys->getScalarVariable(tid, var_name);
6006 if (
_aux->hasScalarVariable(var_name))
6007 return _aux->getScalarVariable(tid, var_name);
6018 else if (
_aux->hasVariable(var_name) ||
_aux->hasScalarVariable(var_name))
6019 return _aux->system();
6021 mooseError(
"Unable to find a system containing the variable " + var_name);
6129 mat->setActiveProperties(mat_prop_ids);
6131 mat->setActiveProperties(mat_prop_ids);
6133 mat->setActiveProperties(mat_prop_ids);
6153 #ifdef LIBMESH_ENABLE_AMR 6163 const std::string & redistributer_name,
6164 const bool use_displaced_mesh)
6168 redistribute_params.
set<std::string>(
"for_whom") = this->
name();
6172 redistribute_params.
set<
bool>(
"use_displaced_mesh") = use_displaced_mesh;
6175 std::shared_ptr<RedistributeProperties> redistributer =
6177 "RedistributeProperties", redistributer_name, redistribute_params);
6191 add_redistributer(
_mesh,
"mesh_property_redistributer",
false);
6193 add_redistributer(
_displaced_problem->mesh(),
"displaced_mesh_property_redistributer",
true);
6195 #endif // LIBMESH_ENABLE_AMR 6215 mooseError(
"Max quadrature points per element assumptions made in some code (e.g. Coupleable ",
6216 "and MaterialPropertyInterface classes) have been violated.\n",
6217 "Complain to Moose developers to have constMaxQpsPerElem increased from ",
6225 _zero[tid].resize(max_qpts, 0);
6268 const bool allow_negative_qweights)
6277 if (order < _aux->getMinQuadratureOrder())
6278 order =
_aux->getMinQuadratureOrder();
6282 volume_order = order;
6290 type, order, volume_order, face_order, block, allow_negative_qweights);
6294 type, order, volume_order, face_order, block, allow_negative_qweights);
6305 mooseError(
"Someone told us (the FEProblemBase) to trust the user coupling matrix, but we " 6306 "haven't been provided a coupling matrix!");
6327 _cm[i] = std::move(cm);
6334 mooseError(
"Someone told us (the FEProblemBase) to trust the user coupling matrix, but we " 6335 "haven't been provided a coupling matrix!");
6343 TIME_SECTION(
"setNonlocalCouplingMatrix", 5,
"Setting Nonlocal Coupling Matrix");
6346 mooseError(
"Nonlocal kernels are weirdly stored on the FEProblem so we don't currently support " 6347 "multiple nonlinear systems with nonlocal kernels.");
6351 auto & nl =
_nl[nl_sys_num];
6353 unsigned int n_vars = nl->nVariables();
6354 nonlocal_cm.resize(
n_vars);
6355 const auto &
vars = nl->getVariables(0);
6358 for (
const auto & ivar :
vars)
6360 for (
const auto & kernel : nonlocal_kernel)
6362 for (
unsigned int i = ivar->number(); i < ivar->number() + ivar->count(); ++i)
6363 if (i == kernel->variable().number())
6364 for (
const auto & jvar :
vars)
6369 unsigned int j = jvar->number();
6370 nonlocal_cm(i, j) = 1;
6374 for (
const auto & integrated_bc : nonlocal_integrated_bc)
6376 for (
unsigned int i = ivar->number(); i < ivar->number() + ivar->count(); ++i)
6377 if (i == integrated_bc->variable().number())
6378 for (
const auto & jvar :
vars)
6383 unsigned int j = jvar->number();
6384 nonlocal_cm(i, j) = 1;
6394 const unsigned int jvar,
6395 const unsigned int nl_sys)
const 6397 return (*
_cm[nl_sys])(ivar, jvar);
6400 std::vector<std::pair<MooseVariableFEBase *, MooseVariableFEBase *>> &
6403 return _assembly[tid][nl_sys]->couplingEntries();
6406 std::vector<std::pair<MooseVariableFEBase *, MooseVariableFEBase *>> &
6409 return _assembly[tid][nl_sys]->nonlocalCouplingEntries();
6418 TIME_SECTION(
"init", 2,
"Initializing");
6434 unsigned int n_vars = nl->nVariables();
6436 TIME_SECTION(
"fillCouplingMatrix", 3,
"Filling Coupling Matrix");
6441 cm = std::make_unique<CouplingMatrix>(
n_vars);
6442 for (
unsigned int i = 0; i <
n_vars; i++)
6448 cm = std::make_unique<CouplingMatrix>(
n_vars);
6449 for (
unsigned int i = 0; i <
n_vars; i++)
6450 for (
unsigned int j = 0; j <
n_vars; j++)
6460 nl->dofMap()._dof_coupling = cm.get();
6466 nl->dofMap()._dof_coupling =
nullptr;
6468 nl->dofMap().attach_extra_sparsity_function(&
extraSparsity, nl.get());
6469 nl->dofMap().attach_extra_send_list_function(&
extraSendList, nl.get());
6473 mooseError(
"No variables specified in nonlinear system '", nl->name(),
"'.");
6495 for (
auto & nl :
_nl)
6497 nl->turnOffJacobian();
6515 TIME_SECTION(
"EquationSystems::Init", 2,
"Initializing Equation Systems");
6537 "Coupling matrix not set for system " 6539 <<
". This should only happen if a preconditioner was not setup for this system");
6546 #ifdef MOOSE_KOKKOS_ENABLED 6557 std::istringstream ss(nl_sys_name);
6558 unsigned int nl_sys_num;
6559 if (!(ss >> nl_sys_num) || !ss.eof())
6568 std::istringstream ss(linear_sys_name);
6569 unsigned int linear_sys_num;
6570 if (!(ss >> linear_sys_num) || !ss.eof())
6573 return linear_sys_num;
6579 std::istringstream ss(solver_sys_name);
6580 unsigned int solver_sys_num;
6581 if (!(ss >> solver_sys_num) || !ss.eof())
6585 mooseError(
"The solver system number was requested for system '" + solver_sys_name,
6586 "' but this system does not exist in the Problem. Systems can be added to the " 6587 "problem using the 'nl_sys_names'/'linear_sys_names' parameter.\nSystems in the " 6590 solver_sys_num = search->second;
6593 return solver_sys_num;
6600 if (solver_sys->hasVariable(variable_name))
6601 return solver_sys->number();
6602 mooseAssert(
_aux,
"Should have an auxiliary system");
6603 if (
_aux->hasVariable(variable_name))
6604 return _aux->number();
6608 "' was not found in any solver (nonlinear/linear) or auxiliary system");
6614 TIME_SECTION(
"solve", 1,
"Solving",
false);
6628 #if PETSC_RELEASE_LESS_THAN(3, 12, 0) 6667 #if !PETSC_RELEASE_LESS_THAN(3, 12, 0) 6669 LibmeshPetscCall(PetscOptionsPop());
6686 TIME_SECTION(
"checkExceptionAndStopSolve", 5);
6707 <<
"To recover, the solution will fail and then be re-attempted with a reduced time " 6722 _aux->solution().close();
6736 mooseError(
"The following parallel-communicated exception was detected during " +
6739 "\nBecause this did not occur during residual evaluation, there" 6740 " is no way to handle this, so the solution is aborting.\n");
6748 ADReal::do_derivatives =
true;
6773 TIME_SECTION(
"solve", 1,
"Solving",
false);
6783 #if PETSC_RELEASE_LESS_THAN(3, 12, 0) 6785 options, solver_params));
6803 #if !PETSC_RELEASE_LESS_THAN(3, 12, 0) 6805 LibmeshPetscCall(PetscOptionsPop());
6821 return _nl[nl_sys_num]->nNonlinearIterations();
6827 return _nl[nl_sys_num]->nLinearIterations();
6833 return _nl[nl_sys_num]->finalNonlinearResidual();
6839 return _nl[nl_sys_num]->computingPreSMOResidual();
6845 TIME_SECTION(
"copySolutionsBackwards", 3,
"Copying Solutions Backward");
6848 sys->copySolutionsBackwards();
6849 _aux->copySolutionsBackwards();
6855 TIME_SECTION(
"advanceState", 5,
"Advancing State");
6858 sys->copyOldSolutions();
6859 _aux->copyOldSolutions();
6881 #ifdef MOOSE_KOKKOS_ENABLED 6896 TIME_SECTION(
"restoreSolutions", 5,
"Restoring Solutions");
6900 "There is currently no way to restore not-zeroed vectors.");
6905 _console <<
"Restoring solutions on system " << sys->name() <<
"..." << std::endl;
6906 sys->restoreSolutions();
6910 _console <<
"Restoring solutions on Auxiliary system..." << std::endl;
6911 _aux->restoreSolutions();
6914 _console <<
"Restoring postprocessor, vector-postprocessor, and reporter data..." << std::endl;
6924 TIME_SECTION(
"saveOldSolutions", 5,
"Saving Old Solutions");
6927 sys->saveOldSolutions();
6928 _aux->saveOldSolutions();
6934 TIME_SECTION(
"restoreOldSolutions", 5,
"Restoring Old Solutions");
6937 sys->restoreOldSolutions();
6938 _aux->restoreOldSolutions();
6944 TIME_SECTION(
"outputStep", 1,
"Outputting");
6981 TIME_SECTION(
"onTimestepBegin", 2);
6983 for (
auto & nl :
_nl)
6984 nl->onTimestepBegin();
7000 switch (state.
state)
7009 mooseError(
"Unhandled state ", state.
state,
" in FEProblemBase::getTimeFromStateArg");
7015 const std::string & name,
7018 parallel_object_only();
7030 _aux->addDotVectors();
7031 for (
auto & nl :
_nl)
7033 nl->addDotVectors();
7035 auto tag_udot = nl->getTimeIntegrators()[0]->uDotFactorTag();
7036 if (!nl->hasVector(tag_udot))
7037 nl->associateVectorToTag(*nl->solutionUDot(), tag_udot);
7038 auto tag_udotdot = nl->getTimeIntegrators()[0]->uDotDotFactorTag();
7040 nl->associateVectorToTag(*nl->solutionUDotDot(), tag_udotdot);
7050 const std::string & name,
7053 parallel_object_only();
7056 mooseError(
"Vector bounds cannot be used with LinearSystems!");
7062 for (
auto & nl :
_nl)
7063 nl->setPredictor(predictor);
7087 residual->scale(-1.0);
7089 return residual->l2_norm();
7095 TIME_SECTION(
"computeResidualL2Norm", 2,
"Computing L2 Norm of Residual");
7099 for (
auto sys :
_nl)
7119 parallel_object_only();
7121 TIME_SECTION(
"computeResidualSys", 5);
7139 const unsigned int nl_sys_num)
7148 mooseAssert(
_fe_vector_tags.empty(),
"This should be empty indicating a clean starting state");
7171 "This should be empty indicating a clean starting state");
7183 for (
auto & tag : tags)
7201 for (
auto index :
make_range(matrix.row_start(), matrix.row_stop()))
7202 matrix.add(index, index, 0);
7205 _aux->zeroVariablesForResidual();
7229 for (
unsigned int tid = 0; tid <
n_threads; tid++)
7234 _aux->residualSetup();
7250 #ifdef MOOSE_KOKKOS_ENABLED 7315 mooseError(
"An unhandled MooseException was raised during residual computation. Please " 7316 "contact the MOOSE team for assistance.");
7323 const std::set<TagID> & tags)
7325 parallel_object_only();
7327 TIME_SECTION(
"computeResidualInternal", 1);
7348 mooseError(
"An unhandled MooseException was raised during residual computation. Please " 7349 "contact the MOOSE team for assistance.");
7358 TIME_SECTION(
"computeResidualType", 5);
7379 mooseError(
"An unhandled MooseException was raised during residual computation. Please " 7380 "contact the MOOSE team for assistance.");
7387 auto create_exception_message =
7388 [&calling_method](
const std::string & exception_type,
const auto & exception)
7390 return std::string(
"A " + exception_type +
" was raised during FEProblemBase::" +
7391 calling_method +
"\n" + std::string(exception.what()));
7400 setException(create_exception_message(
"MooseException", e));
7402 catch (
const MetaPhysicL::LogicError & e)
7418 mooseError(create_exception_message(
"libMesh::PetscSolverException", e));
7420 catch (
const std::exception & e)
7423 if (strstr(e.what(),
"Jacobian") || strstr(e.what(),
"singular") ||
7424 strstr(e.what(),
"det != 0"))
7425 setException(create_exception_message(
"libMesh DegenerateMap", e));
7428 const auto message = create_exception_message(
"std::exception", e);
7442 parallel_object_only();
7448 TIME_SECTION(
"computeResidualTags", 5,
"Computing Residual");
7450 ADReal::do_derivatives =
false;
7454 _aux->zeroVariablesForResidual();
7468 for (
unsigned int tid = 0; tid <
n_threads; tid++)
7473 _aux->residualSetup();
7489 #ifdef MOOSE_KOKKOS_ENABLED 7548 const unsigned int nl_sys_num)
7555 for (
auto & tag : tags)
7564 const std::set<TagID> & tags)
7566 TIME_SECTION(
"computeJacobianInternal", 1);
7586 TIME_SECTION(
"computeJacobianTags", 5,
"Computing Jacobian");
7588 for (
auto tag : tags)
7600 for (
auto index :
make_range(matrix.row_start(), matrix.row_stop()))
7601 matrix.add(index, index, 0);
7604 _aux->zeroVariablesForJacobian();
7620 for (
unsigned int tid = 0; tid <
n_threads; tid++)
7625 _aux->jacobianSetup();
7633 for (
unsigned int tid = 0; tid <
n_threads; tid++)
7639 #ifdef MOOSE_KOKKOS_ENABLED 7684 const unsigned int nl_sys_num)
7686 TIME_SECTION(
"computeTransientImplicitJacobian", 2);
7708 JacobianBlock jac_block(precond_system, jacobian, ivar, jvar);
7709 std::vector<JacobianBlock *>
blocks = {&jac_block};
7724 "I expect these system numbers to be the same");
7729 TIME_SECTION(
"computeBounds", 1,
"Computing Bounds");
7738 _aux->residualSetup();
7762 const bool compute_gradients)
7764 TIME_SECTION(
"computeLinearSystemSys", 5);
7797 const std::set<TagID> & vector_tags,
7798 const std::set<TagID> & matrix_tags,
7799 const bool compute_gradients)
7801 TIME_SECTION(
"computeLinearSystemTags", 5,
"Computing Linear System");
7805 for (
auto tag : matrix_tags)
7824 _aux->jacobianSetup();
7831 #ifdef MOOSE_KOKKOS_ENABLED 7841 _console <<
"\nA MooseException was raised during Auxiliary variable computation.\n" 7842 <<
"The next solve will fail, the timestep will be reduced, and we will try again.\n" 7872 "I expect these system numbers to be the same");
7875 for (
unsigned int i = 0; i <
subspaceDim(
"NearNullSpace"); ++i)
7877 std::stringstream postfix;
7878 postfix <<
"_" << i;
7879 std::string modename =
"NearNullSpace" + postfix.str();
7889 "I expect these system numbers to be the same");
7891 for (
unsigned int i = 0; i <
subspaceDim(
"NullSpace"); ++i)
7893 std::stringstream postfix;
7894 postfix <<
"_" << i;
7904 "I expect these system numbers to be the same");
7906 for (
unsigned int i = 0; i <
subspaceDim(
"TransposeNullSpace"); ++i)
7908 std::stringstream postfix;
7909 postfix <<
"_" << i;
7919 bool & changed_search_direction,
7920 bool & changed_new_soln)
7923 "I expect these system numbers to be the same");
7934 TIME_SECTION(
"computePostCheck", 2,
"Computing Post Check");
7949 std::unique_ptr<NumericVector<Number>> ghosted_solution =
7951 ghosted_search_direction =
7955 *ghosted_solution = new_soln;
7956 *ghosted_search_direction = search_direction;
7967 new_soln = old_soln;
7968 new_soln.
add(-damping, search_direction);
7969 changed_new_soln =
true;
7976 if (changed_new_soln)
7977 *ghosted_solution = new_soln;
7979 bool updated_solution =
updateSolution(new_soln, *ghosted_solution);
7980 if (updated_solution)
7981 changed_new_soln =
true;
7988 _aux->copyCurrentIntoPreviousNL();
7992 changed_search_direction =
false;
8006 TIME_SECTION(
"computeDamping", 1,
"Computing Damping");
8047 parallel_object_only();
8056 TIME_SECTION(
"updateGeometricSearch", 3,
"Updating Geometric Search");
8067 TIME_SECTION(
"updateMortarMesh", 5,
"Updating Mortar Mesh");
8076 const std::pair<BoundaryID, BoundaryID> & primary_secondary_boundary_pair,
8077 const std::pair<SubdomainID, SubdomainID> & primary_secondary_subdomain_pair,
8081 const bool correct_edge_dropping,
8082 const Real minimum_projection_angle)
8087 return _mortar_data->createMortarInterface(primary_secondary_boundary_pair,
8088 primary_secondary_subdomain_pair,
8093 correct_edge_dropping,
8094 minimum_projection_angle);
8096 return _mortar_data->createMortarInterface(primary_secondary_boundary_pair,
8097 primary_secondary_subdomain_pair,
8102 correct_edge_dropping,
8103 minimum_projection_angle);
8108 const std::pair<BoundaryID, BoundaryID> & primary_secondary_boundary_pair,
8109 const std::pair<SubdomainID, SubdomainID> & primary_secondary_subdomain_pair,
8110 bool on_displaced)
const 8113 primary_secondary_boundary_pair, primary_secondary_subdomain_pair, on_displaced);
8118 const std::pair<BoundaryID, BoundaryID> & primary_secondary_boundary_pair,
8119 const std::pair<SubdomainID, SubdomainID> & primary_secondary_subdomain_pair,
8123 primary_secondary_boundary_pair, primary_secondary_subdomain_pair, on_displaced);
8131 TIME_SECTION(
"possiblyRebuildGeomSearchPatches", 5,
"Rebuilding Geometric Search Patches");
8165 libmesh_fallthrough();
8171 _console <<
"\n\nUpdating geometric search patches\n" << std::endl;
8187 #ifdef LIBMESH_ENABLE_AMR 8196 mooseError(
"HFEM does not support mesh adaptivity currently.");
8198 TIME_SECTION(
"initialAdaptMesh", 2,
"Performing Initial Adaptivity");
8200 for (
unsigned int i = 0; i < n; i++)
8217 _console <<
"Mesh unchanged, skipping remaining steps..." << std::endl;
8233 TIME_SECTION(
"adaptMesh", 3,
"Adapting Mesh");
8237 bool mesh_changed =
false;
8239 for (
unsigned int i = 0; i < cycles_per_step; ++i)
8242 mooseError(
"HFEM does not support mesh adaptivity currently.");
8248 bool mesh_changed_this_step;
8251 if (mesh_changed_this_step)
8253 mesh_changed =
true;
8266 _console <<
"Mesh unchanged, skipping remaining steps..." << std::endl;
8282 return mesh_changed;
8284 #endif // LIBMESH_ENABLE_AMR 8298 data[tid] = &storage.getMaterialData(tid);
8305 for (
unsigned int i = 0; i <
n_threads; ++i)
8317 TIME_SECTION(
"updateMeshXFEM", 5,
"Updating XFEM");
8319 bool updated =
false;
8322 if (
_xfem->updateHeal())
8327 false,
true,
false);
8333 false,
true,
false);
8336 _console <<
"\nXFEM update complete: Mesh modified" << std::endl;
8339 _console <<
"\nXFEM update complete: Mesh not modified" << std::endl;
8346 const bool contract_mesh,
8347 const bool clean_refinement_flags)
8349 TIME_SECTION(
"meshChanged", 3,
"Handling Mesh Changes");
8367 if (intermediate_change)
8375 if (clean_refinement_flags)
8383 if (!intermediate_change)
8433 for (
auto & nl_sys :
_nl)
8434 nl_sys->reinitMortarFunctors();
8451 Threads::parallel_reduce(range, pmp);
8459 for (
const auto & elem : range)
8472 Threads::parallel_reduce(range, pmp);
8476 for (
const auto & elem : range)
8479 for (
auto && child : coarsened_children)
8515 mdi->meshDisplaced();
8524 Threads::parallel_reduce(elem_range, cmt);
8526 cmt(elem_range,
true);
8528 #ifdef MOOSE_KOKKOS_ENABLED 8537 TIME_SECTION(
"checkProblemIntegrity", 5);
8540 const auto & subdomain_names = getParam<std::vector<SubdomainName>>(
"block");
8542 std::set<SubdomainID> mesh_subdomains(mesh_subdomains_vec.begin(), mesh_subdomains_vec.end());
8548 std::set<SubdomainID>
blocks;
8551 blocks = mesh_subdomains;
8554 blocks = mesh_subdomains;
8562 "\" not found in mesh.");
8574 "\" not found in mesh.");
8578 for (
auto & nl :
_nl)
8579 nl->checkKernelCoverage(
blocks);
8584 #ifdef LIBMESH_ENABLE_AMR 8589 _console <<
"Using EXPERIMENTAL Stateful Material Property projection with Adaptivity!\n" 8594 std::set<SubdomainID> local_mesh_subs(mesh_subdomains);
8603 bool check_material_coverage =
false;
8605 for (
const auto &
id : ids)
8607 local_mesh_subs.erase(
id);
8608 check_material_coverage =
true;
8619 "Subdomain \"" + subdomain_name +
"\" not found in mesh.");
8620 local_mesh_subs.erase(
id);
8625 std::set<SubdomainID>
blocks(local_mesh_subs);
8631 "Subdomain \"" + subdomain_name +
"\" not found in mesh.");
8634 for (
const auto id :
blocks)
8635 local_mesh_subs.erase(
id);
8639 auto && mortar_subdomain_ids =
_mortar_data->getMortarSubdomainIDs();
8640 for (
auto subdomain_id : mortar_subdomain_ids)
8641 local_mesh_subs.erase(subdomain_id);
8644 if (check_material_coverage && !local_mesh_subs.empty())
8646 std::stringstream extra_subdomain_ids;
8648 std::copy(local_mesh_subs.begin(),
8649 local_mesh_subs.end(),
8650 std::ostream_iterator<unsigned int>(extra_subdomain_ids,
" "));
8652 std::vector<SubdomainID> local_mesh_subs_vec(local_mesh_subs.begin(),
8653 local_mesh_subs.end());
8655 mooseError(
"The following blocks from your input mesh do not contain an active material: " +
8656 extra_subdomain_ids.str() +
8658 ")\nWhen ANY mesh block contains a Material object, " 8659 "all blocks must contain a Material object.\n");
8669 for (
const auto & material : materials)
8670 material->checkStatefulSanity();
8690 mooseError(
"Coordinate transformation parameters, listed below, are only to be used in the " 8691 "context of application to application field transfers at this time. The mesh is " 8692 "not modified by these parameters within an application.\n" 8693 "You should likely use a 'TransformGenerator' in the [Mesh] block to achieve the " 8694 "desired mesh modification.\n\n",
8711 bool mesh_has_second_order_elements =
false;
8717 mesh_has_second_order_elements =
true;
8727 if (mesh_has_second_order_elements)
8729 const std::vector<std::string> & displacement_variables =
8732 for (
const auto & var_name : displacement_variables)
8740 mooseError(
"Error: mesh has SECOND order elements, so all displacement variables must be " 8752 std::set<SubdomainID> user_objects_blocks;
8756 std::set<std::string> names;
8758 std::vector<UserObject *> objects;
8761 for (
const auto & obj : objects)
8762 names.insert(obj->name());
8765 std::set<SubdomainID> difference;
8766 std::set_difference(user_objects_blocks.begin(),
8767 user_objects_blocks.end(),
8768 mesh_subdomains.begin(),
8769 mesh_subdomains.end(),
8770 std::inserter(difference, difference.end()));
8772 if (!difference.empty())
8774 std::ostringstream oss;
8775 oss <<
"One or more UserObjects is referencing a nonexistent block:\n";
8776 for (
const auto &
id : difference)
8784 const std::map<
SubdomainID, std::vector<std::shared_ptr<MaterialBase>>> & materials_map)
8786 for (
const auto & it : materials_map)
8789 std::set<std::string> block_depend_props, block_supplied_props;
8791 for (
const auto & mat1 : it.second)
8793 auto & alldeps = mat1->getMatPropDependencies();
8794 for (
auto & dep : alldeps)
8798 for (
const auto & mat2 : it.second)
8800 const std::set<std::string> & supplied_props = mat2->MaterialBase::getSuppliedItems();
8801 block_supplied_props.insert(supplied_props.begin(), supplied_props.end());
8810 std::set<std::string> difference;
8811 std::set_difference(block_depend_props.begin(),
8812 block_depend_props.end(),
8813 block_supplied_props.begin(),
8814 block_supplied_props.end(),
8815 std::inserter(difference, difference.end()));
8817 if (!difference.empty())
8819 std::ostringstream oss;
8820 oss <<
"One or more Material Properties were not supplied on block ";
8822 if (subdomain_name.length() > 0)
8823 oss << subdomain_name <<
" (" << it.first <<
")";
8827 for (
const auto &
name : difference)
8828 oss <<
name <<
"\n";
8834 for (
const auto & it : materials_map)
8836 const auto & materials = it.second;
8837 std::set<std::string> inner_supplied, outer_supplied;
8839 for (
const auto & outer_mat : materials)
8842 outer_supplied = outer_mat->getSuppliedItems();
8843 inner_supplied.clear();
8846 std::map<std::string, std::set<std::string>> prop_to_mat;
8847 for (
const auto &
name : outer_supplied)
8848 prop_to_mat[
name].insert(outer_mat->name());
8850 for (
const auto & inner_mat : materials)
8852 if (outer_mat == inner_mat)
8856 auto outer_mat_type = outer_mat->type();
8857 auto inner_mat_type = inner_mat->type();
8862 if (outer_mat_type == inner_mat_type && outer_mat_type != outer_mat->type() &&
8863 inner_mat_type != inner_mat->type())
8866 inner_supplied.insert(inner_mat->getSuppliedItems().begin(),
8867 inner_mat->getSuppliedItems().end());
8869 for (
const auto & inner_supplied_name : inner_supplied)
8870 prop_to_mat[inner_supplied_name].insert(inner_mat->name());
8874 std::set<std::string> intersection;
8875 std::set_intersection(outer_supplied.begin(),
8876 outer_supplied.end(),
8877 inner_supplied.begin(),
8878 inner_supplied.end(),
8879 std::inserter(intersection, intersection.end()));
8881 if (!intersection.empty())
8883 std::ostringstream oss;
8884 oss <<
"The following material properties are declared on block " << it.first
8885 <<
" by multiple materials:\n";
8887 <<
"Material Objects\n";
8888 for (
const auto & outer_name : intersection)
8891 for (
const auto & inner_name : prop_to_mat[outer_name])
8892 oss << inner_name <<
" ";
8914 mooseInfo(
"Restart file ", file_name,
" is NOT being used since we are performing recovery.");
8920 mooseInfo(
"Using ", file_name,
" for restart.");
8924 std::vector<VariableName>
8927 std::vector<VariableName> names;
8931 const std::vector<VariableName> & var_names = sys->getVariableNames();
8932 names.insert(names.end(), var_names.begin(), var_names.end());
8935 const std::vector<VariableName> & aux_var_names =
_aux->getVariableNames();
8936 names.insert(names.end(), aux_var_names.begin(), aux_var_names.end());
8945 "Solver system number '" << solver_sys_num <<
"' is out of bounds. We have '" 8962 auto random_data_ptr = insert_pair.first->second.get();
8972 bnd_mat_side_cache =
false;
8975 if (
_aux->needMaterialOnSide(bnd_id))
8977 bnd_mat_side_cache =
true;
8980 for (
auto & nl :
_nl)
8981 if (nl->needBoundaryMaterialOnSide(bnd_id, tid))
8983 bnd_mat_side_cache =
true;
8997 bnd_mat_side_cache =
true;
9011 interface_mat_side_cache =
false;
9014 for (
auto & nl :
_nl)
9015 if (nl->needInterfaceMaterialOnSide(bnd_id, tid))
9017 interface_mat_side_cache =
true;
9030 interface_mat_side_cache =
true;
9035 interface_mat_side_cache =
true;
9049 for (
auto & nl :
_nl)
9050 if (nl->needInternalNeighborSideMaterial(subdomain_id, tid))
9083 mooseError(
"Previous nonlinear solution is required but not added through " 9084 "Problem/previous_nl_solution_required=true");
9101 const std::string & object_name,
9104 parallel_object_only();
9111 mooseError(
"The name '", object_name,
"' is a reserved name for output objects");
9115 if (output_warehouse.
hasOutput(object_name))
9116 mooseError(
"An output object named '", object_name,
"' already exists");
9122 std::vector<std::string> exclude;
9123 if (object_type ==
"Console")
9125 exclude.push_back(
"execute_on");
9133 else if (object_type ==
"Checkpoint")
9134 exclude.push_back(
"execute_on");
9140 if (common &&
std::find(exclude.begin(), exclude.end(),
"execute_on") != exclude.end() &&
9143 "'execute_on' parameter specified in [Outputs] block is ignored for object '" +
9145 "'.\nDefine this object in its own sub-block of [Outputs] to modify its " 9146 "execution schedule.");
9149 if (object_type ==
"XDR")
9151 else if (object_type ==
"XDA")
9155 if (object_name ==
"auto_recovery_checkpoint")
9187 else if (sys_name ==
"aux0")
9190 mooseError(
"System '" + sys_name +
"' was requested from problem but does not exist.");
9205 mooseAssert(sys_num <
_nl.size(),
"System number greater than the number of nonlinear systems");
9206 return *
_nl[sys_num];
9212 mooseAssert(sys_num <
_nl.size(),
"System number greater than the number of nonlinear systems");
9213 return *
_nl[sys_num];
9220 "System number greater than the number of linear systems");
9228 "System number greater than the number of linear systems");
9236 "System number greater than the number of solver systems");
9244 "System number greater than the number of solver systems");
9263 parallel_object_only();
9307 const std::vector<Point> *
const pts,
9308 const std::vector<Real> *
const weights,
9320 unsigned int neighbor_side,
9322 const std::vector<Point> *
const pts,
9323 const std::vector<Real> *
const weights,
9336 std::vector<std::shared_ptr<MaterialBase>> & face_materials,
9337 std::vector<std::shared_ptr<MaterialBase>> & neighbor_materials,
9338 std::set<MooseVariableFieldBase *> & variables,
9343 auto & this_face_mats =
9345 for (std::shared_ptr<MaterialBase> face_mat : this_face_mats)
9346 if (face_mat->ghostable())
9348 face_materials.push_back(face_mat);
9349 auto & var_deps = face_mat->getMooseVariableDependencies();
9350 for (
auto * var : var_deps)
9354 "Ghostable materials should only have finite volume variables coupled into them.");
9355 else if (face_mat->hasStatefulProperties())
9356 mooseError(
"Finite volume materials do not currently support stateful properties.");
9357 variables.insert(var);
9364 auto & this_neighbor_mats =
9366 for (std::shared_ptr<MaterialBase> neighbor_mat : this_neighbor_mats)
9367 if (neighbor_mat->ghostable())
9369 neighbor_materials.push_back(neighbor_mat);
9371 auto & var_deps = neighbor_mat->getMooseVariableDependencies();
9372 for (
auto * var : var_deps)
9376 "Ghostable materials should only have finite volume variables coupled into them.");
9377 else if (neighbor_mat->hasStatefulProperties())
9378 mooseError(
"Finite volume materials do not currently support stateful properties.");
9379 auto pr = variables.insert(var);
9380 mooseAssert(!pr.second,
9381 "We should not have inserted any new variables dependencies from our " 9382 "neighbor materials that didn't exist for our face materials");
9391 const unsigned int nqp,
9402 "There must be one convergence object per nonlinear system");
9418 const std::vector<ConvergenceName> &
9423 mooseError(
"The nonlinear system convergence name(s) have not been set.");
9438 paramError(
"linear_convergence",
"There must be one convergence object per linear system");
9442 const std::vector<ConvergenceName> &
9447 mooseError(
"The linear convergence name(s) have not been set.");
9450 const ConvergenceName &
9456 mooseError(
"The fixed point convergence name has not been set.");
9459 const ConvergenceName &
9465 mooseError(
"The steady convergence name has not been set.");
9476 _nl[i]->residualSetup();
9490 _nl[i]->jacobianSetup();
9510 return current_nl_sys_num;
9521 return current_linear_sys_num;
9538 std::vector<MortarUserObject *>
9541 const bool displaced,
9542 const std::vector<MortarUserObject *> & mortar_uo_superset)
9544 std::vector<MortarUserObject *> mortar_uos;
9546 : static_cast<SubProblem *>(
this);
9547 for (
auto *
const obj : mortar_uo_superset)
9548 if (obj->onInterface(primary_boundary_id, secondary_boundary_id) &&
9549 (&obj->getSubProblem() == subproblem))
9550 mortar_uos.push_back(obj);
9555 std::vector<MortarUserObject *>
9558 const bool displaced)
9560 std::vector<MortarUserObject *> mortar_uos;
9564 .queryInto(mortar_uos);
9565 return getMortarUserObjects(primary_boundary_id, secondary_boundary_id, displaced, mortar_uos);
9571 const bool displaced)
9573 const auto mortar_uos =
9575 for (
auto *
const mortar_uo : mortar_uos)
9577 mortar_uo->setNormals();
9578 mortar_uo->reinit();
9610 mooseAssert(nl_sys_num <
_nl.size(),
9611 "System number greater than the number of nonlinear systems");
9620 "System number greater than the number of linear systems");
9633 solver_sys->compute(
type);
9715 return solver_params;
9730 const std::unordered_map<std::pair<BoundaryID, BoundaryID>,
9731 std::unique_ptr<AutomaticMortarGeneration>> &
9734 return _mortar_data->getMortarInterfaces(on_displaced);
bool _reinit_displaced_elem
Whether to call DisplacedProblem::reinitElem when this->reinitElem is called.
This class determines the maximum number of Quadrature Points and Shape Functions used for a given si...
virtual void addInterfaceMaterial(const std::string &material_name, const std::string &name, InputParameters ¶meters)
std::map< NonlinearSystemName, unsigned int > _nl_sys_name_to_num
Map from nonlinear system name to number.
void setCurrentAlgebraicElementRange(libMesh::ConstElemRange *range)
These functions allow setting custom ranges for the algebraic elements, nodes, and boundary nodes tha...
std::string indent(unsigned int spaces)
Create empty string for indenting.
std::vector< Point > _point_zero
Interface for objects that need parallel consistent random numbers without patterns over the course o...
void updateVariableDependency(std::set< MooseVariableFieldBase *> &needed_moose_vars, THREAD_ID tid=0) const
Update variable dependency vector.
virtual void addCachedResidual(const THREAD_ID tid)
virtual void computeJacobianTag(const NumericVector< libMesh::Number > &soln, libMesh::SparseMatrix< libMesh::Number > &jacobian, TagID tag)
Form a Jacobian matrix for a given tag.
void addObject(std::shared_ptr< T > object, THREAD_ID tid=0, bool recurse=true) override
Adds an object to the storage structure.
unsigned short getCurrentICState()
Retrieves the current initial condition state.
virtual void addFVInitialCondition(const std::string &ic_name, const std::string &name, InputParameters ¶meters)
Add an initial condition for a finite volume variables.
bool adaptMesh(std::string marker_name=std::string())
Adapts the mesh based on the error estimator used.
void sort(THREAD_ID tid=0)
Sort the objects using the DependencyResolver.
virtual void addMaterialHelper(std::vector< MaterialWarehouse *> warehouse, const std::string &material_name, const std::string &name, InputParameters ¶meters)
bool initialAdaptMesh()
Used during initial adaptivity.
virtual void residualSetup(THREAD_ID tid=0) const
virtual bool hasVariable(const std::string &var_name) const override
Whether or not this problem has the variable.
virtual void stopSolve(const ExecFlagType &exec_flag, const std::set< TagID > &vector_tags_to_close) override
Quit the current solve as soon as possible.
bool hasInvalidSolutionError() const
Whether or not an invalid solution was encountered that was an error.
void mooseInfo(Args &&... args) const
void setActiveMaterialProperties(const std::unordered_set< unsigned int > &mat_prop_ids, const THREAD_ID tid)
Record and set the material properties required by the current computing thread.
const bool _regard_general_exceptions_as_errors
If we catch an exception during residual/Jacobian evaluaton for which we don't have specific handling...
const std::size_t _num_nl_sys
The number of nonlinear systems.
void setVariableAllDoFMap(const std::vector< const MooseVariableFEBase *> &moose_vars)
void computeJacobianBlocks(std::vector< JacobianBlock *> &blocks)
Computes several Jacobian blocks simultaneously, summing their contributions into smaller preconditio...
virtual void initPetscOutputAndSomeSolverSettings()
Reinitialize PETSc output for proper linear/nonlinear iteration display.
const std::vector< ConvergenceName > & getNonlinearConvergenceNames() const
Gets the nonlinear system convergence object name(s).
MetaPhysicL::DualNumber< V, D, asd > abs(const MetaPhysicL::DualNumber< V, D, asd > &a)
void timestepSetup() override
virtual void addSampler(const std::string &type, const std::string &name, InputParameters ¶meters)
The following functions will enable MOOSE to have the capability to import Samplers.
bool _skip_exception_check
If or not skip 'exception and stop solve'.
const std::vector< std::string > & get_global_var_names()
bool isFiniteVolumeInfoDirty() const
Helper class for holding the preconditioning blocks to fill.
virtual void restore_original_nonzero_pattern()
bool _reinit_displaced_neighbor
Whether to call DisplacedProblem::reinitNeighbor when this->reinitNeighbor is called.
virtual void clearActiveFEVariableCoupleableMatrixTags(const THREAD_ID tid)
void outputStep(ExecFlagType type)
Calls the outputStep method for each output object.
virtual void meshChanged()
Deprecated.
virtual void addDamper(const std::string &damper_name, const std::string &name, InputParameters ¶meters)
std::map< LinearSystemName, unsigned int > _linear_sys_name_to_num
Map from linear system name to number.
virtual void clearActiveFEVariableCoupleableVectorTags(const THREAD_ID tid)
libMesh::ConstElemRange * getActiveLocalElementRange()
Return pointers to range objects for various types of ranges (local nodes, boundary elems...
void getFVMatsAndDependencies(SubdomainID block_id, std::vector< std::shared_ptr< MaterialBase >> &face_materials, std::vector< std::shared_ptr< MaterialBase >> &neighbor_materials, std::set< MooseVariableFieldBase *> &variables, const THREAD_ID tid)
Get the materials and variables potentially needed for FV.
std::vector< MooseArray< ADRealTensorValue > > _ad_second_zero
bool _have_ad_objects
AD flag indicating whether any AD objects have been added.
void shift()
Shift the material properties in time.
virtual void prepareFace(const Elem *elem, const THREAD_ID tid) override
Base class for function objects.
void setPreserveMatrixSparsityPattern(bool preserve)
Set whether the sparsity pattern of the matrices being formed during the solve (usually the Jacobian)...
void reinitBecauseOfGhostingOrNewGeomObjects(bool mortar_changed=false)
Call when it is possible that the needs for ghosted elements has changed.
void fill_data(std::map< processor_id_type, std::vector< std::set< unsigned int >>> &data, int M)
virtual void addTransfer(const std::string &transfer_name, const std::string &name, InputParameters ¶meters)
Add a Transfer to the problem.
KOKKOS_INLINE_FUNCTION const T * find(const T &target, const T *const begin, const T *const end)
Find a value in an array.
const std::string & getBoundaryName(BoundaryID boundary_id) const
Return the name of the boundary given the id.
virtual libMesh::System & getSystem(const std::string &var_name) override
Returns the equation system containing the variable provided.
virtual void setActiveScalarVariableCoupleableMatrixTags(std::set< TagID > &mtags, const THREAD_ID tid)
static const std::string app_param
The name of the parameter that contains the MooseApp.
A MultiMooseEnum object to hold "execute_on" flags.
static SolverParams makeLinearSolverParams()
Make basic solver params for linear solves.
bool _parallel_barrier_messaging
Whether or not information about how many transfers have completed is printed.
MooseVariableFieldBase & getVariableHelper(const THREAD_ID tid, const std::string &var_name, Moose::VarKindType expected_var_type, Moose::VarFieldType expected_var_field_type, const std::vector< T > &nls, const SystemBase &aux) const
Helper function called by getVariable that handles the logic for checking whether Variables of the re...
virtual void addResidualLower(const THREAD_ID tid) override
A class for creating restricted objects.
bool isUltimateMaster() const
Whether or not this app is the ultimate master app.
virtual void addJacobianLowerD(const THREAD_ID tid) override
Factory & _factory
The Factory for building objects.
virtual void clearActiveScalarVariableCoupleableVectorTags(const THREAD_ID tid) override
MaterialPropertyStorage & _bnd_material_props
virtual void addGhostedElem(dof_id_type elem_id) override
Will make sure that all dofs connected to elem_id are ghosted to this processor.
void setNonlocalCouplingMatrix()
Set custom coupling matrix for variables requiring nonlocal contribution.
Threads::spin_mutex get_function_mutex
void initialSetup()
Calls the initialSetup function for each of the output objects.
virtual Real & time() const
virtual const char * what() const
Get out the error message.
std::vector< std::pair< MooseVariableFEBase *, MooseVariableFEBase * > > & couplingEntries(const THREAD_ID tid, const unsigned int nl_sys_num)
const Variable & variable(unsigned int var) const
void checkDependMaterialsHelper(const std::map< SubdomainID, std::vector< std::shared_ptr< MaterialBase >>> &materials_map)
Helper method for checking Material object dependency.
void extraSparsity(libMesh::SparsityPattern::Graph &sparsity, std::vector< dof_id_type > &n_nz, std::vector< dof_id_type > &n_oz, void *context)
Free function used for a libMesh callback.
void projectFunctionOnCustomRange(ConstElemRange &elem_range, Number(*func)(const Point &, const libMesh::Parameters &, const std::string &, const std::string &), Gradient(*func_grad)(const Point &, const libMesh::Parameters &, const std::string &, const std::string &), const libMesh::Parameters ¶ms, const VariableName &target_var)
Project a function onto a range of elements for a given variable.
virtual void cacheResidualNeighbor(const THREAD_ID tid) override
ExecFlagType _current_execute_on_flag
Current execute_on flag.
const std::set< SubdomainID > & interiorLowerDBlocks() const
void clearCurrentResidualVectorTags()
Clear the current residual vector tag data structure.
bool hasActiveBlockObjects(THREAD_ID tid=0) const
QueryCache is a convenient way to construct and pass around (possible partially constructed) warehous...
std::shared_ptr< DisplacedProblem > displaced_problem
const unsigned int invalid_uint
virtual void reinitLowerDElem(const Elem *lower_d_elem, const THREAD_ID tid, const std::vector< Point > *const pts=nullptr, const std::vector< Real > *const weights=nullptr)
RelationshipManagerType
Main types of Relationship Managers.
bool hasVector(const std::string &tag_name) const
Check if the named vector exists in the system.
unsigned int get_node_index(const Node *node_ptr) const
virtual void checkExceptionAndStopSolve(bool print_message=true)
Check to see if an exception has occurred on any processor and, if possible, force the solve to fail...
virtual void meshDisplaced()
Update data after a mesh displaced.
const std::set< BoundaryID > & getSubdomainBoundaryIds(const SubdomainID subdomain_id) const
Get the list of boundary ids associated with the given subdomain id.
std::optional< ConvergenceName > _multiapp_fixed_point_convergence_name
MultiApp fixed point convergence name.
const std::string & name() const
MooseAppCoordTransform & coordTransform()
virtual void setActiveFEVariableCoupleableMatrixTags(std::set< TagID > &mtags, const THREAD_ID tid) override
void setCurrentAlgebraicNodeRange(libMesh::ConstNodeRange *range)
void paramError(const std::string ¶m, Args... args) const
Emits an error prefixed with the file and line number of the given param (from the input file) along ...
const std::map< SubdomainID, std::vector< std::shared_ptr< T > > > & getActiveBlockObjects(THREAD_ID tid=0) const
Real computeDamping(const NumericVector< Number > &solution, const NumericVector< Number > &update)
Compute damping.
const T & getParam(const std::string &name) const
Retrieve a parameter for the object.
virtual void reinitNode(const Node *node, const THREAD_ID tid) override
virtual std::size_t numNonlinearSystems() const override
Base class for implementing interface user objects.
virtual void setPreviousNewtonSolution(const NumericVector< Number > &soln)
virtual void predictorCleanup(NumericVector< libMesh::Number > &ghosted_solution)
Perform cleanup tasks after application of predictor to solution vector.
virtual void prepare(const Elem *elem, const THREAD_ID tid) override
TagID rightHandSideVectorTag() const
virtual Elem * elemPtr(const dof_id_type i)
TagID systemMatrixTag() const override
Return the Matrix Tag ID for System.
NumericVector< Number > & solution()
bool hasObjects(THREAD_ID tid=0) const
Convenience functions for determining if objects exist.
bool _has_jacobian
Indicates if the Jacobian was computed.
virtual bool haveFV() const override
returns true if this problem includes/needs finite volume functionality.
Interface for objects acting when the mesh has been displaced.
static void uniformRefine(MooseMesh *mesh, unsigned int level=libMesh::invalid_uint)
Performs uniform refinement of the passed Mesh object.
bool _has_dampers
Whether or not this system has any Dampers associated with it.
MooseObjectWarehouse< InternalSideIndicatorBase > _internal_side_indicators
void shift()
Shift current, old, and older material property data storages.
std::vector< SubdomainName > _kernel_coverage_blocks
const std::map< dof_id_type, std::vector< dof_id_type > > & nodeToActiveSemilocalElemMap()
If not already created, creates a map from every node to all active semilocal elements to which they ...
virtual Distribution & getDistribution(const std::string &name)
void swapBack(const Elem &elem, unsigned int side=0)
material properties for given element (and possible side)
bool _has_nonlocal_coupling
Indicates if nonlocal coupling is required/exists.
void setCurrentAlgebraicBndNodeRange(ConstBndNodeRange *range)
void dof_indices(const Elem *const elem, std::vector< dof_id_type > &di) const
This is the base class for Samplers as used within the Stochastic Tools module.
Base class for predictors.
bool areCoupled(const unsigned int ivar, const unsigned int jvar, const unsigned int nl_sys_num) const
Moose::LineSearchType _line_search
const T & get() const
Get the restartable value.
void setPostprocessorValueByName(const PostprocessorName &name, const PostprocessorValue &value, std::size_t t_index=0)
Set the value of a PostprocessorValue.
virtual void clearActiveScalarVariableCoupleableMatrixTags(const THREAD_ID tid) override
virtual void postExecute()
Method called at the end of the simulation.
void reinit(bool reinit_for_derivative_reordering=false)
Fill out the VariableValue arrays from the system solution vector.
unsigned int number() const
Get variable number coming from libMesh.
void eraseProperty(const Elem *elem)
Remove the property storage and element pointer from internal data structures Use this when elements ...
bool isSolverSystemNonlinear(const unsigned int sys_num)
Check if the solver system is nonlinear.
void petscSetDefaults(FEProblemBase &problem)
Sets the default options for PETSc.
std::unordered_set< TagID > _not_zeroed_tagged_vectors
the list of vector tags that will not be zeroed when all other tags are
void joinAndFinalize(TheWarehouse::Query query, bool isgen=false)
bool hasInitialBackup() const
std::vector< MooseArray< ADRealVectorValue > > _ad_grad_zero
std::vector< SolverParams > _solver_params
InputParameterWarehouse & getInputParameterWarehouse()
Get the InputParameterWarehouse for MooseObjects.
ExecuteMooseObjectWarehouse< Control > _control_warehouse
The control logic warehouse.
void reinitMaterialsFaceOnBoundary(const BoundaryID boundary_id, const SubdomainID blk_id, const THREAD_ID tid, const bool swap_stateful=true, const std::deque< MaterialBase *> *const reinit_mats=nullptr)
reinit materials on element faces on a boundary (internal or external) This specific routine helps us...
void updateActive(THREAD_ID tid=0) override
Updates the active objects storage.
virtual std::pair< bool, unsigned int > determineSolverSystem(const std::string &var_name, bool error_if_not_found=false) const override
Determine what solver system the provided variable name lies in.
std::unique_ptr< libMesh::ConstNodeRange > _current_algebraic_node_range
virtual void setActiveScalarVariableCoupleableMatrixTags(std::set< TagID > &mtags, const THREAD_ID tid) override
void setCoupling(Moose::CouplingType type)
Set the coupling between variables TODO: allow user-defined coupling.
constexpr std::size_t constMaxQpsPerElem
This is used for places where we initialize some qp-sized data structures that would end up being siz...
const ExecFlagType & getCurrentExecuteOnFlag() const
Return/set the current execution flag.
unsigned int _cycles_completed
bool _currently_computing_jacobian
Flag to determine whether the problem is currently computing Jacobian.
virtual void reinitScalars(const THREAD_ID tid, bool reinit_for_derivative_reordering=false) override
fills the VariableValue arrays for scalar variables from the solution vector
const ExecFlagEnum & getExecuteOnEnum() const
Return the app level ExecFlagEnum, this contains all the available flags for the app.
virtual void init() override
void add(std::shared_ptr< MooseObject > obj)
add adds a new object to the warehouse and stores attributes/metadata about it for running queries/fi...
void translateMetaPhysicLError(const MetaPhysicL::LogicError &)
emit a relatively clear error message when we catch a MetaPhysicL logic error
virtual void getDiracElements(std::set< const Elem *> &elems) override
Fills "elems" with the elements that should be looped over for Dirac Kernels.
virtual void setActiveElementalMooseVariables(const std::set< MooseVariableFieldBase *> &moose_vars, const THREAD_ID tid)
Set the MOOSE variables to be reinited on each element.
void parentOutputPositionChanged()
Calls parentOutputPositionChanged() on all sub apps.
void setupDM()
Setup the PETSc DM object (when appropriate)
virtual void setCurrentBoundaryID(BoundaryID bid, const THREAD_ID tid)
sets the current boundary ID in assembly
virtual void addInterfaceKernel(const std::string &kernel_name, const std::string &name, InputParameters ¶meters)
virtual void neighborSubdomainSetup(THREAD_ID tid=0) const
libMesh::LinearImplicitSystem & linearImplicitSystem()
Return a reference to the stored linear implicit system.
bool _is_petsc_options_inserted
If or not PETSc options have been added to database.
void setCurrentlyComputingResidual(bool currently_computing_residual) final
Set whether or not the problem is in the process of computing the residual.
virtual void addMaterial(const std::string &material_name, const std::string &name, InputParameters ¶meters)
virtual void lineSearch()
execute MOOSE line search
const std::vector< T > & getSortedValues()
This function also returns dependency resolved values but with a simpler single vector interface...
unsigned int getCyclesPerStep() const
Pull out the number of cycles_per_step previously set through the AdaptivityAction.
virtual void setCurrentLowerDElem(const Elem *const lower_d_elem, const THREAD_ID tid)
Set the current lower dimensional element.
const Elem * getLowerDElem(const Elem *, unsigned short int) const
Returns a const pointer to a lower dimensional element that corresponds to a side of a higher dimensi...
NonlocalIntegratedBC is used for solving integral terms in integro-differential equations.
virtual bool checkNonlocalCouplingRequirement() const override
virtual bool uDotDotRequested()
Get boolean flag to check whether solution second time derivative needs to be stored.
bool _has_kokkos_objects
Whether we have any Kokkos objects.
void updateErrorVectors()
Update the ErrorVectors that have been requested through calls to getErrorVector().
const InputParameters & parameters() const
Get the parameters of the object.
unsigned short _current_ic_state
virtual void reinitNeighborPhys(const Elem *neighbor, unsigned int neighbor_side, const std::vector< Point > &physical_points, const THREAD_ID tid) override
virtual TagID addVectorTag(const TagName &tag_name, const Moose::VectorTagType type=Moose::VECTOR_TAG_RESIDUAL)
Create a Tag.
std::vector< MeshDisplacedInterface * > _notify_when_mesh_displaces
Objects to be notified when the mesh displaces.
std::vector< T * > & queryInto(std::vector< T *> &results, Args &&... args)
queryInto executes the query and stores the results in the given vector.
void trustUserCouplingMatrix()
Whether to trust the user coupling matrix even if we want to do things like be paranoid and create a ...
virtual void newAssemblyArray(std::vector< std::shared_ptr< SolverSystem >> &solver_systems)
const bool _uo_aux_state_check
Whether or not checking the state of uo/aux evaluation.
virtual const std::set< MooseVariableFieldBase * > & getActiveElementalMooseVariables(const THREAD_ID tid) const
Get the MOOSE variables to be reinited on each element.
This is a template class that implements the workhorse compute and computeNodal methods.
virtual void addMeshDivision(const std::string &type, const std::string &name, InputParameters ¶ms)
Add a MeshDivision.
const ExecFlagType EXEC_NONE
A struct for storing the various types of petsc options and values.
virtual void computeMarkers()
void reportMooseObjectDependency(MooseObject *a, MooseObject *b)
Register a MOOSE object dependency so we can either order operations properly or report when we canno...
void residualSetup() override
MaterialDataType
MaterialData types.
void computeUserObjectsInternal(const ExecFlagType &type, const Moose::AuxGroup &group, TheWarehouse::Query &query)
TagID nonTimeVectorTag() const override
A class for "pretty printing" a table of data.
virtual void addCachedJacobian(const THREAD_ID tid)
void cacheChangedLists()
Cache information about what elements were refined and coarsened in the previous step.
virtual void residualSetup()
Positions objects are under the hood Reporters.
void reinitMortarUserObjects(BoundaryID primary_boundary_id, BoundaryID secondary_boundary_id, bool displaced)
Call reinit on mortar user objects with matching primary boundary ID, secondary boundary ID...
virtual TagID systemMatrixTag() const override
Return the Matrix Tag ID for System.
virtual void associateVectorToTag(NumericVector< Number > &vec, TagID tag)
Associate a vector for a given tag.
virtual void reinitNodes(const std::vector< dof_id_type > &nodes, const THREAD_ID tid) override
virtual void updateActiveObjects()
Update the active objects in the warehouses.
Stores the stateful material properties computed by materials.
const RestartableEquationSystems & getRestartableEquationSystems() const
Get the RestartableEquationSystems object.
virtual void computeIndicatorsAndMarkers()
void reinitMaterialsBoundary(BoundaryID boundary_id, const THREAD_ID tid, bool swap_stateful=true, const std::deque< MaterialBase *> *reinit_mats=nullptr)
reinit materials on a boundary
virtual void addJacobianOffDiagScalar(unsigned int ivar, const THREAD_ID tid=0)
virtual void setException(const std::string &message)
Set an exception, which is stored at this point by toggling a member variable in this class...
virtual void addJacobian(const THREAD_ID tid) override
void addFunctor(const std::string &name, const Moose::FunctorBase< T > &functor, const THREAD_ID tid)
add a functor to the problem functor container
virtual libMesh::System & system()=0
Get the reference to the libMesh system.
std::filesystem::path restartFolderBase(const std::filesystem::path &folder_base) const
The file suffix for restartable data.
virtual void addAuxScalarKernel(const std::string &kernel_name, const std::string &name, InputParameters ¶meters)
virtual void customSetup(const ExecFlagType &exec_type, THREAD_ID tid=0) const
bool isReservedName(const std::string &name)
Test if the given name is reserved.
bool globalADIndexing()
Whether we are using global AD indexing.
bool hasOutput(const std::string &name) const
Returns true if the output object exists.
Base class for MOOSE-based applications.
void disable_refine_in_reinit()
void mooseInfoRepeated(Args &&... args)
Emit an informational message with the given stringified, concatenated args.
PetscOptions _petsc_option_data_base
bool needBoundaryMaterialOnSide(BoundaryID bnd_id, const THREAD_ID tid)
These methods are used to determine whether stateful material properties need to be stored on interna...
virtual const std::vector< VectorTag > & currentResidualVectorTags() const override
Return the residual vector tags we are currently computing.
processor_id_type rank() const
std::vector< SubdomainName > _material_coverage_blocks
bool computingScalingJacobian() const
Whether we are computing an initial Jacobian for automatic variable scaling.
TODO: delete this later - it is a temporary hack for dealing with inter-system dependencies.
NumericVector< Number > * rhs
void setSteadyStateConvergenceName(const ConvergenceName &convergence_name)
Sets the steady-state detection convergence object name if there is one.
virtual void addAuxScalarVariable(const std::string &var_name, libMesh::Order order, Real scale_factor=1., const std::set< SubdomainID > *const active_subdomains=NULL)
virtual const SystemBase & systemBaseLinear(unsigned int sys_num) const override
Get a constant base class reference to a linear system.
const Parallel::Communicator & comm() const
void logAdd(const std::string &system, const std::string &name, const std::string &type, const InputParameters ¶ms) const
Output information about the object just added to the problem.
virtual bool hasScalarVariable(const std::string &var_name) const override
Returns a Boolean indicating whether any system contains a variable with the name provided...
void setSolution(const NumericVector< Number > &soln)
Set the solution to a given vector.
MultiApp Implementation for Transient Apps.
Solving a linear problem.
void resizeMaterialData(Moose::MaterialDataType data_type, unsigned int nqp, const THREAD_ID tid)
Resize material data.
void finishMultiAppStep(ExecFlagType type, bool recurse_through_multiapp_levels=false)
Finish the MultiApp time step (endStep, postStep) associated with the ExecFlagType.
virtual void addFunctorMaterial(const std::string &functor_material_name, const std::string &name, InputParameters ¶meters)
virtual void timestepSetup(THREAD_ID tid=0) const
std::vector< VariableSecond > _second_zero
void clean_refinement_flags()
std::map< SolverVariableName, unsigned int > _solver_var_to_sys_num
Map connecting variable names with their respective solver systems.
virtual std::unique_ptr< NumericVector< T > > clone() const=0
std::vector< MooseArray< ADReal > > _ad_zero
void customSetup(const ExecFlagType &exec_type)
Calls the setup function for each of the output objects.
virtual bool hasMatrix(TagID tag) const
Check if the tagged matrix exists in the system.
bool _requires_nonlocal_coupling
nonlocal coupling requirement flag
virtual void onTimestepEnd() override
virtual void computeNearNullSpace(libMesh::NonlinearImplicitSystem &sys, std::vector< NumericVector< libMesh::Number > *> &sp)
virtual void addNodalKernel(const std::string &kernel_name, const std::string &name, InputParameters ¶meters)
std::vector< std::shared_ptr< SolverSystem > > _solver_systems
Combined container to base pointer of every solver system.
All Distributions should inherit from this class.
void setCurrentDirection(const int direction)
Set this Transfer to be executed in a given direction.
std::unique_ptr< T_DEST, T_DELETER > dynamic_pointer_cast(std::unique_ptr< T_SRC, T_DELETER > &src)
These are reworked from https://stackoverflow.com/a/11003103.
ConstElemPointerRange * refinedElementRange() const
Return a range that is suitable for threaded execution over elements that were just refined...
MaterialWarehouse _kokkos_materials
std::vector< VectorVariableCurl > _vector_curl_zero
static void selectVectorTagsFromSystem(const SystemBase &system, const std::vector< VectorTag > &input_vector_tags, std::set< TagID > &selected_tags)
Select the vector tags which belong to a specific system.
Base class for user objects executed one or more sidesets, which may be on the outer boundary of the ...
bool _has_exception
Whether or not an exception has occurred.
unsigned int _num_grid_steps
Number of steps in a grid sequence.
virtual void associateMatrixToTag(libMesh::SparseMatrix< Number > &matrix, TagID tag)
Associate a matrix to a tag.
bool haveXFEM()
Find out whether the current analysis is using XFEM.
virtual void addJacobianBlockTags(libMesh::SparseMatrix< libMesh::Number > &jacobian, unsigned int ivar, unsigned int jvar, const DofMap &dof_map, std::vector< dof_id_type > &dof_indices, const std::set< TagID > &tags, const THREAD_ID tid)
void registerRandomInterface(RandomInterface &random_interface, const std::string &name)
bool _has_time_integrator
Indicates whether or not this executioner has a time integrator (during setup)
This class provides an interface for common operations on field variables of both FE and FV types wit...
const Parallel::Communicator & _communicator
virtual void addAuxKernel(const std::string &kernel_name, const std::string &name, InputParameters ¶meters)
MaterialPropertyRegistry _material_prop_registry
virtual void jacobianSetup()
void clearActiveMaterialProperties(const THREAD_ID tid)
Clear the active material properties.
virtual unsigned int nLinearIterations(const unsigned int nl_sys_num) const override
bool has_static_condensation() const
std::vector< subdomain_id_type > getSubdomainIDs(const libMesh::MeshBase &mesh, const std::vector< SubdomainName > &subdomain_name)
Get the associated subdomainIDs for the subdomain names that are passed in.
ExecuteMooseObjectWarehouse< TransientMultiApp > _transient_multi_apps
Storage for TransientMultiApps (only needed for calling 'computeDT')
bool hasUserObject(const std::string &name) const
Check if there if a user object of given name.
MaterialWarehouse _interface_materials
Real getStartTime() const
Thread to compute threaded general user objects.
The following methods are specializations for using the libMesh::Parallel::packed_range_* routines fo...
bool _ignore_zeros_in_jacobian
Whether to ignore zeros in the Jacobian, thereby leading to a reduced sparsity pattern.
const libMesh::ConstElemRange & getCurrentAlgebraicElementRange()
These are the element and nodes that contribute to the jacobian and residual for this local processor...
void setup(const ExecFlagType &exec_flag, THREAD_ID tid=0) const
void setCurrentExecuteOnFlag(const ExecFlagType &)
virtual void computeResidualInternal(const NumericVector< libMesh::Number > &soln, NumericVector< libMesh::Number > &residual, const std::set< TagID > &tags)
Form a residual vector for a set of tags.
void copyValuesBack()
Copies current chain control data values into old values.
void initElementStatefulProps(const libMesh::ConstElemRange &elem_range, const bool threaded)
Initialize stateful properties for elements in a specific elem_range This is needed when elements/bou...
const libMesh::ConstNodeRange & getCurrentAlgebraicNodeRange()
void setCurrentlyComputingResidualAndJacobian(bool currently_computing_residual_and_jacobian)
Set whether or not the problem is in the process of computing the Jacobian.
ExecuteMooseObjectWarehouse< Transfer > _from_multi_app_transfers
Transfers executed just after MultiApps to transfer data from them.
virtual void addKernel(const std::string &kernel_name, const std::string &name, InputParameters ¶meters)
libMesh::TensorValue< ADReal > ADRealTensorValue
Base class for a system (of equations)
const ExecFlagType EXEC_ALWAYS
SparseMatrix< Number > & getSystemMatrix()
Fetching the system matrix from the libmesh system.
This user object allows related evaluations on elements, boundaries, internal sides, interfaces in one single place.
virtual void addAuxVariable(const std::string &var_type, const std::string &var_name, InputParameters ¶ms)
Canonical method for adding an auxiliary variable.
std::pair< typename M::iterator, bool > moose_try_emplace(M &m, const typename M::key_type &k, Args &&... args)
Function to mirror the behavior of the C++17 std::map::try_emplace() method (no hint).
const T_sys & get_system(std::string_view name) const
std::optional< ConvergenceName > _steady_state_convergence_name
Steady-state detection convergence name.
Base class for MeshDivision objects.
MooseObjectWarehouse< Moose::FunctionBase > _kokkos_functions
bool computingNonlinearResid() const
Returns true if the problem is in the process of computing the nonlinear residual.
virtual void addFVInterfaceKernel(const std::string &fv_ik_name, const std::string &name, InputParameters ¶meters)
MeshDivision & getMeshDivision(const std::string &name, const THREAD_ID tid=0) const
Get a MeshDivision.
bool isRestarting() const
Whether or not this is a "restart" calculation.
Base class for creating new nodally-based mortar user objects.
Reporter objects allow for the declaration of arbitrary data types that are aggregate values for a si...
const Positions & getPositionsObject(const std::string &name) const
Get the Positions object by its name.
libMesh::ConstNodeRange * getLocalNodeRange()
std::map< SolverSystemName, unsigned int > _solver_sys_name_to_num
Map connecting solver system names with their respective systems.
FEProblemBase(const InputParameters ¶meters)
void addEdge(const T &a, const T &b)
Add an edge between nodes 'a' and 'b'.
std::string convertLatestCheckpoint(std::string orig)
bool isOn()
Is adaptivity on?
void computeResidualTags(const std::set< TagID > &tags)
Form multiple tag-associated residual vectors for all the given tags.
virtual void cacheJacobianNeighbor(const THREAD_ID tid) override
Specialization of SubProblem for solving nonlinear equations plus auxiliary equations.
virtual void clearActiveElementalMooseVariables(const THREAD_ID tid)
Clear the active elemental MooseVariableFieldBase.
std::vector< std::unordered_map< BoundaryID, bool > > _bnd_mat_side_cache
Cache for calculating materials on side.
bool hasLinearConvergenceObjects() const
Whether we have linear convergence objects.
virtual const Node & nodeRef(const dof_id_type i) const
std::set< dof_id_type > _ghosted_elems
Elements that should have Dofs ghosted to the local processor.
ExecFlagEnum _print_execution_on
When to print the execution of loops.
std::vector< SubdomainID > getSubdomainIDs(const std::vector< SubdomainName > &subdomain_names) const
Get the associated subdomainIDs for the subdomain names that are passed in.
void clearAllDofIndices()
Clear dof indices from variables in nl and aux systems.
virtual void setResidual(NumericVector< libMesh::Number > &residual, const THREAD_ID tid) override
virtual void solve(const unsigned int nl_sys_num)
virtual void setCurrentLowerDElem(const Elem *const lower_d_elem, const THREAD_ID tid) override
Set the current lower dimensional element.
std::set< TagID > _linear_matrix_tags
Temporary storage for filtered matrix tags for linear systems.
MooseApp & getMooseApp() const
Get the MooseApp this class is associated with.
void bumpAllQRuleOrder(libMesh::Order order, SubdomainID block)
Real computeMultiAppsDT(ExecFlagType type)
Find the smallest timestep over all MultiApps.
const std::string & getSubdomainName(SubdomainID subdomain_id) const
Return the name of a block given an id.
virtual void reinitNeighborFaceRef(const Elem *neighbor_elem, unsigned int neighbor_side, Real tolerance, const std::vector< Point > *const pts, const std::vector< Real > *const weights=nullptr, const THREAD_ID tid=0)
reinitialize FE objects on a given neighbor element on a given side at a given set of reference point...
virtual const MooseVariableFieldBase & getVariable(const THREAD_ID tid, const std::string &var_name, Moose::VarKindType expected_var_type=Moose::VarKindType::VAR_ANY, Moose::VarFieldType expected_var_field_type=Moose::VarFieldType::VAR_FIELD_ANY) const override
Returns the variable reference for requested variable which must be of the expected_var_type (Nonline...
void reinitMaterialsFace(SubdomainID blk_id, const THREAD_ID tid, bool swap_stateful=true, const std::deque< MaterialBase *> *reinit_mats=nullptr)
reinit materials on element faces
std::unique_ptr< libMesh::ConstElemRange > _nl_evaluable_local_elem_range
virtual void disassociateMatrixFromTag(libMesh::SparseMatrix< Number > &matrix, TagID tag)
Disassociate a matrix from a tag.
Scope guard for starting and stopping Floating Point Exception Trapping.
virtual void computeResidualTags(const std::set< TagID > &tags)
Form multiple residual vectors and each is associated with one tag.
void forceOutput()
Indicates that the next call to outputStep should be forced This is private, users should utilize FEP...
virtual void computeJacobianSys(libMesh::NonlinearImplicitSystem &sys, const NumericVector< libMesh::Number > &soln, libMesh::SparseMatrix< libMesh::Number > &jacobian)
Form a Jacobian matrix.
auto max(const L &left, const R &right)
std::shared_ptr< MultiApp > getMultiApp(const std::string &multi_app_name) const
Get a MultiApp object by name.
ExecuteMooseObjectWarehouse< UserObject > _all_user_objects
virtual void reinitElemNeighborAndLowerD(const Elem *elem, unsigned int side, const THREAD_ID tid) override
bool hasSolverVariable(const std::string &var_name) const
void preparePRefinement()
Prepare DofMap and Assembly classes with our p-refinement information.
AuxGroup
Flag for AuxKernel related execution type.
void removeSubstring(std::string &main, const std::string &sub)
virtual Elem * queryElemPtr(const dof_id_type i)
virtual void addMarker(const std::string &marker_name, const std::string &name, InputParameters ¶meters)
void updateGhostedElems()
Updates the list of ghosted elements at the start of each time step for the nonlinear iteration patch...
unsigned int subspaceDim(const std::string &prefix) const
Dimension of the subspace spanned by vectors with a given prefix.
elem_info_iterator ownedElemInfoBegin()
Iterators to owned faceInfo objects.
void setCurrentlyComputingJacobian(const bool currently_computing_jacobian)
Set whether or not the problem is in the process of computing the Jacobian.
unsigned int variable_number(std::string_view var) const
A ReporterName that represents a VectorPostprocessor.
bool needsPreviousNewtonIteration() const
Check to see whether we need to compute the variable values of the previous Newton iterate...
virtual void addBoundaryCondition(const std::string &bc_name, const std::string &name, InputParameters ¶meters)
bool _computing_nonlinear_residual
Whether the non-linear residual is being evaluated.
virtual bool computingPreSMOResidual(const unsigned int nl_sys_num) const override
Returns true if the problem is in the process of computing it's initial residual. ...
void update()
Update the system (doing libMesh magic)
This class is a container/interface for the objects involved in automatic generation of mortar spaces...
virtual Assembly & assembly(const THREAD_ID tid, const unsigned int sys_num) override
void createTagMatrices(CreateTaggedMatrixKey)
const bool _skip_nl_system_check
virtual void resetState()
Reset state of this object in preparation for the next evaluation.
void jacobianSetup()
Calls the jacobianSetup function for each of the output objects.
virtual void addInitialCondition(const std::string &ic_name, const std::string &name, InputParameters ¶meters)
virtual void addCachedResidualDirectly(NumericVector< libMesh::Number > &residual, const THREAD_ID tid)
Allows for all the residual contributions that are currently cached to be added directly into the vec...
bool hasActiveBoundaryObjects(THREAD_ID tid=0) const
virtual void jacobianSetup(THREAD_ID tid=0) const
const SubdomainID INVALID_BLOCK_ID
ScalarInitialConditionWarehouse _scalar_ics
virtual void computeLinearSystemSys(libMesh::LinearImplicitSystem &sys, libMesh::SparseMatrix< libMesh::Number > &system_matrix, NumericVector< libMesh::Number > &rhs, const bool compute_gradients=true)
Assemble both the right hand side and the system matrix of a given linear system. ...
Nonlinear system to be solved.
bool getExodusFileRestart() const
Whether or not we need to use a separate Exodus reader to read the mesh BEFORE we create the mesh...
virtual void swapBackMaterialsFace(const THREAD_ID tid)
virtual void addDistribution(const std::string &type, const std::string &name, InputParameters ¶meters)
The following functions will enable MOOSE to have the capability to import distributions.
virtual void advanceState()
Advance all of the state holding vectors / datastructures so that we can move to the next timestep...
A user object that runs over all the nodes and does an aggregation step to compute a single value...
ExecuteMooseObjectWarehouse< Transfer > _transfers
Normal Transfers.
void setAuxKernelParamsAndLog(const std::string &ak_name, const std::string &name, InputParameters ¶meters, const std::string &base_name)
Set the subproblem and system parameters for auxiliary kernels and log their addition.
virtual void customSetup(const ExecFlagType &exec_type)
virtual void checkBoundaryMatProps()
Checks boundary material properties integrity.
std::map< std::string, std::vector< dof_id_type > > _var_dof_map
Based class for output objects.
const VectorPostprocessorValue & getVectorPostprocessorValueByName(const std::string &object_name, const std::string &vector_name, std::size_t t_index=0) const
Get a read-only reference to the vector value associated with the VectorPostprocessor.
virtual void addPredictor(const std::string &type, const std::string &name, InputParameters ¶meters)
virtual Function & getFunction(const std::string &name, const THREAD_ID tid=0)
virtual void computeJacobianBlocks(std::vector< JacobianBlock *> &blocks, const unsigned int nl_sys_num)
Computes several Jacobian blocks simultaneously, summing their contributions into smaller preconditio...
virtual void copySolutionsBackwards()
const ConstBndNodeRange & getCurrentAlgebraicBndNodeRange()
bool _calculate_jacobian_in_uo
TODO: delete this later - it is a temporary hack for dealing with inter-system dependencies.
virtual void reinitElemFaceRef(const Elem *elem, unsigned int side, Real tolerance, const std::vector< Point > *const pts, const std::vector< Real > *const weights=nullptr, const THREAD_ID tid=0) override
reinitialize FE objects on a given element on a given side at a given set of reference points and the...
virtual void setActiveScalarVariableCoupleableVectorTags(std::set< TagID > &vtags, const THREAD_ID tid)
virtual void prepareFaceShapes(unsigned int var, const THREAD_ID tid) override
virtual void addPostprocessor(const std::string &pp_name, const std::string &name, InputParameters ¶meters)
virtual Real finalNonlinearResidual(const unsigned int nl_sys_num) const override
void addItem(const T &value)
Add an independent item to the set.
std::vector< std::shared_ptr< NonlinearSystemBase > > _nl
The nonlinear systems.
bool automaticScaling() const
Automatic scaling getter.
virtual void computeUserObjects(const ExecFlagType &type, const Moose::AuxGroup &group)
Call compute methods on UserObjects.
virtual void setActiveElementalMooseVariables(const std::set< MooseVariableFEBase *> &moose_vars, const THREAD_ID tid) override
Set the MOOSE variables to be reinited on each element.
virtual void reinit_systems()
std::map< std::pair< BoundaryID, BoundaryID >, NearestNodeLocator * > _nearest_node_locators
std::vector< VariablePhiGradient > _grad_phi_zero
void mooseWarning(Args &&... args) const
void initialSetup(THREAD_ID tid)
Initial setup.
bool hasJacobian() const
Returns _has_jacobian.
void notifyWhenMeshDisplaces(MeshDisplacedInterface *mdi)
Register an object that derives from MeshDisplacedInterface to be notified when the displaced mesh ge...
void createTagSolutions()
Create extra tagged solution vectors.
std::vector< SolverSystemName > _solver_sys_names
The union of nonlinear and linear system names.
virtual void execute(const ExecFlagType &exec_type)
Convenience function for performing execution of MOOSE systems.
bool _verbose_restore
Whether or not to be verbose on solution restoration post a failed time step.
bool _previous_nl_solution_required
Indicates we need to save the previous NL iteration variable values.
processor_id_type n_processors() const
bool _trust_user_coupling_matrix
Whether to trust the user coupling matrix no matter what.
void setRestartRecoverFileBase(const std::string &file_base)
mutator for recover_base (set by RecoverBaseAction)
unsigned int number() const
const ConvergenceName & getSteadyStateConvergenceName() const
Gets the steady-state detection convergence object name.
void computeResidualAndJacobianTags(const std::set< TagID > &vector_tags, const std::set< TagID > &matrix_tags)
Form possibly multiple tag-associated vectors and matrices.
void handleException(const std::string &calling_method)
Handle exceptions.
virtual std::vector< VariableName > getVariableNames()
Returns a list of all the variables in the problem (both from the NL and Aux systems.
ReporterData _reporter_data
const std::string & name() const
Get the name of the class.
void uniformRefine()
uniformly refine the problem mesh(es).
virtual void computeResidualSys(libMesh::NonlinearImplicitSystem &sys, const NumericVector< libMesh::Number > &soln, NumericVector< libMesh::Number > &residual)
This function is called by Libmesh to form a residual.
const ReporterData & getReporterData() const
Provides const access the ReporterData object.
virtual const libMesh::CouplingMatrix & nonlocalCouplingMatrix(const unsigned i) const override
std::unique_ptr< libMesh::ConstElemRange > _current_algebraic_elem_range
FunctorMaterials compute functor material properties.
std::vector< std::shared_ptr< Transfer > > getTransfers(ExecFlagType type, Transfer::DIRECTION direction) const
Get Transfers by ExecFlagType and direction.
virtual void addConvergence(const std::string &type, const std::string &name, InputParameters ¶meters)
Adds a Convergence object.
MultiPointMap & getPoints()
Returns a writeable reference to the _points container.
bool shouldPrintExecution(const THREAD_ID tid) const
Check whether the problem should output execution orders at this time.
const std::vector< std::shared_ptr< T > > & getActiveObjects(THREAD_ID tid=0) const
Retrieve complete vector to the active all/block/boundary restricted objects for a given thread...
const std::set< subdomain_id_type > & active_subdomains() const
bool havePRefinement() const
Query whether p-refinement has been requested at any point during the simulation. ...
virtual Real l2_norm() const=0
bool getRecomputeMarkersFlag() const
Pull out the _recompute_markers_during_cycles flag previously set through the AdaptivityAction.
const bool & _solve
Whether or not to actually solve the nonlinear system.
virtual const SystemBase & systemBaseSolver(const unsigned int sys_num) const override
Return the solver system object as a base class reference given the system number.
DenseVector< Real > getAllRealReporterValues() const
Get all real reporter values including postprocessor and vector postprocessor values into a dense vec...
ExecuteMooseObjectWarehouse< Transfer > _to_multi_app_transfers
Transfers executed just before MultiApps to transfer data to them.
std::set< SubdomainID > getActiveBlocks(THREAD_ID tid=0) const
Return a set of active SubdomainsIDs.
NonlinearSystemBase * _current_nl_sys
The current nonlinear system that we are solving.
MooseObjectWarehouse< Convergence > _convergences
convergence warehouse
Interface for notifications that the mesh has changed.
void sort(THREAD_ID tid=0, bool sort_all_objects=false)
By default, this method only sorts block and boundary-wise object storages that are used by the MOOSE...
virtual std::unique_ptr< Base > create()=0
void setCurrentNonlinearSystem(const unsigned int nl_sys_num)
std::shared_ptr< T > getActiveObject(const std::string &name, THREAD_ID tid=0) const
const std::vector< std::shared_ptr< T > > & getObjects(THREAD_ID tid=0) const
Retrieve complete vector to the all/block/boundary restricted objects for a given thread...
virtual const NumericVector< Number > *const & currentSolution() const override final
The solution vector that is currently being operated on.
void initialSetup()
Initial setup.
Real value(unsigned n, unsigned alpha, unsigned beta, Real x)
Base class for convergence criteria.
MeshBase & getMesh()
Accessor for the underlying libMesh Mesh object.
void min(const T &r, T &o, Request &req) const
virtual void reinitElem(const Elem *elem, const THREAD_ID tid) override
const T & getReporterValue(const ReporterName &reporter_name, const MooseObject &consumer, const ReporterMode &mode, const std::size_t time_index=0) const
Method for returning read only references to Reporter values.
virtual Convergence & getConvergence(const std::string &name, const THREAD_ID tid=0) const
Gets a Convergence object.
TheWarehouse & theWarehouse() const
void createTagVectors()
Create extra tagged vectors and matrices.
virtual void createQRules(libMesh::QuadratureType type, libMesh::Order order, libMesh::Order volume_order=libMesh::INVALID_ORDER, libMesh::Order face_order=libMesh::INVALID_ORDER, SubdomainID block=Moose::ANY_BLOCK_ID, bool allow_negative_qweights=true)
void reinitMaterialsNeighbor(SubdomainID blk_id, const THREAD_ID tid, bool swap_stateful=true, const std::deque< MaterialBase *> *reinit_mats=nullptr)
reinit materials on the neighboring element face
void setMultiAppFixedPointConvergenceName(const ConvergenceName &convergence_name)
Sets the MultiApp fixed point convergence object name if there is one.
Moose::CouplingType _coupling
Type of variable coupling.
Every object that can be built by the factory should be derived from this class.
virtual bool shouldUpdateSolution()
Check to see whether the problem should update the solution.
virtual void setActiveFEVariableCoupleableVectorTags(std::set< TagID > &vtags, const THREAD_ID tid)
void extraSendList(std::vector< dof_id_type > &send_list, void *context)
///< Type of coordinate system
void addObjects(std::shared_ptr< MaterialBase > block, std::shared_ptr< MaterialBase > neighbor, std::shared_ptr< MaterialBase > face, THREAD_ID tid=0)
A special method unique to this class for adding Block, Neighbor, and Face material objects...
const ConvergenceName & getMultiAppFixedPointConvergenceName() const
Gets the MultiApp fixed point convergence object name.
std::vector< std::string > getAllRealReporterFullNames() const
Get full names of all real reporter values Note: For a postprocessor, the full name is the postproces...
virtual void clearActiveScalarVariableCoupleableVectorTags(const THREAD_ID tid)
Real getTimeFromStateArg(const Moose::StateArg &state) const
Returns the time associated with the requested state.
virtual std::string solverTypeString(unsigned int solver_sys_num=0)
Return solver type as a human readable string.
const ExecFlagType EXEC_TIMESTEP_BEGIN
std::shared_ptr< T > getObject(const std::string &name, THREAD_ID tid=0) const
void executeSamplers(const ExecFlagType &exec_type)
Performs setup and execute calls for Sampler objects.
unsigned int which_neighbor_am_i(const Elem *e) const
virtual void computeJacobianInternal(const NumericVector< libMesh::Number > &soln, libMesh::SparseMatrix< libMesh::Number > &jacobian, const std::set< TagID > &tags)
Form a Jacobian matrix for multiple tags.
bool _safe_access_tagged_vectors
Is it safe to retrieve data from tagged vectors.
virtual void computeJacobian(const NumericVector< libMesh::Number > &soln, libMesh::SparseMatrix< libMesh::Number > &jacobian, const unsigned int nl_sys_num)
Form a Jacobian matrix with the default tag (system).
const std::unordered_map< std::pair< BoundaryID, BoundaryID >, std::unique_ptr< AutomaticMortarGeneration > > & getMortarInterfaces(bool on_displaced) const
void reinitMaterialsNeighborOnBoundary(const BoundaryID boundary_id, const SubdomainID blk_id, const THREAD_ID tid, const bool swap_stateful=true, const std::deque< MaterialBase *> *const reinit_mats=nullptr)
reinit materials on neighbor element (usually faces) on a boundary (internal or external) This specif...
void addOutput(const std::string &, const std::string &, InputParameters &)
Adds an Output object.
SolutionIterationType iteration_type
The solution iteration type, e.g. time or nonlinear.
boundary_id_type BoundaryID
void boundaryIntegrityCheckError(const MooseObject &object, const std::set< MooseVariableFieldBase *> &variables, const BoundaryName &boundary_name)
Compose boundary restricted error message for the provided object, variables, and boundary_name if th...
const bool _allow_ics_during_restart
bool constJacobian() const
Returns _const_jacobian (whether a MOOSE object has specified that the Jacobian is the same as the pr...
virtual void clearActiveFEVariableCoupleableMatrixTags(const THREAD_ID tid) override
void computeJacobianTags(const std::set< TagID > &tags)
Computes multiple (tag associated) Jacobian matricese.
SolutionInvalidity & solutionInvalidity()
Get the SolutionInvalidity for this app.
std::vector< MeshChangedInterface * > _notify_when_mesh_changes
Objects to be notified when the mesh changes.
virtual void timestepSetup(THREAD_ID tid=0) const
void checkNonlocalCoupling()
VarKindType
Framework-wide stuff.
void addDefaultSteadyStateConvergence(const InputParameters ¶ms)
Adds the default steady-state detection Convergence.
NonlinearSystemBase & currentNonlinearSystem()
SimpleRange< IndexType > as_range(const std::pair< IndexType, IndexType > &p)
Jacobian-Free Newton Krylov.
void groupUserObjects(TheWarehouse &w, AuxiliarySystem &aux, const ExecFlagEnum &execute_flags, const std::vector< T *> &objs, const std::set< std::string > &ic_deps)
void checkDisplacementOrders()
Verify that SECOND order mesh uses SECOND order displacements.
virtual void addFunction(const std::string &type, const std::string &name, InputParameters ¶meters)
Real PostprocessorValue
various MOOSE typedefs
void uniformly_coarsen(unsigned int n=1)
virtual void addJacobianNeighbor(const THREAD_ID tid) override
virtual TagID addMatrixTag(TagName tag_name)
Create a Tag.
virtual libMesh::EquationSystems & es() override
std::vector< std::unordered_map< SubdomainID, bool > > _block_mat_side_cache
Cache for calculating materials on side.
std::shared_ptr< AuxiliarySystem > _aux
The auxiliary system.
void setRestart(bool value)
Sets the restart/recover flags.
AttribBoundaries tracks all boundary IDs associated with an object.
void setValue(unsigned int i, Number value)
Set the nodal value for this variable (to keep everything up to date.
virtual void reinitElemFaceRef(const Elem *elem, unsigned int side, Real tolerance, const std::vector< Point > *const pts, const std::vector< Real > *const weights=nullptr, const THREAD_ID tid=0)
reinitialize FE objects on a given element on a given side at a given set of reference points and the...
virtual void addVectorPostprocessor(const std::string &pp_name, const std::string &name, InputParameters ¶meters)
MooseMesh wraps a libMesh::Mesh object and enhances its capabilities by caching additional data and s...
virtual bool converged(const unsigned int sys_num)
Eventually we want to convert this virtual over to taking a solver system number argument.
virtual unsigned int currentNlSysNum() const override
virtual void computeIndicators()
virtual MooseVariableScalar & getScalarVariable(const THREAD_ID tid, const std::string &var_name) override
Returns the scalar variable reference from whichever system contains it.
const bool _boundary_restricted_node_integrity_check
whether to perform checking of boundary restricted nodal object variable dependencies, e.g.
virtual void setActiveScalarVariableCoupleableVectorTags(std::set< TagID > &vtags, const THREAD_ID tid) override
virtual void updateActive(THREAD_ID tid=0)
Update the active status of Kernels.
virtual bool updateMeshXFEM()
Update the mesh due to changing XFEM cuts.
virtual const SystemBase & systemBaseNonlinear(const unsigned int sys_num) const override
Return the nonlinear system object as a base class reference given the system number.
std::vector< MortarUserObject * > getMortarUserObjects(BoundaryID primary_boundary_id, BoundaryID secondary_boundary_id, bool displaced, const std::vector< MortarUserObject *> &mortar_uo_superset)
Helper for getting mortar objects corresponding to primary boundary ID, secondary boundary ID...
virtual void restoreSolutions()
virtual bool hasConvergence(const std::string &name, const THREAD_ID tid=0) const
Returns true if the problem has a Convergence object of the given name.
void markFamilyPRefinement(const InputParameters ¶ms)
Mark a variable family for either disabling or enabling p-refinement with valid parameters of a varia...
virtual const std::vector< dof_id_type > & dofIndices() const
Get local DoF indices.
void addAnyRedistributers()
void mooseDeprecated(Args &&... args) const
const std::string & type() const
Get the type of this class.
bool hasPostprocessorValueByName(const PostprocessorName &name) const
Whether or not a Postprocessor value exists by a given name.
virtual void checkBlockMatProps()
Checks block material properties integrity.
void restoreFromInitialBackup(const bool for_restart)
Restores from a "initial" backup, that is, one set in _initial_backup.
void setAxisymmetricCoordAxis(const MooseEnum &rz_coord_axis)
void initialSetup() override
This is a "smart" enum class intended to replace many of the shortcomings in the C++ enum type It sho...
void reinit()
Completely redo all geometric search objects.
std::vector< VectorTag > getVectorTags(const std::set< TagID > &tag_ids) const
bool allowInvalidSolution() const
Whether to accept / allow an invalid solution.
bool needInternalNeighborSideMaterial(SubdomainID subdomain_id, const THREAD_ID tid)
virtual const SystemBase & systemBaseAuxiliary() const override
Return the auxiliary system object as a base class reference.
void setLinearConvergenceNames(const std::vector< ConvergenceName > &convergence_names)
Sets the linear convergence object name(s) if there is one.
void checkUserObjectJacobianRequirement(THREAD_ID tid)
MooseVariableFieldBase & getActualFieldVariable(const THREAD_ID tid, const std::string &var_name) override
Returns the variable reference for requested MooseVariableField which may be in any system...
void finalize(const std::string &object_name)
Helper function for performing post calculation actions via the ReporterContext objects.
void addObject(std::shared_ptr< InitialConditionBase > object, THREAD_ID tid, bool recurse=true)
Add object to the warehouse.
virtual void disassociateVectorFromTag(NumericVector< Number > &vec, TagID tag)
Disassociate a given vector from a given tag.
virtual void computeNullSpace(libMesh::NonlinearImplicitSystem &sys, std::vector< NumericVector< libMesh::Number > *> &sp)
virtual void addTimeIntegrator(const std::string &type, const std::string &name, InputParameters ¶meters)
LinearSystem * _current_linear_sys
The current linear system that we are solving.
virtual void cacheResidual(const THREAD_ID tid) override
virtual void computeResidualType(const NumericVector< libMesh::Number > &soln, NumericVector< libMesh::Number > &residual, TagID tag)
Form a residual vector for a given tag and "residual" tag.
const bool _force_restart
void checkCoordinateSystems()
Performs a sanity check for every element in the mesh.
QueryCache clone() const
clone creates and returns an independent copy of the query in its current state.
void forceOutput()
Indicates that the next call to outputStep should be forced.
const VectorPostprocessor & getVectorPostprocessorObjectByName(const std::string &object_name, const THREAD_ID tid=0) const
Return the VPP object given the name.
std::vector< VariablePhiSecond > _second_phi_zero
StoredRange< std::vector< GeneralUserObject * >::iterator, GeneralUserObject * > GeneralUserObjectRange
bool _started_initial_setup
At or beyond initialSteup stage.
std::map< std::string, std::unique_ptr< RandomData > > _random_data_objects
A map of objects that consume random numbers.
virtual bool vectorTagExists(const TagID tag_id) const
Check to see if a particular Tag exists.
std::unique_ptr< ConstBndNodeRange > _current_algebraic_bnd_node_range
virtual void addResidual(const THREAD_ID tid) override
virtual void addResidualNeighbor(const THREAD_ID tid) override
virtual void reinitNeighborFaceRef(const Elem *neighbor_elem, unsigned int neighbor_side, Real tolerance, const std::vector< Point > *const pts, const std::vector< Real > *const weights=nullptr, const THREAD_ID tid=0) override
reinitialize FE objects on a given neighbor element on a given side at a given set of reference point...
void setCoordSystem(const std::vector< SubdomainName > &blocks, const MultiMooseEnum &coord_sys)
Set the coordinate system for the provided blocks to coord_sys.
Base class for all Postprocessors.
libMesh::ExodusII_IO * getExReaderForRestart() const
Get the Exodus reader to restart variables from an Exodus mesh file.
void needSolutionState(unsigned int oldest_needed, Moose::SolutionIterationType iteration_type)
Declare that we need up to old (1) or older (2) solution states for a given type of iteration...
void clearPoints()
Remove all of the current points and elements.
std::string typeAndName() const
Get the class's combined type and name; useful in error handling.
MooseApp & _app
The MOOSE application this is associated with.
virtual void clearActiveFEVariableCoupleableVectorTags(const THREAD_ID tid) override
void maxloc(T &r, unsigned int &max_id) const
bool isValueSet(const std::string &value) const
Methods for seeing if a value is set in the MultiMooseEnum.
void setCouplingMatrix(std::unique_ptr< libMesh::CouplingMatrix > cm, const unsigned int nl_sys_num)
Set custom coupling matrix.
unsigned int number() const
Gets the number of this system.
virtual void addDefaultNonlinearConvergence(const InputParameters ¶ms)
Adds the default nonlinear Convergence associated with the problem.
virtual void solve() override
Solve the system (using libMesh magic)
void setNonlinearConvergenceNames(const std::vector< ConvergenceName > &convergence_names)
Sets the nonlinear convergence object name(s) if there is one.
unsigned int uniformRefineLevel() const
Returns the level of uniform refinement requested (zero if AMR is disabled).
const ExecFlagType EXEC_LINEAR
TODO: delete this later - it is a temporary hack for dealing with inter-system dependencies.
virtual bool solverSystemConverged(const unsigned int solver_sys_num) override
std::string stringify(const T &t)
conversion to string
std::string _exception_message
The error message to go with an exception.
const std::set< SubdomainID > & boundaryLowerDBlocks() const
std::vector< SubdomainName > getSubdomainNames(const std::vector< SubdomainID > &subdomain_ids) const
Get the associated subdomainNames for the subdomain ids that are passed in.
virtual void checkProblemIntegrity()
Method called to perform a series of sanity checks before a simulation is run.
void setReporterValue(const ReporterName &reporter_name, const T &value, const std::size_t time_index=0)
Method for setting Reporter values that already exist.
Class for storing and utilizing output objects.
AuxiliarySystem & getAuxiliarySystem()
virtual void initialSetup(THREAD_ID tid=0) const
Convenience methods for calling object setup methods.
virtual void updateGeomSearch(GeometricSearchData::GeometricSearchType type=GeometricSearchData::ALL) override
void petscSetOptions(const PetscOptions &po, const SolverParams &solver_params, FEProblemBase *const problem=nullptr)
A function for setting the PETSc options in PETSc from the options supplied to MOOSE.
MooseObjectWarehouse< MeshDivision > _mesh_divisions
Warehouse to store mesh divisions NOTE: this could probably be moved to the MooseMesh instead of the ...
virtual void addConstraint(const std::string &c_name, const std::string &name, InputParameters ¶meters)
void buildRefinementAndCoarseningMaps(Assembly *assembly)
Create the refinement and coarsening maps necessary for projection of stateful material properties wh...
MooseObjectWarehouse< Indicator > _indicators
virtual void addMultiApp(const std::string &multi_app_name, const std::string &name, InputParameters ¶meters)
Add a MultiApp to the problem.
virtual void prepareAssembly(const THREAD_ID tid) override
bool haveADObjects() const
Method for reading wehther we have any ad objects.
unsigned int systemNumForVariable(const VariableName &variable_name) const
bool _checking_uo_aux_state
Flag used to indicate whether we are doing the uo/aux state check in execute.
const PostprocessorValue & getPostprocessorValueByName(const PostprocessorName &name, std::size_t t_index=0) const
Get a read-only reference to the value associated with a Postprocessor that exists.
MeshBase::element_iterator activeLocalElementsBegin()
Calls active_local_nodes_begin/end() on the underlying libMesh mesh object.
InitialConditions are objects that set the initial value of variables.
Base class for user objects executed on all element sides internal to one or more blocks...
virtual void clearActiveScalarVariableCoupleableMatrixTags(const THREAD_ID tid)
virtual std::map< TagName, TagID > & getMatrixTags()
Return all matrix tags in the system, where a tag is represented by a map from name to ID...
virtual void initNullSpaceVectors(const InputParameters ¶meters, std::vector< std::shared_ptr< NonlinearSystemBase >> &nl)
virtual bool hasVariable(const std::string &var_name) const
Query a system for a variable.
Executioner * getExecutioner() const
Retrieve the Executioner for this App.
virtual void setCurrentSubdomainID(const Elem *elem, const THREAD_ID tid) override
MaterialData & getMaterialData(Moose::MaterialDataType type, const THREAD_ID tid=0, const MooseObject *object=nullptr) const
void broadcast(T &data, const unsigned int root_id=0, const bool identical_sizes=false) const
virtual void clearDiracInfo() override
Gets called before Dirac Kernels are asked to add the points they are supposed to be evaluated in...
virtual void addIndicator(const std::string &indicator_name, const std::string &name, InputParameters ¶meters)
virtual void reinitNodesNeighbor(const std::vector< dof_id_type > &nodes, const THREAD_ID tid) override
bool duplicateVariableCheck(const std::string &var_name, const libMesh::FEType &type, bool is_aux, const std::set< SubdomainID > *const active_subdomains)
Helper to check for duplicate variable names across systems or within a single system.
virtual void solve() override=0
Solve the system (using libMesh magic)
GeometricSearchType
Used to select groups of geometric search objects to update.
void backupMultiApps(ExecFlagType type)
Backup the MultiApps associated with the ExecFlagType.
A ReporterName that represents a Postprocessor.
virtual void addVariable(const std::string &var_type, const std::string &var_name, InputParameters ¶ms)
Canonical method for adding a non-linear variable.
bool doingPRefinement() const
ExecuteMooseObjectWarehouse< MultiApp > _multi_apps
MultiApp Warehouse.
virtual void jacobianSetup(THREAD_ID tid=0) const
void updateBoundaryMatPropDependency(std::unordered_set< unsigned int > &needed_mat_props, THREAD_ID tid=0) const
void uniformRefineWithProjection()
Performs uniform refinement on the meshes in the current object.
TagID residualVectorTag() const override
std::vector< std::vector< std::unique_ptr< Assembly > > > _assembly
The Assembly objects.
virtual void addDisplacedProblem(std::shared_ptr< DisplacedProblem > displaced_problem)
const std::map< BoundaryID, std::vector< std::shared_ptr< T > > > & getActiveBoundaryObjects(THREAD_ID tid=0) const
void computeResidual(libMesh::NonlinearImplicitSystem &sys, const NumericVector< libMesh::Number > &soln, NumericVector< libMesh::Number > &residual)
This function is called by Libmesh to form a residual.
virtual void cacheJacobianNeighbor(const THREAD_ID tid)
void setResidualObjectParamsAndLog(const std::string &ro_name, const std::string &name, InputParameters ¶meters, const unsigned int nl_sys_num, const std::string &base_name, bool &reinit_displaced)
Set the subproblem and system parameters for residual objects and log their addition.
void setVectorPostprocessorValueByName(const std::string &object_name, const std::string &vector_name, const VectorPostprocessorValue &value, std::size_t t_index=0)
Set the value of a VectorPostprocessor vector.
virtual MooseVariable & getStandardVariable(const THREAD_ID tid, const std::string &var_name) override
Returns the variable reference for requested MooseVariable which may be in any system.
virtual void initialSetup(THREAD_ID tid=0) const
Convenience methods for calling object setup methods that handle the extra neighbor and face objects...
void setCoordSystem(const std::vector< SubdomainName > &blocks, const MultiMooseEnum &coord_sys)
virtual void swapBackMaterialsNeighbor(const THREAD_ID tid)
virtual void addLinearFVKernel(const std::string &kernel_name, const std::string &name, InputParameters ¶meters)
bool hasStatefulProperties() const
void residualSetup()
Calls the residualSetup function for each of the output objects.
virtual NonlinearSystem & getNonlinearSystem(const unsigned int sys_num)
void solveSetup()
Calls the timestepSetup function for each of the output objects.
virtual bool reinitDirac(const Elem *elem, const THREAD_ID tid) override
Returns true if the Problem has Dirac kernels it needs to compute on elem.
MooseAppCoordTransform & coordTransform()
virtual void cacheResidual(const THREAD_ID tid)
virtual void timestepSetup()
libMesh::Order order() const
Get the order of this variable Note: Order enum can be implicitly converted to unsigned int...
const ExecFlagType EXEC_PRE_DISPLACE
virtual const Elem * elem_ptr(const dof_id_type i) const=0
const std::vector< NonlinearSystemName > _nl_sys_names
The nonlinear system names.
const ExecFlagType EXEC_POSTCHECK
PetscErrorCode PetscInt const PetscInt fields[]
const ExecFlagType EXEC_NONLINEAR
std::vector< Real > VectorPostprocessorValue
virtual void updateMortarMesh()
void copyValuesBack()
At the end of a timestep this method is called to copy the values back in time in preparation for the...
const std::vector< const Elem * > & coarsenedElementChildren(const Elem *elem) const
Get the newly removed children element ids for an element that was just coarsened.
void restore(const std::filesystem::path &folder_base, const bool for_restart)
Restore an application from file.
void addDefaultMultiAppFixedPointConvergence(const InputParameters ¶ms)
Adds the default fixed point Convergence associated with the problem.
std::set< TagID > _fe_matrix_tags
Moose::Kokkos::MaterialPropertyStorage & _kokkos_material_props
virtual NumericVector< Number > & RHS()=0
virtual void addAuxArrayVariable(const std::string &var_name, const libMesh::FEType &type, unsigned int components, const std::set< SubdomainID > *const active_subdomains=NULL)
const ExecuteMooseObjectWarehouse< Transfer > & getMultiAppTransferWarehouse(Transfer::DIRECTION direction) const
Return the complete warehouse for MultiAppTransfer object for the given direction.
virtual const SystemBase & getSystemBase(const unsigned int sys_num) const
Get constant reference to a system in this problem.
const Elem * neighbor_ptr(unsigned int i) const
virtual void reinitLowerDElem(const Elem *lower_d_elem, const THREAD_ID tid, const std::vector< Point > *const pts=nullptr, const std::vector< Real > *const weights=nullptr) override
Provides a way for users to bail out of the current solve.
virtual void addReporter(const std::string &type, const std::string &name, InputParameters ¶meters)
Add a Reporter object to the simulation.
virtual void swapBackMaterials(const THREAD_ID tid)
std::vector< VariablePhiValue > _phi_zero
InitialConditionWarehouse _ics
std::vector< unsigned char > _has_active_material_properties
Whether there are active material properties on each thread.
MaterialWarehouse _discrete_materials
bool _reinit_displaced_face
Whether to call DisplacedProblem::reinitElemFace when this->reinitElemFace is called.
void updateBlockMatPropDependency(SubdomainID id, std::unordered_set< unsigned int > &needed_mat_props, THREAD_ID tid=0) const
void setSinglePetscOption(const std::string &name, const std::string &value="", FEProblemBase *const problem=nullptr)
A wrapper function for dealing with different versions of PetscOptionsSetValue.
virtual void initialSetup()
NumericVector< Number > & getRightHandSideVector()
Fetching the right hand side vector from the libmesh system.
std::unique_ptr< MortarInterfaceWarehouse > _mortar_data
virtual void addDGKernel(const std::string &kernel_name, const std::string &name, InputParameters ¶meters)
virtual void setCurrentBoundaryID(BoundaryID bid, const THREAD_ID tid) override
sets the current boundary ID in assembly
SolverSystem * _current_solver_sys
The current solver system.
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
virtual std::shared_ptr< const DisplacedProblem > getDisplacedProblem() const
virtual bool contract()=0
std::optional< std::vector< ConvergenceName > > _nonlinear_convergence_names
Nonlinear system(s) convergence name(s)
Generic class for solving transient nonlinear problems.
virtual void preProblemInit()
Perform initializations during executing actions right before init_problem task.
void updateActiveSemiLocalNodeRange(std::set< dof_id_type > &ghosted_elems)
Clears the "semi-local" node list and rebuilds it.
subdomain_id_type subdomain_id() const
virtual void stopSolve(const ExecFlagType &exec_flag, const std::set< TagID > &vector_tags_to_close)=0
Quit the current solve as soon as possible.
const InputParameters * getCommonParameters() const
Get a reference to the common output parameters.
TagID timeVectorTag() const override
Ideally, we should not need this API.
std::map< SubdomainID, std::set< MaterialPropertyName > > _zero_block_material_props
Set of properties returned as zero properties.
Class for containing MooseEnum item information.
unsigned int solverSysNum(const SolverSystemName &solver_sys_name) const override
std::shared_ptr< MaterialBase > getMaterial(std::string name, Moose::MaterialDataType type, const THREAD_ID tid=0, bool no_warn=false)
Return a pointer to a MaterialBase object.
virtual void swap(NumericVector< T > &v)
bool hasActiveObject(const std::string &name, THREAD_ID tid=0) const
Convenience functions for checking/getting specific objects.
std::vector< VariableGradient > _grad_zero
bool hasActiveObjects(THREAD_ID tid=0) const
void clearCurrentJacobianMatrixTags()
Clear the current Jacobian matrix tag data structure ...
CTSub CT_OPERATOR_BINARY CTMul CTCompareLess CTCompareGreater CTCompareEqual _arg template * sqrt(_arg)) *_arg.template D< dtag >()) CT_SIMPLE_UNARY_FUNCTION(tanh
virtual void subdomainSetup(SubdomainID subdomain, const THREAD_ID tid)
virtual void restoreOldSolutions()
Restore old solutions from the backup vectors and deallocate them.
unsigned int getInitialSteps() const
Pull out the number of initial steps previously set by calling init()
void max(const T &r, T &o, Request &req) const
void reinitMaterials(SubdomainID blk_id, const THREAD_ID tid, bool swap_stateful=true)
virtual unsigned short dim() const=0
const AutomaticMortarGeneration & getMortarInterface(const std::pair< BoundaryID, BoundaryID > &primary_secondary_boundary_pair, const std::pair< SubdomainID, SubdomainID > &primary_secondary_subdomain_pair, bool on_displaced) const
Return the undisplaced or displaced mortar generation object associated with the provided boundaries ...
bool acceptInvalidSolution() const
Whether or not to accept the solution based on its invalidity.
void setLoadAllVectors(const bool load_all_vectors)
Sets whether or not all vectors are to be loaded.
Class for threaded computation of UserObjects.
const bool _restore_original_nonzero_pattern
Whether we should restore the original nonzero pattern for every Jacobian evaluation.
void setRandomDataPointer(RandomData *random_data)
Base class for all MultiAppTransfer objects.
virtual libMesh::SparseMatrix< Number > & getMatrix(TagID tag)
Get a raw SparseMatrix.
void execMultiAppTransfers(ExecFlagType type, Transfer::DIRECTION direction)
Execute MultiAppTransfers associated with execution flag and direction.
T & set(const std::string &)
Wrapper class that owns a libMesh EquationSystem and adds advanced restart capability to it...
void restoreMultiApps(ExecFlagType type, bool force=false)
Restore the MultiApps associated with the ExecFlagType.
virtual void addLinearFVBC(const std::string &fv_bc_name, const std::string &name, InputParameters ¶meters)
virtual bool is_vertex(const unsigned int i) const=0
void subdomainSetup()
Calls the subdomainSetup function for each of the output objects.
const std::string & getName(const unsigned int id) const
const std::vector< dof_id_type > & allDofIndices() const
Get all global dofindices for the variable.
const std::vector< std::string > & get_elem_var_names()
void addMaterialPropertyStorage(MaterialPropertyStorage &mat_props)
Pushes the given pair ( mat_data , mat_props ) onto our list of _materials data to redistribute each ...
SparseMatrix< Number > * matrix
void customSetup(const ExecFlagType &exec_type) override
void setRestartFile(const std::string &file_name)
Communicate to the Resurector the name of the restart filer.
void setCurrentLinearSystem(unsigned int sys_num)
Set the current linear system pointer.
void initNonlocalCoupling()
Create pair of variables requiring nonlocal jacobian contributions.
void executeControls(const ExecFlagType &exec_type)
Performs setup and execute calls for Control objects.
virtual std::vector< std::shared_ptr< UserObject > > addUserObject(const std::string &user_object_name, const std::string &name, InputParameters ¶meters)
Query query()
query creates and returns an initialized a query object for querying objects from the warehouse...
void allowOutput(bool state)
Ability to enable/disable output calls This is private, users should utilize FEProblemBase::allowOutp...
bool hasStartTime() const
virtual void onTimestepBegin() override
virtual void computeBounds(libMesh::NonlinearImplicitSystem &sys, NumericVector< libMesh::Number > &lower, NumericVector< libMesh::Number > &upper)
Nonlinear system to be solved.
void initKokkos()
Construct Kokkos assembly and systems and allocate Kokkos material property storages.
virtual void computePostCheck(libMesh::NonlinearImplicitSystem &sys, const NumericVector< libMesh::Number > &old_soln, NumericVector< libMesh::Number > &search_direction, NumericVector< libMesh::Number > &new_soln, bool &changed_search_direction, bool &changed_new_soln)
void checkDuplicatePostprocessorVariableNames()
void addConsumer(Moose::MaterialDataType type, const MooseObject *object)
Add object as the consumer of storage of type type.
void setAxisymmetricCoordAxis(const MooseEnum &rz_coord_axis)
For axisymmetric simulations, set the symmetry coordinate axis.
void addOutput(std::shared_ptr< Output > output)
Adds an existing output object to the warehouse.
void computeResidualAndJacobian(const NumericVector< libMesh::Number > &soln, NumericVector< libMesh::Number > &residual, libMesh::SparseMatrix< libMesh::Number > &jacobian)
Form a residual and Jacobian with default tags.
std::vector< std::pair< MooseVariableFEBase *, MooseVariableFEBase * > > & nonlocalCouplingEntries(const THREAD_ID tid, const unsigned int nl_sys_num)
static void selectMatrixTagsFromSystem(const SystemBase &system, const std::map< TagName, TagID > &input_matrix_tags, std::set< TagID > &selected_tags)
Select the matrix tags which belong to a specific system.
std::vector< VariableValue > _scalar_zero
virtual Real computeResidualL2Norm()
Computes the residual using whatever is sitting in the current solution vector then returns the L2 no...
void update(GeometricSearchType type=ALL)
Update all of the search objects.
const std::vector< LinearSystemName > _linear_sys_names
The linear system names.
void incrementMultiAppTStep(ExecFlagType type)
Advance the MultiApps t_step (incrementStepOrReject) associated with the ExecFlagType.
Class for scalar variables (they are different).
IntRange< T > make_range(T beg, T end)
void computeLinearSystemTags(const NumericVector< libMesh::Number > &soln, const std::set< TagID > &vector_tags, const std::set< TagID > &matrix_tags, const bool compute_gradients=true)
Assemble the current linear system given a set of vector and matrix tags.
void bumpVolumeQRuleOrder(libMesh::Order order, SubdomainID block)
Increases the element/volume quadrature order for the specified mesh block if and only if the current...
const bool _material_dependency_check
Determines whether a check to verify material dependencies on every subdomain.
std::vector< std::vector< const MooseVariableFEBase * > > _uo_jacobian_moose_vars
virtual MooseMesh & mesh() override
NonlocalKernel is used for solving integral terms in integro-differential equations.
virtual void subdomainSetup(THREAD_ID tid=0) const
std::vector< VariableValue > _zero
void mooseError(Args &&... args) const
Emits an error prefixed with object name and type and optionally a file path to the top-level block p...
const ExecFlagType EXEC_SAME_AS_MULTIAPP
unsigned int linearSysNum(const LinearSystemName &linear_sys_name) const override
LinearSystem & currentLinearSystem()
Get a non-constant reference to the current linear system.
virtual void updateActive(THREAD_ID tid=0) override
Update the active status of Kernels.
std::set< TagID > _fe_vector_tags
const std::set< const MooseObject * > & getConsumers(Moose::MaterialDataType type) const
const std::set< const MooseObject * > & getMaterialPropertyStorageConsumers(Moose::MaterialDataType type) const
void addObjectParamsHelper(InputParameters ¶ms, const std::string &object_name, const std::string &var_param_name="variable")
Helper for setting the "_subproblem" and "_sys" parameters in addObject() and in addUserObject().
virtual unsigned int size() const override final
SolverParams & solverParams(unsigned int solver_sys_num=0)
Get the solver parameters.
virtual void saveOldSolutions()
Allocate vectors and save old solutions into them.
std::unique_ptr< NumericVector< Number > > current_local_solution
ADRealVectorValue ADRealGradient
virtual void setActiveFEVariableCoupleableMatrixTags(std::set< TagID > &mtags, const THREAD_ID tid)
void mooseConsole()
Send current output buffer to Console output objects.
std::set< std::string > getDependObjects() const
Get a list of dependent UserObjects for this exec type.
virtual void computeTransposeNullSpace(libMesh::NonlinearImplicitSystem &sys, std::vector< NumericVector< libMesh::Number > *> &sp)
bool hasPostprocessor(const std::string &name) const
Deprecated.
virtual bool updateSolution(NumericVector< libMesh::Number > &vec_solution, NumericVector< libMesh::Number > &ghosted_solution)
Update the solution.
ChainControlDataSystem & getChainControlDataSystem()
Gets the system that manages the ChainControls.
std::shared_ptr< DisplacedProblem > _displaced_problem
GeometricSearchData _geometric_search_data
State argument for evaluating functors.
void setCurrentResidualVectorTags(const std::set< TagID > &vector_tags)
Set the current residual vector tag data structure based on the passed in tag IDs.
MooseObjectWarehouse< Function > _functions
functions
void project_vector(NumericVector< Number > &new_vector, FunctionBase< Number > *f, FunctionBase< Gradient > *g=nullptr, int is_adjoint=-1) const
virtual void addObject(std::shared_ptr< T > object, THREAD_ID tid=0, bool recurse=true)
Adds an object to the storage structure.
virtual Real & timeOld() const
Proxy for accessing MaterialPropertyStorage.
std::vector< VectorVariableValue > _vector_zero
bool hasMultiApp(const std::string &name) const
void createMortarInterface(const std::pair< BoundaryID, BoundaryID > &primary_secondary_boundary_pair, const std::pair< SubdomainID, SubdomainID > &primary_secondary_subdomain_pair, bool on_displaced, bool periodic, const bool debug, const bool correct_edge_dropping, const Real minimum_projection_angle)
std::vector< std::unique_ptr< libMesh::CouplingMatrix > > _cm
Coupling matrix for variables.
bool needInterfaceMaterialOnSide(BoundaryID bnd_id, const THREAD_ID tid)
void reinitElemFace(const Elem *elem, unsigned int side, BoundaryID, const THREAD_ID tid)
virtual void cacheResidualNeighbor(const THREAD_ID tid)
Linear system to be solved.
bool hasReporterValue(const ReporterName &reporter_name) const
Return True if a Reporter value with the given type and name have been created.
std::optional< std::vector< ConvergenceName > > _linear_convergence_names
Linear system(s) convergence name(s) (if any)
bool _has_initialized_stateful
Whether nor not stateful materials have been initialized.
void checkICRestartError(const std::string &ic_name, const std::string &name, const VariableName &var_name)
Checks if the variable of the initial condition is getting restarted and errors for specific cases...
virtual void setResidualNeighbor(NumericVector< libMesh::Number > &residual, const THREAD_ID tid) override
QueryCache & condition(Args &&... args)
Adds a new condition to the query.
const TagName SOLUTION_TAG
unsigned int _max_qps
Maximum number of quadrature points used in the problem.
A class for storing an input parameter name.
static InputParameters validParams()
Eigen::Matrix< Real, Eigen::Dynamic, 1 > RealEigenVector
virtual void addScalarKernel(const std::string &kernel_name, const std::string &name, InputParameters ¶meters)
elem_info_iterator ownedElemInfoEnd()
std::set< const Elem * > & getElements()
Returns a writeable reference to the _elements container.
virtual void set(const numeric_index_type i, const T value)=0
void addGhostedBoundary(BoundaryID boundary_id)
This will add the boundary ids to be ghosted to this processor.
bool _preserve_matrix_sparsity_pattern
Whether to preserve the system matrix / Jacobian sparsity pattern, using 0-valued entries usually...
virtual unsigned int nNonlinearIterations(const unsigned int nl_sys_num) const override
CoverageCheckMode _material_coverage_check
Determines whether and which subdomains are to be checked to ensure that they have an active material...
bool isAdaptivityDue()
Query if an adaptivity step should be performed at the current time / time step.
virtual std::size_t numLinearSystems() const override
MaterialPropertyStorage & _neighbor_material_props
std::unique_ptr< Backup > finalizeRestore()
Finalizes (closes) the restoration process done in restore().
libMesh::StoredRange< MooseMesh::const_bnd_elem_iterator, const BndElement * > * getBoundaryElementRange()
bool isParamValid(const std::string &name) const
Test if the supplied parameter is valid.
MOOSE now contains C++17 code, so give a reasonable error message stating what the user can do to add...
const ConsoleStream _console
An instance of helper class to write streams to the Console objects.
const std::size_t _num_linear_sys
The number of linear systems.
std::map< std::string, unsigned int > _subspace_dim
Dimension of the subspace spanned by the vectors with a given prefix.
const libMesh::ConstElemRange & getEvaluableElementRange()
In general, {evaluable elements} >= {local elements} U {algebraic ghosting elements}.
static InputParameters validParams()
bool _currently_computing_residual
Whether the residual is being evaluated.
const UserObject & getUserObjectBase(const std::string &name, const THREAD_ID tid=0) const
Get the user object by its name.
This is a "smart" enum class intended to replace many of the shortcomings in the C++ enum type...
MooseVariableFieldBase & getVariable(THREAD_ID tid, const std::string &var_name) const
Gets a reference to a variable of with specified name.
bool _has_internal_edge_residual_objects
Whether the problem has dgkernels or interface kernels.
bool execMultiApps(ExecFlagType type, bool auto_advance=true)
Execute the MultiApps associated with the ExecFlagType.
const std::string & name() const
void paramWarning(const std::string ¶m, Args... args) const
virtual ArrayMooseVariable & getArrayVariable(const THREAD_ID tid, const std::string &var_name) override
Returns the variable reference for requested ArrayMooseVariable which may be in any system...
const ExecFlagType EXEC_SUBDOMAIN
bool _has_constraints
Whether or not this system has any Constraints.
virtual bool isTransient() const override
bool hasMultiApps() const
Returns whether or not the current simulation has any multiapps.
virtual void reinitNeighbor(const Elem *elem, unsigned int side, const THREAD_ID tid) override
const MaterialData & getMaterialData(const THREAD_ID tid) const
void doingPRefinement(bool doing_p_refinement)
Indicate whether the kind of adaptivity we're doing is p-refinement.
const bool & currentlyComputingJacobian() const
Returns true if the problem is in the process of computing the Jacobian.
void notifyWhenMeshChanges(MeshChangedInterface *mci)
Register an object that derives from MeshChangedInterface to be notified when the mesh changes...
ConstElemPointerRange * coarsenedElementRange() const
Return a range that is suitable for threaded execution over elements that were just coarsened...
std::unique_ptr< libMesh::ConstElemRange > _evaluable_local_elem_range
const Moose::PatchUpdateType & getPatchUpdateStrategy() const
Get the current patch update strategy.
virtual void executeAllObjects(const ExecFlagType &exec_type)
CoverageCheckMode _kernel_coverage_check
Determines whether and which subdomains are to be checked to ensure that they have an active kernel...
virtual void setActiveFEVariableCoupleableVectorTags(std::set< TagID > &vtags, const THREAD_ID tid) override
void check() const
Perform integrity check for get/declare calls.
std::set< std::string > getPostprocessorNames() const
Return a list of all postprocessor names.
bool _fail_next_system_convergence_check
void ghostGhostedBoundaries()
Actually do the ghosting of boundaries that need to be ghosted to this processor. ...
std::vector< std::shared_ptr< LinearSystem > > _linear_systems
The vector of linear systems.
const hit::Node * getHitNode() const
std::shared_ptr< XFEMInterface > _xfem
Pointer to XFEM controller.
virtual void prepareShapes(unsigned int var, const THREAD_ID tid) override
const bool _boundary_restricted_elem_integrity_check
whether to perform checking of boundary restricted elemental object variable dependencies, e.g.
void reinitMaterialsInterface(BoundaryID boundary_id, const THREAD_ID tid, bool swap_stateful=true)
bool _const_jacobian
true if the Jacobian is constant
virtual void computeJacobianBlock(libMesh::SparseMatrix< libMesh::Number > &jacobian, libMesh::System &precond_system, unsigned int ivar, unsigned int jvar)
Really not a good idea to use this.
virtual void solveLinearSystem(const unsigned int linear_sys_num, const Moose::PetscSupport::PetscOptions *po=nullptr)
Build and solve a linear system.
virtual void computeUserObjectByName(const ExecFlagType &type, const Moose::AuxGroup &group, const std::string &name)
Compute an user object with the given name.
virtual void possiblyRebuildGeomSearchPatches()
virtual void add(const numeric_index_type i, const T value)=0
bool _safe_access_tagged_matrices
Is it safe to retrieve data from tagged matrices.
std::set< TagID > _linear_vector_tags
Temporary storage for filtered vector tags for linear systems.
Class that represents the dependecy as a graph.
Moose::Kokkos::MaterialPropertyStorage & _kokkos_bnd_material_props
DiracKernelInfo _dirac_kernel_info
A MultiApp represents one or more MOOSE applications that are running simultaneously.
const TagName PREVIOUS_NL_SOLUTION_TAG
void updateBoundaryVariableDependency(std::set< MooseVariableFieldBase *> &needed_moose_vars, THREAD_ID tid=0) const
processor_id_type processor_id() const
void addObject(std::shared_ptr< FVInitialConditionBase > object, THREAD_ID tid, bool recurse=true)
Add object to the warehouse.
std::vector< T * > & queryIntoUnsorted(std::vector< T *> &results, Args &&... args)
queryInto executes the query and stores the results in the given vector.
const libMesh::ConstElemRange & getNonlinearEvaluableElementRange()
A class for storing the names of MooseObject by tag and object name.
MaterialPropertyStorage & _material_props
Base class for Postprocessors that produce a vector of values.
virtual Order default_order() const=0
void prepareMaterials(const std::unordered_set< unsigned int > &consumer_needed_mat_props, const SubdomainID blk_id, const THREAD_ID tid)
Add the MooseVariables and the material properties that the current materials depend on to the depend...
virtual void addFVKernel(const std::string &kernel_name, const std::string &name, InputParameters ¶meters)
virtual void addFVBC(const std::string &fv_bc_name, const std::string &name, InputParameters ¶meters)
libMesh::Order _max_scalar_order
Maximum scalar variable order.
virtual void addGhostedBoundary(BoundaryID boundary_id) override
Will make sure that all necessary elements from boundary_id are ghosted to this processor.
virtual bool hasFunction(const std::string &name, const THREAD_ID tid=0)
Adaptivity & adaptivity()
bool hasActiveMaterialProperties(const THREAD_ID tid) const
Method to check whether or not a list of active material roperties has been set.
ExecuteMooseObjectWarehouse< Transfer > _between_multi_app_transfers
Transfers executed just before MultiApps to transfer data between them.
bool isRecovering() const
Whether or not this is a "recover" calculation.
SystemBase & sys()
Get the system this variable is part of.
virtual void cacheJacobian(const THREAD_ID tid) override
auto min(const L &left, const R &right)
void jacobianSetup() override
virtual std::size_t numSolverSystems() const override
virtual void addHDGKernel(const std::string &kernel_name, const std::string &name, InputParameters ¶meters)
virtual NumericVector< Number > & getVector(const std::string &name)
Get a raw NumericVector by name.
Restartable::ManagedValue< RestartableEquationSystems > _req
The EquationSystems object, wrapped for restart.
virtual unsigned int currentLinearSysNum() const override
std::vector< libMesh::CouplingMatrix > _nonlocal_cm
nonlocal coupling matrix
virtual void reinitNodeFace(const Node *node, BoundaryID bnd_id, const THREAD_ID tid) override
virtual void reinitOffDiagScalars(const THREAD_ID tid) override
processor_id_type processor_id() const
virtual void reinitElemPhys(const Elem *elem, const std::vector< Point > &phys_points_in_elem, const THREAD_ID tid) override
std::vector< std::unordered_map< BoundaryID, bool > > _interface_mat_side_cache
Cache for calculating materials on interface.
virtual void addObject(std::shared_ptr< T > object, THREAD_ID tid=0, bool recurse=true) override
Adds an object to the storage structure.
void initKokkosStatefulProps()
const std::vector< std::string > & get_nodal_var_names()
std::string getRestartRecoverFileBase() const
The file_base for the recovery file.
virtual void addJacobianNeighborLowerD(const THREAD_ID tid) override
virtual void prepareNeighborShapes(unsigned int var, const THREAD_ID tid) override
MooseObjectWarehouse< Marker > _markers
FVInitialConditionWarehouse _fv_ics
void setVerboseProblem(bool verbose)
Make the problem be verbose.
virtual void setNeighborSubdomainID(const Elem *elem, unsigned int side, const THREAD_ID tid) override
virtual const VectorTag & getVectorTag(const TagID tag_id) const
Get a VectorTag from a TagID.
MaterialBases compute MaterialProperties.
virtual void initialAdaptMesh()
void updatePointLocator(const MooseMesh &mesh)
Called during FEProblemBase::meshChanged() to update the PointLocator object used by the DiracKernels...
virtual void addResidualScalar(const THREAD_ID tid=0)
Moose::Kokkos::MaterialPropertyStorage & _kokkos_neighbor_material_props
This is a template class that implements the workhorse compute and computeNodal methods.
MaterialWarehouse _all_materials
const MeshBase::element_iterator activeLocalElementsEnd()
virtual void addCachedResidual(const THREAD_ID tid) override
for(PetscInt i=0;i< nvars;++i)
void clearNearestNodeLocators()
Clear out the Penetration Locators so they will redo the search.
Moose::PetscSupport::PetscOptions _petsc_options
PETSc option storage.
libMesh::StoredRange< MooseMesh::const_bnd_node_iterator, const BndNode * > * getBoundaryNodeRange()
virtual const std::vector< std::shared_ptr< Convergence > > & getConvergenceObjects(const THREAD_ID tid=0) const
Gets the Convergence objects.
void ErrorVector unsigned int
virtual void clearActiveElementalMooseVariables(const THREAD_ID tid) override
Clear the active elemental MooseVariableFEBase.
auto index_range(const T &sizable)
Base class for user-specific data.
void timestepSetup()
Calls the timestepSetup function for each of the output objects.
void allowOutput(bool state)
Ability to enable/disable all output calls.
virtual void cacheJacobian(const THREAD_ID tid)
virtual Sampler & getSampler(const std::string &name, const THREAD_ID tid=0)
const std::string & _type
The type of this class.
virtual void outputStep(ExecFlagType type)
Output the current step.
void projectInitialConditionOnCustomRange(libMesh::ConstElemRange &elem_range, ConstBndNodeRange &bnd_node_range, const std::optional< std::set< VariableName >> &target_vars=std::nullopt)
Project initial conditions for custom elem_range and bnd_node_range This is needed when elements/boun...
virtual unsigned int nlSysNum(const NonlinearSystemName &nl_sys_name) const override
OutputWarehouse & getOutputWarehouse()
Get the OutputWarehouse objects.
MooseEnum _verbose_setup
Whether or not to be verbose during setup.
static InputParameters validParams()
RedistributeProperties is used for its redistribute() callback, which ensures that any stateful prope...
unsigned int state
The state.
virtual void computeJacobianTags(const std::set< TagID > &tags)
Form multiple matrices, and each is associated with a tag.
void computeSystems(const ExecFlagType &type)
Do generic system computations.
MooseMesh * _displaced_mesh
void resize(unsigned int n_qpoints)
Resize the data to hold properties for n_qpoints quadrature points.
bool _has_mortar
Whether the simulation requires mortar coupling.
void computeLinearSystemTags(const std::set< TagID > &vector_tags, const std::set< TagID > &matrix_tags, const bool compute_gradients=true)
Compute the right hand side and the system matrix of the system for given tags.
libMesh::Order getMaxScalarOrder() const
void execTransfers(ExecFlagType type)
Execute the Transfers associated with the ExecFlagType.
void addNotZeroedVectorTag(const TagID tag)
Adds a vector tag to the list of vectors that will not be zeroed when other tagged vectors are...
void restoreState(bool verbose=false)
When a time step fails, this method is called to revert the current reporter values to their old stat...
void meshChanged()
Declares that the MooseMesh has changed, invalidates cached data and rebuilds caches.
void buildPRefinementAndCoarseningMaps(Assembly *assembly)
const std::vector< ConvergenceName > & getLinearConvergenceNames() const
Gets the linear convergence object name(s).
virtual void ghostGhostedBoundaries() override
Causes the boundaries added using addGhostedBoundary to actually be ghosted.
const ExecFlagType EXEC_POST_ADAPTIVITY
void add_ghosting_functor(GhostingFunctor &ghosting_functor)
MaterialWarehouse _materials
virtual void addJacobianScalar(const THREAD_ID tid=0)
virtual void addDiracKernel(const std::string &kernel_name, const std::string &name, InputParameters ¶meters)
An instance of this object type has one copy per thread that runs on each thread. ...
MooseObjectWarehouse< IntegratedBCBase > _nonlocal_integrated_bcs
nonlocal integrated_bcs
virtual void computeResidualTag(const NumericVector< libMesh::Number > &soln, NumericVector< libMesh::Number > &residual, TagID tag)
Form a residual vector for a given tag.
virtual VectorMooseVariable & getVectorVariable(const THREAD_ID tid, const std::string &var_name) override
Returns the variable reference for requested VectorMooseVariable which may be in any system...
std::shared_ptr< LineSearch > _line_search
void initXFEM(std::shared_ptr< XFEMInterface > xfem)
Create XFEM controller object.
const std::set< SubdomainID > & meshSubdomains() const
Returns a read-only reference to the set of subdomains currently present in the Mesh.
SubdomainID getSubdomainID(const SubdomainName &subdomain_name) const
Get the associated subdomain ID for the subdomain name.
const FEType & type() const
Base class for all Transfer objects.
void parallelBarrierNotify(const Parallel::Communicator &comm, bool messaging)
virtual void neighborSubdomainSetup(SubdomainID subdomain, const THREAD_ID tid)
void setupFiniteVolumeMeshData() const
Sets up the additional data needed for finite volume computations.
virtual void addCachedJacobian(const THREAD_ID tid) override
virtual void residualSetup(THREAD_ID tid=0) const
virtual void sizeZeroes(unsigned int size, const THREAD_ID tid)
virtual Real computeDamping(const NumericVector< libMesh::Number > &soln, const NumericVector< libMesh::Number > &update)
std::vector< Real > _real_zero
Convenience zeros.
MooseObjectWarehouse< KernelBase > _nonlocal_kernels
nonlocal kernels
void checkCoordinateSystems()
Verify that there are no element type/coordinate type conflicts.
unsigned int getMaxQps() const
const ExecFlagType EXEC_INITIAL
virtual libMesh::System & system() override
Get the reference to the libMesh system.
bool _verbose_multiapps
Whether or not to be verbose with multiapps.
Key structure for APIs manipulating global vectors/matrices.