84 #include "libmesh/nonlinear_solver.h" 85 #include "libmesh/quadrature_gauss.h" 86 #include "libmesh/dense_vector.h" 87 #include "libmesh/boundary_info.h" 88 #include "libmesh/petsc_matrix.h" 89 #include "libmesh/petsc_vector.h" 90 #include "libmesh/petsc_nonlinear_solver.h" 91 #include "libmesh/numeric_vector.h" 92 #include "libmesh/mesh.h" 93 #include "libmesh/dense_subvector.h" 94 #include "libmesh/dense_submatrix.h" 95 #include "libmesh/dof_map.h" 96 #include "libmesh/sparse_matrix.h" 97 #include "libmesh/petsc_matrix.h" 98 #include "libmesh/default_coupling.h" 99 #include "libmesh/diagonal_matrix.h" 100 #include "libmesh/fe_interface.h" 101 #include "libmesh/petsc_solver_exception.h" 105 #include "petscsnes.h" 115 const std::string & name)
121 _residual_ghosted(NULL),
124 _Re_non_time_tag(-1),
126 _scalar_kernels(false),
128 _preset_nodal_bcs(false),
129 _ad_preset_nodal_bcs(false),
131 _increment_vec(NULL),
132 _use_finite_differenced_preconditioner(false),
133 _fdcoloring(nullptr),
135 _add_implicit_geometric_coupling_entries_to_jacobian(false),
136 _assemble_constraints_separately(false),
137 _need_residual_ghosted(false),
138 _debugging_residuals(false),
142 _n_residual_evaluations(0),
144 _computing_pre_smo_residual(false),
145 _pre_smo_residual(0),
146 _initial_residual(0),
147 _use_pre_smo_residual(false),
148 _print_all_var_norms(false),
150 _has_diag_save_in(false),
151 _has_nodalbc_save_in(false),
152 _has_nodalbc_diag_save_in(false),
153 _computed_scaling(false),
154 _compute_scaling_once(true),
155 _resid_vs_jac_scaling_param(0),
156 _off_diagonals_in_auto_scaling(false),
157 _auto_scaling_initd(false)
175 dof_map.set_implicit_neighbor_dofs(
false);
199 functor.second.setupMortarMaterials();
201 functor.second.setupMortarMaterials();
214 TIME_SECTION(
"nlInitialSetup", 2,
"Setting Up Nonlinear System");
219 TIME_SECTION(
"kernelsInitialSetup", 2,
"Setting Up Kernels/BCs/Constraints");
236 std::vector<FVElementalKernel *> fv_elemental_kernels;
239 .template condition<AttribSystem>(
"FVElementalKernel")
240 .
template condition<AttribThread>(tid)
243 for (
auto * fv_kernel : fv_elemental_kernels)
244 fv_kernel->initialSetup();
246 std::vector<FVFluxKernel *> fv_flux_kernels;
249 .template condition<AttribSystem>(
"FVFluxKernel")
250 .
template condition<AttribThread>(tid)
253 for (
auto * fv_kernel : fv_flux_kernels)
254 fv_kernel->initialSetup();
265 TIME_SECTION(
"mortarSetup", 2,
"Initializing Mortar Interfaces");
267 auto create_mortar_functors = [
this](
const bool displaced)
271 for (
const auto & mortar_interface : mortar_interfaces)
273 const auto primary_secondary_boundary_pair = mortar_interface.first;
277 const auto & mortar_generation_object = mortar_interface.second;
279 auto & mortar_constraints =
286 auto & mortar_functors =
289 mortar_functors.emplace(primary_secondary_boundary_pair,
291 mortar_generation_object,
299 create_mortar_functors(
false);
300 create_mortar_functors(
true);
334 std::vector<FVFluxBC *> bcs;
337 .template condition<AttribSystem>(
"FVFluxBC")
338 .
template condition<AttribThread>(tid)
341 std::vector<FVInterfaceKernel *> iks;
344 .template condition<AttribSystem>(
"FVInterfaceKernel")
345 .
template condition<AttribThread>(tid)
348 std::vector<FVFluxKernel *> kernels;
351 .template condition<AttribSystem>(
"FVFluxKernel")
352 .
template condition<AttribThread>(tid)
355 for (
auto * bc : bcs)
357 for (
auto * ik : iks)
359 for (
auto * kernel : kernels)
360 kernel->timestepSetup();
388 std::vector<FVFluxBC *> bcs;
391 .template condition<AttribSystem>(
"FVFluxBC")
392 .
template condition<AttribThread>(tid)
395 std::vector<FVInterfaceKernel *> iks;
398 .template condition<AttribSystem>(
"FVInterfaceKernel")
399 .
template condition<AttribThread>(tid)
402 std::vector<FVFluxKernel *> kernels;
405 .template condition<AttribSystem>(
"FVFluxKernel")
406 .
template condition<AttribThread>(tid)
409 for (
auto * bc : bcs)
410 bc->customSetup(exec_type);
411 for (
auto * ik : iks)
412 ik->customSetup(exec_type);
413 for (
auto * kernel : kernels)
414 kernel->customSetup(exec_type);
432 const std::string & name,
438 std::shared_ptr<KernelBase> kernel =
446 if (parameters.
get<std::vector<AuxVariableName>>(
"save_in").size() > 0)
448 if (parameters.
get<std::vector<AuxVariableName>>(
"diag_save_in").size() > 0)
454 const std::string & name,
471 const std::string & name,
477 std::shared_ptr<NodalKernelBase> kernel =
485 if (parameters.
get<std::vector<AuxVariableName>>(
"save_in").size() > 0)
487 if (parameters.
get<std::vector<AuxVariableName>>(
"diag_save_in").size() > 0)
493 const std::string & name,
496 std::shared_ptr<ScalarKernelBase> kernel =
506 const std::string & name,
513 std::shared_ptr<BoundaryCondition> bc =
518 const std::set<BoundaryID> & boundary_ids = bc->boundaryIDs();
520 _vars[tid].addBoundaryVar(boundary_ids, bc_var);
529 if (nbc->checkNodalVar() && !nbc->variable().isNodal())
530 mooseError(
"Trying to use nodal boundary condition '",
532 "' on a non-nodal variable '",
533 nbc->variable().name(),
539 _vars[tid].addBoundaryVars(boundary_ids, nbc->getCoupledVars());
541 if (parameters.get<std::vector<AuxVariableName>>(
"save_in").size() > 0)
543 if (parameters.get<std::vector<AuxVariableName>>(
"diag_save_in").size() > 0)
548 if (dbc && dbc->preset())
552 if (addbc && addbc->preset())
562 _vars[tid].addBoundaryVars(boundary_ids, ibc->getCoupledVars());
564 if (parameters.get<std::vector<AuxVariableName>>(
"save_in").size() > 0)
566 if (parameters.get<std::vector<AuxVariableName>>(
"diag_save_in").size() > 0)
578 const std::set<BoundaryID> & boundary_ids = bc->boundaryIDs();
579 _vars[tid].addBoundaryVar(boundary_ids, bc_var);
584 _vars[tid].addBoundaryVars(boundary_ids, ibc->getCoupledVars());
589 mooseError(
"Unknown BoundaryCondition type for object named ", bc->name());
594 const std::string & name,
601 if (constraint && constraint->addCouplingEntriesToJacobian())
607 const std::string & name,
612 std::shared_ptr<DiracKernelBase> kernel =
623 const std::string & name,
637 if (parameters.
get<std::vector<AuxVariableName>>(
"save_in").size() > 0)
639 if (parameters.
get<std::vector<AuxVariableName>>(
"diag_save_in").size() > 0)
645 const std::string & name,
650 std::shared_ptr<InterfaceKernelBase> interface_kernel =
654 const std::set<BoundaryID> & boundary_ids = interface_kernel->boundaryIDs();
656 _vars[tid].addBoundaryVar(boundary_ids, ik_var);
661 _vars[tid].addBoundaryVars(boundary_ids, interface_kernel->getCoupledVars());
667 const std::string & name,
695 const std::string & name,
704 std::shared_ptr<Split>
722 if (
_app.
parameters().
get<
bool>(
"use_legacy_initial_residual_evaluation_behavior"))
738 mooseError(
"pre-SMO residual is requested but not evaluated.");
790 parallel_object_only();
792 TIME_SECTION(
"nl::computeResidualTags", 5);
797 bool required_residual = tags.find(
residualVectorTag()) == tags.end() ? false :
true;
820 if (required_residual)
826 ti->postResidual(residual);
869 const std::set<TagID> & matrix_tags)
871 const bool required_residual =
881 if (required_residual)
887 ti->postResidual(residual);
925 TIME_SECTION(
"applyPredictor", 2,
"Applying Predictor");
931 _console <<
" Skipping predictor this step" << std::endl;
936 TIME_SECTION(
"initialBCs", 2,
"Applying BCs To Initial Condition");
939 for (
const auto & bnode : bnd_nodes)
942 Node * node = bnode->_node;
952 for (
const auto & preset_bc : preset_bcs)
953 preset_bc->computeValue(initial_solution);
958 for (
const auto & preset_bc : preset_bcs_res)
959 preset_bc->computeValue(initial_solution);
1051 mooseError(
"The required residual vector is not available");
1063 for (
const auto & nc : ncs)
1065 std::vector<dof_id_type> & secondary_node_ids = nc->getSecondaryNodeId();
1066 std::vector<dof_id_type> & primary_node_ids = nc->getPrimaryNodeId();
1068 if ((secondary_node_ids.size() > 0) && (primary_node_ids.size() > 0))
1072 nc->computeResidual(residual);
1092 for (
const auto & nc : ncs)
1094 std::vector<dof_id_type> & secondary_node_ids = nc->getSecondaryNodeId();
1095 std::vector<dof_id_type> & primary_node_ids = nc->getPrimaryNodeId();
1097 if ((secondary_node_ids.size() > 0) && (primary_node_ids.size() > 0))
1101 nc->computeJacobian(jacobian);
1112 const bool displaced)
1117 const Elem * primary_elem =
info._elem;
1118 unsigned int primary_side =
info._side_num;
1119 std::vector<Point> points;
1120 points.push_back(
info._closest_point);
1141 const Elem *
const undisplaced_primary_elem =
1143 const Point undisplaced_primary_physical_point =
1144 [&points, displaced, primary_elem, undisplaced_primary_elem]()
1148 const Point reference_point =
1149 FEMap::inverse_map(primary_elem->dim(), primary_elem, points[0]);
1150 return FEMap::map(primary_elem->dim(), undisplaced_primary_elem, reference_point);
1159 undisplaced_primary_elem, primary_side, {undisplaced_primary_physical_point}, 0);
1176 "If we're calling this method with displaced = true, then we better well have a " 1177 "displaced problem");
1182 bool constraints_applied =
false;
1184 for (
const auto & it : penetration_locators)
1195 const auto & constraints =
1197 std::unordered_set<unsigned int> needed_mat_props;
1198 for (
const auto & constraint : constraints)
1200 const auto & mp_deps = constraint->getMatPropDependencies();
1201 needed_mat_props.insert(mp_deps.begin(), mp_deps.end());
1205 for (
unsigned int i = 0; i < secondary_nodes.size(); i++)
1207 dof_id_type secondary_node_num = secondary_nodes[i];
1218 for (
const auto & nfc : constraints)
1220 if (nfc->isExplicitConstraint())
1226 if (nfc->secondaryBoundary() != secondary_boundary ||
1227 nfc->primaryBoundary() != primary_boundary)
1230 if (nfc->shouldApply())
1232 constraints_applied =
true;
1233 nfc->computeSecondaryValue(
solution);
1236 if (nfc->hasWritableCoupledVariables())
1238 Threads::spin_mutex::scoped_lock lock(Threads::spin_mtx);
1239 for (
auto * var : nfc->getWritableCoupledVariables())
1241 if (var->isNodalDefined())
1253 std::set<dof_id_type> unique_secondary_node_ids;
1261 const auto & constraints =
1265 unique_secondary_node_ids.clear();
1267 for (
const auto & elem :
as_range(meshhelper.active_subdomain_elements_begin(secondary_id),
1268 meshhelper.active_subdomain_elements_end(secondary_id)))
1270 for (
auto & n : elem->node_ref_range())
1271 unique_secondary_node_ids.insert(n.id());
1274 for (
auto secondary_node_id : unique_secondary_node_ids)
1288 for (
const auto & nec : constraints)
1290 if (nec->shouldApply())
1292 constraints_applied =
true;
1293 nec->computeSecondaryValue(
solution);
1305 if (constraints_applied)
1320 "If we're calling this method with displaced = true, then we better well have a " 1321 "displaced problem");
1326 bool constraints_applied;
1327 bool residual_has_inserted_values =
false;
1329 constraints_applied =
false;
1330 for (
const auto & it : penetration_locators)
1336 constraints_applied =
false;
1345 bool has_writable_variables(
false);
1349 const auto & constraints =
1352 for (
unsigned int i = 0; i < secondary_nodes.size(); i++)
1354 dof_id_type secondary_node_num = secondary_nodes[i];
1365 for (
const auto & nfc : constraints)
1371 if (nfc->secondaryBoundary() != secondary_boundary ||
1372 nfc->primaryBoundary() != primary_boundary)
1375 if (nfc->shouldApply())
1377 constraints_applied =
true;
1378 nfc->computeResidual();
1380 if (nfc->overwriteSecondaryResidual())
1386 const auto & secondary_var = nfc->variable();
1387 const auto & secondary_dofs = secondary_var.dofIndices();
1388 mooseAssert(secondary_dofs.size() == secondary_var.count(),
1389 "We are on a node so there should only be one dof per variable (for " 1390 "an ArrayVariable we should have a number of dofs equal to the " 1391 "number of components");
1397 std::vector<Number> values = {nfc->secondaryResidual()};
1398 residual.
insert(values, secondary_dofs);
1399 residual_has_inserted_values =
true;
1405 if (nfc->hasWritableCoupledVariables())
1407 Threads::spin_mutex::scoped_lock lock(Threads::spin_mtx);
1408 has_writable_variables =
true;
1409 for (
auto * var : nfc->getWritableCoupledVariables())
1411 if (var->isNodalDefined())
1422 if (has_writable_variables)
1440 if (constraints_applied)
1445 if (residual_has_inserted_values)
1448 residual_has_inserted_values =
false;
1462 if (constraints_applied)
1467 if (residual_has_inserted_values)
1481 for (
const auto & it : element_pair_locators)
1488 const auto & _element_constraints =
1492 const std::list<std::pair<const Elem *, const Elem *>> & elem_pairs =
1494 for (
const auto & pr : elem_pairs)
1496 const Elem * elem1 = pr.first;
1497 const Elem * elem2 = pr.second;
1505 for (
const auto & ec : _element_constraints)
1512 ec->prepareShapes(ec->variable().number());
1513 ec->prepareNeighborShapes(ec->variable().number());
1516 ec->computeResidual();
1526 std::set<dof_id_type> unique_secondary_node_ids;
1528 constraints_applied =
false;
1529 residual_has_inserted_values =
false;
1530 bool has_writable_variables =
false;
1537 const auto & constraints =
1541 unique_secondary_node_ids.clear();
1543 for (
const auto & elem :
as_range(meshhelper.active_subdomain_elements_begin(secondary_id),
1544 meshhelper.active_subdomain_elements_end(secondary_id)))
1546 for (
auto & n : elem->node_ref_range())
1547 unique_secondary_node_ids.insert(n.id());
1550 for (
auto secondary_node_id : unique_secondary_node_ids)
1563 for (
const auto & nec : constraints)
1565 if (nec->shouldApply())
1567 constraints_applied =
true;
1568 nec->computeResidual();
1570 if (nec->overwriteSecondaryResidual())
1573 residual_has_inserted_values =
true;
1579 if (nec->hasWritableCoupledVariables())
1581 Threads::spin_mutex::scoped_lock lock(Threads::spin_mtx);
1582 has_writable_variables =
true;
1583 for (
auto * var : nec->getWritableCoupledVariables())
1585 if (var->isNodalDefined())
1598 if (constraints_applied)
1603 if (residual_has_inserted_values)
1614 if (has_writable_variables)
1637 for (
const auto & it : penetration_locators)
1647 const auto & constraints =
1651 const auto secondary_node_num = secondary_nodes[i];
1656 for (
const auto & nfc : constraints)
1658 if (!nfc->isExplicitConstraint())
1665 if (nfc->secondaryBoundary() != secondary_boundary ||
1666 nfc->primaryBoundary() != primary_boundary)
1669 nfc->overwriteBoundaryVariables(soln, secondary_node);
1680 TIME_SECTION(
"residualSetup", 3);
1710 parallel_object_only();
1712 TIME_SECTION(
"computeResidualInternal", 3);
1720 std::vector<UserObject *> uos;
1726 for (
auto & uo : uos)
1727 uo->residualSetup();
1728 for (
auto & uo : uos)
1742 TIME_SECTION(
"Kernels", 3 );
1747 Threads::parallel_reduce(elem_range, cr);
1759 Threads::parallel_reduce(faces, fvr);
1768 Threads::parallel_reduce(faces, fvr);
1784 TIME_SECTION(
"ScalarKernels", 3 );
1792 else if (tags.size() == 1)
1793 scalar_kernel_warehouse =
1799 bool have_scalar_contributions =
false;
1801 for (
const auto & scalar_kernel : scalars)
1803 scalar_kernel->reinit();
1804 const std::vector<dof_id_type> & dof_indices = scalar_kernel->variable().dofIndices();
1810 if (dof >= first_dof && dof < end_dof)
1812 scalar_kernel->computeResidual();
1813 have_scalar_contributions =
true;
1818 if (have_scalar_contributions)
1829 TIME_SECTION(
"NodalKernels", 3 );
1839 Threads::parallel_reduce(range, cnk);
1861 TIME_SECTION(
"NodalKernelBCs", 3 );
1867 Threads::parallel_reduce(bnd_node_range, cnk);
1929 const std::set<TagID> & matrix_tags)
1931 TIME_SECTION(
"computeResidualAndJacobianInternal", 3);
1936 for (
auto tag : matrix_tags)
1945 LibmeshPetscCall(MatSetOption(petsc_matrix->mat(),
1946 MAT_KEEP_NONZERO_PATTERN,
1950 MatSetOption(petsc_matrix->mat(), MAT_NEW_NONZERO_ALLOCATION_ERR, PETSC_FALSE));
1953 MAT_IGNORE_ZERO_ENTRIES,
1962 std::vector<UserObject *> uos;
1968 for (
auto & uo : uos)
1969 uo->residualSetup();
1970 for (
auto & uo : uos)
1984 TIME_SECTION(
"Kernels", 3 );
1989 Threads::parallel_reduce(elem_range, crj);
1997 Threads::parallel_reduce(faces, fvrj);
2006 Threads::parallel_reduce(faces, fvr);
2028 for (
const auto & residual_vector_tag : residual_vector_tags)
2059 else if (tags.size() == 1)
2065 if (!nbc_warehouse->
size())
2072 if (!bnd_nodes.
empty())
2074 TIME_SECTION(
"NodalBCs", 3 );
2076 for (
const auto & bnode : bnd_nodes)
2079 Node * node = bnode->_node;
2088 for (
const auto & nbc : bcs)
2089 if (nbc->shouldApply())
2090 nbc->computeResidual();
2109 if (!bnd_nodes.
empty())
2111 TIME_SECTION(
"NodalBCs", 3 );
2113 for (
const auto & bnode : bnd_nodes)
2116 Node * node = bnode->_node;
2125 for (
const auto & nbc : bcs)
2126 if (nbc->shouldApply())
2127 nbc->computeResidualAndJacobian();
2143 unsigned int s =
number();
2146 for (
unsigned int v = 0; v <
nVariables(); v++)
2147 for (
unsigned int c = 0; c < node.
n_comp(s, v); c++)
2155 std::unordered_map<
dof_id_type, std::vector<dof_id_type>> & graph)
2159 for (
const auto & it : nearest_node_locators)
2161 std::vector<dof_id_type> & secondary_nodes = it.second->_secondary_nodes;
2163 for (
const auto & secondary_node : secondary_nodes)
2165 std::set<dof_id_type> unique_secondary_indices;
2166 std::set<dof_id_type> unique_primary_indices;
2168 auto node_to_elem_pair = node_to_elem_map.find(secondary_node);
2169 if (node_to_elem_pair != node_to_elem_map.end())
2171 const std::vector<dof_id_type> & elems = node_to_elem_pair->second;
2174 for (
const auto & cur_elem : elems)
2176 std::vector<dof_id_type> dof_indices;
2179 for (
const auto & dof : dof_indices)
2180 unique_secondary_indices.insert(dof);
2184 std::vector<dof_id_type> primary_nodes = it.second->_neighbor_nodes[secondary_node];
2186 for (
const auto & primary_node : primary_nodes)
2188 auto primary_node_to_elem_pair = node_to_elem_map.find(primary_node);
2189 mooseAssert(primary_node_to_elem_pair != node_to_elem_map.end(),
2190 "Missing entry in node to elem map");
2191 const std::vector<dof_id_type> & primary_node_elems = primary_node_to_elem_pair->second;
2194 for (
const auto & cur_elem : primary_node_elems)
2196 std::vector<dof_id_type> dof_indices;
2199 for (
const auto & dof : dof_indices)
2200 unique_primary_indices.insert(dof);
2204 for (
const auto & secondary_id : unique_secondary_indices)
2205 for (
const auto & primary_id : unique_primary_indices)
2207 graph[secondary_id].push_back(primary_id);
2208 graph[primary_id].push_back(secondary_id);
2215 for (
const auto & nc : ncs)
2217 std::vector<dof_id_type> primary_dofs;
2218 std::vector<dof_id_type> & primary_node_ids = nc->getPrimaryNodeId();
2219 for (
const auto & node_id : primary_node_ids)
2230 std::vector<dof_id_type> secondary_dofs;
2231 std::vector<dof_id_type> & secondary_node_ids = nc->getSecondaryNodeId();
2232 for (
const auto & node_id : secondary_node_ids)
2243 for (
const auto & primary_id : primary_dofs)
2244 for (
const auto & secondary_id : secondary_dofs)
2246 graph[primary_id].push_back(secondary_id);
2247 graph[secondary_id].push_back(primary_id);
2252 for (
auto & it : graph)
2254 std::vector<dof_id_type> & row = it.second;
2255 std::sort(row.begin(), row.end());
2256 std::vector<dof_id_type>::iterator uit = std::unique(row.begin(), row.end());
2257 row.resize(uit - row.begin());
2271 std::unordered_map<dof_id_type, std::vector<dof_id_type>> graph;
2275 for (
const auto & it : graph)
2278 const auto & row = it.second;
2280 for (
const auto & coupled_dof : row)
2281 jacobian.add(dof, coupled_dof, 0);
2296 MAT_NEW_NONZERO_ALLOCATION_ERR,
2299 LibmeshPetscCall(MatSetOption(
2300 static_cast<PetscMatrix<Number> &
>(jacobian).mat(), MAT_IGNORE_ZERO_ENTRIES, PETSC_TRUE));
2302 std::vector<numeric_index_type> zero_rows;
2306 "If we're calling this method with displaced = true, then we better well have a " 2307 "displaced problem");
2312 bool constraints_applied;
2314 constraints_applied =
false;
2315 for (
const auto & it : penetration_locators)
2321 constraints_applied =
false;
2333 const auto & constraints =
2336 for (
const auto & secondary_node_num : secondary_nodes)
2349 for (
const auto & nfc : constraints)
2351 if (nfc->isExplicitConstraint())
2357 if (nfc->secondaryBoundary() != secondary_boundary ||
2358 nfc->primaryBoundary() != primary_boundary)
2361 nfc->_jacobian = &jacobian_to_view;
2363 if (nfc->shouldApply())
2365 constraints_applied =
true;
2367 nfc->prepareShapes(nfc->variable().number());
2368 nfc->prepareNeighborShapes(nfc->variable().number());
2370 nfc->computeJacobian();
2372 if (nfc->overwriteSecondaryJacobian())
2375 zero_rows.push_back(nfc->variable().nodalDofIndex());
2378 std::vector<dof_id_type> secondary_dofs(1, nfc->variable().nodalDofIndex());
2384 Real scaling_factor =
2385 nfc->overwriteSecondaryJacobian() ? 1. : nfc->variable().scalingFactor();
2391 nfc->_connected_dof_indices,
2395 if (nfc->addCouplingEntriesToJacobian())
2402 nfc->primaryVariable().dofIndicesNeighbor(),
2408 nfc->primaryVariable().dofIndicesNeighbor(),
2409 nfc->_connected_dof_indices,
2410 nfc->primaryVariable().scalingFactor());
2417 const std::vector<MooseVariableFEBase *> coupled_vars = nfc->getCoupledMooseVars();
2418 for (
const auto & jvar : coupled_vars)
2426 if (nfc->variable().number() == jvar->number() ||
2428 nfc->variable().number(), jvar->number(), this->
number()))
2434 nfc->prepareShapes(nfc->variable().number());
2435 nfc->prepareNeighborShapes(jvar->number());
2437 nfc->computeOffDiagJacobian(jvar->number());
2443 nfc->_connected_dof_indices,
2447 if (nfc->addCouplingEntriesToJacobian())
2454 jvar->dofIndicesNeighbor(),
2460 nfc->variable().dofIndicesNeighbor(),
2461 nfc->_connected_dof_indices,
2462 nfc->variable().scalingFactor());
2479 if (constraints_applied)
2482 MAT_KEEP_NONZERO_PATTERN,
2486 jacobian.zero_rows(zero_rows, 0.0);
2498 if (constraints_applied)
2501 MAT_KEEP_NONZERO_PATTERN,
2505 jacobian.zero_rows(zero_rows, 0.0);
2515 for (
const auto & it : element_pair_locators)
2522 const auto & _element_constraints =
2526 const std::list<std::pair<const Elem *, const Elem *>> & elem_pairs =
2528 for (
const auto & pr : elem_pairs)
2530 const Elem * elem1 = pr.first;
2531 const Elem * elem2 = pr.second;
2539 for (
const auto & ec : _element_constraints)
2546 ec->prepareShapes(ec->variable().number());
2547 ec->prepareNeighborShapes(ec->variable().number());
2550 ec->computeJacobian();
2560 std::set<dof_id_type> unique_secondary_node_ids;
2561 constraints_applied =
false;
2568 const auto & constraints =
2572 unique_secondary_node_ids.clear();
2574 for (
const auto & elem :
as_range(meshhelper.active_subdomain_elements_begin(secondary_id),
2575 meshhelper.active_subdomain_elements_end(secondary_id)))
2577 for (
auto & n : elem->node_ref_range())
2578 unique_secondary_node_ids.insert(n.id());
2581 for (
auto secondary_node_id : unique_secondary_node_ids)
2595 for (
const auto & nec : constraints)
2597 if (nec->shouldApply())
2599 constraints_applied =
true;
2601 nec->_jacobian = &jacobian_to_view;
2602 nec->prepareShapes(nec->variable().number());
2603 nec->prepareNeighborShapes(nec->variable().number());
2605 nec->computeJacobian();
2607 if (nec->overwriteSecondaryJacobian())
2610 zero_rows.push_back(nec->variable().nodalDofIndex());
2613 std::vector<dof_id_type> secondary_dofs(1, nec->variable().nodalDofIndex());
2619 nec->_connected_dof_indices,
2620 nec->variable().scalingFactor());
2625 nec->primaryVariable().dofIndicesNeighbor(),
2626 nec->_connected_dof_indices,
2627 nec->primaryVariable().scalingFactor());
2633 const std::vector<MooseVariableFEBase *> coupled_vars = nec->getCoupledMooseVars();
2634 for (
const auto & jvar : coupled_vars)
2642 if (nec->variable().number() == jvar->number() ||
2644 nec->variable().number(), jvar->number(), this->
number()))
2650 nec->prepareShapes(nec->variable().number());
2651 nec->prepareNeighborShapes(jvar->number());
2653 nec->computeOffDiagJacobian(jvar->number());
2659 nec->_connected_dof_indices,
2660 nec->variable().scalingFactor());
2665 nec->variable().dofIndicesNeighbor(),
2666 nec->_connected_dof_indices,
2667 nec->variable().scalingFactor());
2682 if (constraints_applied)
2685 MAT_KEEP_NONZERO_PATTERN,
2689 jacobian.zero_rows(zero_rows, 0.0);
2703 else if (tags.size() == 1)
2717 bool have_scalar_contributions =
false;
2718 for (
const auto & kernel : scalars)
2720 if (!kernel->computesJacobian())
2724 const std::vector<dof_id_type> & dof_indices = kernel->variable().dofIndices();
2730 if (dof >= first_dof && dof < end_dof)
2732 kernel->computeJacobian();
2734 have_scalar_contributions =
true;
2740 if (have_scalar_contributions)
2776 TIME_SECTION(
"computeJacobianInternal", 3);
2783 for (
auto tag : tags)
2792 LibmeshPetscCall(MatSetOption(petsc_matrix->mat(),
2793 MAT_KEEP_NONZERO_PATTERN,
2797 MatSetOption(petsc_matrix->mat(), MAT_NEW_NONZERO_ALLOCATION_ERR, PETSC_FALSE));
2800 MAT_IGNORE_ZERO_ENTRIES,
2809 std::vector<UserObject *> uos;
2815 for (
auto & uo : uos)
2816 uo->jacobianSetup();
2817 for (
auto & uo : uos)
2840 Threads::parallel_reduce(range, cnkjt);
2856 Threads::parallel_reduce(faces, fvj);
2865 Threads::parallel_reduce(faces, fvr);
2881 Threads::parallel_reduce(elem_range, cj);
2903 Threads::parallel_reduce(elem_range, cj);
2916 Threads::parallel_reduce(bnd_range, cnkjt);
2929 Threads::parallel_reduce(elem_range, cj);
2932 for (
unsigned int i = 0; i <
n_threads; i++)
2941 Threads::parallel_reduce(bnd_range, cnkjt);
2953 static bool first =
true;
2978 #if PETSC_RELEASE_GREATER_EQUALS(3, 23, 0) 2980 std::unique_ptr<SparseMatrix<Number>> hash_copy;
2981 if (system_matrix.use_hash_table())
2983 hash_copy = libMesh::cast_ref<PetscMatrix<Number> &>(system_matrix).copy_from_hash();
2984 view_jac_ptr = hash_copy.get();
2987 view_jac_ptr = &system_matrix;
2988 auto & jacobian_to_view = *view_jac_ptr;
2990 auto & jacobian_to_view = system_matrix;
2992 if (&jacobian_to_view == &system_matrix)
2993 system_matrix.
close();
3019 else if (tags.size() == 1)
3036 std::map<std::string, std::set<unsigned int>> bc_involved_vars;
3038 for (
const auto & bid : all_boundary_ids)
3045 for (
const auto & bc : bcs)
3047 const std::vector<MooseVariableFEBase *> & coupled_moose_vars =
3048 bc->getCoupledMooseVars();
3052 std::set<unsigned int> & var_set = bc_involved_vars[bc->name()];
3053 for (
const auto & coupled_var : coupled_moose_vars)
3055 var_set.insert(coupled_var->number());
3057 var_set.insert(bc->variable().number());
3077 for (
const auto & bnode : bnd_nodes)
3080 Node * node = bnode->_node;
3088 for (
const auto & bc : bcs)
3091 std::set<unsigned int> & var_set = bc_involved_vars[bc->name()];
3097 for (
const auto & it : coupling_entries)
3099 unsigned int ivar = it.first->number(), jvar = it.second->number();
3105 if ((bc->variable().number() == ivar) && var_set.count(jvar) && bc->shouldApply())
3106 bc->computeOffDiagJacobian(jvar);
3109 const auto & coupled_scalar_vars = bc->getCoupledMooseScalarVars();
3110 for (
const auto & jvariable : coupled_scalar_vars)
3112 bc->computeOffDiagJacobianScalar(jvariable->number());
3146 for (
auto & tag : tags)
3165 TIME_SECTION(
"computeJacobianTags", 5);
3187 for (
auto & tag : tags)
3195 const std::set<TagID> & tags)
3197 TIME_SECTION(
"computeJacobianBlocks", 3);
3200 for (
unsigned int i = 0; i <
blocks.size(); i++)
3205 MAT_KEEP_NONZERO_PATTERN,
3209 MAT_NEW_NONZERO_ALLOCATION_ERR,
3222 Threads::parallel_reduce(elem_range, cjb);
3226 for (
unsigned int i = 0; i <
blocks.size(); i++)
3227 blocks[i]->_jacobian.close();
3229 for (
unsigned int i = 0; i <
blocks.size(); i++)
3234 unsigned int ivar =
blocks[i]->_ivar;
3235 unsigned int jvar =
blocks[i]->_jvar;
3238 std::vector<numeric_index_type> zero_rows;
3242 for (
const auto & bnode : bnd_nodes)
3245 Node * node = bnode->_node;
3255 for (
const auto & bc : bcs)
3256 if (bc->variable().number() == ivar && bc->shouldApply())
3308 bool has_active_dampers =
false;
3316 TIME_SECTION(
"computeDampers", 3,
"Computing Dampers");
3317 has_active_dampers =
true;
3330 TIME_SECTION(
"computeDamping::element", 3,
"Computing Element Damping");
3332 has_active_dampers =
true;
3345 TIME_SECTION(
"computeDamping::general", 3,
"Computing General Damping");
3347 has_active_dampers =
true;
3349 for (
const auto & damper : gdampers)
3354 damper->checkMinDamping(gd_damping);
3360 damping =
std::min(gd_damping, damping);
3375 if (has_active_dampers && damping < 1.0)
3376 _console <<
" Damping factor: " << damping << std::endl;
3386 std::set<const Elem *> dirac_elements;
3390 TIME_SECTION(
"computeDirac", 3,
"Computing DiracKernels");
3396 for (
const auto & dkernel : dkernels)
3398 dkernel->clearPoints();
3399 dkernel->addPoints();
3407 DistElemRange range(dirac_elements.begin(), dirac_elements.end(), 1);
3456 std::vector<dof_id_type> & n_nz,
3457 std::vector<dof_id_type> & n_oz)
3463 std::unordered_map<dof_id_type, std::vector<dof_id_type>> graph;
3478 for (
const auto & git : graph)
3483 if (dof < first_dof_on_proc || dof >= end_dof_on_proc)
3486 const auto & row = git.second;
3490 unsigned int original_row_length = sparsity_row.size();
3492 sparsity_row.insert(sparsity_row.end(), row.begin(), row.end());
3494 SparsityPattern::sort_row(
3495 sparsity_row.begin(), sparsity_row.begin() + original_row_length, sparsity_row.end());
3498 for (
const auto & coupled_dof : row)
3500 if (coupled_dof < first_dof_on_proc || coupled_dof >= end_dof_on_proc)
3502 if (n_oz[local_dof] < n_dofs_not_on_proc)
3507 if (n_nz[local_dof] < n_dofs_on_proc)
3543 mooseError(
"More than one active Preconditioner detected");
3562 const std::set<MooseVariable *> & damped_vars)
3564 for (
const auto & var : damped_vars)
3570 const std::set<MooseVariable *> & damped_vars)
3572 for (
const auto & var : damped_vars)
3580 std::set<SubdomainID> input_subdomains;
3581 std::set<std::string> kernel_variables;
3583 bool global_kernels_exist =
false;
3595 std::vector<FVElementalKernel *> fv_elemental_kernels;
3598 .template condition<AttribSystem>(
"FVElementalKernel")
3599 .queryInto(fv_elemental_kernels);
3601 for (
auto fv_kernel : fv_elemental_kernels)
3603 if (fv_kernel->blockRestricted())
3604 for (
auto block_id : fv_kernel->blockIDs())
3605 input_subdomains.insert(block_id);
3607 global_kernels_exist =
true;
3608 kernel_variables.insert(fv_kernel->variable().name());
3611 if (dynamic_cast<FVScalarLagrangeMultiplierConstraint *>(fv_kernel))
3612 kernel_variables.insert(dynamic_cast<FVScalarLagrangeMultiplierConstraint *>(fv_kernel)
3617 std::vector<FVFluxKernel *> fv_flux_kernels;
3620 .template condition<AttribSystem>(
"FVFluxKernel")
3621 .queryInto(fv_flux_kernels);
3623 for (
auto fv_kernel : fv_flux_kernels)
3625 if (fv_kernel->blockRestricted())
3626 for (
auto block_id : fv_kernel->blockIDs())
3627 input_subdomains.insert(block_id);
3629 global_kernels_exist =
true;
3630 kernel_variables.insert(fv_kernel->variable().name());
3633 std::vector<FVInterfaceKernel *> fv_interface_kernels;
3636 .template condition<AttribSystem>(
"FVInterfaceKernel")
3637 .queryInto(fv_interface_kernels);
3639 for (
auto fvik : fv_interface_kernels)
3640 if (
auto scalar_fvik = dynamic_cast<FVScalarLagrangeMultiplierInterface *>(fvik))
3641 kernel_variables.insert(scalar_fvik->lambdaVariable().name());
3643 std::vector<FVFluxBC *> fv_flux_bcs;
3646 .template condition<AttribSystem>(
"FVFluxBC")
3647 .queryInto(fv_flux_bcs);
3649 for (
auto fvbc : fv_flux_bcs)
3650 if (
auto scalar_fvbc = dynamic_cast<FVBoundaryScalarLagrangeMultiplierConstraint *>(fvbc))
3651 kernel_variables.insert(scalar_fvbc->lambdaVariable().name());
3655 if (!global_kernels_exist)
3657 std::set<SubdomainID> difference;
3658 std::set_difference(mesh_subdomains.begin(),
3659 mesh_subdomains.end(),
3660 input_subdomains.begin(),
3661 input_subdomains.end(),
3662 std::inserter(difference, difference.end()));
3666 difference.erase(
id);
3668 difference.erase(
id);
3670 if (!difference.empty())
3672 std::vector<SubdomainID> difference_vec =
3673 std::vector<SubdomainID>(difference.begin(), difference.end());
3675 std::stringstream missing_block_names;
3676 std::copy(difference_names.begin(),
3677 difference_names.end(),
3678 std::ostream_iterator<std::string>(missing_block_names,
" "));
3679 std::stringstream missing_block_ids;
3680 std::copy(difference.begin(),
3682 std::ostream_iterator<unsigned int>(missing_block_ids,
" "));
3684 mooseError(
"Each subdomain must contain at least one Kernel.\nThe following block(s) lack an " 3686 missing_block_names.str(),
3688 missing_block_ids.str(),
3696 std::set<VariableName> difference;
3697 std::set_difference(variables.begin(),
3699 kernel_variables.begin(),
3700 kernel_variables.end(),
3701 std::inserter(difference, difference.end()));
3704 std::set<VariableName>
vars(difference);
3705 for (
auto & var_name :
vars)
3708 for (
const auto &
id : blks)
3710 difference.erase(var_name);
3713 if (!difference.empty())
3715 std::stringstream missing_kernel_vars;
3716 std::copy(difference.begin(),
3718 std::ostream_iterator<std::string>(missing_kernel_vars,
" "));
3719 mooseError(
"Each variable must be referenced by at least one active Kernel.\nThe following " 3720 "variable(s) lack an active kernel: " +
3721 missing_kernel_vars.str());
3733 std::vector<std::string>
3736 std::vector<std::string> variable_names;
3738 if (time_kernels.hasActiveObjects())
3739 for (
const auto & kernel : time_kernels.getObjects())
3740 variable_names.push_back(kernel->variable().name());
3742 return variable_names;
3779 const std::set<TagID> & vector_tags,
3780 const std::set<TagID> & matrix_tags)
3782 parallel_object_only();
3787 map_pr.second(compute_type, vector_tags, matrix_tags);
3790 map_pr.second(compute_type, vector_tags, matrix_tags);
3792 catch (MetaPhysicL::LogicError &)
3795 "We caught a MetaPhysicL error in NonlinearSystemBase::mortarConstraints. This is very " 3796 "likely due to AD not having a sufficiently large derivative container size. Please run " 3797 "MOOSE configure with the '--with-derivative-size=<n>' option");
3820 std::set<unsigned int> var_numbers, var_numbers_covered, var_numbers_not_covered;
3822 var_numbers.insert(var_number);
3832 "', provided to the 'scaling_group_variables' parameter, does not exist in " 3833 "the nonlinear system.");
3840 if (!map_pair.second)
3841 mooseError(
"Variable ", var_name,
" is contained in multiple scaling grouplings");
3842 var_numbers_covered.insert(var.
number());
3845 std::set_difference(var_numbers.begin(),
3847 var_numbers_covered.begin(),
3848 var_numbers_covered.end(),
3849 std::inserter(var_numbers_not_covered, var_numbers_not_covered.begin()));
3854 for (
auto var_number : var_numbers_not_covered)
3859 const auto & number_to_var_map =
_vars[0].numberToVariableMap();
3865 libmesh_map_find(number_to_var_map, i)->name()) !=
3878 _console <<
"\nPerforming automatic scaling calculation\n" << std::endl;
3880 TIME_SECTION(
"computeScaling", 3,
"Computing Automatic Scaling");
3887 std::vector<dof_id_type> dof_indices;
3895 auto & dof_map =
dofMap();
3939 auto examine_dof_indices = [
this,
3943 &jac_inverse_scaling_factors,
3944 &resid_inverse_scaling_factors,
3945 &scaling_residual](
const auto & dof_indices,
const auto var_number)
3947 for (
auto dof_index : dof_indices)
3948 if (dof_map.local_index(dof_index))
3953 auto mat_value = (*_scaling_matrix)(dof_index, dof_index);
3959 auto vec_value = scaling_residual(dof_index);
3971 dof_map.dof_indices(elem, dof_indices, i);
3972 examine_dof_indices(dof_indices, i);
3978 dof_map.SCALAR_dof_indices(dof_indices, i);
3979 examine_dof_indices(dof_indices, i);
3987 if (jac_scaling && resid_scaling)
3988 for (MooseIndex(inverse_scaling_factors) i = 0; i < inverse_scaling_factors.size(); ++i)
3991 if (!resid_inverse_scaling_factors[i])
3993 if (!jac_inverse_scaling_factors[i])
3994 inverse_scaling_factors[i] = 1;
3996 inverse_scaling_factors[i] = jac_inverse_scaling_factors[i];
3998 else if (!jac_inverse_scaling_factors[i])
4000 inverse_scaling_factors[i] = resid_inverse_scaling_factors[i];
4002 inverse_scaling_factors[i] =
4006 else if (jac_scaling)
4007 inverse_scaling_factors = jac_inverse_scaling_factors;
4008 else if (resid_scaling)
4009 inverse_scaling_factors = resid_inverse_scaling_factors;
4011 mooseError(
"We shouldn't be calling this routine if we're not performing any scaling");
4014 for (
auto & scaling_factor : inverse_scaling_factors)
4015 if (scaling_factor == 0)
4019 std::vector<Real> flattened_inverse_scaling_factors(
system().
n_vars());
4020 for (
const auto i :
index_range(flattened_inverse_scaling_factors))
4021 flattened_inverse_scaling_factors[i] = inverse_scaling_factors[
_var_to_group_var[i]];
4027 flattened_inverse_scaling_factors);
4040 auto & scaling_vector =
getVector(
"scaling_factors");
4043 const auto & dof_map =
dofMap();
4045 const auto & field_variables =
_vars[0].fieldVariables();
4046 const auto & scalar_variables =
_vars[0].scalars();
4048 std::vector<dof_id_type> dof_indices;
4050 for (
const Elem *
const elem :
4051 as_range(lm_mesh.active_local_elements_begin(), lm_mesh.active_local_elements_end()))
4052 for (
const auto *
const field_var : field_variables)
4054 const auto & factors = field_var->arrayScalingFactor();
4055 for (
const auto i :
make_range(field_var->count()))
4057 dof_map.dof_indices(elem, dof_indices, field_var->number() + i);
4058 for (
const auto dof : dof_indices)
4059 scaling_vector.set(dof, factors[i]);
4063 for (
const auto *
const scalar_var : scalar_variables)
4065 mooseAssert(scalar_var->count() == 1,
4066 "Scalar variables should always have only one component.");
4067 dof_map.SCALAR_dof_indices(dof_indices, scalar_var->number());
4068 for (
const auto dof : dof_indices)
4069 scaling_vector.set(dof, scalar_var->scalingFactor());
4073 scaling_vector.close();
4095 if (!scaling_succeeded)
4110 LibmeshPetscCall(MatFDColoringDestroy(&
_fdcoloring));
4117 mooseError(
"No field split preconditioner is present for this system");
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
dof_id_type end_dof(const processor_id_type proc) const
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.
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
std::shared_ptr< DisplacedProblem > displaced_problem
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.
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 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...
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.
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...
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.
const InputParameters & parameters() const
Get the parameters of the object.
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
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
dof_id_type n_dofs(const unsigned int vn) const
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.
dof_id_type n_local_dofs(const unsigned int vn) const
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.
const std::vector< std::shared_ptr< NodeElemConstraintBase > > & getActiveNodeElemConstraints(SubdomainID secondary_id, SubdomainID primary_id, bool displaced) const
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
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.
const Variable & variable(const unsigned int c) const override
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 void activateAllMatrixTags()
Make all existing matrices active.
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.
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.
virtual void deactivateAllMatrixTags()
Make matrices inactive.
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.
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...
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
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
FieldSplitPreconditionerBase & getFieldSplitPreconditioner()
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
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.
virtual void setupDM()=0
setup the data management data structure that manages the field split
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 ...
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
Moose::CouplingType coupling() const
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.
MooseObjectTagWarehouse< HDGKernel > _hybridized_kernels
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.
Base interface for field split preconditioner.
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 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.
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(s) ...
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
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.
bool restoreOriginalNonzeroPattern() const
face_info_iterator ownedFaceInfoEnd()
void constraintJacobians(const SparseMatrix< Number > &jacobian_to_view, bool displaced)
Add jacobian contributions from Constraints.
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. ...
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.
dof_id_type first_dof(const processor_id_type proc) const
bool _computed_scaling
Flag used to indicate whether we have already computed the scaling Jacobian.
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.
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.
FieldSplitPreconditionerBase * _fsp
The field split preconditioner if this sytem is using one.
auto index_range(const T &sizable)
virtual NumericVector< Number > & residualCopy() override
void reinitMortarFunctors()
Update the mortar functors if the mesh has changed.
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.