25 #include "libmesh/coupling_matrix.h"    26 #include "libmesh/dof_map.h"    27 #include "libmesh/elem.h"    28 #include "libmesh/equation_systems.h"    29 #include "libmesh/fe_interface.h"    30 #include "libmesh/node.h"    31 #include "libmesh/quadrature_gauss.h"    32 #include "libmesh/sparse_matrix.h"    33 #include "libmesh/tensor_value.h"    34 #include "libmesh/vector_value.h"    35 #include "libmesh/fe.h"    39 template <
typename P, 
typename C>
    50 template <
typename P, 
typename C>
    59                   ? 
mesh.getCoordSystem(sub_id) == 
mesh.getCoordSystem(neighbor_sub_id)
    61               "Coordinate systems must be the same between element and neighbor");
    62   const auto coord_type = 
mesh.getCoordSystem(sub_id);
    66     if (
mesh.usingGeneralAxisymmetricCoordAxes())
    68       const auto & axis = 
mesh.getGeneralAxisymmetricCoordAxis(sub_id);
    73           point, factor, coord_type, 
mesh.getAxisymmetricRadialCoord());
    81     _subproblem(_sys.subproblem()),
    83     _nonlocal_cm(_subproblem.nonlocalCouplingMatrix(_sys.number())),
    84     _computing_residual(_subproblem.currentlyComputingResidual()),
    85     _computing_jacobian(_subproblem.currentlyComputingJacobian()),
    86     _computing_residual_and_jacobian(_subproblem.currentlyComputingResidualAndJacobian()),
    87     _dof_map(_sys.dofMap()),
    90     _mesh_dimension(_mesh.dimension()),
    92     _user_added_fe_of_helper_type(false),
    93     _user_added_fe_face_of_helper_type(false),
    94     _user_added_fe_face_neighbor_of_helper_type(false),
    95     _user_added_fe_neighbor_of_helper_type(false),
    96     _user_added_fe_lower_of_helper_type(false),
    97     _building_helpers(false),
    98     _current_qrule(nullptr),
    99     _current_qrule_volume(nullptr),
   100     _current_qrule_arbitrary(nullptr),
   102     _current_qrule_face(nullptr),
   103     _current_qface_arbitrary(nullptr),
   104     _current_qrule_neighbor(nullptr),
   105     _need_JxW_neighbor(false),
   107     _custom_mortar_qrule(false),
   108     _current_qrule_lower(nullptr),
   110     _current_elem(nullptr),
   111     _current_elem_volume(0),
   113     _current_side_elem(nullptr),
   114     _current_side_volume(0),
   115     _current_neighbor_elem(nullptr),
   116     _current_neighbor_side(0),
   117     _current_neighbor_side_elem(nullptr),
   118     _need_neighbor_elem_volume(false),
   119     _current_neighbor_volume(0),
   120     _current_node(nullptr),
   121     _current_neighbor_node(nullptr),
   122     _current_elem_volume_computed(false),
   123     _current_side_volume_computed(false),
   125     _current_lower_d_elem(nullptr),
   126     _current_neighbor_lower_d_elem(nullptr),
   127     _need_lower_d_elem_volume(false),
   128     _need_neighbor_lower_d_elem_volume(false),
   132     _cached_residual_values(2), 
   133     _cached_residual_rows(2),   
   134     _max_cached_residuals(0),
   135     _max_cached_jacobians(0),
   137     _block_diagonal_matrix(false),
   138     _calculate_xyz(false),
   139     _calculate_face_xyz(false),
   140     _calculate_curvatures(false),
   141     _calculate_ad_coord(false),
   142     _have_p_refinement(false)
   176   _fe_msm->add_p_level_in_reinit(
false);
   189     for (
auto & it : 
_fe[
dim])
   280     _fe[
dim][type]->get_phi();
   281     _fe[
dim][type]->get_dphi();
   285     _fe[
dim][type]->get_xyz();
   287       _fe[
dim][type]->get_d2phi();
   413   if (ending_dim < 
dim)
   415   for (; 
dim <= ending_dim; 
dim++)
   438   if (ending_dim < 
dim)
   440   for (; 
dim <= ending_dim; 
dim++)
   459   unsigned int min_dim;
   490   unsigned int min_dim;
   520   unsigned int min_dim;
   550   unsigned int min_dim;
   578   mooseAssert(qdefault.size() > 0, 
"default quadrature must be initialized before order bumps");
   582   if (qvec.size() != ndims || !qvec[0].vol)
   584                  qdefault[0].arbitrary_vol->get_order(),
   586                  qdefault[0].face->get_order(),
   588   else if (qvec[0].vol->get_order() < volume_order)
   590                  qvec[0].arbitrary_vol->get_order(),
   592                  qvec[0].face->get_order(),
   601   mooseAssert(qdefault.size() > 0, 
"default quadrature must be initialized before order bumps");
   605   if (qvec.size() != ndims || !qvec[0].vol)
   606     createQRules(qdefault[0].vol->type(), order, order, order, block);
   607   else if (qvec[0].vol->get_order() < order || qvec[0].face->get_order() < order)
   609                  std::max(order, qvec[0].arbitrary_vol->get_order()),
   610                  std::max(order, qvec[0].vol->get_order()),
   611                  std::max(order, qvec[0].face->get_order()),
   622                        bool allow_negative_qweights)
   626   if (qvec.size() != ndims)
   629   for (
unsigned int i = 0; i < qvec.size(); i++)
   632     auto & q = qvec[
dim];
   633     q.vol = QBase::build(type, 
dim, volume_order);
   634     q.vol->allow_rules_with_negative_weights = allow_negative_qweights;
   635     q.face = QBase::build(type, 
dim - 1, face_order);
   636     q.face->allow_rules_with_negative_weights = allow_negative_qweights;
   638     q.fv_face->allow_rules_with_negative_weights = allow_negative_qweights;
   639     q.neighbor = std::make_unique<ArbitraryQuadrature>(
dim - 1, face_order);
   640     q.neighbor->allow_rules_with_negative_weights = allow_negative_qweights;
   641     q.arbitrary_vol = std::make_unique<ArbitraryQuadrature>(
dim, order);
   642     q.arbitrary_vol->allow_rules_with_negative_weights = allow_negative_qweights;
   643     q.arbitrary_face = std::make_unique<ArbitraryQuadrature>(
dim - 1, face_order);
   644     q.arbitrary_face->allow_rules_with_negative_weights = allow_negative_qweights;
   661     for (
auto & it : 
_fe[
dim])
   662       it.second->attach_quadrature_rule(qrule);
   664       it.second->attach_quadrature_rule(qrule);
   679     it.second->attach_quadrature_rule(qrule);
   681     it.second->attach_quadrature_rule(qrule);
   698     it.second->attach_quadrature_rule(qrule);
   700     it.second->attach_quadrature_rule(qrule);
   714     it.second->attach_quadrature_rule(qrule);
   716     it.second->attach_quadrature_rule(qrule);
   720                 "We should not be indexing out of bounds");
   753                  " does not match previously specified quadrature_order: ",
   755                  ". Quadrature_order (when specified) must match for all mortar constraints.");
   764   for (
const auto & it : 
_fe[
dim])
   767     const FEType & fe_type = it.first;
   775     fesd.
_phi.shallowCopy(
const_cast<std::vector<std::vector<Real>
> &>(fe.
get_phi()));
   777         const_cast<std::vector<std::vector<VectorValue<Real>
>> &>(fe.
get_dphi()));
   785     const FEType & fe_type = it.first;
   793     fesd.
_phi.shallowCopy(
const_cast<std::vector<std::vector<VectorValue<Real>
>> &>(fe.
get_phi()));
   795         const_cast<std::vector<std::vector<TensorValue<Real>
>> &>(fe.
get_dphi()));
   824       for (
unsigned int qp = 0; qp != n_qp; qp++)
   829       for (
unsigned qp = 0; qp < n_qp; ++qp)
   832         for (
unsigned qp = 0; qp < n_qp; ++qp)
   836     for (
const auto & it : 
_fe[
dim])
   839       auto fe_type = it.first;
   840       auto num_shapes = FEInterface::n_shape_functions(fe_type, 
elem);
   843       grad_phi.resize(num_shapes);
   844       for (decltype(num_shapes) i = 0; i < num_shapes; ++i)
   845         grad_phi[i].resize(n_qp);
   851         const auto & regular_grad_phi = 
_fe_shape_data[fe_type]->_grad_phi;
   852         for (decltype(num_shapes) i = 0; i < num_shapes; ++i)
   853           for (
unsigned qp = 0; qp < n_qp; ++qp)
   854             grad_phi[i][qp] = regular_grad_phi[i][qp];
   860       auto fe_type = it.first;
   861       auto num_shapes = FEInterface::n_shape_functions(fe_type, 
elem);
   864       grad_phi.resize(num_shapes);
   865       for (decltype(num_shapes) i = 0; i < num_shapes; ++i)
   866         grad_phi[i].resize(n_qp);
   873         for (decltype(num_shapes) i = 0; i < num_shapes; ++i)
   874           for (
unsigned qp = 0; qp < n_qp; ++qp)
   875             grad_phi[i][qp] = regular_grad_phi[i][qp];
   885   if (
_xfem != 
nullptr)
   889 template <
typename OutputType>
   911   auto num_shapes = grad_phi.size();
   917       for (decltype(num_shapes) i = 0; i < num_shapes; ++i)
   918         for (
unsigned qp = 0; qp < n_qp; ++qp)
   925       for (decltype(num_shapes) i = 0; i < num_shapes; ++i)
   926         for (
unsigned qp = 0; qp < n_qp; ++qp)
   928           grad_phi[i][qp].slice(0) = dphidxi[i][qp] * 
_ad_dxidx_map[qp];
   929           grad_phi[i][qp].slice(1) = dphidxi[i][qp] * 
_ad_dxidy_map[qp];
   930           grad_phi[i][qp].slice(2) = dphidxi[i][qp] * 
_ad_dxidz_map[qp];
   937       for (decltype(num_shapes) i = 0; i < num_shapes; ++i)
   938         for (
unsigned qp = 0; qp < n_qp; ++qp)
   940           grad_phi[i][qp].slice(0) =
   942           grad_phi[i][qp].slice(1) =
   944           grad_phi[i][qp].slice(2) =
   952       for (decltype(num_shapes) i = 0; i < num_shapes; ++i)
   953         for (
unsigned qp = 0; qp < n_qp; ++qp)
   955           grad_phi[i][qp].slice(0) = dphidxi[i][qp] * 
_ad_dxidx_map[qp] +
   958           grad_phi[i][qp].slice(1) = dphidxi[i][qp] * 
_ad_dxidy_map[qp] +
   961           grad_phi[i][qp].slice(2) = dphidxi[i][qp] * 
_ad_dxidz_map[qp] +
  1002                                   const std::vector<Real> & qw,
  1045   auto num_shapes = FEInterface::n_shape_functions(fe->
get_fe_type(), 
elem);
  1051   const bool do_derivatives =
  1072       for (std::size_t i = 0; i < num_shapes; i++)
  1075         const Node & 
node = *elem_nodes[i];
  1081                   elem_point(direction).derivatives(), 
node.
dof_number(sys_num, disp_num, 0), 1.);
  1093         static bool failing = 
false;
  1098           libmesh_error_msg(
"ERROR: negative Jacobian " << 
_ad_jac[p].
value() << 
" at point index "  1099                                                         << p << 
" in element " << 
elem->
id());
  1122       for (std::size_t i = 0; i < num_shapes; i++)
  1125         const Node & 
node = *elem_nodes[i];
  1131                   elem_point(direction).derivatives(), 
node.
dof_number(sys_num, disp_num, 0), 1.);
  1144       const auto g11 = (dx_dxi * dx_dxi + dy_dxi * dy_dxi + dz_dxi * dz_dxi);
  1146       const auto g12 = (dx_dxi * dx_deta + dy_dxi * dy_deta + dz_dxi * dz_deta);
  1148       const auto & g21 = g12;
  1150       const auto g22 = (dx_deta * dx_deta + dy_deta * dy_deta + dz_deta * dz_deta);
  1152       auto det = (g11 * g22 - g12 * g21);
  1154       if (det.value() <= -TOLERANCE * TOLERANCE)
  1156         static bool failing = 
false;
  1161           libmesh_error_msg(
"ERROR: negative Jacobian " << det << 
" at point index " << p
  1162                                                         << 
" in element " << 
elem->
id());
  1167       else if (det.value() <= 0.)
  1168         det.value() = TOLERANCE * TOLERANCE;
  1170       const auto inv_det = 1. / det;
  1175       const auto g11inv = g22 * inv_det;
  1176       const auto g12inv = -g12 * inv_det;
  1177       const auto g21inv = -g21 * inv_det;
  1178       const auto g22inv = g11 * inv_det;
  1199       for (std::size_t i = 0; i < num_shapes; i++)
  1202         const Node & 
node = *elem_nodes[i];
  1208                   elem_point(direction).derivatives(), 
node.
dof_number(sys_num, disp_num, 0), 1.);
  1224       _ad_jac[p] = (dx_dxi * (dy_deta * dz_dzeta - dz_deta * dy_dzeta) +
  1225                     dy_dxi * (dz_deta * dx_dzeta - dx_deta * dz_dzeta) +
  1226                     dz_dxi * (dx_deta * dy_dzeta - dy_deta * dx_dzeta));
  1230         static bool failing = 
