85 #include "libmesh/nonlinear_solver.h" 86 #include "libmesh/quadrature_gauss.h" 87 #include "libmesh/dense_vector.h" 88 #include "libmesh/boundary_info.h" 89 #include "libmesh/petsc_matrix.h" 90 #include "libmesh/petsc_vector.h" 91 #include "libmesh/petsc_nonlinear_solver.h" 92 #include "libmesh/numeric_vector.h" 93 #include "libmesh/mesh.h" 94 #include "libmesh/dense_subvector.h" 95 #include "libmesh/dense_submatrix.h" 96 #include "libmesh/dof_map.h" 97 #include "libmesh/sparse_matrix.h" 98 #include "libmesh/petsc_matrix.h" 99 #include "libmesh/default_coupling.h" 100 #include "libmesh/diagonal_matrix.h" 101 #include "libmesh/fe_interface.h" 102 #include "libmesh/petsc_solver_exception.h" 106 #include "petscsnes.h" 116 const std::string & name)
122 _residual_ghosted(NULL),
125 _Re_non_time_tag(-1),
127 _scalar_kernels(false),
129 _preset_nodal_bcs(false),
130 _ad_preset_nodal_bcs(false),
132 _increment_vec(NULL),
133 _use_finite_differenced_preconditioner(false),
134 _fdcoloring(nullptr),
135 _have_decomposition(false),
136 _use_field_split_preconditioner(false),
137 _add_implicit_geometric_coupling_entries_to_jacobian(false),
138 _assemble_constraints_separately(false),
139 _need_residual_ghosted(false),
140 _debugging_residuals(false),
144 _n_residual_evaluations(0),
146 _computing_pre_smo_residual(false),
147 _pre_smo_residual(0),
148 _initial_residual(0),
149 _use_pre_smo_residual(false),
150 _print_all_var_norms(false),
152 _has_diag_save_in(false),
153 _has_nodalbc_save_in(false),
154 _has_nodalbc_diag_save_in(false),
155 _computed_scaling(false),
156 _compute_scaling_once(true),
157 _resid_vs_jac_scaling_param(0),
158 _off_diagonals_in_auto_scaling(false),
159 _auto_scaling_initd(false)
177 dof_map.set_implicit_neighbor_dofs(
false);
205 TIME_SECTION(
"nlInitialSetup", 2,
"Setting Up Nonlinear System");
210 TIME_SECTION(
"kernelsInitialSetup", 2,
"Setting Up Kernels/BCs/Constraints");
227 std::vector<FVElementalKernel *> fv_elemental_kernels;
230 .template condition<AttribSystem>(
"FVElementalKernel")
231 .
template condition<AttribThread>(tid)
234 for (
auto * fv_kernel : fv_elemental_kernels)
235 fv_kernel->initialSetup();
237 std::vector<FVFluxKernel *> fv_flux_kernels;
240 .template condition<AttribSystem>(
"FVFluxKernel")
241 .
template condition<AttribThread>(tid)
244 for (
auto * fv_kernel : fv_flux_kernels)
245 fv_kernel->initialSetup();
256 TIME_SECTION(
"mortarSetup", 2,
"Initializing Mortar Interfaces");
258 auto create_mortar_functors = [
this](
const bool displaced)
262 for (
const auto & mortar_interface : mortar_interfaces)
264 const auto primary_secondary_boundary_pair = mortar_interface.first;
268 const auto & mortar_generation_object = mortar_interface.second;
270 auto & mortar_constraints =
277 auto & mortar_functors =
280 mortar_functors.emplace(primary_secondary_boundary_pair,
282 mortar_generation_object,
290 create_mortar_functors(
false);
291 create_mortar_functors(
true);
322 std::vector<FVFluxBC *> bcs;
325 .template condition<AttribSystem>(
"FVFluxBC")
326 .
template condition<AttribThread>(tid)
329 std::vector<FVInterfaceKernel *> iks;
332 .template condition<AttribSystem>(
"FVInterfaceKernel")
333 .
template condition<AttribThread>(tid)
336 std::vector<FVFluxKernel *> kernels;
339 .template condition<AttribSystem>(
"FVFluxKernel")
340 .
template condition<AttribThread>(tid)
343 for (
auto * bc : bcs)
345 for (
auto * ik : iks)
347 for (
auto * kernel : kernels)
348 kernel->timestepSetup();
376 std::vector<FVFluxBC *> bcs;
379 .template condition<AttribSystem>(
"FVFluxBC")
380 .
template condition<AttribThread>(tid)
383 std::vector<FVInterfaceKernel *> iks;
386 .template condition<AttribSystem>(
"FVInterfaceKernel")
387 .
template condition<AttribThread>(tid)
390 std::vector<FVFluxKernel *> kernels;
393 .template condition<AttribSystem>(
"FVFluxKernel")
394 .
template condition<AttribThread>(tid)
397 for (
auto * bc : bcs)
398 bc->customSetup(exec_type);
399 for (
auto * ik : iks)
400 ik->customSetup(exec_type);
401 for (
auto * kernel : kernels)
402 kernel->customSetup(exec_type);
422 if (splits.size() && splits.size() != 1)
423 mooseError(
"Only a single top-level split is allowed in a Problem's decomposition.");
441 top_split->setup(*
this);
446 const std::string & name,
452 std::shared_ptr<KernelBase> kernel =
458 if (parameters.
get<std::vector<AuxVariableName>>(
"save_in").size() > 0)
460 if (parameters.
get<std::vector<AuxVariableName>>(
"diag_save_in").size() > 0)
466 const std::string & name,
485 const std::string & name,
498 const std::string & name,
504 std::shared_ptr<NodalKernelBase> kernel =
510 if (parameters.
get<std::vector<AuxVariableName>>(
"save_in").size() > 0)
512 if (parameters.
get<std::vector<AuxVariableName>>(
"diag_save_in").size() > 0)
518 const std::string & name,
521 std::shared_ptr<ScalarKernelBase> kernel =
529 const std::string & name,
536 std::shared_ptr<BoundaryCondition> bc =
541 const std::set<BoundaryID> & boundary_ids = bc->boundaryIDs();
543 _vars[tid].addBoundaryVar(boundary_ids, bc_var);
552 if (nbc->checkNodalVar() && !nbc->variable().isNodal())
553 mooseError(
"Trying to use nodal boundary condition '",
555 "' on a non-nodal variable '",
556 nbc->variable().name(),
560 _vars[tid].addBoundaryVars(boundary_ids, nbc->getCoupledVars());
562 if (parameters.get<std::vector<AuxVariableName>>(
"save_in").size() > 0)
564 if (parameters.get<std::vector<AuxVariableName>>(
"diag_save_in").size() > 0)
569 if (dbc && dbc->preset())
573 if (addbc && addbc->preset())
581 _vars[tid].addBoundaryVars(boundary_ids, ibc->getCoupledVars());
583 if (parameters.get<std::vector<AuxVariableName>>(
"save_in").size() > 0)
585 if (parameters.get<std::vector<AuxVariableName>>(
"diag_save_in").size() > 0)
597 const std::set<BoundaryID> & boundary_ids = bc->boundaryIDs();
598 _vars[tid].addBoundaryVar(boundary_ids, bc_var);
603 _vars[tid].addBoundaryVars(boundary_ids, ibc->getCoupledVars());
608 mooseError(
"Unknown BoundaryCondition type for object named ", bc->name());
613 const std::string & name,
620 if (constraint && constraint->addCouplingEntriesToJacobian())
626 const std::string & name,
631 std::shared_ptr<DiracKernelBase> kernel =
640 const std::string & name,
652 if (parameters.
get<std::vector<AuxVariableName>>(
"save_in").size() > 0)
654 if (parameters.
get<std::vector<AuxVariableName>>(
"diag_save_in").size() > 0)
660 const std::string & name,
665 std::shared_ptr<InterfaceKernelBase> interface_kernel =
669 const std::set<BoundaryID> & boundary_ids = interface_kernel->boundaryIDs();
671 _vars[tid].addBoundaryVar(boundary_ids, ik_var);
674 _vars[tid].addBoundaryVars(boundary_ids, interface_kernel->getCoupledVars());
680 const std::string & name,
708 const std::string & name,
715 std::shared_ptr<Split>
733 if (
_app.
parameters().
get<
bool>(
"use_legacy_initial_residual_evaluation_behavior"))
749 mooseError(
"pre-SMO residual is requested but not evaluated.");
801 parallel_object_only();
803 TIME_SECTION(
"nl::computeResidualTags", 5);
808 bool required_residual = tags.find(
residualVectorTag()) == tags.end() ? false :
true;
831 if (required_residual)
837 ti->postResidual(residual);
880 const std::set<TagID> & matrix_tags)
882 const bool required_residual =
892 if (required_residual)
898 ti->postResidual(residual);
936 TIME_SECTION(
"applyPredictor", 2,
"Applying Predictor");
942 _console <<
" Skipping predictor this step" << std::endl;
947 TIME_SECTION(
"initialBCs", 2,
"Applying BCs To Initial Condition");
950 for (
const auto & bnode : bnd_nodes)
953 Node * node = bnode->_node;
963 for (
const auto & preset_bc : preset_bcs)
964 preset_bc->computeValue(initial_solution);
969 for (
const auto & preset_bc : preset_bcs_res)
970 preset_bc->computeValue(initial_solution);
1062 mooseError(
"The required residual vector is not available");
1074 for (
const auto & nc : ncs)
1076 std::vector<dof_id_type> & secondary_node_ids = nc->getSecondaryNodeId();
1077 std::vector<dof_id_type> & primary_node_ids = nc->getPrimaryNodeId();
1079 if ((secondary_node_ids.size() > 0) && (primary_node_ids.size() > 0))
1083 nc->computeResidual(residual);
1103 for (
const auto & nc : ncs)
1105 std::vector<dof_id_type> & secondary_node_ids = nc->getSecondaryNodeId();
1106 std::vector<dof_id_type> & primary_node_ids = nc->getPrimaryNodeId();
1108 if ((secondary_node_ids.size() > 0) && (primary_node_ids.size() > 0))
1112 nc->computeJacobian(jacobian);
1124 const bool displaced)
1129 const Elem * primary_elem =
info._elem;
1130 unsigned int primary_side =
info._side_num;
1131 std::vector<Point> points;
1132 points.push_back(
info._closest_point);
1153 const Elem *
const undisplaced_primary_elem =
1155 const Point undisplaced_primary_physical_point =
1156 [&points, displaced, primary_elem, undisplaced_primary_elem]()
1160 const Point reference_point =
1161 FEMap::inverse_map(primary_elem->dim(), primary_elem, points[0]);
1162 return FEMap::map(primary_elem->dim(), undisplaced_primary_elem, reference_point);
1171 undisplaced_primary_elem, primary_side, {undisplaced_primary_physical_point}, 0);
1188 "If we're calling this method with displaced = true, then we better well have a " 1189 "displaced problem");
1194 bool constraints_applied =
false;
1196 for (
const auto & it : penetration_locators)
1207 const auto & constraints =
1209 std::unordered_set<unsigned int> needed_mat_props;
1210 for (
const auto & constraint : constraints)
1212 const auto & mp_deps = constraint->getMatPropDependencies();
1213 needed_mat_props.insert(mp_deps.begin(), mp_deps.end());
1217 for (
unsigned int i = 0; i < secondary_nodes.size(); i++)
1219 dof_id_type secondary_node_num = secondary_nodes[i];
1230 for (
const auto & nfc : constraints)
1232 if (nfc->isExplicitConstraint())
1238 if (nfc->secondaryBoundary() != secondary_boundary ||
1239 nfc->primaryBoundary() != primary_boundary)
1242 if (nfc->shouldApply())
1244 constraints_applied =
true;
1245 nfc->computeSecondaryValue(
solution);
1248 if (nfc->hasWritableCoupledVariables())
1250 Threads::spin_mutex::scoped_lock lock(Threads::spin_mtx);
1251 for (
auto * var : nfc->getWritableCoupledVariables())
1253 if (var->isNodalDefined())
1265 std::set<dof_id_type> unique_secondary_node_ids;
1273 const auto & constraints =
1277 unique_secondary_node_ids.clear();
1279 for (
const auto & elem :
as_range(meshhelper.active_subdomain_elements_begin(secondary_id),
1280 meshhelper.active_subdomain_elements_end(secondary_id)))
1282 for (
auto & n : elem->node_ref_range())
1283 unique_secondary_node_ids.insert(n.id());
1286 for (
auto secondary_node_id : unique_secondary_node_ids)
1300 for (
const auto & nec : constraints)
1302 if (nec->shouldApply())
1304 constraints_applied =
true;
1305 nec->computeSecondaryValue(
solution);
1317 if (constraints_applied)
1332 "If we're calling this method with displaced = true, then we better well have a " 1333 "displaced problem");
1338 bool constraints_applied;
1339 bool residual_has_inserted_values =
false;
1341 constraints_applied =
false;
1342 for (
const auto & it : penetration_locators)
1348 constraints_applied =
false;
1357 bool has_writable_variables(
false);
1361 const auto & constraints =
1364 for (
unsigned int i = 0; i < secondary_nodes.size(); i++)
1366 dof_id_type secondary_node_num = secondary_nodes[i];
1377 for (
const auto & nfc : constraints)
1383 if (nfc->secondaryBoundary() != secondary_boundary ||
1384 nfc->primaryBoundary() != primary_boundary)
1387 if (nfc->shouldApply())
1389 constraints_applied =
true;
1390 nfc->computeResidual();
1392 if (nfc->overwriteSecondaryResidual())
1398 const auto & secondary_var = nfc->variable();
1399 const auto & secondary_dofs = secondary_var.dofIndices();
1400 mooseAssert(secondary_dofs.size() == secondary_var.count(),
1401 "We are on a node so there should only be one dof per variable (for " 1402 "an ArrayVariable we should have a number of dofs equal to the " 1403 "number of components");
1409 std::vector<Number> values = {nfc->secondaryResidual()};
1410 residual.
insert(values, secondary_dofs);
1411 residual_has_inserted_values =
true;
1417 if (nfc->hasWritableCoupledVariables())
1419 Threads::spin_mutex::scoped_lock lock(Threads::spin_mtx);
1420 has_writable_variables =
true;
1421 for (
auto * var : nfc->getWritableCoupledVariables())
1423 if (var->isNodalDefined())
1434 if (has_writable_variables)
1452 if (constraints_applied)
1457 if (residual_has_inserted_values)
1460 residual_has_inserted_values =
false;
1474 if (constraints_applied)
1479 if (residual_has_inserted_values)
1493 for (
const auto & it : element_pair_locators)
1500 const auto & _element_constraints =
1504 const std::list<std::pair<const Elem *, const Elem *>> & elem_pairs =
1506 for (
const auto & pr : elem_pairs)
1508 const Elem * elem1 = pr.first;
1509 const Elem * elem2 = pr.second;
1517 for (
const auto & ec : _element_constraints)
1524 ec->prepareShapes(ec->variable().number());
1525 ec->prepareNeighborShapes(ec->variable().number());
1528 ec->computeResidual();
1538 std::set<dof_id_type> unique_secondary_node_ids;
1540 constraints_applied =
false;
1541 residual_has_inserted_values =
false;
1548 const auto & constraints =
1552 unique_secondary_node_ids.clear();
1554 for (
const auto & elem :
as_range(meshhelper.active_subdomain_elements_begin(secondary_id),
1555 meshhelper.active_subdomain_elements_end(secondary_id)))
1557 for (
auto & n : elem->node_ref_range())
1558 unique_secondary_node_ids.insert(n.id());
1561 for (
auto secondary_node_id : unique_secondary_node_ids)
1574 for (
const auto & nec : constraints)
1576 if (nec->shouldApply())
1578 constraints_applied =
true;
1579 nec->computeResidual();
1581 if (nec->overwriteSecondaryResidual())
1584 residual_has_inserted_values =
true;
1599 if (constraints_applied)
1604 if (residual_has_inserted_values)
1627 for (
const auto & it : penetration_locators)
1637 const auto & constraints =
1641 const auto secondary_node_num = secondary_nodes[i];
1646 for (
const auto & nfc : constraints)
1648 if (!nfc->isExplicitConstraint())
1655 if (nfc->secondaryBoundary() != secondary_boundary ||
1656 nfc->primaryBoundary() != primary_boundary)
1659 nfc->overwriteBoundaryVariables(soln, secondary_node);
1670 TIME_SECTION(
"residualSetup", 3);
1700 parallel_object_only();
1702 TIME_SECTION(
"computeResidualInternal", 3);
1710 std::vector<UserObject *> uos;
1716 for (
auto & uo : uos)
1717 uo->residualSetup();
1718 for (
auto & uo : uos)
1732 TIME_SECTION(
"Kernels", 3 );
1737 Threads::parallel_reduce(elem_range, cr);
1749 Threads::parallel_reduce(faces, fvr);
1752 displaced_problem && displaced_problem->haveFV())
1756 FVRange faces(displaced_problem->mesh().ownedFaceInfoBegin(),
1757 displaced_problem->mesh().ownedFaceInfoEnd());
1758 Threads::parallel_reduce(faces, fvr);
1774 TIME_SECTION(
"ScalarKernels", 3 );
1782 else if (tags.size() == 1)
1783 scalar_kernel_warehouse =
1789 bool have_scalar_contributions =
false;
1791 for (
const auto & scalar_kernel : scalars)
1793 scalar_kernel->reinit();
1794 const std::vector<dof_id_type> & dof_indices = scalar_kernel->variable().dofIndices();
1800 if (dof >= first_dof && dof < end_dof)
1802 scalar_kernel->computeResidual();
1803 have_scalar_contributions =
true;
1808 if (have_scalar_contributions)
1819 TIME_SECTION(
"NodalKernels", 3 );
1829 Threads::parallel_reduce(range, cnk);
1851 TIME_SECTION(
"NodalKernelBCs", 3 );
1857 Threads::parallel_reduce(bnd_node_range, cnk);
1919 const std::set<TagID> & matrix_tags)
1921 TIME_SECTION(
"computeResidualAndJacobianInternal", 3);
1926 for (
auto tag : matrix_tags)
1935 LibmeshPetscCall(MatSetOption(petsc_matrix->mat(),
1936 MAT_KEEP_NONZERO_PATTERN,
1940 MatSetOption(petsc_matrix->mat(), MAT_NEW_NONZERO_ALLOCATION_ERR, PETSC_FALSE));
1948 std::vector<UserObject *> uos;
1954 for (
auto & uo : uos)
1955 uo->residualSetup();
1956 for (
auto & uo : uos)
1970 TIME_SECTION(
"Kernels", 3 );
1975 Threads::parallel_reduce(elem_range, crj);
1983 Threads::parallel_reduce(faces, fvrj);
1986 displaced_problem && displaced_problem->haveFV())
1990 FVRange faces(displaced_problem->mesh().ownedFaceInfoBegin(),
1991 displaced_problem->mesh().ownedFaceInfoEnd());
1992 Threads::parallel_reduce(faces, fvr);
2014 for (
const auto & residual_vector_tag : residual_vector_tags)
2045 else if (tags.size() == 1)
2051 if (!nbc_warehouse->
size())
2058 if (!bnd_nodes.
empty())
2060 TIME_SECTION(
"NodalBCs", 3 );
2062 for (
const auto & bnode : bnd_nodes)
2065 Node * node = bnode->_node;
2074 for (
const auto & nbc : bcs)
2075 if (nbc->shouldApply())
2076 nbc->computeResidual();
2095 if (!bnd_nodes.
empty())
2097 TIME_SECTION(
"NodalBCs", 3 );
2099 for (
const auto & bnode : bnd_nodes)
2102 Node * node = bnode->_node;
2111 for (
const auto & nbc : bcs)
2112 if (nbc->shouldApply())
2113 nbc->computeResidualAndJacobian();
2129 unsigned int s =
number();
2132 for (
unsigned int v = 0; v <
nVariables(); v++)
2133 for (
unsigned int c = 0; c < node.
n_comp(s, v); c++)
2141 std::unordered_map<
dof_id_type, std::vector<dof_id_type>> & graph)
2145 for (
const auto & it : nearest_node_locators)
2147 std::vector<dof_id_type> & secondary_nodes = it.second->_secondary_nodes;
2149 for (
const auto & secondary_node : secondary_nodes)
2151 std::set<dof_id_type> unique_secondary_indices;
2152 std::set<dof_id_type> unique_primary_indices;
2154 auto node_to_elem_pair = node_to_elem_map.find(secondary_node);
2155 if (node_to_elem_pair != node_to_elem_map.end())
2157 const std::vector<dof_id_type> & elems = node_to_elem_pair->second;
2160 for (
const auto & cur_elem : elems)
2162 std::vector<dof_id_type> dof_indices;
2165 for (
const auto & dof : dof_indices)
2166 unique_secondary_indices.insert(dof);
2170 std::vector<dof_id_type> primary_nodes = it.second->_neighbor_nodes[secondary_node];
2172 for (
const auto & primary_node : primary_nodes)
2174 auto primary_node_to_elem_pair = node_to_elem_map.find(primary_node);
2175 mooseAssert(primary_node_to_elem_pair != node_to_elem_map.end(),
2176 "Missing entry in node to elem map");
2177 const std::vector<dof_id_type> & primary_node_elems = primary_node_to_elem_pair->second;
2180 for (
const auto & cur_elem : primary_node_elems)
2182 std::vector<dof_id_type> dof_indices;
2185 for (
const auto & dof : dof_indices)
2186 unique_primary_indices.insert(dof);
2190 for (
const auto & secondary_id : unique_secondary_indices)
2191 for (
const auto & primary_id : unique_primary_indices)
2193 graph[secondary_id].push_back(primary_id);
2194 graph[primary_id].push_back(secondary_id);
2201 for (
const auto & nc : ncs)
2203 std::vector<dof_id_type> primary_dofs;
2204 std::vector<dof_id_type> & primary_node_ids = nc->getPrimaryNodeId();
2205 for (
const auto & node_id : primary_node_ids)
2216 std::vector<dof_id_type> secondary_dofs;
2217 std::vector<dof_id_type> & secondary_node_ids = nc->getSecondaryNodeId();
2218 for (
const auto & node_id : secondary_node_ids)
2229 for (
const auto & primary_id : primary_dofs)
2230 for (
const auto & secondary_id : secondary_dofs)
2232 graph[primary_id].push_back(secondary_id);
2233 graph[secondary_id].push_back(primary_id);
2238 for (
auto & it : graph)
2240 std::vector<dof_id_type> & row = it.second;
2241 std::sort(row.begin(), row.end());
2242 std::vector<dof_id_type>::iterator uit = std::unique(row.begin(), row.end());
2243 row.resize(uit - row.begin());
2257 std::unordered_map<dof_id_type, std::vector<dof_id_type>> graph;
2261 for (
const auto & it : graph)
2264 const auto & row = it.second;
2266 for (
const auto & coupled_dof : row)
2267 jacobian.add(dof, coupled_dof, 0);
2281 MAT_NEW_NONZERO_ALLOCATION_ERR,
2285 LibmeshPetscCall(MatSetOption(
2286 static_cast<PetscMatrix<Number> &
>(jacobian).mat(), MAT_IGNORE_ZERO_ENTRIES, PETSC_TRUE));
2288 std::vector<numeric_index_type> zero_rows;
2292 "If we're calling this method with displaced = true, then we better well have a " 2293 "displaced problem");
2298 bool constraints_applied;
2300 constraints_applied =
false;
2301 for (
const auto & it : penetration_locators)
2307 constraints_applied =
false;
2319 const auto & constraints =
2322 for (
const auto & secondary_node_num : secondary_nodes)
2335 for (
const auto & nfc : constraints)
2337 if (nfc->isExplicitConstraint())
2343 if (nfc->secondaryBoundary() != secondary_boundary ||
2344 nfc->primaryBoundary() != primary_boundary)
2347 nfc->_jacobian = &jacobian;
2349 if (nfc->shouldApply())
2351 constraints_applied =
true;
2353 nfc->prepareShapes(nfc->variable().number());
2354 nfc->prepareNeighborShapes(nfc->variable().number());
2356 nfc->computeJacobian();
2358 if (nfc->overwriteSecondaryJacobian())
2361 zero_rows.push_back(nfc->variable().nodalDofIndex());
2364 std::vector<dof_id_type> secondary_dofs(1, nfc->variable().nodalDofIndex());
2370 Real scaling_factor =
2371 nfc->overwriteSecondaryJacobian() ? 1. : nfc->variable().scalingFactor();
2377 nfc->_connected_dof_indices,
2381 if (nfc->addCouplingEntriesToJacobian())
2388 nfc->primaryVariable().dofIndicesNeighbor(),
2394 nfc->primaryVariable().dofIndicesNeighbor(),
2395 nfc->_connected_dof_indices,
2396 nfc->variable().scalingFactor());
2403 const std::vector<MooseVariableFEBase *> coupled_vars = nfc->getCoupledMooseVars();
2404 for (
const auto & jvar : coupled_vars)
2412 if (nfc->variable().number() == jvar->number() ||
2414 nfc->variable().number(), jvar->number(), this->
number()))
2420 nfc->prepareShapes(nfc->variable().number());
2421 nfc->prepareNeighborShapes(jvar->number());
2423 nfc->computeOffDiagJacobian(jvar->number());
2429 nfc->_connected_dof_indices,
2433 if (nfc->addCouplingEntriesToJacobian())
2440 jvar->dofIndicesNeighbor(),
2446 nfc->variable().dofIndicesNeighbor(),
2447 nfc->_connected_dof_indices,
2448 nfc->variable().scalingFactor());
2465 if (constraints_applied)
2468 MAT_KEEP_NONZERO_PATTERN,
2472 jacobian.zero_rows(zero_rows, 0.0);
2484 if (constraints_applied)
2487 MAT_KEEP_NONZERO_PATTERN,
2491 jacobian.zero_rows(zero_rows, 0.0);
2501 for (
const auto & it : element_pair_locators)
2508 const auto & _element_constraints =
2512 const std::list<std::pair<const Elem *, const Elem *>> & elem_pairs =
2514 for (
const auto & pr : elem_pairs)
2516 const Elem * elem1 = pr.first;
2517 const Elem * elem2 = pr.second;
2525 for (
const auto & ec : _element_constraints)
2532 ec->prepareShapes(ec->variable().number());
2533 ec->prepareNeighborShapes(ec->variable().number());
2536 ec->computeJacobian();
2546 std::set<dof_id_type> unique_secondary_node_ids;
2547 constraints_applied =
false;
2554 const auto & constraints =
2558 unique_secondary_node_ids.clear();
2560 for (
const auto & elem :
as_range(meshhelper.active_subdomain_elements_begin(secondary_id),
2561 meshhelper.active_subdomain_elements_end(secondary_id)))
2563 for (
auto & n : elem->node_ref_range())
2564 unique_secondary_node_ids.insert(n.id());
2567 for (
auto secondary_node_id : unique_secondary_node_ids)
2581 for (
const auto & nec : constraints)
2583 if (nec->shouldApply())
2585 constraints_applied =
true;
2587 nec->_jacobian = &jacobian;
2588 nec->prepareShapes(nec->variable().number());
2589 nec->prepareNeighborShapes(nec->variable().number());
2591 nec->computeJacobian();
2593 if (nec->overwriteSecondaryJacobian())
2596 zero_rows.push_back(nec->variable().nodalDofIndex());
2599 std::vector<dof_id_type> secondary_dofs(1, nec->variable().nodalDofIndex());
2605 nec->_connected_dof_indices,
2606 nec->variable().scalingFactor());
2611 nec->primaryVariable().dofIndicesNeighbor(),
2612 nec->_connected_dof_indices,
2613 nec->variable().scalingFactor());
2619 const std::vector<MooseVariableFEBase *> coupled_vars = nec->getCoupledMooseVars();
2620 for (
const auto & jvar : coupled_vars)
2628 if (nec->variable().number() == jvar->number() ||
2630 nec->variable().number(), jvar->number(), this->
number()))
2636 nec->prepareShapes(nec->variable().number());
2637 nec->prepareNeighborShapes(jvar->number());
2639 nec->computeOffDiagJacobian(jvar->number());
2645 nec->_connected_dof_indices,
2646 nec->variable().scalingFactor());
2651 nec->variable().dofIndicesNeighbor(),
2652 nec->_connected_dof_indices,
2653 nec->variable().scalingFactor());
2668 if (constraints_applied)
2671 MAT_KEEP_NONZERO_PATTERN,
2675 jacobian.zero_rows(zero_rows, 0.0);
2689 else if (tags.size() == 1)
2703 bool have_scalar_contributions =
false;
2704 for (
const auto & kernel : scalars)
2707 const std::vector<dof_id_type> & dof_indices = kernel->variable().dofIndices();
2713 if (dof >= first_dof && dof < end_dof)
2715 kernel->computeJacobian();
2717 have_scalar_contributions =
true;
2723 if (have_scalar_contributions)
2759 TIME_SECTION(
"computeJacobianInternal", 3);
2766 for (
auto tag : tags)
2775 LibmeshPetscCall(MatSetOption(petsc_matrix->mat(),
2776 MAT_KEEP_NONZERO_PATTERN,
2780 MatSetOption(petsc_matrix->mat(), MAT_NEW_NONZERO_ALLOCATION_ERR, PETSC_FALSE));
2788 std::vector<UserObject *> uos;
2794 for (
auto & uo : uos)
2795 uo->jacobianSetup();
2796 for (
auto & uo : uos)
2819 Threads::parallel_reduce(range, cnkjt);
2835 Threads::parallel_reduce(faces, fvj);
2838 displaced_problem && displaced_problem->haveFV())
2842 FVRange faces(displaced_problem->mesh().ownedFaceInfoBegin(),
2843 displaced_problem->mesh().ownedFaceInfoEnd());
2844 Threads::parallel_reduce(faces, fvr);
2860 Threads::parallel_reduce(elem_range, cj);
2882 Threads::parallel_reduce(elem_range, cj);
2895 Threads::parallel_reduce(bnd_range, cnkjt);
2908 Threads::parallel_reduce(elem_range, cj);
2911 for (
unsigned int i = 0; i <
n_threads; i++)
2920 Threads::parallel_reduce(bnd_range, cnkjt);
2932 static bool first =
true;
2980 else if (tags.size() == 1)
2997 std::map<std::string, std::set<unsigned int>> bc_involved_vars;
2999 for (
const auto & bid : all_boundary_ids)
3006 for (
const auto & bc : bcs)
3008 const std::vector<MooseVariableFEBase *> & coupled_moose_vars =
3009 bc->getCoupledMooseVars();
3013 std::set<unsigned int> & var_set = bc_involved_vars[bc->name()];
3014 for (
const auto & coupled_var : coupled_moose_vars)
3016 var_set.insert(coupled_var->number());
3018 var_set.insert(bc->variable().number());
3038 for (
const auto & bnode : bnd_nodes)
3041 Node * node = bnode->_node;
3049 for (
const auto & bc : bcs)
3052 std::set<unsigned int> & var_set = bc_involved_vars[bc->name()];
3058 for (
const auto & it : coupling_entries)
3060 unsigned int ivar = it.first->number(), jvar = it.second->number();
3066 if ((bc->variable().number() == ivar) && var_set.count(jvar) && bc->shouldApply())
3067 bc->computeOffDiagJacobian(jvar);
3070 const auto & coupled_scalar_vars = bc->getCoupledMooseScalarVars();
3071 for (
const auto & jvariable : coupled_scalar_vars)
3073 bc->computeOffDiagJacobianScalar(jvariable->number());
3107 for (
auto & tag : tags)
3126 TIME_SECTION(
"computeJacobianTags", 5);
3148 for (
auto & tag : tags)
3156 const std::set<TagID> & tags)
3158 TIME_SECTION(
"computeJacobianBlocks", 3);
3161 for (
unsigned int i = 0; i < blocks.size(); i++)
3166 MAT_KEEP_NONZERO_PATTERN,
3170 MAT_NEW_NONZERO_ALLOCATION_ERR,
3183 Threads::parallel_reduce(elem_range, cjb);
3187 for (
unsigned int i = 0; i < blocks.size(); i++)
3188 blocks[i]->_jacobian.close();
3190 for (
unsigned int i = 0; i < blocks.size(); i++)
3195 unsigned int ivar = blocks[i]->_ivar;
3196 unsigned int jvar = blocks[i]->_jvar;
3199 std::vector<numeric_index_type> zero_rows;
3203 for (
const auto & bnode : bnd_nodes)
3206 Node * node = bnode->_node;
3216 for (
const auto & bc : bcs)
3217 if (bc->variable().number() == ivar && bc->shouldApply())
3269 bool has_active_dampers =
false;
3277 TIME_SECTION(
"computeDampers", 3,
"Computing Dampers");
3278 has_active_dampers =
true;
3291 TIME_SECTION(
"computeDamping::element", 3,
"Computing Element Damping");
3293 has_active_dampers =
true;
3306 TIME_SECTION(
"computeDamping::general", 3,
"Computing General Damping");
3308 has_active_dampers =
true;
3310 for (
const auto & damper : gdampers)
3315 damper->checkMinDamping(gd_damping);
3321 damping =
std::min(gd_damping, damping);
3336 if (has_active_dampers && damping < 1.0)
3337 _console <<
" Damping factor: " << damping << std::endl;
3347 std::set<const Elem *> dirac_elements;
3351 TIME_SECTION(
"computeDirac", 3,
"Computing DiracKernels");
3357 for (
const auto & dkernel : dkernels)
3359 dkernel->clearPoints();
3360 dkernel->addPoints();
3368 DistElemRange range(dirac_elements.begin(), dirac_elements.end(), 1);
3417 std::vector<dof_id_type> & n_nz,
3418 std::vector<dof_id_type> & n_oz)
3424 std::unordered_map<dof_id_type, std::vector<dof_id_type>> graph;
3439 for (
const auto & git : graph)
3444 if (dof < first_dof_on_proc || dof >= end_dof_on_proc)
3447 const auto & row = git.second;
3451 unsigned int original_row_length = sparsity_row.size();
3453 sparsity_row.insert(sparsity_row.end(), row.begin(), row.end());
3455 SparsityPattern::sort_row(
3456 sparsity_row.begin(), sparsity_row.begin() + original_row_length, sparsity_row.end());
3459 for (
const auto & coupled_dof : row)
3461 if (coupled_dof < first_dof_on_proc || coupled_dof >= end_dof_on_proc)
3463 if (n_oz[local_dof] < n_dofs_not_on_proc)
3468 if (n_nz[local_dof] < n_dofs_on_proc)
3504 mooseError(
"More than one active Preconditioner detected");
3523 const std::set<MooseVariable *> & damped_vars)
3525 for (
const auto & var : damped_vars)
3531 const std::set<MooseVariable *> & damped_vars)
3533 for (
const auto & var : damped_vars)
3541 std::set<SubdomainID> input_subdomains;
3542 std::set<std::string> kernel_variables;
3544 bool global_kernels_exist =
false;
3556 std::vector<FVElementalKernel *> fv_elemental_kernels;
3559 .template condition<AttribSystem>(
"FVElementalKernel")
3560 .queryInto(fv_elemental_kernels);
3562 for (
auto fv_kernel : fv_elemental_kernels)
3564 if (fv_kernel->blockRestricted())
3565 for (
auto block_id : fv_kernel->blockIDs())
3566 input_subdomains.insert(block_id);
3568 global_kernels_exist =
true;
3569 kernel_variables.insert(fv_kernel->variable().name());
3572 if (dynamic_cast<FVScalarLagrangeMultiplierConstraint *>(fv_kernel))
3573 kernel_variables.insert(dynamic_cast<FVScalarLagrangeMultiplierConstraint *>(fv_kernel)
3578 std::vector<FVFluxKernel *> fv_flux_kernels;
3581 .template condition<AttribSystem>(
"FVFluxKernel")
3582 .queryInto(fv_flux_kernels);
3584 for (
auto fv_kernel : fv_flux_kernels)
3586 if (fv_kernel->blockRestricted())
3587 for (
auto block_id : fv_kernel->blockIDs())
3588 input_subdomains.insert(block_id);
3590 global_kernels_exist =
true;
3591 kernel_variables.insert(fv_kernel->variable().name());
3594 std::vector<FVInterfaceKernel *> fv_interface_kernels;
3597 .template condition<AttribSystem>(
"FVInterfaceKernel")
3598 .queryInto(fv_interface_kernels);
3600 for (
auto fvik : fv_interface_kernels)
3601 if (
auto scalar_fvik = dynamic_cast<FVScalarLagrangeMultiplierInterface *>(fvik))
3602 kernel_variables.insert(scalar_fvik->lambdaVariable().name());
3604 std::vector<FVFluxBC *> fv_flux_bcs;
3607 .template condition<AttribSystem>(
"FVFluxBC")
3608 .queryInto(fv_flux_bcs);
3610 for (
auto fvbc : fv_flux_bcs)
3611 if (
auto scalar_fvbc = dynamic_cast<FVBoundaryScalarLagrangeMultiplierConstraint *>(fvbc))
3612 kernel_variables.insert(scalar_fvbc->lambdaVariable().name());
3616 if (!global_kernels_exist)
3618 std::set<SubdomainID> difference;
3619 std::set_difference(mesh_subdomains.begin(),
3620 mesh_subdomains.end(),
3621 input_subdomains.begin(),
3622 input_subdomains.end(),
3623 std::inserter(difference, difference.end()));
3627 difference.erase(
id);
3629 difference.erase(
id);
3631 if (!difference.empty())
3633 std::vector<SubdomainID> difference_vec =
3634 std::vector<SubdomainID>(difference.begin(), difference.end());
3636 std::stringstream missing_block_names;
3637 std::copy(difference_names.begin(),
3638 difference_names.end(),
3639 std::ostream_iterator<std::string>(missing_block_names,
" "));
3640 std::stringstream missing_block_ids;
3641 std::copy(difference.begin(),
3643 std::ostream_iterator<unsigned int>(missing_block_ids,
" "));
3645 mooseError(
"Each subdomain must contain at least one Kernel.\nThe following block(s) lack an " 3647 missing_block_names.str(),
3649 missing_block_ids.str(),
3657 std::set<VariableName> difference;
3658 std::set_difference(variables.begin(),
3660 kernel_variables.begin(),
3661 kernel_variables.end(),
3662 std::inserter(difference, difference.end()));
3665 std::set<VariableName> vars(difference);
3666 for (
auto & var_name : vars)
3669 for (
const auto &
id : blks)
3671 difference.erase(var_name);
3674 if (!difference.empty())
3676 std::stringstream missing_kernel_vars;
3677 std::copy(difference.begin(),
3679 std::ostream_iterator<std::string>(missing_kernel_vars,
" "));
3680 mooseError(
"Each variable must be referenced by at least one active Kernel.\nThe following " 3681 "variable(s) lack an active kernel: " +
3682 missing_kernel_vars.str());
3694 std::vector<std::string>
3697 std::vector<std::string> variable_names;
3699 if (time_kernels.hasActiveObjects())
3700 for (
const auto & kernel : time_kernels.getObjects())
3701 variable_names.push_back(kernel->variable().name());
3703 return variable_names;
3740 const std::set<TagID> & vector_tags,
3741 const std::set<TagID> & matrix_tags)
3743 parallel_object_only();
3748 map_pr.second(compute_type, vector_tags, matrix_tags);
3751 map_pr.second(compute_type, vector_tags, matrix_tags);
3753 catch (MetaPhysicL::LogicError &)
3756 "We caught a MetaPhysicL error in NonlinearSystemBase::mortarConstraints. This is very " 3757 "likely due to AD not having a sufficiently large derivative container size. Please run " 3758 "MOOSE configure with the '--with-derivative-size=<n>' option");
3781 std::set<unsigned int> var_numbers, var_numbers_covered, var_numbers_not_covered;
3783 var_numbers.insert(var_number);
3793 "', provided to the 'scaling_group_variables' parameter, does not exist in " 3794 "the nonlinear system.");
3801 if (!map_pair.second)
3802 mooseError(
"Variable ", var_name,
" is contained in multiple scaling grouplings");
3803 var_numbers_covered.insert(var.
number());
3806 std::set_difference(var_numbers.begin(),
3808 var_numbers_covered.begin(),
3809 var_numbers_covered.end(),
3810 std::inserter(var_numbers_not_covered, var_numbers_not_covered.begin()));
3815 for (
auto var_number : var_numbers_not_covered)
3820 const auto & number_to_var_map =
_vars[0].numberToVariableMap();
3826 libmesh_map_find(number_to_var_map, i)->name()) !=
3839 _console <<
"\nPerforming automatic scaling calculation\n" << std::endl;
3841 TIME_SECTION(
"computeScaling", 3,
"Computing Automatic Scaling");
3848 std::vector<dof_id_type> dof_indices;
3856 auto & dof_map =
dofMap();
3900 auto examine_dof_indices = [
this,
3904 &jac_inverse_scaling_factors,
3905 &resid_inverse_scaling_factors,
3906 &scaling_residual](
const auto & dof_indices,
const auto var_number)
3908 for (
auto dof_index : dof_indices)
3909 if (dof_map.local_index(dof_index))
3914 auto mat_value = (*_scaling_matrix)(dof_index, dof_index);
3920 auto vec_value = scaling_residual(dof_index);
3932 dof_map.dof_indices(elem, dof_indices, i);
3933 examine_dof_indices(dof_indices, i);
3939 dof_map.SCALAR_dof_indices(dof_indices, i);
3940 examine_dof_indices(dof_indices, i);
3948 if (jac_scaling && resid_scaling)
3949 for (MooseIndex(inverse_scaling_factors) i = 0; i < inverse_scaling_factors.size(); ++i)
3952 if (!resid_inverse_scaling_factors[i])
3954 if (!jac_inverse_scaling_factors[i])
3955 inverse_scaling_factors[i] = 1;
3957 inverse_scaling_factors[i] = jac_inverse_scaling_factors[i];
3959 else if (!jac_inverse_scaling_factors[i])
3961 inverse_scaling_factors[i] = resid_inverse_scaling_factors[i];
3963 inverse_scaling_factors[i] =
3967 else if (jac_scaling)
3968 inverse_scaling_factors = jac_inverse_scaling_factors;
3969 else if (resid_scaling)
3970 inverse_scaling_factors = resid_inverse_scaling_factors;
3972 mooseError(
"We shouldn't be calling this routine if we're not performing any scaling");
3975 for (
auto & scaling_factor : inverse_scaling_factors)
3976 if (scaling_factor == 0)
3980 std::vector<Real> flattened_inverse_scaling_factors(
system().
n_vars());
3981 for (
const auto i :
index_range(flattened_inverse_scaling_factors))
3982 flattened_inverse_scaling_factors[i] = inverse_scaling_factors[
_var_to_group_var[i]];
3987 displaced_problem->systemBaseNonlinear(
number()).applyScalingFactors(
3988 flattened_inverse_scaling_factors);
4001 auto & scaling_vector =
getVector(
"scaling_factors");
4004 const auto & dof_map =
dofMap();
4006 const auto & field_variables =
_vars[0].fieldVariables();
4007 const auto & scalar_variables =
_vars[0].scalars();
4009 std::vector<dof_id_type> dof_indices;
4011 for (
const Elem *
const elem :
4012 as_range(lm_mesh.active_local_elements_begin(), lm_mesh.active_local_elements_end()))
4013 for (
const auto *
const field_var : field_variables)
4015 const auto & factors = field_var->arrayScalingFactor();
4016 for (
const auto i :
make_range(field_var->count()))
4018 dof_map.dof_indices(elem, dof_indices, field_var->number() + i);
4019 for (
const auto dof : dof_indices)
4020 scaling_vector.set(dof, factors[i]);
4024 for (
const auto *
const scalar_var : scalar_variables)
4026 mooseAssert(scalar_var->count() == 1,
4027 "Scalar variables should always have only one component.");
4028 dof_map.SCALAR_dof_indices(dof_indices, scalar_var->number());
4029 for (
const auto dof : dof_indices)
4030 scaling_vector.set(dof, scalar_var->scalingFactor());
4034 scaling_vector.close();
4038 displaced_problem->systemBaseNonlinear(
number()).getVector(
"scaling_factors") = scaling_vector;
4056 if (!scaling_succeeded)
4071 LibmeshPetscCall(MatFDColoringDestroy(&
_fdcoloring));
std::string name(const ElemQuality q)
std::vector< std::shared_ptr< TimeIntegrator > > _time_integrators
Time integrator.
virtual void setSolutionUDotDotOld(const NumericVector< Number > &u_dotdot_old)
virtual void reinitNeighborPhys(const Elem *neighbor, unsigned int neighbor_side, const std::vector< Point > &physical_points, const THREAD_ID tid)=0
virtual void residualSetup(THREAD_ID tid=0) const
NumericVector< Number > & getResidualTimeVector()
Return a numeric vector that is associated with the time tag.
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.
MooseObjectTagWarehouse< NodalKernelBase > _nodal_kernels
NodalKernels for each thread.
NumericVector< Number > * _Re_time
residual vector for time contributions
void computeJacobianBlocks(std::vector< JacobianBlock *> &blocks)
Computes several Jacobian blocks simultaneously, summing their contributions into smaller preconditio...
virtual void insert(const T *v, const std::vector< numeric_index_type > &dof_indices)
MetaPhysicL::DualNumber< V, D, asd > abs(const MetaPhysicL::DualNumber< V, D, asd > &a)
TagID _Re_time_tag
Tag for time contribution residual.
void allgather(const T &send_data, std::vector< T, A > &recv_data) const
unsigned int size(THREAD_ID tid=0) const
Return how many kernels we store in the current warehouse.
std::map< std::pair< BoundaryID, BoundaryID >, PenetrationLocator * > _penetration_locators
virtual void addKernel(const std::string &kernel_name, const std::string &name, InputParameters ¶meters)
Adds a kernel.
virtual void setSolutionUDotDot(const NumericVector< Number > &udotdot)
Set transient term used by residual and Jacobian evaluation.
dof_id_type dof_number(const unsigned int s, const unsigned int var, const unsigned int comp) const
A kernel for hybridized finite element formulations.
dof_id_type n_local_dofs() const
void reinitIncrementAtNodeForDampers(THREAD_ID tid, const std::set< MooseVariable *> &damped_vars)
Compute the incremental change in variables at nodes for dampers.
void overwriteNodeFace(NumericVector< Number > &soln)
Called from explicit time stepping to overwrite boundary positions (explicit dynamics).
Base class for deriving general dampers.
bool _use_pre_smo_residual
Whether to use the pre-SMO initial residual in the relative convergence check.
MoosePreconditioner const * getPreconditioner() 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)
void findImplicitGeometricCouplingEntries(GeometricSearchData &geom_search_data, std::unordered_map< dof_id_type, std::vector< dof_id_type >> &graph)
Finds the implicit sparsity graph between geometrically related dofs.
void setupDampers()
Setup damping stuff (called before we actually start)
Real _initial_residual
The initial (i.e., 0th nonlinear iteration) residual, see setPreSMOResidual for a detailed explanatio...
std::vector< bool > _variable_autoscaled
Container to hold flag if variable is to participate in autoscaling.
void zeroVectorForResidual(const std::string &vector_name)
virtual void cacheResidualNeighbor(const THREAD_ID tid) override
bool identifyVariableGroupsInNL() const
Whether to identify variable groups in nonlinear systems.
void zeroTaggedVectors(const std::set< TagID > &tags)
Zero all vectors for given tags.
const std::set< SubdomainID > & interiorLowerDBlocks() const
Base class for split-based preconditioners.
bool hasActiveBlockObjects(THREAD_ID tid=0) const
bool hasVector(const std::string &tag_name) const
Check if the named vector exists in the system.
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...
unsigned int n_comp(const unsigned int s, const unsigned int var) const
void applyScalingFactors(const std::vector< Real > &inverse_scaling_factors)
Applies scaling factors to the system's variables.
void computeNodalBCsResidualAndJacobian()
compute the residual and Jacobian for nodal boundary conditions
bool _debugging_residuals
true if debugging residuals
BoundaryID _secondary_boundary
NumericVector< Number > * _Re_non_time
residual vector for non-time contributions
Real computeDamping(const NumericVector< Number > &solution, const NumericVector< Number > &update)
Compute damping.
virtual void reinitNode(const Node *node, const THREAD_ID tid) override
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.
void enforceNodalConstraintsJacobian()
bool _assemble_constraints_separately
Whether or not to assemble the residual and Jacobian after the application of each constraint...
virtual Elem * elemPtr(const dof_id_type i)
TagID systemMatrixTag() const override
Return the Matrix Tag ID for System.
void petscSetupDM(NonlinearSystemBase &nl, const std::string &dm_name)
Setup the PETSc DM object.
NumericVector< Number > & solution()
MooseObjectTagWarehouse< DGKernelBase > _dg_kernels
virtual bool haveFV() const override
returns true if this problem includes/needs finite volume functionality.
face_info_iterator ownedFaceInfoBegin()
Iterators to owned faceInfo objects.
void reinitIncrementAtQpsForDampers(THREAD_ID tid, const std::set< MooseVariable *> &damped_vars)
Compute the incremental change in variables at QPs for dampers.
void computeResidualAndJacobianInternal(const std::set< TagID > &vector_tags, const std::set< TagID > &matrix_tags)
Compute residual and Jacobian from contributions not related to constraints, such as nodal boundary c...
void addImplicitGeometricCouplingEntriesToJacobian(bool add=true)
If called with true this will add entries into the jacobian to link together degrees of freedom that ...
void dof_indices(const Elem *const elem, std::vector< dof_id_type > &di) const
bool haveFieldSplitPreconditioner() const
bool areCoupled(const unsigned int ivar, const unsigned int jvar, const unsigned int nl_sys_num) const
void mooseError(Args &&... args)
Emit an error message with the given stringified, concatenated args and terminate the application...
InputParameters & parameters()
Get the parameters of the object.
unsigned int number() const
Get variable number coming from libMesh.
virtual void initialSetup() override
Setup Functions.
Data structure used to hold penetration information.
const std::vector< std::shared_ptr< NodalConstraint > > & getActiveNodalConstraints() const
Access methods for active objects.
NumericVector< Number > * _u_dot_old
old solution vector for u^dot
bool _has_nodalbc_diag_save_in
If there is a nodal BC having diag_save_in.
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
Base class for automatic differentiation Dirichlet BCs.
virtual void getDiracElements(std::set< const Elem *> &elems) override
Fills "elems" with the elements that should be looped over for Dirac Kernels.
void setupDM()
Setup the PETSc DM object (when appropriate)
void setCurrentlyComputingResidual(bool currently_computing_residual) final
Set whether or not the problem is in the process of computing the residual.
void checkKernelCoverage(const std::set< SubdomainID > &mesh_subdomains) const
void addDGKernel(std::string dg_kernel_name, const std::string &name, InputParameters ¶meters)
Adds a DG kernel.
void computeJacobian(libMesh::SparseMatrix< Number > &jacobian, const std::set< TagID > &tags)
Associate jacobian to systemMatrixTag, and then form a matrix for all the tags.
void setupFieldDecomposition()
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< T * > & queryInto(std::vector< T *> &results, Args &&... args)
queryInto executes the query and stores the results in the given vector.
void getNodeDofs(dof_id_type node_id, std::vector< dof_id_type > &dofs)
Base class for all Constraint types.
std::set< TagID > _nl_vector_tags
Vector tags to temporarily store all tags associated with the current system.
std::vector< std::string > _ignore_variables_for_autoscaling
A container for variables that do not partipate in autoscaling.
void residualSetup() override
Base boundary condition of a Dirichlet type.
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
MooseObjectTagWarehouse< NodalBCBase > _nodal_bcs
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...
const std::vector< std::shared_ptr< NodeFaceConstraint > > & getActiveNodeFaceConstraints(BoundaryID boundary_id, bool displaced) const
void setDecomposition(const std::vector< std::string > &decomposition)
If called with a single string, it is used as the name of a the top-level decomposition split...
virtual void customSetup(const ExecFlagType &exec_type, THREAD_ID tid=0) const
bool needSubdomainMaterialOnSide(SubdomainID subdomain_id, THREAD_ID tid) const
Indicates whether this system needs material properties on internal sides.
MooseObjectWarehouse< T > & getVectorTagsObjectWarehouse(const std::set< TagID > &tags, THREAD_ID tid)
Retrieve a moose object warehouse in which every moose object at least has one of the given vector ta...
virtual const Node * queryNodePtr(const dof_id_type i) const
const ElementPairInfo & getElemPairInfo(std::pair< const Elem *, const Elem *> elem_pair) const
MooseObjectWarehouseBase< Split > _splits
Decomposition splits.
NumericVector< Number > * _u_dotdot
solution vector for u^dotdot
bool hasActiveMortarConstraints(const std::pair< BoundaryID, BoundaryID > &mortar_interface_key, bool displaced) const
const Parallel::Communicator & comm() const
NumericVector< Number > & add_vector(std::string_view vec_name, const bool projections=true, const ParallelType type=PARALLEL)
Solving a linear problem.
bool _has_nodalbc_save_in
If there is a nodal BC having save_in.
bool hasActiveNodalConstraints() const
Deterimine if active objects exist.
virtual bool hasMatrix(TagID tag) const
Check if the tagged matrix exists in the system.
MooseObjectWarehouse< NodalDamper > _nodal_dampers
Nodal Dampers for each thread.
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.
virtual libMesh::NonlinearSolver< Number > * nonlinearSolver()=0
Real preSMOResidual() const
The pre-SMO residual.
std::unique_ptr< libMesh::DiagonalMatrix< Number > > _scaling_matrix
A diagonal matrix used for computing scaling.
virtual void setSolutionUDotOld(const NumericVector< Number > &u_dot_old)
virtual void associateMatrixToTag(libMesh::SparseMatrix< Number > &matrix, TagID tag)
Associate a matrix to a tag.
bool hasDiagSaveIn() const
Weather or not the nonlinear system has diagonal Jacobian save-ins.
This class provides an interface for common operations on field variables of both FE and FV types wit...
const Parallel::Communicator & _communicator
void updateActive(THREAD_ID tid=0) override
Update the various active lists.
Real initialResidual() const
The initial residual.
The following methods are specializations for using the libMesh::Parallel::packed_range_* routines fo...
bool needInterfaceMaterialOnSide(BoundaryID bnd_id, THREAD_ID tid) const
Indicated whether this system needs material properties on interfaces.
const libMesh::ConstElemRange & getCurrentAlgebraicElementRange()
These are the element and nodes that contribute to the jacobian and residual for this local processor...
std::size_t _num_scaling_groups
The number of scaling groups.
const libMesh::ConstNodeRange & getCurrentAlgebraicNodeRange()
void computingScalingJacobian(bool computing_scaling_jacobian)
Setter for whether we're computing the scaling jacobian.
virtual void updateActive(THREAD_ID tid=0) override
Update the active status of Kernels.
bool has_dofs(const unsigned int s=libMesh::invalid_uint) const
std::map< dof_id_type, PenetrationInfo * > & _penetration_info
Data structure of nodes and their associated penetration information.
bool hasActiveNodeElemConstraints(SubdomainID secondary_id, SubdomainID primary_id, bool displaced) const
Real _pre_smo_residual
The pre-SMO residual, see setPreSMOResidual for a detailed explanation.
bool hasDampers()
Whether or not this system has dampers.
bool _compute_scaling_once
Whether the scaling factors should only be computed once at the beginning of the simulation through a...
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.
bool _has_save_in
If there is any Kernel or IntegratedBC having save_in.
virtual const Node & nodeRef(const dof_id_type i) const
TagID _Ke_system_tag
Tag for system contribution Jacobian.
virtual void setResidual(NumericVector< libMesh::Number > &residual, const THREAD_ID tid) override
bool _have_decomposition
Whether or not the system can be decomposed into splits.
dof_id_type n_dofs() const
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.
auto max(const L &left, const R &right)
Serves as a base class for DGKernel and ADDGKernel.
void constraintResiduals(NumericVector< Number > &residual, bool displaced)
Add residual contributions from Constraints.
Base class for MOOSE preconditioners.
NumericVector< Number > & addVector(const std::string &vector_name, const bool project, const libMesh::ParallelType type)
Adds a solution length vector to the system.
virtual GeometricSearchData & geomSearchData() override
std::unordered_map< std::pair< BoundaryID, BoundaryID >, ComputeMortarFunctor > _undisplaced_mortar_functors
Functors for computing undisplaced mortar constraints.
Specialization for filling multiple "small" preconditioning matrices simulatenously.
virtual bool matrixFromColoring() const
Whether a system matrix is formed from coloring.
void update()
Update the system (doing libMesh magic)
virtual Assembly & assembly(const THREAD_ID tid, const unsigned int sys_num) override
void addScalarKernel(const std::string &kernel_name, const std::string &name, InputParameters ¶meters)
Adds a scalar kernel.
void addBoundaryCondition(const std::string &bc_name, const std::string &name, InputParameters ¶meters)
Adds a boundary condition.
bool hasActiveNodeFaceConstraints(BoundaryID boundary_id, bool displaced) const
void computeResidual(NumericVector< Number > &residual, TagID tag_id)
Form a residual vector for a given tag.
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...
virtual unsigned int nVariables() const
Get the number of variables in this system.
EXTERN_C_BEGIN PetscErrorCode DMCreate_Moose(DM)
bool hasActiveBoundaryObjects(THREAD_ID tid=0) const
bool _need_residual_ghosted
Whether or not a ghosted copy of the residual needs to be made.
virtual const std::string & name() const
virtual void jacobianSetup()
virtual bool containsTimeKernel() override
If the system has a kernel that corresponds to a time derivative.
void onTimestepBegin()
Called at the beginning of the time step.
const ConstBndNodeRange & getCurrentAlgebraicBndNodeRange()
std::vector< dof_id_type, Threads::scalable_allocator< dof_id_type > > Row
MooseObjectTagWarehouse< DiracKernelBase > _dirac_kernels
Dirac Kernel storage for each thread.
void closeTaggedMatrices(const std::set< TagID > &tags)
Close all matrices associated the tags.
virtual void deactiveAllMatrixTags()
Make matrices inactive.
TagID _Re_non_time_tag
Tag for non-time contribution residual.
std::set< TagID > _nl_matrix_tags
Matrix tags to temporarily store all tags associated with the current system.
void solutionInvalidAccumulation()
Pass the number of solution invalid occurrences from current iteration to cumulative counters...
void set_basic_system_only()
std::map< std::pair< BoundaryID, BoundaryID >, NearestNodeLocator * > _nearest_node_locators
void setPredictor(std::shared_ptr< Predictor > predictor)
Real _resid_vs_jac_scaling_param
The param that indicates the weighting of the residual vs the Jacobian in determining variable scalin...
bool _auto_scaling_initd
Whether we've initialized the automatic scaling data structures.
virtual void computeScalingResidual()=0
Compute a "residual" for automatic scaling purposes.
bool _doing_dg
true if DG is active (optimization reasons)
virtual libMesh::DofMap & dofMap()
Gets writeable reference to the dof map.
void syncIteration()
Sync iteration counts to main processor.
unsigned int number() const
void computeResidualAndJacobianTags(const std::set< TagID > &vector_tags, const std::set< TagID > &matrix_tags)
Form possibly multiple tag-associated vectors and matrices.
bool needBoundaryMaterialOnSide(BoundaryID bnd_id, THREAD_ID tid) const
Indicated whether this system needs material properties on boundaries.
dof_id_type n_dofs() const
MooseObjectWarehouse< DirichletBCBase > _preset_nodal_bcs
std::unordered_map< unsigned int, unsigned int > _var_to_group_var
A map from variable index to group variable index and it's associated (inverse) scaling factor...
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 Variable & variable(const unsigned int c) const
std::vector< unsigned int > _current_l_its
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
This is the common base class for the three main kernel types implemented in MOOSE, Kernel, VectorKernel and ArrayKernel.
std::vector< dof_id_type > _secondary_nodes
MeshBase & getMesh()
Accessor for the underlying libMesh Mesh object.
void min(const T &r, T &o, Request &req) const
MooseObjectWarehouse< HDGIntegratedBC > _hybridized_ibcs
void computeDiracContributions(const std::set< TagID > &tags, bool is_jacobian)
void updateActive(THREAD_ID tid)
Update active objects of Warehouses owned by NonlinearSystemBase.
TheWarehouse & theWarehouse() const
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
const ElementPairList & getElemPairs() const
std::unordered_map< std::pair< BoundaryID, BoundaryID >, ComputeMortarFunctor > _displaced_mortar_functors
Functors for computing displaced mortar constraints.
unsigned int _current_nl_its
boundary_id_type BoundaryID
An integrated boundary condition for hybridized finite element formulations.
Real referenceResidual() const
The reference residual used in relative convergence check.
void addSplit(const std::string &split_name, const std::string &name, InputParameters ¶meters)
Adds a split.
bool _automatic_scaling
Whether to automatically scale the variables.
MatFDColoring _fdcoloring
void computeJacobianTags(const std::set< TagID > &tags)
Computes multiple (tag associated) Jacobian matricese.
SolutionInvalidity & solutionInvalidity()
Get the SolutionInvalidity for this app.
std::shared_ptr< MoosePreconditioner > _preconditioner
Preconditioner.
virtual void timestepSetup(THREAD_ID tid=0) const
NonlinearSystemBase & currentNonlinearSystem()
SimpleRange< IndexType > as_range(const std::pair< IndexType, IndexType > &p)
void computingScalingResidual(bool computing_scaling_residual)
Setter for whether we're computing the scaling residual.
SubProblem & subproblem()
std::vector< std::string > _vecs_to_zero_for_residual
vectors that will be zeroed before a residual computation
virtual TagID addMatrixTag(TagName tag_name)
Create a Tag.
std::shared_ptr< Split > getSplit(const std::string &name)
Retrieves a split by name.
void setInitialSolution()
std::unique_ptr< NumericVector< Number > > solution
SubProblem & _subproblem
The subproblem for whom this class holds variable data, etc; this can either be the governing finite ...
MooseObjectWarehouse< HDGKernel > _hybridized_kernels
void subdomainsCovered(std::set< SubdomainID > &subdomains_covered, std::set< std::string > &unique_variables, THREAD_ID tid=0) const
Populates a set of covered subdomains and the associated variable names.
void addImplicitGeometricCouplingEntries(GeometricSearchData &geom_search_data)
Adds entries to the Jacobian in the correct positions for couplings coming from dofs being coupled th...
virtual void addHDGKernel(const std::string &kernel_name, const std::string &name, InputParameters ¶meters)
Adds a hybridized discontinuous Galerkin (HDG) kernel.
virtual void zero_rows(std::vector< numeric_index_type > &rows, T diag_value=0.0)
MooseObjectTagWarehouse< KernelBase > _kernels
MooseObjectWarehouse< T > & getMatrixTagObjectWarehouse(TagID tag_id, THREAD_ID tid)
Retrieve a moose object warehouse in which every moose object has the given matrix tag...
bool shouldEvaluatePreSMOResidual() const
We offer the option to check convergence against the pre-SMO residual.
std::vector< VectorTag > getVectorTags(const std::set< TagID > &tag_ids) const
Base class for deriving nodal dampers.
virtual void disassociateVectorFromTag(NumericVector< Number > &vec, TagID tag)
Disassociate a given vector from a given tag.
virtual void cacheResidual(const THREAD_ID tid) override
void mooseDeprecated(Args &&... args)
Emit a deprecated code/feature message with the given stringified, concatenated args.
virtual void computeScalingJacobian()=0
Compute a "Jacobian" for automatic scaling purposes.
bool errorOnJacobianNonzeroReallocation() const
Will return True if the user wants to get an error when a nonzero is reallocated in the Jacobian by P...
This is the ElementPairLocator class.
This is the ElementPairInfo class.
std::map< BoundaryID, std::shared_ptr< ElementPairLocator > > _element_pair_locators
virtual void activeAllMatrixTags()
Make all exsiting matrices ative.
unsigned int number() const
Gets the number of this system.
void setupScalingData()
Setup group scaling containers.
virtual GeometricSearchData & geomSearchData()=0
const bool & usePreSMOResidual() const
Whether we are using pre-SMO residual in relative convergence checks.
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.
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 closeTaggedVectors(const std::set< TagID > &tags)
Close all vectors for given tags.
Base class for deriving any boundary condition that works at nodes.
void computeResidualInternal(const std::set< TagID > &tags)
Compute the residual for a given tag.
virtual void prepareAssembly(const THREAD_ID tid) override
bool computeScaling()
Method used to obtain scaling factors for variables.
Interface for objects interacting with the PerfGraph.
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 bool hasVariable(const std::string &var_name) const
Query a system for a variable.
virtual void setCurrentSubdomainID(const Elem *elem, const THREAD_ID tid) override
virtual void clearDiracInfo() override
Gets called before Dirac Kernels are asked to add the points they are supposed to be evaluated in...
void destroyColoring()
Destroy the coloring object if it exists.
virtual void reinitNodesNeighbor(const std::vector< dof_id_type > &nodes, const THREAD_ID tid) override
bool identify_variable_groups() const
virtual void jacobianSetup(THREAD_ID tid=0) const
ConstraintWarehouse _constraints
Constraints storage object.
virtual void turnOffJacobian()
Turn off the Jacobian (must be called before equation system initialization)
TagID residualVectorTag() const override
const std::map< BoundaryID, std::vector< std::shared_ptr< T > > > & getActiveBoundaryObjects(THREAD_ID tid=0) const
void computingNonlinearResid(bool computing_nonlinear_residual) final
Set whether or not the problem is in the process of computing the nonlinear residual.
virtual void customSetup(const ExecFlagType &exec_type) override
ComputeType
The type of nonlinear computation being performed.
Base class for deriving element dampers.
bool _add_implicit_geometric_coupling_entries_to_jacobian
Whether or not to add implicit geometric couplings to the Jacobian for FDP.
const_iterator end() const
virtual void addHDGIntegratedBC(const std::string &bc_name, const std::string &name, InputParameters ¶meters)
Adds a hybridized discontinuous Galerkin (HDG) bc.
virtual void addNodalKernel(const std::string &kernel_name, const std::string &name, InputParameters ¶meters)
Adds a NodalKernel.
virtual unsigned int numMatrixTags() const
The total number of tags.
Base class for creating new types of boundary conditions.
FEProblemBase & _fe_problem
the governing finite element/volume problem
virtual void reinitElemPhys(const Elem *elem, const std::vector< Point > &phys_points_in_elem, const THREAD_ID tid)=0
virtual MooseVariableScalar & getScalarVariable(THREAD_ID tid, const std::string &var_name) const
Gets a reference to a scalar variable with specified number.
ParallelType type() const
virtual NumericVector< Number > & RHS()=0
std::vector< VariableWarehouse > _vars
Variable warehouses (one for each thread)
Provides a way for users to bail out of the current solve.
unsigned int _n_residual_evaluations
Total number of residual evaluations that have been performed.
void addDiracKernel(const std::string &kernel_name, const std::string &name, InputParameters ¶meters)
Adds a Dirac kernel.
void computeJacobianInternal(const std::set< TagID > &tags)
Form multiple matrices for all the tags.
bool _has_diag_save_in
If there is any Kernel or IntegratedBC having diag_save_in.
Base class for creating new types of nodal kernels.
const FEType & variable_type(const unsigned int i) const
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
virtual std::shared_ptr< const DisplacedProblem > getDisplacedProblem() const
std::unique_ptr< NumericVector< Number > > _residual_copy
Copy of the residual vector, or nullptr if a copy is not needed.
void constraintJacobians(bool displaced)
Add jacobian contributions from Constraints.
virtual void subdomainSetup()
bool hasSaveIn() const
Weather or not the nonlinear system has save-ins.
Generic class for solving transient nonlinear problems.
TagID timeVectorTag() const override
Ideally, we should not need this API.
Class for containing MooseEnum item information.
virtual std::vector< std::string > timeKernelVariableNames() override
Returns the names of the variables that have time derivative kernels in the system.
bool hasActiveObjects(THREAD_ID tid=0) const
NonlinearSystemBase(FEProblemBase &problem, libMesh::System &sys, const std::string &name)
void max(const T &r, T &o, Request &req) const
NumericVector< Number > * _u_dot
solution vector for u^dot
MooseObjectWarehouse< ElementDamper > _element_dampers
Element Dampers for each thread.
void addObject(std::shared_ptr< Constraint > object, THREAD_ID tid=0, bool recurse=true) override
Add Constraint object to the warehouse.
virtual void setSolutionUDot(const NumericVector< Number > &udot)
Set transient term used by residual and Jacobian evaluation.
virtual libMesh::SparseMatrix< Number > & getMatrix(TagID tag)
Get a raw SparseMatrix.
virtual void augmentSparsity(libMesh::SparsityPattern::Graph &sparsity, std::vector< dof_id_type > &n_nz, std::vector< dof_id_type > &n_oz) override
Will modify the sparsity pattern to add logical geometric connections.
const std::vector< std::shared_ptr< MortarConstraintBase > > & getActiveMortarConstraints(const std::pair< BoundaryID, BoundaryID > &mortar_interface_key, bool displaced) const
MooseObjectWarehouse< T > & getMatrixTagsObjectWarehouse(const std::set< TagID > &tags, THREAD_ID tid)
Retrieve a moose object warehouse in which every moose object has one of the given matrix tags...
void computeScalarKernelsJacobians(const std::set< TagID > &tags)
void setInitialResidual(Real r)
Record the initial residual (for later relative convergence check)
Query query()
query creates and returns an initialized a query object for querying objects from the warehouse...
virtual Assembly & assembly(const THREAD_ID tid, const unsigned int sys_num)=0
const_iterator begin() const
Base class for deriving dampers.
bool getFailNextNonlinearConvergenceCheck() const
Whether it will skip further residual evaluations and fail the next nonlinear convergence check...
Base class shared by AD and non-AD scalar kernels.
void addDamper(const std::string &damper_name, const std::string &name, InputParameters ¶meters)
Adds a damper.
IntRange< T > make_range(T beg, T end)
virtual MooseMesh & mesh() override
virtual void postAddResidualObject(ResidualObject &)
Called after any ResidualObject-derived objects are added to the system.
const std::vector< VariableName > & getVariableNames() const
virtual void preInit() override
This is called prior to the libMesh system has been init'd.
virtual void updateActive(THREAD_ID tid=0) override
Update the active status of Kernels.
virtual void timestepSetup() override
bool hasActiveElemElemConstraints(const InterfaceID interface_id, bool displaced) const
bool _off_diagonals_in_auto_scaling
Whether to include off diagonals when determining automatic scaling factors.
virtual unsigned int numVectorTags(const Moose::VectorTagType type=Moose::VECTOR_TAG_ANY) const
The total number of tags, which can be limited to the tag type.
void reinitNodeFace(const Node &secondary_node, const BoundaryID secondary_boundary, const PenetrationInfo &info, const bool displaced)
Reinitialize quantities such as variables, residuals, Jacobians, materials for node-face constraints...
Base class for deriving any boundary condition of a integrated type.
SolverParams & solverParams(unsigned int solver_sys_num=0)
Get the solver parameters.
NumericVector< Number > * _residual_ghosted
ghosted form of the residual
void setCachedJacobian(GlobalDataKey)
Sets previously-cached Jacobian values via SparseMatrix::set() calls.
TagID _Re_tag
Used for the residual vector from PETSc.
virtual void customSetup(const ExecFlagType &exec_type)
MooseObjectWarehouse< T > & getVectorTagObjectWarehouse(TagID tag_id, THREAD_ID tid)
Retrieve a moose object warehouse in which every moose object has the given vector tag...
void computeNodalBCs(NumericVector< Number > &residual)
Enforces nodal boundary conditions.
const std::set< SubdomainID > & getSubdomainsForVar(unsigned int var_number) const
Moose::CouplingType coupling()
virtual void addObject(std::shared_ptr< T > object, THREAD_ID tid=0, bool recurse=true)
Adds an object to the storage structure.
bool ignoreZerosInJacobian() const
Will return true if zeros in the Jacobian are to be dropped from the sparsity pattern.
const ExecFlagType EXEC_PRE_KERNELS
void mortarConstraints(Moose::ComputeType compute_type, const std::set< TagID > &vector_tags, const std::set< TagID > &matrix_tags)
Do mortar constraint residual/jacobian computations.
NumericVector< Number > * _increment_vec
increment vector
InterfaceKernelBase is the base class for all InterfaceKernel type classes.
QueryCache & condition(Args &&... args)
Adds a new condition to the query.
bool doingDG() const
Getter for _doing_dg.
void computeResidualTag(NumericVector< Number > &residual, TagID tag_id)
Computes residual for a given tag.
void addConstraint(const std::string &c_name, const std::string &name, InputParameters ¶meters)
Adds a Constraint.
virtual TagName vectorTagName(const TagID tag) const
Retrieve the name associated with a TagID.
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.
face_info_iterator ownedFaceInfoEnd()
virtual libMesh::System & system() override
Get the reference to the libMesh system.
MooseVariableFieldBase & getVariable(THREAD_ID tid, const std::string &var_name) const
Gets a reference to a variable of with specified name.
std::vector< BoundaryID > getBoundaryIDs(const Elem *const elem, const unsigned short int side) const
Returns a vector of boundary IDs for the requested element on the requested side. ...
const std::vector< std::shared_ptr< NodeElemConstraint > > & getActiveNodeElemConstraints(SubdomainID secondary_id, SubdomainID primary_id, bool displaced) const
bool preSolve()
Perform some steps to get ready for the solver.
const std::unordered_map< std::pair< BoundaryID, BoundaryID >, AutomaticMortarGeneration > & getMortarInterfaces(bool on_displaced) const
bool _has_constraints
Whether or not this system has any Constraints.
virtual void residualAndJacobianTogether()=0
Call this method if you want the residual and Jacobian to be computed simultaneously.
bool _computed_scaling
Flag used to indicate whether we have already computed the scaling Jacobian.
dof_id_type first_dof(const processor_id_type proc) const
std::string _decomposition_split
Name of the top-level split of the decomposition.
void remove_algebraic_ghosting_functor(GhostingFunctor &evaluable_functor)
MooseObjectTagWarehouse< InterfaceKernelBase > _interface_kernels
unsigned int n_vars() const
void resetSolutionInvalidCurrentIteration()
Reset the number of solution invalid occurrences back to zero.
dof_id_type end_dof(const processor_id_type proc) const
NumericVector< Number > & residualVector(TagID tag)
Return a residual vector that is associated with the residual tag.
NumericVector< Number > & solutionOld()
NumericVector< Number > & getResidualNonTimeVector()
Return a numeric vector that is associated with the nontime tag.
virtual bool hasScalarVariable(const std::string &var_name) const
const TagName PREVIOUS_NL_SOLUTION_TAG
processor_id_type processor_id() const
std::shared_ptr< Predictor > _predictor
If predictor is active, this is non-NULL.
void enforceNodalConstraintsResidual(NumericVector< Number > &residual)
Enforce nodal constraints.
void subdomainsCovered(std::set< SubdomainID > &subdomains_covered, std::set< std::string > &unique_variables, THREAD_ID tid=0) const
Update supplied subdomain and variable coverate containters.
MooseObjectWarehouse< GeneralDamper > _general_dampers
General Dampers.
const std::vector< std::shared_ptr< ElemElemConstraint > > & getActiveElemElemConstraints(InterfaceID interface_id, bool displaced) const
virtual void initialSetup()
Setup Functions.
bool defaultGhosting()
Whether or not the user has requested default ghosting ot be on.
void addCachedJacobian(GlobalDataKey)
Adds the values that have been cached by calling cacheJacobian() and or cacheJacobianNeighbor() to th...
virtual void cacheJacobian(const THREAD_ID tid) override
auto min(const L &left, const R &right)
void jacobianSetup() override
virtual NumericVector< Number > & getVector(const std::string &name)
Get a raw NumericVector by name.
MooseObjectTagWarehouse< IntegratedBCBase > _integrated_bcs
const DofMap & get_dof_map() const
virtual void reinitNodeFace(const Node *node, BoundaryID bnd_id, const THREAD_ID tid) override
virtual void residualSetup()
virtual void reinitOffDiagScalars(const THREAD_ID tid) override
processor_id_type processor_id() const
virtual void addObject(std::shared_ptr< T > object, THREAD_ID tid=0, bool recurse=true) override
Adds an object to the storage structure.
virtual void setNeighborSubdomainID(const Elem *elem, unsigned int side, const THREAD_ID tid) override
virtual void addResidualScalar(const THREAD_ID tid=0)
virtual void subdomainSetup(THREAD_ID tid=0) const
virtual void jacobianSetup() override
virtual void addCachedResidual(const THREAD_ID tid) override
std::vector< std::vector< std::string > > _scaling_group_variables
A container of variable groupings that can be used in scaling calculations.
void addInterfaceKernel(std::string interface_kernel_name, const std::string &name, InputParameters ¶meters)
Adds an interface kernel.
auto index_range(const T &sizable)
virtual NumericVector< Number > & residualCopy() override
virtual NumericVector< Number > & residualGhosted() override
DiracKernelBase is the base class for all DiracKernel type classes.
void assembleScalingVector()
Assemble the numeric vector of scaling factors such that it can be used during assembly of the system...
BoundaryID _primary_boundary
NumericVector< Number > * _u_dotdot_old
old solution vector for u^dotdot
MooseObjectTagWarehouse< ScalarKernelBase > _scalar_kernels
virtual void residualEnd(THREAD_ID tid=0) const
void setConstraintSecondaryValues(NumericVector< Number > &solution, bool displaced)
Sets the value of constrained variables in the solution vector.
virtual void addJacobianScalar(const THREAD_ID tid=0)
NearestNodeLocator & _nearest_node
const std::map< dof_id_type, std::vector< dof_id_type > > & nodeToElemMap()
If not already created, creates a map from every node to all elements to which they are connected...
const std::set< SubdomainID > & meshSubdomains() const
Returns a read-only reference to the set of subdomains currently present in the Mesh.
virtual void addCachedJacobian(const THREAD_ID tid) override
virtual void timestepSetup()
virtual ~NonlinearSystemBase()
virtual void preInit() override
This is called prior to the libMesh system has been init'd.
virtual void residualSetup() override
void setPreconditioner(std::shared_ptr< MoosePreconditioner > pc)
Sets a preconditioner.
virtual void localize(std::vector< T > &v_local) const=0
MooseObjectWarehouse< ADDirichletBCBase > _ad_preset_nodal_bcs
virtual libMesh::System & system() override
Get the reference to the libMesh system.
Key structure for APIs manipulating global vectors/matrices.