*/
template <int dim>
void
- assert_existence_of_face_matrix (const FiniteElement<dim> &fe1,
+ ensure_existence_of_face_matrix (const FiniteElement<dim> &fe1,
const FiniteElement<dim> &fe2,
boost::shared_ptr<FullMatrix<double> > &matrix)
{
*/
template <int dim>
void
- assert_existence_of_subface_matrix (const FiniteElement<dim> &fe1,
+ ensure_existence_of_subface_matrix (const FiniteElement<dim> &fe1,
const FiniteElement<dim> &fe2,
const unsigned int subface,
boost::shared_ptr<FullMatrix<double> > &matrix)
// properties of a
// finite element onto
// that mesh
- assert_existence_of_subface_matrix
+ ensure_existence_of_subface_matrix
(cell->get_fe(),
subface->get_fe(subface_fe_index),
c,
cell->get_fe().dofs_per_face,
ExcInternalError());
- assert_existence_of_face_matrix
+ ensure_existence_of_face_matrix
(dominating_fe,
cell->get_fe(),
face_interpolation_matrices
Assert (dominating_fe.dofs_per_face <=
subface_fe.dofs_per_face,
ExcInternalError());
- assert_existence_of_subface_matrix
+ ensure_existence_of_subface_matrix
(dominating_fe,
subface_fe,
sf,
// for this
// face are
// available
- assert_existence_of_face_matrix
+ ensure_existence_of_face_matrix
(cell->get_fe(),
neighbor->get_fe(),
face_interpolation_matrices
*/
template <int dim, int structdim>
void
- assert_existence_of_dof_identities (const FiniteElement<dim> &fe1,
+ ensure_existence_of_dof_identities (const FiniteElement<dim> &fe1,
const FiniteElement<dim> &fe2,
boost::shared_ptr<DoFIdentities> &identities)
{
// entry in the
// equivalence
// table exists
- internal::hp::assert_existence_of_dof_identities<dim,0>
+ internal::hp::ensure_existence_of_dof_identities<dim,0>
(get_fe()[first_fe_index],
get_fe()[other_fe_index],
vertex_dof_identities[first_fe_index][other_fe_index]);
const unsigned int
other_fe_index = line->nth_active_fe_index (f);
- internal::hp::assert_existence_of_dof_identities<dim,1>
+ internal::hp::ensure_existence_of_dof_identities<dim,1>
((*finite_elements)[first_fe_index],
(*finite_elements)[other_fe_index],
line_dof_identities[first_fe_index][other_fe_index]);
const unsigned int
other_fe_index = quad->nth_active_fe_index (f);
- internal::hp::assert_existence_of_dof_identities<dim,2>
+ internal::hp::ensure_existence_of_dof_identities<dim,2>
((*finite_elements)[first_fe_index],
(*finite_elements)[other_fe_index],
quad_dof_identities[first_fe_index][other_fe_index]);