false;
  1235           libmesh_error_msg(
"ERROR: negative Jacobian " << 
_ad_jac[p].
value() << 
" at point index "  1236                                                         << p << 
" in element " << 
elem->
id());
  1244       const auto inv_jac = 1. / 
_ad_jac[p];
  1246       _ad_dxidx_map[p] = (dy_deta * dz_dzeta - dz_deta * dy_dzeta) * inv_jac;
  1247       _ad_dxidy_map[p] = (dz_deta * dx_dzeta - dx_deta * dz_dzeta) * inv_jac;
  1248       _ad_dxidz_map[p] = (dx_deta * dy_dzeta - dy_deta * dx_dzeta) * inv_jac;
  1250       _ad_detadx_map[p] = (dz_dxi * dy_dzeta - dy_dxi * dz_dzeta) * inv_jac;
  1251       _ad_detady_map[p] = (dx_dxi * dz_dzeta - dz_dxi * dx_dzeta) * inv_jac;
  1252       _ad_detadz_map[p] = (dy_dxi * dx_dzeta - dx_dxi * dy_dzeta) * inv_jac;
  1262       libmesh_error_msg(
"Invalid dim = " << 
dim);
  1273     FEBase & fe_face = *it.second;
  1274     const FEType & fe_type = it.first;
  1279     fesd.
_phi.shallowCopy(
const_cast<std::vector<std::vector<Real>
> &>(fe_face.
get_phi()));
  1281         const_cast<std::vector<std::vector<VectorValue<Real>
>> &>(fe_face.
get_dphi()));
  1289     const FEType & fe_type = it.first;
  1297     fesd.
_phi.shallowCopy(
  1298         const_cast<std::vector<std::vector<VectorValue<Real>
>> &>(fe_face.
get_phi()));
  1300         const_cast<std::vector<std::vector<TensorValue<Real>
>> &>(fe_face.
get_dphi()));
  1309           const_cast<std::vector<std::vector<Real>> &>(fe_face.
get_div_phi()));
  1337   if (
_xfem != 
nullptr)
  1357   const auto n_qp = qw.size();
  1361   std::vector<std::vector<Real>> 
const * d2psidxi2_map = 
nullptr;
  1362   std::vector<std::vector<Real>> 
const * d2psidxideta_map = 
nullptr;
  1363   std::vector<std::vector<Real>> 
const * d2psideta2_map = 
nullptr;
  1395                 side_point(direction).derivatives(), 
node.
dof_number(sys_num, disp_num, 0), 1.);
  1428       const auto n_mapping_shape_functions =
  1431       for (
unsigned int i = 0; i < n_mapping_shape_functions; i++)
  1439                 side_point(direction).derivatives(), 
node.
dof_number(sys_num, disp_num, 0), 1.);
  1461           libmesh_assert_not_equal_to(denominator, 0);
  1496       const unsigned int n_mapping_shape_functions =
  1499       for (
unsigned int i = 0; i < n_mapping_shape_functions; i++)
  1507                 side_point(direction).derivatives(), 
node.
dof_number(sys_num, disp_num, 0), 1.);
  1534         const auto g11 = (dxdxi * dxdxi + dydxi * dydxi + dzdxi * dzdxi);
  1536         const auto g12 = (dxdxi * dxdeta + dydxi * dydeta + dzdxi * dzdeta);
  1538         const auto & g21 = g12;
  1540         const auto g22 = (dxdeta * dxdeta + dydeta * dydeta + dzdeta * dzdeta);
  1542         const auto the_jac = 
std::sqrt(g11 * g22 - g12 * g21);
  1555           const auto numerator = E * 
N - 2. * F * M + G * L;
  1556           const auto denominator = E * G - F * F;
  1557           libmesh_assert_not_equal_to(denominator, 0.);
  1578     FEBase & fe_face_neighbor = *it.second;
  1579     FEType fe_type = it.first;
  1586     fesd.
_phi.shallowCopy(
const_cast<std::vector<std::vector<Real>
> &>(fe_face_neighbor.
get_phi()));
  1588         const_cast<std::vector<std::vector<RealGradient>
> &>(fe_face_neighbor.
get_dphi()));
  1596     const FEType & fe_type = it.first;
  1604     fesd.
_phi.shallowCopy(
  1605         const_cast<std::vector<std::vector<VectorValue<Real>
>> &>(fe_face_neighbor.
get_phi()));
  1607         const_cast<std::vector<std::vector<TensorValue<Real>
>> &>(fe_face_neighbor.
get_dphi()));
  1616           const_cast<std::vector<std::vector<Real>> &>(fe_face_neighbor.
get_div_phi()));
  1621                 "We should be in bounds here");
  1637     FEBase & fe_neighbor = *it.second;
  1638     FEType fe_type = it.first;
  1645     fesd.
_phi.shallowCopy(
const_cast<std::vector<std::vector<Real>
> &>(fe_neighbor.
get_phi()));
  1647         const_cast<std::vector<std::vector<RealGradient>
> &>(fe_neighbor.
get_dphi()));
  1655     const FEType & fe_type = it.first;
  1663     fesd.
_phi.shallowCopy(
  1664         const_cast<std::vector<std::vector<VectorValue<Real>
>> &>(fe_neighbor.
get_phi()));
  1666         const_cast<std::vector<std::vector<TensorValue<Real>
>> &>(fe_neighbor.
get_dphi()));
  1675           const_cast<std::vector<std::vector<Real>> &>(fe_neighbor.
get_div_phi()));
  1689               "Neighbor subdomain ID has not been correctly set");
  1693   neighbor_rule->setPoints(reference_points);
  1698               "current neighbor subdomain has been set incorrectly");
  1710     const std::vector<Real> & 
JxW = fe.
get_JxW();
  1717     for (
unsigned int qp = 0; qp < qrule->
n_points(); qp++)
  1727 template <
typename Po
ints, 
typename Coords>
  1730                                       const Points & q_points,
  1735   mooseAssert(qrule, 
"The quadrature rule is null in Assembly::setCoordinateTransformation");
  1737   mooseAssert(n_points == q_points.size(),
  1738               "The number of points in the quadrature rule doesn't match the number of passed-in "  1739               "points in Assembly::setCoordinateTransformation");
  1746   coord.resize(n_points);
  1747   for (
unsigned int qp = 0; qp < n_points; qp++)
  1795               "current subdomain has been set incorrectly");
  1809   unsigned int elem_dimension = 
elem->
dim();
  1822               "current subdomain has been set incorrectly");
  1836               "current subdomain has been set incorrectly");
  1862               "current subdomain has been set incorrectly");
  1886               "Our finite volume quadrature rule should always yield a single point");
  1894   const auto & ref_point = ref_points[0];
  1901                 "current neighbor subdomain has been set incorrectly");
  1907     neighbor_rule->setPoints(ref_points);
  1917   return qruleFaceHelper<QBase>(
elem, 
side, [](
QRules & q) { 
return q.face.get(); });
  1923   return qruleFaceHelper<ArbitraryQuadrature>(
  1930   const auto elem_dimension = 
elem->
dim();
  1943               "current subdomain has been set incorrectly");
  1957 Assembly::reinit(
const Elem * elem, 
unsigned int side, 
const std::vector<Point> & reference_points)
  1962               "current subdomain has been set incorrectly");
  1994                                 const Elem * neighbor,
  1995                                 unsigned int neighbor_side,
  1996                                 const std::vector<Point> * neighbor_reference_points)
  2004   if (neighbor_reference_points)
  2018                             unsigned int elem_side,
  2020                             const std::vector<Point> * 
const pts,
  2021                             const std::vector<Real> * 
const weights)
  2025   unsigned int elem_dim = 
elem->
dim();
  2031     face_rule->setPoints(*pts);
  2042   for (
const auto & it : 
_fe_face[elem_dim])
  2044     FEBase & fe_face = *it.second;
  2045     FEType fe_type = it.first;
  2048     fe_face.
reinit(
elem, elem_side, tolerance, pts, weights);
  2052     fesd.
_phi.shallowCopy(
const_cast<std::vector<std::vector<Real>
> &>(fe_face.
get_phi()));
  2054         const_cast<std::vector<std::vector<RealGradient>
> &>(fe_face.
get_dphi()));
  2062     const FEType & fe_type = it.first;
  2068     fe_face.
reinit(
elem, elem_side, tolerance, pts, weights);
  2070     fesd.
_phi.shallowCopy(
  2071         const_cast<std::vector<std::vector<VectorValue<Real>
>> &>(fe_face.
get_phi()));
  2073         const_cast<std::vector<std::vector<TensorValue<Real>
>> &>(fe_face.
get_dphi()));
  2082           const_cast<std::vector<std::vector<Real>> &>(fe_face.
get_div_phi()));
  2128       const std::vector<Real> dummy_qw(n_qp, 1.);
  2130       for (
unsigned int qp = 0; qp != n_qp; qp++)
  2135       for (
unsigned qp = 0; qp < n_qp; ++qp)
  2141         for (
unsigned qp = 0; qp < n_qp; ++qp)
  2144         for (
unsigned qp = 0; qp < n_qp; ++qp)
  2150       FEBase & fe = *it.second;
  2151       auto fe_type = it.first;
  2152       auto num_shapes = FEInterface::n_shape_functions(fe_type, &
elem);
  2155       grad_phi.resize(num_shapes);
  2156       for (decltype(num_shapes) i = 0; i < num_shapes; ++i)
  2157         grad_phi[i].resize(n_qp);
  2164         for (decltype(num_shapes) i = 0; i < num_shapes; ++i)
  2165           for (
unsigned qp = 0; qp < n_qp; ++qp)
  2166             grad_phi[i][qp] = regular_grad_phi[i][qp];
  2171       auto fe_type = it.first;
  2172       auto num_shapes = FEInterface::n_shape_functions(fe_type, &
elem);
  2175       grad_phi.resize(num_shapes);
  2176       for (decltype(num_shapes) i = 0; i < num_shapes; ++i)
  2177         grad_phi[i].resize(n_qp);
  2184         for (decltype(num_shapes) i = 0; i < num_shapes; ++i)
  2185           for (
unsigned qp = 0; qp < n_qp; ++qp)
  2186             grad_phi[i][qp] = regular_grad_phi[i][qp];
  2193                                 unsigned int neighbor_side,
  2195                                 const std::vector<Point> * 
const pts,
  2196                                 const std::vector<Real> * 
const weights)
  2216     FEBase & fe_face_neighbor = *it.second;
  2217     FEType fe_type = it.first;
  2220     fe_face_neighbor.
reinit(
neighbor, neighbor_side, tolerance, pts, weights);
  2224     fesd.
_phi.shallowCopy(
const_cast<std::vector<std::vector<Real>
> &>(fe_face_neighbor.
get_phi()));
  2226         const_cast<std::vector<std::vector<RealGradient>
> &>(fe_face_neighbor.
get_dphi()));
  2234     const FEType & fe_type = it.first;
  2240     fe_face_neighbor.
reinit(
neighbor, neighbor_side, tolerance, pts, weights);
  2242     fesd.
_phi.shallowCopy(
  2243         const_cast<std::vector<std::vector<VectorValue<Real>
>> &>(fe_face_neighbor.
get_phi()));
  2245         const_cast<std::vector<std::vector<TensorValue<Real>
>> &>(fe_face_neighbor.
get_dphi()));
  2254           const_cast<std::vector<std::vector<Real>> &>(fe_face_neighbor.
get_div_phi()));
  2259                 "We should be in bounds here");
  2261         neighbor, neighbor_side, tolerance, pts, weights);
  2271                      const std::vector<Point> & pts,
  2272                      const std::vector<Real> & JxW)
  2274   const unsigned int elem_dim = 
elem->
dim();
  2276               "Dual shape functions should only be computed on lower dimensional face elements");
  2278   for (
const auto & it : 
_fe_lower[elem_dim])
  2280     FEBase & fe_lower = *it.second;
  2289                            const std::vector<Point> * 
const pts,
  2290                            const std::vector<Real> * 
const weights)
  2294   const unsigned int elem_dim = 
elem->
dim();
  2296               "The lower dimensional element should truly be a lower dimensional element");
  2314   for (
const auto & it : 
_fe_lower[elem_dim])
  2316     FEBase & fe_lower = *it.second;
  2317     FEType fe_type = it.first;
  2323       fesd->_phi.shallowCopy(
const_cast<std::vector<std::vector<Real>
> &>(fe_lower.
get_phi()));
  2324       fesd->_grad_phi.shallowCopy(
  2325           const_cast<std::vector<std::vector<RealGradient>
> &>(fe_lower.
get_dphi()));
  2327         fesd->_second_phi.shallowCopy(
  2334       fesd->_phi.shallowCopy(
const_cast<std::vector<std::vector<Real>
> &>(fe_lower.
get_dual_phi()));
  2335       fesd->_grad_phi.shallowCopy(
  2336           const_cast<std::vector<std::vector<RealGradient>
> &>(fe_lower.
get_dual_dphi()));
  2338         fesd->_second_phi.shallowCopy(
  2351   if (pts && !weights)
  2369     const auto & physical_q_points = helper_fe.
get_xyz();
  2384               "You should be calling reinitNeighborLowerDElem on a lower dimensional element");
  2405               "You should be calling reinitMortarElem on a lower dimensional element");
  2417                                    unsigned int neighbor_side,
  2418                                    const std::vector<Point> & physical_points)
  2426         physical_points.size() == 1,
  2427         "If reinitializing with more than one point, then I am dubious of your use case. Perhaps "  2428         "you are performing a DG type method and you are reinitializing using points from the "  2429         "element face. In such a case your neighbor JxW must have its index order 'match' the "  2430         "element JxW index order, e.g. imagining a vertical 1D face with two quadrature points, "  2432         "index 0 for elem JxW corresponds to the 'top' quadrature point, then index 0 for "  2434         "JxW must also correspond to the 'top' quadrature point. And libMesh/MOOSE has no way to "  2435         "guarantee that with multiple quadrature points.");
  2453                                    const std::vector<Point> & physical_points)
  2479   for (
auto & ivar : 
vars)
  2481     auto i = ivar->number();
  2486     for (
unsigned int k = 0; k < ivar->count(); ++k)
  2488       unsigned int iv = i + k;
  2500           auto pair = std::make_pair(ivar, &jvar);
  2501           auto c = ivar_start;
  2503           bool has_pair = 
false;
  2516           if (i != jvar.number())
  2527   for (
auto & ivar : scalar_vars)
  2529     auto i = ivar->number();
  2551   _sub_Re.resize(num_vector_tags);
  2552   _sub_Rn.resize(num_vector_tags);
  2553   _sub_Rl.resize(num_vector_tags);
  2587   for (MooseIndex(num_matrix_tags) tag = 0; tag < num_matrix_tags; tag++)
  2653   for (
auto & ivar : 
vars)
  2655     auto i = ivar->number();
  2657     for (
unsigned int k = 0; k < ivar->count(); ++k)
  2659       unsigned int iv = i + k;
  2664           auto pair = std::make_pair(ivar, &jvar);
  2665           auto c = ivar_start;
  2667           bool has_pair = 
false;
  2689     unsigned int vi = ivar.
number();
  2690     unsigned int vj = jvar.
number();
  2707   for (
const auto & var : 
vars)
  2709       tag_Re[var->number()].resize(var->dofIndices().size() * var->count());
  2727     unsigned int vi = ivar.
number();
  2728     unsigned int vj = jvar.
number();
  2751     unsigned int vi = ivar.
number();
  2752     unsigned int vj = jvar.
number();
  2779     unsigned int vi = ivar.
number();
  2780     unsigned int vj = jvar.
number();
  2806     unsigned int vi = ivar.
number();
  2807     unsigned int vj = jvar.
number();
  2832   for (
const auto & var : 
vars)
  2834       tag_Rn[var->number()].resize(var->dofIndicesNeighbor().size() * var->count());
  2845     unsigned int vi = ivar.
number();
  2846     unsigned int vj = jvar.
number();
  2888   for (
const auto & var : 
vars)
  2890       tag_Rl[var->number()].resize(var->dofIndicesLower().size() * var->count());
  2896                        const std::vector<dof_id_type> & dof_indices)
  2900   const unsigned int ivn = iv.
number();
  2901   const unsigned int jvn = jv.number();
  2902   const unsigned int icount = iv.count();
  2903   unsigned int jcount = jv.count();
  2910         .resize(dof_indices.size() * icount, dof_indices.size() * jcount);
  2915     tag_Re[ivn].resize(dof_indices.size() * icount);
  2921                                const std::vector<dof_id_type> & idof_indices,
  2922                                const std::vector<dof_id_type> & jdof_indices)
  2926   const unsigned int ivn = iv.
number();
  2927   const unsigned int jvn = jv.number();
  2928   const unsigned int icount = iv.count();
  2929   unsigned int jcount = jv.count();
  2938         .resize(idof_indices.size() * icount, jdof_indices.size() * jcount);
  2948   for (
const auto & ivar : 
vars)
  2950     auto idofs = ivar->dofIndices().size();
  2953       tag_Re[ivar->number()].resize(idofs);
  2955     for (
const auto & jvar : 
vars)
  2957       auto jdofs = jvar->dofIndices().size();
  2974   for (
const auto & ivar : scalar_vars)
  2976     auto idofs = ivar->dofIndices().size();
  2978     for (
const auto & jvar : 
vars)
  2980       auto jdofs = jvar->dofIndices().size() * jvar->count();
  2993 template <
typename T>
  2997   phi(v).shallowCopy(v.
phi());
  3021     if (v.computingCurl())
  3022       curlPhi(v).shallowCopy(v.curlPhi());
  3023     if (v.computingDiv())
  3024       divPhi(v).shallowCopy(v.divPhi());
  3027     mooseError(
"Unsupported variable field type!");
  3030 template <
typename T>
  3058     if (v.computingCurl())
  3060     if (v.computingDiv())
  3064     mooseError(
"Unsupported variable field type!");
  3067 template <
typename T>
  3108     mooseError(
"Unsupported variable field type!");
  3214                                std::vector<dof_id_type> & dof_indices,
  3215                                const std::vector<Real> & scaling_factor,
  3221   auto ndof = dof_indices.size();
  3222   auto ntdof = res_block.
size();
  3223   auto count = ntdof / ndof;
  3224   mooseAssert(count == scaling_factor.size(), 
"Inconsistent of number of components");
  3225   mooseAssert(count * ndof == ntdof, 
"Inconsistent of number of components");
  3229     dof_indices.resize(ntdof);
  3231     for (MooseIndex(count) j = 0; j < count; ++j)
  3232       for (MooseIndex(ndof) i = 0; i < ndof; ++i)
  3234         dof_indices[p] = dof_indices[i] + (is_nodal ? j : j * ndof);
  3235         res_block(p) *= scaling_factor[j];
  3241     if (scaling_factor[0] != 1.0)
  3242       res_block *= scaling_factor[0];
  3251                            const std::vector<dof_id_type> & dof_indices,
  3252                            const std::vector<Real> & scaling_factor,
  3255   if (dof_indices.size() > 0 && res_block.
size())
  3266                              std::vector<dof_id_type> & cached_residual_rows,
  3268                              const std::vector<dof_id_type> & dof_indices,
  3269                              const std::vector<Real> & scaling_factor,
  3272   if (dof_indices.size() > 0 && res_block.
size())
  3280       cached_residual_values.push_back(
_tmp_Re(i));
  3291                            const std::vector<dof_id_type> & dof_indices,
  3292                            const std::vector<Real> & scaling_factor,
  3295   if (dof_indices.size() > 0)
  3297     std::vector<dof_id_type> di(dof_indices);
  3308               "Non-residual tag in Assembly::addResidual");
  3313   for (
const auto & var : 
vars)
  3315                      tag_Re[var->number()],
  3317                      var->arrayScalingFactor(),
  3324   for (
const auto & vector_tag : vector_tags)
  3333               "Non-residual tag in Assembly::addResidualNeighbor");
  3338   for (
const auto & var : 
vars)
  3340                      tag_Rn[var->number()],
  3341                      var->dofIndicesNeighbor(),
  3342                      var->arrayScalingFactor(),
  3349   for (
const auto & vector_tag : vector_tags)
  3358               "Non-residual tag in Assembly::addResidualLower");
  3363   for (
const auto & var : 
vars)
  3365                      tag_Rl[var->number()],
  3366                      var->dofIndicesLower(),
  3367                      var->arrayScalingFactor(),
  3374   for (
const auto & vector_tag : vector_tags)
  3384               "Non-residual tag in Assembly::addResidualScalar");
  3390   for (
const auto & var : 
vars)
  3392         residual, tag_Re[var->number()], var->dofIndices(), var->arrayScalingFactor(), 
false);
  3398   for (
const auto & vector_tag : vector_tags)
  3407   for (
const auto & var : 
vars)
  3408     for (
const auto & vector_tag : tags)
  3412                            _sub_Re[vector_tag._type_id][var->number()],
  3414                            var->arrayScalingFactor(),
  3432   for (
auto & tag : tags)
  3438                              const std::vector<dof_id_type> & dof_index,
  3447   for (MooseIndex(dof_index) i = 0; i < dof_index.size(); ++i)
  3458   for (
const auto & var : 
vars)
  3459     for (
const auto & vector_tag : tags)
  3463                            _sub_Rn[vector_tag._type_id][var->number()],
  3464                            var->dofIndicesNeighbor(),
  3465                            var->arrayScalingFactor(),
  3473   for (
const auto & var : 
vars)
  3474     for (
const auto & vector_tag : tags)
  3478                            _sub_Rl[vector_tag._type_id][var->number()],
  3479                            var->dofIndicesLower(),
  3480                            var->arrayScalingFactor(),
  3487   for (
const auto & vector_tag : tags)
  3513   mooseAssert(values.size() == rows.size(),
  3514               "Number of cached residuals and number of rows must match!");
  3537   mooseAssert(values.size() == rows.size(),
  3538               "Number of cached residuals and number of rows must match!");
  3540   if (!values.empty())
  3552   for (
const auto & var : 
vars)
  3554                      tag_Re[var->number()],
  3556                      var->arrayScalingFactor(),
  3567   for (
const auto & var : 
vars)
  3569                      tag_Rn[var->number()],
  3570                      var->dofIndicesNeighbor(),
  3571                      var->arrayScalingFactor(),
  3581                            const std::vector<dof_id_type> & idof_indices,
  3582                            const std::vector<dof_id_type> & jdof_indices)
  3584   if (idof_indices.size() == 0 || jdof_indices.size() == 0)
  3586   if (jac_block.
n() == 0 || jac_block.
m() == 0)
  3591   for (
unsigned int i = 0; i < ivar.
count(); ++i)
  3593     unsigned int iv = ivar.
number();
  3596       unsigned int jv = jvar.
number();
  3597       if (jt < jv || jt >= jv + jvar.
count())
  3599       unsigned int j = jt - jv;
  3603       auto indof = di.size();
  3604       auto jndof = dj.size();
  3606       unsigned int jj = j;
  3611       auto sub = jac_block.
sub_matrix(i * indof, indof, jj * jndof, jndof);
  3612       if (scaling_factor[i] != 1.0)
  3613         sub *= scaling_factor[i];
  3631                              const std::vector<dof_id_type> & idof_indices,
  3632                              const std::vector<dof_id_type> & jdof_indices,
  3635   if (idof_indices.size() == 0 || jdof_indices.size() == 0)
  3637   if (jac_block.
n() == 0 || jac_block.
m() == 0)
  3644   for (
unsigned int i = 0; i < ivar.
count(); ++i)
  3646     unsigned int iv = ivar.
number();
  3649       unsigned int jv = jvar.
number();
  3650       if (jt < jv || jt >= jv + jvar.
count())
  3652       unsigned int j = jt - jv;
  3656       auto indof = di.size();
  3657       auto jndof = dj.size();
  3659       unsigned int jj = j;
  3664       auto sub = jac_block.
sub_matrix(i * indof, indof, jj * jndof, jndof);
  3665       if (scaling_factor[i] != 1.0)
  3666         sub *= scaling_factor[i];
  3674       for (MooseIndex(di) i = 0; i < di.size(); i++)
  3675         for (MooseIndex(dj) j = 0; j < dj.size(); j++)
  3692                                     const std::vector<dof_id_type> & idof_indices,
  3693                                     const std::vector<dof_id_type> & jdof_indices,
  3696   if (idof_indices.size() == 0 || jdof_indices.size() == 0)
  3698   if (jac_block.
n() == 0 || jac_block.
m() == 0)
  3705   for (
unsigned int i = 0; i < ivar.
count(); ++i)
  3707     unsigned int iv = ivar.
number();
  3710       unsigned int jv = jvar.
number();
  3711       if (jt < jv || jt >= jv + jvar.
count())
  3713       unsigned int j = jt - jv;
  3717       auto indof = di.size();
  3718       auto jndof = dj.size();
  3720       unsigned int jj = j;
  3725       auto sub = jac_block.
sub_matrix(i * indof, indof, jj * jndof, jndof);
  3726       if (scaling_factor[i] != 1.0)
  3727         sub *= scaling_factor[i];
  3731       for (MooseIndex(di) i = 0; i < di.size(); i++)
  3732         for (MooseIndex(dj) j = 0; j < dj.size(); j++)
  3733           if (sub(i, j) != 0.0) 
  3748                              const std::vector<dof_id_type> & idof_indices,
  3749                              const std::vector<dof_id_type> & jdof_indices,
  3750                              Real scaling_factor,
  3755   if ((idof_indices.size() > 0) && (jdof_indices.size() > 0) && jac_block.
n() && jac_block.
m() &&
  3758     std::vector<dof_id_type> di(idof_indices);
  3759     std::vector<dof_id_type> dj(jdof_indices);
  3767     if (scaling_factor != 1.0)
  3768       jac_block *= scaling_factor;
  3770     for (MooseIndex(di) i = 0; i < di.size(); i++)
  3771       for (MooseIndex(dj) j = 0; j < dj.size(); j++)
  3788   const std::vector<Real> & 
JxW = fe->get_JxW();
  3789   const std::vector<Point> & q_points = fe->get_xyz();
  3793   QGauss qrule(
elem->
dim(), fe_type.default_quadrature_order());
  3794   fe->attach_quadrature_rule(&qrule);
  3799   mooseAssert(qrule.n_points() == q_points.size(),
  3800               "The number of points in the quadrature rule doesn't match the number of passed-in "  3801               "points in Assembly::setCoordinateTransformation");
  3805   for (
unsigned int qp = 0; qp < qrule.n_points(); ++qp)
  3809     vol += 
JxW[qp] * coord;
  3821                 "Error: Cached data sizes MUST be the same!");
  3824                   "Error: Cached data sizes MUST be the same for a given tag!");
  3889     auto ivar = it.first;
  3890     auto jvar = it.second;
  3911     auto ivar = it.first;
  3912     auto jvar = it.second;
  3925                          jvar->dofIndicesNeighbor());
  3931                          ivar->dofIndicesNeighbor(),
  3938                          ivar->dofIndicesNeighbor(),
  3939                          jvar->dofIndicesNeighbor());
  3949     auto ivar = it.first;
  3950     auto jvar = it.second;
  3961                          ivar->dofIndicesLower(),
  3962                          jvar->dofIndicesLower());
  3968                          ivar->dofIndicesLower(),
  3969                          jvar->dofIndicesNeighbor());
  3975                          ivar->dofIndicesLower(),
  3982                          ivar->dofIndicesNeighbor(),
  3983                          jvar->dofIndicesLower());
  3990                          jvar->dofIndicesLower());
  4003                          jvar->dofIndicesNeighbor());
  4009                          ivar->dofIndicesNeighbor(),
  4016                          ivar->dofIndicesNeighbor(),
  4017                          jvar->dofIndicesNeighbor());
  4027     auto ivar = it.first;
  4028     auto jvar = it.second;
  4039                          ivar->dofIndicesLower(),
  4040                          jvar->dofIndicesLower());
  4046                          ivar->dofIndicesLower(),
  4054                          jvar->dofIndicesLower());
  4094     auto ivar = it.first;
  4095     auto jvar = it.second;
  4116     auto ivar = it.first;
  4117     auto jvar = it.second;
  4130                            jvar->dofIndicesNeighbor(),
  4135                            ivar->dofIndicesNeighbor(),
  4142             ivar->dofIndicesNeighbor(),
  4143             jvar->dofIndicesNeighbor(),
  4154     auto ivar = it.first;
  4155     auto jvar = it.second;
  4165                            ivar->dofIndicesLower(),
  4166                            jvar->dofIndicesLower(),
  4172                            ivar->dofIndicesLower(),
  4179                            ivar->dofIndicesLower(),
  4180                            jvar->dofIndicesNeighbor(),
  4187                            jvar->dofIndicesLower(),
  4202                            jvar->dofIndicesNeighbor(),
  4208                            ivar->dofIndicesNeighbor(),
  4209                            jvar->dofIndicesLower(),
  4215                            ivar->dofIndicesNeighbor(),
  4222                            ivar->dofIndicesNeighbor(),
  4223                            jvar->dofIndicesNeighbor(),
  4234                                std::vector<dof_id_type> & dof_indices,
  4236                                const std::set<TagID> & tags)
  4238   for (
auto tag : tags)
  4247                            std::vector<dof_id_type> & dof_indices,
  4251   if (dof_indices.size() == 0)
  4253   if (!(*
_cm)(ivar, jvar))
  4260   const unsigned int ivn = iv.number();
  4261   const unsigned int jvn = jv.number();
  4270   const unsigned int i = ivar - ivn;
  4271   const unsigned int j = jvar - jvn;
  4274   auto di = dof_indices;
  4275   auto dj = dof_indices;
  4277   auto indof = di.size();
  4278   auto jndof = dj.size();
  4280   unsigned int jj = j;
  4284   auto sub = ke.
sub_matrix(i * indof, indof, jj * jndof, jndof);
  4291   if (scaling_factor[i] != 1.0)
  4292     sub *= scaling_factor[i];
  4299                                    const unsigned int ivar,
  4300                                    const unsigned int jvar,
  4302                                    const std::vector<dof_id_type> & idof_indices,
  4303                                    const std::vector<dof_id_type> & jdof_indices,
  4307   if (idof_indices.size() == 0 || jdof_indices.size() == 0)
  4309   if (jacobian.
n() == 0 || jacobian.
m() == 0)
  4311   if (!(*
_cm)(ivar, jvar))
  4318   const unsigned int ivn = iv.number();
  4319   const unsigned int jvn = jv.number();
  4328   const unsigned int i = ivar - ivn;
  4329   const unsigned int j = jvar - jvn;
  4332   auto di = idof_indices;
  4333   auto dj = jdof_indices;
  4335   auto indof = di.size();
  4336   auto jndof = dj.size();
  4338   unsigned int jj = j;
  4342   auto sub = keg.
sub_matrix(i * indof, indof, jj * jndof, jndof);
  4349   if (scaling_factor[i] != 1.0)
  4350     sub *= scaling_factor[i];
  4357                                        const unsigned int ivar,
  4358                                        const unsigned int jvar,
  4360                                        const std::vector<dof_id_type> & idof_indices,
  4361                                        const std::vector<dof_id_type> & jdof_indices,
  4363                                        const std::set<TagID> & tags)
  4365   for (
auto tag : tags)
  4367         jacobian, ivar, jvar, dof_map, idof_indices, jdof_indices, 
GlobalDataKey{}, tag);
  4372                               const unsigned int ivar,
  4373                               const unsigned int jvar,
  4375                               std::vector<dof_id_type> & dof_indices,
  4376                               std::vector<dof_id_type> & neighbor_dof_indices,
  4380   if (dof_indices.size() == 0 && neighbor_dof_indices.size() == 0)
  4382   if (!(*
_cm)(ivar, jvar))
  4389   const unsigned int ivn = iv.number();
  4390   const unsigned int jvn = jv.number();
  4401   const unsigned int i = ivar - ivn;
  4402   const unsigned int j = jvar - jvn;
  4404   auto dc = dof_indices;
  4405   auto dn = neighbor_dof_indices;
  4406   auto cndof = dc.size();
  4407   auto nndof = dn.size();
  4409   unsigned int jj = j;
  4413   auto suben = ken.
sub_matrix(i * cndof, cndof, jj * nndof, nndof);
  4414   auto subne = kne.
sub_matrix(i * nndof, nndof, jj * cndof, cndof);
  4415   auto subnn = knn.
sub_matrix(i * nndof, nndof, jj * nndof, nndof);
  4427   if (scaling_factor[i] != 1.0)
  4429     suben *= scaling_factor[i];
  4430     subne *= scaling_factor[i];
  4431     subnn *= scaling_factor[i];
  4441                                   const unsigned int ivar,
  4442                                   const unsigned int jvar,
  4444                                   std::vector<dof_id_type> & dof_indices,
  4445                                   std::vector<dof_id_type> & neighbor_dof_indices,
  4447                                   const std::set<TagID> & tags)
  4449   for (
const auto tag : tags)
  4451         jacobian, ivar, jvar, dof_map, dof_indices, neighbor_dof_indices, 
GlobalDataKey{}, tag);
  4466   for (
const auto & var_j : 
vars)
  4484                         const std::set<TagID> & tags)
  4486   for (
auto tag : tags)
  4535   mooseAssert(
_xfem != 
nullptr, 
"This function should not be called if xfem is inactive");
  4544                 "Size of weight multipliers in xfem doesn't match number of quadrature points");
  4545     for (
unsigned i = 0; i < xfem_weight_multipliers.
size(); i++)
  4548     xfem_weight_multipliers.
release();
  4555   mooseAssert(
_xfem != 
nullptr, 
"This function should not be called if xfem is inactive");
  4561   if (
_xfem->getXFEMFaceWeights(
  4565                 "Size of weight multipliers in xfem doesn't match number of quadrature points");
  4566     for (
unsigned i = 0; i < xfem_face_weight_multipliers.
size(); i++)
  4569     xfem_face_weight_multipliers.
release();
  4585   for (MooseIndex(weights.size()) i = 0; i < weights.size(); ++i)
  4591 Assembly::fePhi<VectorValue<Real>>(
FEType type) 
const  4593   buildVectorFE(type);
  4594   return _vector_fe_shape_data[type]->_phi;
  4599 Assembly::feGradPhi<VectorValue<Real>>(
FEType type) 
const  4601   buildVectorFE(type);
  4602   return _vector_fe_shape_data[type]->_grad_phi;
  4607 Assembly::feSecondPhi<VectorValue<Real>>(
FEType type) 
const  4609   _need_second_derivative.insert(type);
  4610   buildVectorFE(type);
  4611   return _vector_fe_shape_data[type]->_second_phi;
  4616 Assembly::fePhiLower<VectorValue<Real>>(
FEType type) 
const  4618   buildVectorLowerDFE(type);
  4619   return _vector_fe_shape_data_lower[type]->_phi;
  4624 Assembly::feDualPhiLower<VectorValue<Real>>(
FEType type) 
const  4626   buildVectorDualLowerDFE(type);
  4627   return _vector_fe_shape_data_dual_lower[type]->_phi;
  4632 Assembly::feGradPhiLower<VectorValue<Real>>(
FEType type) 
const  4634   buildVectorLowerDFE(type);
  4635   return _vector_fe_shape_data_lower[type]->_grad_phi;
  4640 Assembly::feGradDualPhiLower<VectorValue<Real>>(
FEType type) 
const  4642   buildVectorDualLowerDFE(type);
  4643   return _vector_fe_shape_data_dual_lower[type]->_grad_phi;
  4648 Assembly::fePhiFace<VectorValue<Real>>(
FEType type) 
const  4650   buildVectorFaceFE(type);
  4651   return _vector_fe_shape_data_face[type]->_phi;
  4656 Assembly::feGradPhiFace<VectorValue<Real>>(
FEType type) 
const  4658   buildVectorFaceFE(type);
  4659   return _vector_fe_shape_data_face[type]->_grad_phi;
  4664 Assembly::feSecondPhiFace<VectorValue<Real>>(
FEType type) 
const  4666   _need_second_derivative.insert(type);
  4667   buildVectorFaceFE(type);
  4672   buildVectorFaceNeighborFE(type);
  4674   return _vector_fe_shape_data_face[type]->_second_phi;
  4679 Assembly::fePhiNeighbor<VectorValue<Real>>(
FEType type) 
const  4681   buildVectorNeighborFE(type);
  4682   return _vector_fe_shape_data_neighbor[type]->_phi;
  4687 Assembly::feGradPhiNeighbor<VectorValue<Real>>(
FEType type) 
const  4689   buildVectorNeighborFE(type);
  4690   return _vector_fe_shape_data_neighbor[type]->_grad_phi;
  4695 Assembly::feSecondPhiNeighbor<VectorValue<Real>>(
FEType type) 
const  4697   _need_second_derivative_neighbor.insert(type);
  4698   buildVectorNeighborFE(type);
  4699   return _vector_fe_shape_data_neighbor[type]->_second_phi;
  4704 Assembly::fePhiFaceNeighbor<VectorValue<Real>>(
FEType type) 
const  4706   buildVectorFaceNeighborFE(type);
  4707   return _vector_fe_shape_data_face_neighbor[type]->_phi;
  4712 Assembly::feGradPhiFaceNeighbor<VectorValue<Real>>(
FEType type) 
const  4714   buildVectorFaceNeighborFE(type);
  4715   return _vector_fe_shape_data_face_neighbor[type]->_grad_phi;
  4720 Assembly::feSecondPhiFaceNeighbor<VectorValue<Real>>(
FEType type) 
const  4722   _need_second_derivative_neighbor.insert(type);
  4723   buildVectorFaceNeighborFE(type);
  4724   return _vector_fe_shape_data_face_neighbor[type]->_second_phi;
  4729 Assembly::feCurlPhi<VectorValue<Real>>(
FEType type) 
const  4731   _need_curl.insert(type);
  4732   buildVectorFE(type);
  4733   return _vector_fe_shape_data[type]->_curl_phi;
  4738 Assembly::feCurlPhiFace<VectorValue<Real>>(
FEType type) 
const  4740   _need_curl.insert(type);
  4741   buildVectorFaceFE(type);
  4746   buildVectorFaceNeighborFE(type);
  4748   return _vector_fe_shape_data_face[type]->_curl_phi;
  4753 Assembly::feCurlPhiNeighbor<VectorValue<Real>>(
FEType type) 
const  4755   _need_curl.insert(type);
  4756   buildVectorNeighborFE(type);
  4757   return _vector_fe_shape_data_neighbor[type]->_curl_phi;
  4762 Assembly::feCurlPhiFaceNeighbor<VectorValue<Real>>(
FEType type) 
const  4764   _need_curl.insert(type);
  4765   buildVectorFaceNeighborFE(type);
  4767   return _vector_fe_shape_data_face_neighbor[type]->_curl_phi;
  4772 Assembly::feDivPhi<VectorValue<Real>>(
FEType type) 
const  4774   _need_div.insert(type);
  4775   buildVectorFE(type);
  4776   return _vector_fe_shape_data[type]->_div_phi;
  4781 Assembly::feDivPhiFace<VectorValue<Real>>(
FEType type) 
const  4783   _need_face_div.insert(type);
  4784   buildVectorFaceFE(type);
  4789   buildVectorFaceNeighborFE(type);
  4791   return _vector_fe_shape_data_face[type]->_div_phi;
  4796 Assembly::feDivPhiNeighbor<VectorValue<Real>>(
FEType type) 
const  4798   _need_neighbor_div.insert(type);
  4799   buildVectorNeighborFE(type);
  4800   return _vector_fe_shape_data_neighbor[type]->_div_phi;
  4805 Assembly::feDivPhiFaceNeighbor<VectorValue<Real>>(
FEType type) 
const  4807   _need_face_neighbor_div.insert(type);
  4808   buildVectorFaceNeighborFE(type);
  4809   return _vector_fe_shape_data_face_neighbor[type]->_div_phi;
  4820   feSecondPhi<Real>(helper_type);
  4821   feSecondPhiFace<Real>(helper_type);
  4868       [&disable_families](
const unsigned int num_dimensionalities, 
auto & fe_container)
  4870     if (!disable_families.empty())
  4873         auto fe_container_it = fe_container.find(
dim);
  4874         if (fe_container_it != fe_container.end())
  4875           for (
auto & [fe_type, fe_ptr] : fe_container_it->second)
  4876             if (disable_families.count(fe_type.family))
  4877               fe_ptr->add_p_level_in_reinit(
false);
  4880   auto process_fe_and_helpers = [process_fe, &helper_type](
auto & unique_helper_container,
  4881                                                            auto & helper_container,
  4882                                                            const unsigned int num_dimensionalities,
  4883                                                            const bool user_added_helper_type,
  4884                                                            auto & fe_container)
  4886     unique_helper_container.resize(num_dimensionalities);
  4889       auto & unique_helper = unique_helper_container[
dim];
  4892       unique_helper->add_p_level_in_reinit(
false);
  4893       helper_container[
dim] = unique_helper.get();
  4898       if (!user_added_helper_type)
  4900         auto & fe_container_dim = libmesh_map_find(fe_container, 
dim);
  4901         auto fe_it = fe_container_dim.find(helper_type);
  4902         mooseAssert(fe_it != fe_container_dim.end(), 
"We should have the helper type");
  4903         delete fe_it->second;
  4904         fe_container_dim.erase(fe_it);
  4908     process_fe(num_dimensionalities, fe_container);
  4972 Assembly::genericQPoints<false>() 
const  4979 Assembly::genericQPoints<true>() 
const const Elem *const  & elem() const
Return the current element. 
virtual MooseMesh & mesh()=0
MooseArray< VectorValue< ADReal > > _ad_normals
void copyShapes(MooseVariableField< T > &v)
libMesh::ElemSideBuilder _compute_face_map_side_elem_builder
In place side element builder for computeFaceMap() 
std::map< unsigned int, std::map< FEType, FEBase * > > _fe_face
types of finite elements 
bool _need_neighbor_elem_volume
true is apps need to compute neighbor element volume 
void cacheResidualNeighbor(GlobalDataKey, const std::vector< VectorTag > &tags)
Takes the values that are currently in _sub_Rn of all field variables and appends them to the cached ...
virtual void insert(const T *v, const std::vector< numeric_index_type > &dof_indices)
ArbitraryQuadrature * _current_qrule_arbitrary
The current arbitrary quadrature rule used within the element interior. 
std::map< FEType, FEBase * > _current_fe
The "volume" fe object that matches the current elem. 
MooseArray< Real > _curvatures
const std::vector< MooseVariableFieldBase * > & getVariables(THREAD_ID tid)
std::vector< ADReal > _ad_detadz_map
VectorVariablePhiValue _phi
std::unique_ptr< FEGenericBase< Real > > build(const unsigned int dim, const FEType &fet)
std::vector< std::vector< dof_id_type > > _cached_residual_rows
Where the cached values should go (the first vector is for TIME vs NONTIME) 
std::vector< std::vector< dof_id_type > > _cached_jacobian_rows
Row where the corresponding cached value should go. 
unsigned int _max_cached_residuals
std::map< FEType, ADTemplateVariablePhiGradient< Real > > _ad_grad_phi_data_face
std::vector< dof_id_type > componentDofIndices(const std::vector< dof_id_type > &dof_indices, unsigned int component) const
Obtain DoF indices of a component with the indices of the 0th component. 
virtual_for_inffe const std::vector< std::vector< OutputDivergence > > & get_div_phi() const
dof_id_type dof_number(const unsigned int s, const unsigned int var, const unsigned int comp) const
bool _user_added_fe_lower_of_helper_type
MooseArray< Point > _current_physical_points
This will be filled up with the physical points passed into reinitAtPhysical() if it is called...
const VariablePhiGradient & gradPhiFaceNeighbor(const MooseVariableField< Real > &) const
std::vector< std::unique_ptr< FEBase > > _unique_fe_lower_helper
void print_info(std::ostream &os=libMesh::out) const
MooseArray< ADReal > _ad_coord
The AD version of the current coordinate transformation coefficients. 
virtual const FieldVariablePhiValue & phi() const =0
Return the variable's elemental shape functions. 
void setResidualBlock(NumericVector< Number > &residual, DenseVector< Number > &res_block, const std::vector< dof_id_type > &dof_indices, const std::vector< Real > &scaling_factor, bool is_nodal)
Set a local residual block to a global residual vector with proper scaling. 
void buildNeighborFE(FEType type) const
Build FEs for a neighbor with a type. 
const VariablePhiSecond & secondPhi() const
void setMortarQRule(Order order)
Specifies a custom qrule for integration on mortar segment mesh. 
std::map< unsigned int, std::map< FEType, FEVectorBase * > > _vector_fe
Each dimension's actual vector fe objects indexed on type. 
typename OutputTools< typename Moose::ADType< T >::type >::VariablePhiGradient ADTemplateVariablePhiGradient
const std::vector< std::vector< OutputShape > > & get_dual_phi() const
void buildVectorLowerDFE(FEType type) const
Build Vector FEs for a lower dimensional element with a type. 
MooseArray< Real > _coord_neighbor
The current coordinate transformation coefficients. 
virtual void haveADObjects(bool have_ad_objects)
Method for setting whether we have any ad objects. 
void buildFE(FEType type) const
Build FEs with a type. 
const std::vector< MooseVariableScalar * > & getScalarVariables(THREAD_ID tid)
std::vector< std::vector< std::vector< DenseMatrix< Number > > > > _sub_Kle
dlower/dsecondary (or dlower/delement) 
virtual void zero() override final
void cacheResidualLower(GlobalDataKey, const std::vector< VectorTag > &tags)
Takes the values that are currently in _sub_Rl and appends them to the cached values. 
const unsigned int invalid_uint
void setFaceQRule(libMesh::QBase *qrule, unsigned int dim)
Set the qrule to be used for face integration. 
bool hasVector(const std::string &tag_name) const
Check if the named vector exists in the system. 
Assembly(SystemBase &sys, THREAD_ID tid)
std::map< FEType, std::unique_ptr< FEShapeData > > _fe_shape_data
Shape function values, gradients, second derivatives for each FE type. 
void buildLowerDDualFE(FEType type) const
virtual bool checkNonlocalCouplingRequirement() const =0
MooseArray< Real > _current_JxW_neighbor
The current transformed jacobian weights on a neighbor's face. 
std::shared_ptr< XFEMInterface > _xfem
The XFEM controller. 
void reinitNeighborLowerDElem(const Elem *elem)
reinitialize a neighboring lower dimensional element 
void prepareJacobianBlock()
Sizes and zeroes the Jacobian blocks used for the current element. 
DenseMatrix< Number > & jacobianBlockNonlocal(unsigned int ivar, unsigned int jvar, LocalDataKey, TagID tag)
Get local Jacobian block from non-local contribution for a pair of variables and a tag...
void mooseError(Args &&... args)
Emit an error message with the given stringified, concatenated args and terminate the application...
virtual void zero() override final
std::vector< std::vector< std::vector< DenseMatrix< Number > > > > _sub_Kel
dsecondary/dlower (or delement/dlower) 
const std::vector< Real > & arrayScalingFactor() const
MooseArray< Real > _coord
The current coordinate transformation coefficients. 
unsigned int number() const
Get variable number coming from libMesh. 
bool allow_rules_with_negative_weights
DenseMatrix< Number > & jacobianBlockNeighbor(Moose::DGJacobianType type, unsigned int ivar, unsigned int jvar, LocalDataKey, TagID tag)
Get local Jacobian block of a DG Jacobian type for a pair of variables and a tag. ...
void reinitFE(const Elem *elem)
Just an internal helper function to reinit the volume FE objects. 
TagID _id
The id associated with the vector tag. 
virtual unsigned int currentNlSysNum() const =0
libMesh::QBase * _current_qrule_neighbor
quadrature rule used on neighbors 
void jacobianBlockUsed(TagID tag, unsigned int ivar, unsigned int jvar, bool used)
Sets whether or not Jacobian coupling between ivar and jvar is used to the value used. 
void coordTransformFactor(const P &point, C &factor, const Moose::CoordinateSystemType coord_type, const unsigned int rz_radial_coord=libMesh::invalid_uint)
compute a coordinate transformation factor 
std::map< unsigned int, FEBase * > _holder_fe_neighbor_helper
Each dimension's helper objects. 
std::unique_ptr< FEBase > _fe_msm
A FE object for working on mortar segement elements. 
std::map< FEType, std::unique_ptr< FEShapeData > > _fe_shape_data_face_neighbor
void createQRules(QuadratureType type, Order order, Order volume_order, Order face_order, SubdomainID block, bool allow_negative_qweights=true)
Creates block-specific volume, face and arbitrary qrules based on the orders and the flag of whether ...
const std::vector< std::vector< Real > > & get_dphidzeta_map() const
const Elem & elem() const
void reinitAtPhysical(const Elem *elem, const std::vector< Point > &physical_points)
Reinitialize the assembly data at specific physical point in the given element. 
void addCachedResidualDirectly(NumericVector< Number > &residual, GlobalDataKey, const VectorTag &vector_tag)
Adds the values that have been cached by calling cacheResidual(), cacheResidualNeighbor(), and/or cacheResidualLower() to a user-defined residual (that is, not necessarily the vector that vector_tag points to) 
bool _current_elem_volume_computed
Boolean to indicate whether current element volumes has been computed. 
std::vector< ADReal > _ad_detady_map
void jacobianBlockLowerUsed(TagID tag, unsigned int ivar, unsigned int jvar, bool used)
Sets whether or not lower Jacobian coupling between ivar and jvar is used to the value used...
const VectorVariablePhiDivergence & divPhi(const MooseVariableField< RealVectorValue > &) const
std::vector< ADReal > _ad_dzetadz_map
std::vector< std::unique_ptr< FEBase > > _unique_fe_neighbor_helper
std::vector< std::vector< std::vector< DenseMatrix< Number > > > > _sub_Kll
dlower/dlower 
bool _user_added_fe_face_neighbor_of_helper_type
void setResidualNeighbor(NumericVector< Number > &residual, GlobalDataKey, const VectorTag &vector_tag)
Sets local neighbor residuals of all field variables to the global residual vector for a tag...
bool _have_p_refinement
Whether we have ever conducted p-refinement. 
Real _current_neighbor_volume
Volume of the current neighbor. 
void jacobianBlockNonlocalUsed(TagID tag, unsigned int ivar, unsigned int jvar, bool used)
Sets whether or not nonlocal Jacobian coupling between ivar and jvar is used to the value used...
virtual void add_vector(const T *v, const std::vector< numeric_index_type > &dof_indices)
ArbitraryQuadrature * qruleArbitraryFace(const Elem *elem, unsigned int side)
std::map< FEType, FEBase * > _current_fe_face
The "face" fe object that matches the current elem. 
const VectorVariablePhiCurl & curlPhi(const MooseVariableField< RealVectorValue > &) const
std::vector< Point > _current_neighbor_ref_points
The current reference points on the neighbor element. 
std::vector< std::vector< std::vector< DenseMatrix< Number > > > > _sub_Kln
dlower/dprimary (or dlower/dneighbor) 
void setVolumeQRule(libMesh::QBase *qrule, unsigned int dim)
Set the qrule to be used for volume integration. 
const Elem * _current_neighbor_elem
The current neighbor "element". 
void addJacobianNonlocal(GlobalDataKey)
Adds non-local Jacobian to the global Jacobian matrices. 
std::vector< std::vector< DenseVector< Number > > > _sub_Rn
unsigned int count() const
Get the number of components Note: For standard and vector variables, the number is one...
virtual const FieldVariablePhiGradient & gradPhiNeighbor() const =0
Return the gradients of the variable's shape functions on a neighboring element. 
const VariablePhiValue & phi() const
TagTypeID _type_id
The index for this tag into a vector that contains tags of only its type ordered by ID...
std::map< FEType, std::unique_ptr< FEShapeData > > _fe_shape_data_neighbor
std::map< unsigned int, FEBase * > _holder_fe_face_neighbor_helper
unsigned int n_elem_integers() const
const VariablePhiGradient & gradPhi() const
MooseArray< Real > _current_JxW_face
The current transformed jacobian weights on a face. 
void modifyWeightsDueToXFEM(const Elem *elem)
Update the integration weights for XFEM partial elements. 
const std::vector< Real > & get_weights() const
void coordTransformFactorRZGeneral(const P &point, const std::pair< Point, RealVectorValue > &axis, C &factor)
Computes a coordinate transformation factor for a general axisymmetric axis. 
const Elem * _current_elem
The current "element" we are currently on. 
const VariablePhiSecond & secondPhiNeighbor(const MooseVariableField< Real > &) const
bool computingScalingJacobian() const
Whether we are computing an initial Jacobian for automatic variable scaling. 
THREAD_ID _tid
Thread number (id) 
void reinitFEFaceNeighbor(const Elem *neighbor, const std::vector< Point > &reference_points)
static constexpr std::size_t dim
This is the dimension of all vector and tensor datastructures used in MOOSE. 
virtual const FieldVariablePhiSecond & secondPhi() const =0
Return the rank-2 tensor of second derivatives of the variable's elemental shape functions. 
void reinitNeighborAtPhysical(const Elem *neighbor, unsigned int neighbor_side, const std::vector< Point > &physical_points)
Reinitializes the neighbor at the physical coordinates on neighbor side given. 
std::vector< std::unique_ptr< FEBase > > _unique_fe_face_helper
std::vector< std::vector< std::vector< unsigned char > > > _jacobian_block_nonlocal_used
std::vector< std::pair< MooseVariableScalar *, MooseVariableFieldBase * > > _cm_sf_entry
Entries in the coupling matrix for scalar variables vs field variables. 
void resizeADMappingObjects(unsigned int n_qp, unsigned int dim)
resize any objects that contribute to automatic differentiation-related mapping calculations ...
OutputTools< Real >::VariablePhiValue VariablePhiValue
virtual bool hasMatrix(TagID tag) const
Check if the tagged matrix exists in the system. 
const std::vector< std::vector< Real > > & get_phi_map() const
void setCoordinateTransformation(const libMesh::QBase *qrule, const Points &q_points, Coords &coord, SubdomainID sub_id)
std::map< unsigned int, std::map< FEType, FEVectorBase * > > _vector_fe_face_neighbor
const VariablePhiValue & phiFaceNeighbor(const MooseVariableField< Real > &) const
unsigned int elemSideID() const
std::vector< bool > _component_block_diagonal
An flag array Indiced by variable index to show if there is no component-wise coupling for the variab...
Real _current_elem_volume
Volume of the current element. 
std::map< FEType, FEBase * > _current_fe_face_neighbor
The "neighbor face" fe object that matches the current elem. 
const MooseArray< ADReal > & adCurvatures() const
This class provides an interface for common operations on field variables of both FE and FV types wit...
std::map< FEType, FEVectorBase * > _current_vector_fe_face
The "face" vector fe object that matches the current elem. 
void shallowCopy(const MooseArray &rhs)
Doesn't actually make a copy of the data. 
std::vector< std::unique_ptr< FEBase > > _unique_fe_helper
Containers for holding unique FE helper types if we are doing p-refinement. 
void processLocalResidual(DenseVector< Number > &res_block, std::vector< dof_id_type > &dof_indices, const std::vector< Real > &scaling_factor, bool is_nodal)
Appling scaling, constraints to the local residual block and populate the full DoF indices for array ...
const FEType _helper_type
The finite element type of the FE helper classes. 
void addResidualLower(GlobalDataKey, const std::vector< VectorTag > &vector_tags)
Add local neighbor residuals of all field variables for a set of tags onto the global residual vector...
DenseMatrix< Number > & jacobianBlock(unsigned int ivar, unsigned int jvar, LocalDataKey, TagID tag)
Get local Jacobian block for a pair of variables and a tag. 
The following methods are specializations for using the libMesh::Parallel::packed_range_* routines fo...
void addJacobianScalar(GlobalDataKey)
Add Jacobians for pairs of scalar variables into the global Jacobian matrices. 
const std::vector< std::vector< OutputShape > > & get_dphideta() const
std::vector< std::vector< std::vector< DenseMatrix< Number > > > > _sub_Knn
jacobian contributions from the neighbor <Tag, ivar, jvar> 
Base class for a system (of equations) 
libMesh::QBase * _current_qrule_face
quadrature rule used on faces 
const VariablePhiValue & phiNeighbor(const MooseVariableField< Real > &) const
unsigned int numExtraElemIntegers() const
Number of extra element integers Assembly tracked. 
std::set< FEType > _need_second_derivative_neighbor
void setWeights(const std::vector< libMesh::Real > &weights)
Set the quadrature weights. 
DualNumber< Real, DNDerivativeType, true > ADReal
std::vector< std::vector< Real > > _cached_jacobian_values
Values cached by calling cacheJacobian() 
std::vector< std::pair< MooseVariableFieldBase *, MooseVariableFieldBase * > > _cm_ff_entry
Entries in the coupling matrix for field variables. 
void addJacobianNeighborLowerD(GlobalDataKey)
Add all portions of the Jacobian except PrimaryPrimary, e.g. 
std::map< FEType, FEVectorBase * > _current_vector_fe
The "volume" vector fe object that matches the current elem. 
VariablePhiGradient _grad_phi
template void coordTransformFactor< ADPoint, ADReal >(const SubProblem &s, SubdomainID sub_id, const ADPoint &point, ADReal &factor, SubdomainID neighbor_sub_id)
std::vector< VectorValue< ADReal > > _ad_dxyzdeta_map
virtual const FieldVariablePhiValue & phiNeighbor() const =0
Return the variable's shape functions on a neighboring element. 
void modifyFaceWeightsDueToXFEM(const Elem *elem, unsigned int side=0)
Update the face integration weights for XFEM partial elements. 
void reinitElemAndNeighbor(const Elem *elem, unsigned int side, const Elem *neighbor, unsigned int neighbor_side, const std::vector< Point > *neighbor_reference_points=nullptr)
Reinitialize an element and its neighbor along a particular side. 
OutputTools< Real >::VariablePhiSecond VariablePhiSecond
std::unique_ptr< libMesh::QBase > face
area/face (meshdim-1) quadrature rule 
unsigned int neighborSideID() const
DenseVector< Number > _tmp_Re
auxiliary vector for scaling residuals (optimization to avoid expensive construction/destruction) ...
unsigned int _mesh_dimension
virtual QuadratureType type() const=0
std::vector< Eigen::Map< RealDIMValue > > _mapped_normals
Mapped normals. 
VectorVariablePhiDivergence _vector_div_phi_face
void cacheJacobian(GlobalDataKey)
Takes the values that are currently in _sub_Kee and appends them to the cached values. 
void reinit(const Elem *elem)
Reinitialize objects (JxW, q_points, ...) for an elements. 
const NumericVector< Real > * _scaling_vector
The map from global index to variable scaling factor. 
auto max(const L &left, const R &right)
const std::vector< std::vector< OutputShape > > & get_dphidzeta() const
virtual void set(const numeric_index_type i, const numeric_index_type j, const T value)=0
void addCachedResiduals(GlobalDataKey, const std::vector< VectorTag > &tags)
Pushes all cached residuals to the global residual vectors associated with each tag. 
Data structure for tracking/grouping a set of quadrature rules for a particular dimensionality of mes...
const std::vector< std::vector< Real > > & get_dphideta_map() const
unsigned int _max_cached_jacobians
virtual void add(const numeric_index_type i, const numeric_index_type j, const T value)=0
DenseMatrix< Number > & jacobianBlockMortar(Moose::ConstraintJacobianType type, unsigned int ivar, unsigned int jvar, LocalDataKey, TagID tag)
Returns the jacobian block for the given mortar Jacobian type. 
std::vector< std::vector< std::vector< DenseMatrix< Number > > > > _sub_Ken
jacobian contributions from the element and neighbor <Tag, ivar, jvar> 
FEType get_fe_type() const
std::map< FEType, std::unique_ptr< VectorFEShapeData > > _vector_fe_shape_data_dual_lower
virtual unsigned int nVariables() const
Get the number of variables in this system. 
virtual const FieldVariablePhiValue & phiFaceNeighbor() const =0
Return the variable's shape functions on a neighboring element face. 
unsigned int n_dofs(const unsigned int s, const unsigned int var=libMesh::invalid_uint) const
std::vector< VectorValue< ADReal > > _ad_dxyzdzeta_map
std::vector< Point > _temp_reference_points
Temporary work data for reinitAtPhysical() 
std::vector< std::pair< MooseVariableScalar *, MooseVariableScalar * > > _cm_ss_entry
Entries in the coupling matrix for scalar variables. 
std::vector< std::vector< std::vector< DenseMatrix< Number > > > > _sub_Kne
jacobian contributions from the neighbor and element <Tag, ivar, jvar> 
const Elem * _current_neighbor_lower_d_elem
The current neighboring lower dimensional element. 
unsigned int _current_neighbor_side
The current side of the selected neighboring element (valid only when working with sides) ...
void cacheResidualNodes(const DenseVector< Number > &res, const std::vector< dof_id_type > &dof_index, LocalDataKey, TagID tag)
Lets an external class cache residual at a set of nodes. 
void init(const libMesh::CouplingMatrix *cm)
Initialize the Assembly object and set the CouplingMatrix for use throughout. 
void prepareLowerD()
Prepare the Jacobians and residuals for a lower dimensional element. 
bool _user_added_fe_neighbor_of_helper_type
const std::vector< std::vector< OutputGradient > > & get_dphi() const
void buildFaceNeighborFE(FEType type) const
Build FEs for a neighbor face with a type. 
std::map< FEType, std::unique_ptr< VectorFEShapeData > > _vector_fe_shape_data_face
void reinitLowerDElem(const Elem *elem, const std::vector< Point > *const pts=nullptr, const std::vector< Real > *const weights=nullptr)
Reinitialize FE data for a lower dimenesional element with a given set of reference points...
void computeCurrentFaceVolume()
std::vector< std::vector< DenseVector< Number > > > _sub_Rl
residual contributions for each variable from the lower dimensional element 
This data structure is used to store geometric and variable related metadata about each cell face in ...
QRules & qrules(unsigned int dim)
virtual const FieldVariablePhiSecond & secondPhiFaceNeighbor() const =0
Return the rank-2 tensor of second derivatives of the variable's shape functions on a neighboring ele...
virtual const std::vector< dof_id_type > & dofIndicesNeighbor() const =0
Get neighbor DOF indices for currently selected element. 
std::unique_ptr< libMesh::QBase > vol
volume/elem (meshdim) quadrature rule 
virtual void add_matrix(const DenseMatrix< T > &dm, const std::vector< numeric_index_type > &rows, const std::vector< numeric_index_type > &cols)=0
void prepareOffDiagScalar()
VectorVariablePhiSecond _second_phi
unsigned int size() const
The number of elements that can currently be stored in the array. 
Implements a fake quadrature rule where you can specify the locations (in the reference domain) of th...
void addJacobianCoupledVarPair(const MooseVariableBase &ivar, const MooseVariableBase &jvar)
Adds element matrices for ivar rows and jvar columns to the global Jacobian matrices. 
std::vector< ADReal > _ad_dzetadx_map
void addJacobianLowerD(GlobalDataKey)
Add portions of the Jacobian of LowerLower, LowerSecondary, and SecondaryLower for boundary condition...
virtual const FieldVariablePhiSecond & secondPhiFace() const =0
Return the rank-2 tensor of second derivatives of the variable's shape functions on an element face...
void setPoints(const std::vector< libMesh::Point > &points)
Set the quadrature points. 
const Elem * neighborPtr() const
VectorVariablePhiGradient _grad_phi
MooseArray< ADReal > _ad_curvatures
void computeGradPhiAD(const Elem *elem, unsigned int n_qp, ADTemplateVariablePhiGradient< OutputType > &grad_phi, libMesh::FEGenericBase< OutputType > *fe)
compute gradient of phi possibly with derivative information with respect to nonlinear displacement v...
ArbitraryQuadrature * _current_qrule_arbitrary_face
The current arbitrary quadrature rule used on the element face. 
void modifyArbitraryWeights(const std::vector< Real > &weights)
Modify the weights when using the arbitrary quadrature rule. 
std::vector< std::pair< MooseVariableFieldBase *, MooseVariableScalar * > > _cm_fs_entry
Entries in the coupling matrix for field variables vs scalar variables. 
const Node & node_ref(const unsigned int i) const
const std::vector< Real > * _JxW_msm
A JxW for working on mortar segement elements. 
std::vector< ADReal > _ad_dzetady_map
Real value(unsigned n, unsigned alpha, unsigned beta, Real x)
MeshBase & getMesh()
Accessor for the underlying libMesh Mesh object. 
void coordTransformFactor(const SubProblem &s, const SubdomainID sub_id, const P &point, C &factor, const SubdomainID neighbor_sub_id)
Computes a conversion multiplier for use when computing integraals for the current coordinate system ...
dof_id_type numeric_index_type
std::map< FEType, ADTemplateVariablePhiGradient< Real > > _ad_grad_phi_data
template void coordTransformFactor< Point, Real >(const SubProblem &s, SubdomainID sub_id, const Point &point, Real &factor, SubdomainID neighbor_sub_id)
std::unordered_map< SubdomainID, std::vector< QRules > > _qrules
Holds quadrature rules for each dimension. 
void prepareResidual()
Sizes and zeroes the residual for the current element. 
VectorVariablePhiCurl _curl_phi
std::map< FEType, FEBase * > _current_fe_neighbor
The "neighbor" fe object that matches the current elem. 
Real elementVolume(const Elem *elem) const
On-demand computation of volume element accounting for RZ/RSpherical. 
void cacheJacobianNeighbor(GlobalDataKey)
Takes the values that are currently in the neighbor Dense Matrices and appends them to the cached val...
SubdomainID _current_neighbor_subdomain_id
The current neighbor subdomain ID. 
const std::vector< std::vector< OutputGradient > > & get_dual_dphi() const
std::vector< std::vector< DenseVector< Number > > > _sub_Re
void reinitNeighbor(const Elem *neighbor, const std::vector< Point > &reference_points)
Reinitializes the neighbor side using reference coordinates. 
std::vector< ADReal > _ad_dxidz_map
std::vector< std::vector< std::vector< unsigned char > > > _jacobian_block_used
Flag that indicates if the jacobian block was used. 
virtual numeric_index_type m() const=0
const Node *const * get_nodes() const
MooseMesh wraps a libMesh::Mesh object and enhances its capabilities by caching additional data and s...
libMesh::QBase * _current_qrule_lower
quadrature rule used on lower dimensional elements. 
std::vector< ADReal > _ad_detadx_map
void buildFaceFE(FEType type) const
Build FEs for a face with a type. 
std::map< unsigned int, std::map< FEType, FEBase * > > _fe_neighbor
types of finite elements 
void cacheResidual(GlobalDataKey, const std::vector< VectorTag > &tags)
Takes the values that are currently in _sub_Re of all field variables and appends them to the cached ...
void addJacobianBlockNonlocalTags(libMesh::SparseMatrix< Number > &jacobian, unsigned int ivar, unsigned int jvar, const libMesh::DofMap &dof_map, const std::vector< dof_id_type > &idof_indices, const std::vector< dof_id_type > &jdof_indices, GlobalDataKey, const std::set< TagID > &tags)
Adds non-local element matrix for ivar rows and jvar columns to the global Jacobian matrix...
MooseArray< std::vector< Point > > _current_tangents
The current tangent vectors at the quadrature points. 
virtual const std::vector< dof_id_type > & dofIndices() const
Get local DoF indices. 
bool _calculate_curvatures
const std::vector< VectorTag > & _residual_vector_tags
The residual vector tags that Assembly could possibly contribute to. 
virtual_for_inffe const std::vector< Real > & get_JxW() const
std::map< FEType, FEVectorBase * > _current_vector_fe_face_neighbor
The "neighbor face" vector fe object that matches the current elem. 
std::vector< dof_id_type > _neighbor_extra_elem_ids
Extra element IDs of neighbor. 
MooseArray< Real > _current_JxW
The current list of transformed jacobian weights. 
std::vector< VectorValue< ADReal > > _ad_dxyzdxi_map
AD quantities. 
virtual void zero_rows(std::vector< numeric_index_type > &rows, T diag_value=0.0)
virtual void reinit(const Elem *elem, const std::vector< Point > *const pts=nullptr, const std::vector< Real > *const weights=nullptr)=0
std::vector< std::pair< unsigned int, unsigned short > > _disp_numbers_and_directions
Container of displacement numbers and directions. 
std::vector< dof_id_type > _temp_dof_indices
Temporary work vector to keep from reallocating it. 
std::set< FEType > _need_neighbor_div
OutputTools< Real >::VariablePhiCurl VariablePhiCurl
std::vector< std::vector< std::vector< DenseMatrix< Number > > > > _sub_Kee
std::vector< VectorValue< ADReal > > _ad_d2xyzdxi2_map
unsigned int get_dim() const
std::vector< ADReal > _ad_jac
std::set< FEType > _need_curl
void addJacobianBlockNonlocal(libMesh::SparseMatrix< Number > &jacobian, unsigned int ivar, unsigned int jvar, const libMesh::DofMap &dof_map, const std::vector< dof_id_type > &idof_indices, const std::vector< dof_id_type > &jdof_indices, GlobalDataKey, TagID tag)
Adds non-local element matrix for ivar rows and jvar columns to the global Jacobian matrix...
unsigned int n_points() const
std::map< FEType, std::unique_ptr< VectorFEShapeData > > _vector_fe_shape_data_lower
OStreamProxy err(std::cerr)
const VariablePhiSecond & secondPhiFace(const MooseVariableField< Real > &) const
std::map< FEType, ADTemplateVariablePhiGradient< RealVectorValue > > _ad_vector_grad_phi_data
virtual_for_inffe const std::vector< Point > & get_xyz() const
bool usesPhiNeighbor() const
Whether or not this variable is actually using the shape function value. 
std::map< unsigned int, std::map< FEType, FEVectorBase * > > _vector_fe_face
types of vector finite elements 
libMesh::QBase * _current_qrule_volume
The current volumetric quadrature for the element. 
const std::vector< std::vector< OutputTensor > > & get_d2phi() const
virtual bool computingSecond() const =0
Whether or not this variable is computing any second derivatives. 
unsigned int number() const
Gets the number of this system. 
std::vector< T > stdVector() const
Extremely inefficient way to produce a std::vector from a MooseArray! 
libMesh::QBase * qruleFace(const Elem *elem, unsigned int side)
This is an abstraction over the internal qrules function. 
bool _calculate_ad_coord
Whether to calculate coord with AD. 
std::map< FEType, std::unique_ptr< FEShapeData > > _fe_shape_data_lower
const Elem * _current_lower_d_elem
The current lower dimensional element. 
void addResidualBlock(NumericVector< Number > &residual, DenseVector< Number > &res_block, const std::vector< dof_id_type > &dof_indices, const std::vector< Real > &scaling_factor, bool is_nodal)
Add a local residual block to a global residual vector with proper scaling. 
void addResidual(GlobalDataKey, const std::vector< VectorTag > &vector_tags)
Add local residuals of all field variables for a set of tags onto the global residual vectors associa...
const VariablePhiValue & phiFace() const
std::set< FEType > _need_second_derivative
std::map< unsigned int, std::map< FEType, FEBase * > > _fe_lower
FE objects for lower dimensional elements. 
bool hasSecondOrderElements()
check if the mesh has SECOND order elements 
std::set< FEType > _need_face_neighbor_div
libMesh::QBase * _qrule_msm
A qrule object for working on mortar segement elements. 
libMesh::ElemSideBuilder _current_neighbor_side_elem_builder
In place side element builder for _current_neighbor_side_elem. 
OutputTools< Real >::VariablePhiDivergence VariablePhiDivergence
Real _current_lower_d_elem_volume
The current lower dimensional element volume. 
libMesh::QBase * _current_qrule
The current current quadrature rule being used (could be either volumetric or arbitrary - for dirac k...
std::map< unsigned int, std::map< FEType, FEBase * > > _fe
Each dimension's actual fe objects indexed on type. 
const MooseArray< Real > & JxW() const
Returns the reference to the transformed jacobian weights. 
void reinitMortarElem(const Elem *elem)
reinitialize a mortar segment mesh element in order to get a proper JxW 
Real _current_side_volume
Volume of the current side element. 
std::set< FEType > _need_div
std::vector< std::vector< Real > > _cached_residual_values
Values cached by calling cacheResidual() (the first vector is for TIME vs NONTIME) ...
virtual bool usesSecondPhiNeighbor() const =0
Whether or not this variable is actually using the shape function second derivatives. 
virtual const FieldVariablePhiSecond & secondPhiNeighbor() const =0
Return the rank-2 tensor of second derivatives of the variable's shape functions on a neighboring ele...
void buildVectorFE(FEType type) const
Build Vector FEs with a type. 
virtual const FieldVariablePhiGradient & gradPhiFaceNeighbor() const =0
Return the gradients of the variable's shape functions on a neighboring element face. 
void addJacobianNeighborTags(libMesh::SparseMatrix< Number > &jacobian, unsigned int ivar, unsigned int jvar, const libMesh::DofMap &dof_map, std::vector< dof_id_type > &dof_indices, std::vector< dof_id_type > &neighbor_dof_indices, GlobalDataKey, const std::set< TagID > &tags)
Adds three neighboring element matrices for ivar rows and jvar columns to the global Jacobian matrix...
void reinitFVFace(const FaceInfo &fi)
std::map< unsigned int, std::map< FEType, FEVectorBase * > > _vector_fe_lower
Vector FE objects for lower dimensional elements. 
const MooseArray< Real > & JxWNeighbor() const
Returns the reference to the transformed jacobian weights on a current face. 
const Node * _current_node
The current node we are working with. 
bool _building_helpers
Whether we are currently building the FE classes for the helpers. 
virtual unsigned int numMatrixTags() const
The total number of tags. 
OutputTools< Real >::VariablePhiGradient VariablePhiGradient
std::vector< ADReal > _ad_dxidx_map
virtual MooseVariableScalar & getScalarVariable(THREAD_ID tid, const std::string &var_name) const
Gets a reference to a scalar variable with specified number. 
std::vector< ADReal > _ad_dxidy_map
std::vector< VectorValue< ADReal > > _ad_d2xyzdxideta_map
void set_calculate_default_dual_coeff(const bool val)
std::map< FEType, std::unique_ptr< VectorFEShapeData > > _vector_fe_shape_data_face_neighbor
void addJacobian(GlobalDataKey)
Adds all local Jacobian to the global Jacobian matrices. 
MooseArray< Point > _current_normals
The current Normal vectors at the quadrature points. 
virtual const FieldVariablePhiValue & phiFace() const =0
Return the variable's shape functions on an element face. 
void buildVectorFaceFE(FEType type) const
Build Vector FEs for a face with a type. 
void havePRefinement(const std::unordered_set< FEFamily > &disable_p_refinement_for_families)
Indicate that we have p-refinement. 
const SubdomainID ANY_BLOCK_ID
MooseArray< VectorValue< ADReal > > _ad_q_points
const VariablePhiGradient & gradPhiNeighbor(const MooseVariableField< Real > &) const
MooseArray< VectorValue< ADReal > > _ad_q_points_face
virtual const FieldVariablePhiGradient & gradPhi() const =0
Return the gradients of the variable's elemental shape functions. 
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
const libMesh::CouplingMatrix * _cm
Coupling matrices. 
void hasScalingVector()
signals this object that a vector containing variable scaling factors should be used when doing resid...
void addJacobianBlock(libMesh::SparseMatrix< Number > &jacobian, unsigned int ivar, unsigned int jvar, const libMesh::DofMap &dof_map, std::vector< dof_id_type > &dof_indices, GlobalDataKey, TagID tag)
Adds element matrix for ivar rows and jvar columns to the global Jacobian matrix. ...
Generic class for solving transient nonlinear problems. 
subdomain_id_type subdomain_id() const
std::map< FEType, std::unique_ptr< FEShapeData > > _fe_shape_data_dual_lower
void zeroCachedJacobian(GlobalDataKey)
Zero out previously-cached Jacobian rows. 
void reinitNeighborFaceRef(const Elem *neighbor_elem, unsigned int neighbor_side, Real tolerance, const std::vector< Point > *const pts, const std::vector< Real > *const weights=nullptr)
Reinitialize FE data for the given neighbor_element on the given side with a given set of reference p...
void constrain_element_vector(DenseVector< Number > &rhs, std::vector< dof_id_type > &dofs, bool asymmetric_constraint_rows=true) const
CTSub CT_OPERATOR_BINARY CTMul CTCompareLess CTCompareGreater CTCompareEqual _arg template * sqrt(_arg)) *_arg.template D< dtag >()) CT_SIMPLE_UNARY_FUNCTION(tanh
void setNeighborQRule(libMesh::QBase *qrule, unsigned int dim)
Set the qrule to be used for neighbor integration. 
const std::vector< Point > & get_points() const
virtual unsigned short dim() const=0
bool usesGradPhiNeighbor() const
Whether or not this variable is actually using the shape function gradient. 
void prepareVariableNonlocal(MooseVariableFieldBase *var)
void release()
Manually deallocates the data pointer. 
std::map< FEType, std::unique_ptr< FEShapeData > > _fe_shape_data_face
virtual libMesh::SparseMatrix< Number > & getMatrix(TagID tag)
Get a raw SparseMatrix. 
std::map< FEType, std::unique_ptr< VectorFEShapeData > > _vector_fe_shape_data
Shape function values, gradients, second derivatives for each vector FE type. 
void addResidualScalar(GlobalDataKey, const std::vector< VectorTag > &vector_tags)
Add residuals of all scalar variables for a set of tags onto the global residual vectors associated w...
MooseArray< Real > _coord_msm
The coordinate transformation coefficients evaluated on the quadrature points of the mortar segment m...
std::vector< std::vector< std::vector< DenseMatrix< Number > > > > _sub_Keg
bool _need_lower_d_elem_volume
Whether we need to compute the lower dimensional element volume. 
bool _user_added_fe_face_of_helper_type
const std::vector< dof_id_type > & allDofIndices() const
Get all global dofindices for the variable. 
void buildVectorNeighborFE(FEType type) const
Build Vector FEs for a neighbor with a type. 
std::unique_ptr< ArbitraryQuadrature > arbitrary_vol
volume/elem (meshdim) custom points quadrature rule 
void reinitFENeighbor(const Elem *neighbor, const std::vector< Point > &reference_points)
void initNonlocalCoupling()
Create pair of variables requiring nonlocal jacobian contributions. 
std::map< unsigned int, FEBase * > _holder_fe_face_helper
Each dimension's helper objects. 
const std::vector< std::vector< Real > > & get_dphidxi_map() const
const Elem *const  & neighbor() const
Return the neighbor element. 
std::map< unsigned int, std::map< FEType, FEVectorBase * > > _vector_fe_neighbor
virtual Real volume() const
void cacheJacobianNonlocal(GlobalDataKey)
Takes the values that are currently in _sub_Keg and appends them to the cached values. 
Class for scalar variables (they are different). 
IntRange< T > make_range(T beg, T end)
std::vector< std::unique_ptr< FEBase > > _unique_fe_face_neighbor_helper
void resize(unsigned int size)
Change the number of elements the array can store. 
void computeSinglePointMapAD(const Elem *elem, const std::vector< Real > &qw, unsigned p, FEBase *fe)
compute the finite element reference-physical mapping quantities (such as JxW) with possible dependen...
void helpersRequestData()
request phi, dphi, xyz, JxW, etc. 
std::vector< std::pair< MooseVariableFieldBase *, MooseVariableFieldBase * > > _cm_nonlocal_entry
Entries in the coupling matrix for field variables for nonlocal calculations. 
void addJacobianOffDiagScalar(unsigned int ivar, GlobalDataKey)
Add Jacobians for a scalar variables with all other field variables into the global Jacobian matrices...
virtual void init(const Elem &e, unsigned int p_level=invalid_uint)
void buildLowerDFE(FEType type) const
Build FEs for a lower dimensional element with a type. 
virtual unsigned int size() const override final
unsigned int _current_side
The current side of the selected element (valid only when working with sides) 
void setCachedJacobian(GlobalDataKey)
Sets previously-cached Jacobian values via SparseMatrix::set() calls. 
VariablePhiSecond _second_phi
const libMesh::CouplingMatrix & _nonlocal_cm
std::map< unsigned int, FEBase * > _holder_fe_helper
Each dimension's helper objects. 
void prepareVariable(MooseVariableFieldBase *var)
Used for preparing the dense residual and jacobian blocks for one particular variable. 
const Elem * _current_neighbor_side_elem
The current side element of the ncurrent neighbor element. 
void derivInsert(SemiDynamicSparseNumberArray< Real, libMesh::dof_id_type, NWrapper< N >> &derivs, libMesh::dof_id_type index, Real value)
void reinitElemFaceRef(const Elem *elem, unsigned int elem_side, Real tolerance, const std::vector< Point > *const pts=nullptr, const std::vector< Real > *const weights=nullptr)
Reinitialize FE data for the given element on the given side, optionally with a given set of referenc...
void copyFaceShapes(MooseVariableField< T > &v)
std::vector< dof_id_type > _extra_elem_ids
Extra element IDs. 
Moose::CoordinateSystemType getCoordSystem(SubdomainID sid) const
void clearCachedQRules()
Set the cached quadrature rules to nullptr. 
void addJacobianBlockTags(libMesh::SparseMatrix< Number > &jacobian, unsigned int ivar, unsigned int jvar, const libMesh::DofMap &dof_map, std::vector< dof_id_type > &dof_indices, GlobalDataKey, const std::set< TagID > &tags)
Add element matrix for ivar rows and jvar columns to the global Jacobian matrix for given tags...
void addResidualNeighbor(GlobalDataKey, const std::vector< VectorTag > &vector_tags)
Add local neighbor residuals of all field variables for a set of tags onto the global residual vector...
bool _current_side_volume_computed
Boolean to indicate whether current element side volumes has been computed. 
virtual bool isScalarVariable(unsigned int var_name) const
virtual void reinit_dual_shape_coeffs(const Elem *, const std::vector< Point > &, const std::vector< Real > &)
std::map< FEType, ADTemplateVariablePhiGradient< RealVectorValue > > _ad_vector_grad_phi_data_face
Moose::VectorTagType _type
The type of the vector tag. 
void jacobianBlockNeighborUsed(TagID tag, unsigned int ivar, unsigned int jvar, bool used)
Sets whether or not neighbor Jacobian coupling between ivar and jvar is used to the value used...
std::unique_ptr< ArbitraryQuadrature > arbitrary_face
area/face (meshdim-1) custom points quadrature rule 
Eigen::Matrix< Real, Eigen::Dynamic, 1 > RealEigenVector
virtual const std::vector< dof_id_type > & dofIndicesLower() const =0
Get dof indices for the current lower dimensional element (this is meaningful when performing mortar ...
void prepareBlock(unsigned int ivar, unsigned jvar, const std::vector< dof_id_type > &dof_indices)
std::map< unsigned int, std::map< FEType, FEBase * > > _fe_face_neighbor
void addJacobianNeighbor(GlobalDataKey)
Add ElementNeighbor, NeighborElement, and NeighborNeighbor portions of the Jacobian for compute objec...
std::vector< std::vector< std::vector< unsigned char > > > _jacobian_block_lower_used
Flag that indicates if the jacobian block for the lower dimensional element was used. 
MOOSE now contains C++17 code, so give a reasonable error message stating what the user can do to add...
VectorVariablePhiDivergence _div_phi
void cacheJacobianBlock(DenseMatrix< Number > &jac_block, const std::vector< dof_id_type > &idof_indices, const std::vector< dof_id_type > &jdof_indices, Real scaling_factor, LocalDataKey, TagID tag)
Cache a local Jacobian block with the provided rows (idof_indices) and columns (jdof_indices) for eve...
const std::vector< std::vector< OutputShape > > & get_dphidxi() const
MooseVariableFieldBase & getVariable(THREAD_ID tid, const std::string &var_name) const
Gets a reference to a variable of with specified name. 
bool _custom_mortar_qrule
Flag specifying whether a custom quadrature rule has been specified for mortar segment mesh...
const unsigned int & side() const
Returns the current side. 
void computeCurrentElemVolume()
void cacheJacobianBlockNonzero(DenseMatrix< Number > &jac_block, const MooseVariableBase &ivar, const MooseVariableBase &jvar, const std::vector< dof_id_type > &idof_indices, const std::vector< dof_id_type > &jdof_indices, TagID tag)
Push non-zeros of a local Jacobian block with proper scaling into cache for a certain tag...
Real _current_neighbor_lower_d_elem_volume
The current neighboring lower dimensional element volume. 
const FEMap & get_fe_map() const
bool _need_neighbor_lower_d_elem_volume
Whether we need to compute the neighboring lower dimensional element volume. 
MooseArray< Point > _current_q_points
The current list of quadrature points. 
bool _user_added_fe_of_helper_type
Whether user code requested a FEType the same as our _helper_type. 
Moose::CoordinateSystemType _coord_type
The coordinate system. 
void setLowerQRule(libMesh::QBase *qrule, unsigned int dim)
Set the qrule to be used for lower dimensional integration. 
void cacheJacobianMortar(GlobalDataKey)
Cache all portions of the Jacobian, e.g. 
std::unique_ptr< ArbitraryQuadrature > neighbor
area/face (meshdim-1) custom points quadrature rule for DG 
void buildVectorFaceNeighborFE(FEType type) const
Build Vector FEs for a neighbor face with a type. 
void buildVectorDualLowerDFE(FEType type) const
void bumpVolumeQRuleOrder(Order volume_order, SubdomainID block)
Increases the element/volume quadrature order for the specified mesh block if and only if the current...
Storage for all of the information pretaining to a vector tag. 
const Node *const  & node() const
Returns the reference to the node. 
std::vector< std::vector< std::vector< unsigned char > > > _jacobian_block_neighbor_used
Flag that indicates if the jacobian block for neighbor was used. 
std::map< unsigned int, FEBase * > _holder_fe_lower_helper
helper object for transforming coordinates for lower dimensional element quadrature points ...
static constexpr subdomain_id_type invalid_subdomain_id
const libMesh::DofMap & _dof_map
DOF map. 
virtual Order default_order() const=0
void computeADFace(const Elem &elem, const unsigned int side)
compute AD things on an element face 
std::map< FEType, std::unique_ptr< VectorFEShapeData > > _vector_fe_shape_data_neighbor
void setResidual(NumericVector< Number > &residual, GlobalDataKey, const VectorTag &vector_tag)
Sets local residuals of all field variables to the global residual vector for a tag. 
std::vector< std::vector< dof_id_type > > _cached_jacobian_cols
Column where the corresponding cached value should go. 
void addCachedJacobian(GlobalDataKey)
Adds the values that have been cached by calling cacheJacobian() and or cacheJacobianNeighbor() to th...
DenseMatrix sub_matrix(unsigned int row_id, unsigned int row_size, unsigned int col_id, unsigned int col_size) const
MooseArray< Point > _current_q_points_face
The current quadrature points on a face. 
void cacheResidualBlock(std::vector< Real > &cached_residual_values, std::vector< dof_id_type > &cached_residual_rows, DenseVector< Number > &res_block, const std::vector< dof_id_type > &dof_indices, const std::vector< Real > &scaling_factor, bool is_nodal)
Push a local residual block with proper scaling into cache. 
void prepareBlockNonlocal(unsigned int ivar, unsigned jvar, const std::vector< dof_id_type > &idof_indices, const std::vector< dof_id_type > &jdof_indices)
virtual NumericVector< Number > & getVector(const std::string &name)
Get a raw NumericVector by name. 
void bumpAllQRuleOrder(Order order, SubdomainID block)
Increases the element/volume and face/area quadrature orders for the specified mesh block if and only...
const VariablePhiSecond & secondPhiFaceNeighbor(const MooseVariableField< Real > &) const
const Elem * _current_side_elem
The current "element" making up the side we are currently on. 
bool _block_diagonal_matrix
Will be true if our preconditioning matrix is a block-diagonal matrix. Which means that we can take s...
bool _need_JxW_neighbor
Flag to indicate that JxW_neighbor is needed. 
virtual const VectorTag & getVectorTag(const TagID tag_id) const
Get a VectorTag from a TagID. 
void copyNeighborShapes(MooseVariableField< T > &v)
void cacheJacobianCoupledVarPair(const MooseVariableBase &ivar, const MooseVariableBase &jvar)
Caches element matrix for ivar rows and jvar columns. 
dof_id_type node_id(const unsigned int i) const
MooseArray< Point > _current_q_points_face_neighbor
The current quadrature points on the neighbor face. 
virtual void attach_quadrature_rule(QBase *q)=0
libMesh::ElemSideBuilder _current_side_elem_builder
In place side element builder for _current_side_elem. 
VectorVariablePhiCurl _vector_curl_phi_face
Key structure for APIs adding/caching local element residuals/Jacobians. 
std::set< FEType > _need_face_div
SubdomainID _current_subdomain_id
The current subdomain ID. 
dof_id_type get_extra_integer(const unsigned int index) const
virtual numeric_index_type n() const=0
std::map< FEType, FEVectorBase * > _current_vector_fe_neighbor
The "neighbor" vector fe object that matches the current elem. 
void clearCachedResiduals(GlobalDataKey)
Clears all of the residuals in _cached_residual_rows and _cached_residual_values. ...
virtual const FieldVariablePhiGradient & gradPhiFace() const =0
Return the gradients of the variable's shape functions on an element face. 
const Node * _current_neighbor_node
The current neighboring node we are working with. 
std::vector< VectorValue< ADReal > > _ad_d2xyzdeta2_map
void clearCachedJacobian()
Clear any currently cached jacobians. 
virtual_for_inffe const std::vector< std::vector< OutputShape > > & get_curl_phi() const
const std::vector< std::vector< OutputShape > > & get_phi() const
const VariablePhiGradient & gradPhiFace() const
std::vector< std::vector< std::vector< DenseMatrix< Number > > > > _sub_Knl
dprimary/dlower (or dneighbor/dlower) 
const std::vector< std::vector< OutputTensor > > & get_dual_d2phi() const
MooseVariableField< T > & getActualFieldVariable(THREAD_ID tid, const std::string &var_name)
Returns a field variable pointer - this includes finite volume variables. 
void reinitFEFace(const Elem *elem, unsigned int side)
Just an internal helper function to reinit the face FE objects. 
MooseArray< ADReal > _ad_JxW
MooseArray< ADReal > _ad_JxW_face
void computeFaceMap(const Elem &elem, const unsigned int side, const std::vector< Real > &qw)
void reinitDual(const Elem *elem, const std::vector< Point > &pts, const std::vector< Real > &JxW)
Reintialize dual basis coefficients based on a customized quadrature rule. 
void constrain_element_matrix(DenseMatrix< Number > &matrix, std::vector< dof_id_type > &elem_dofs, bool asymmetric_constraint_rows=true) const
Key structure for APIs manipulating global vectors/matrices.