/**
* Reference cell type.
*/
- const ReferenceCell cell_type;
+ const ReferenceCell reference_cell_kind;
/**
* Number of unique quads. If all quads have the same type, the value is
* underlying geometric entity can be specified.
*/
FiniteElementData(const std::vector<unsigned int> &dofs_per_object,
- const ReferenceCell cell_type,
+ const ReferenceCell reference_cell,
const unsigned int n_components,
const unsigned int degree,
const Conformity conformity = unknown,
* is particular useful for cells with triangles and quadrilaterals as faces.
*/
FiniteElementData(const internal::GenericDoFsPerObject &data,
- const ReferenceCell cell_type,
+ const ReferenceCell reference_cell,
const unsigned int n_components,
const unsigned int degree,
const Conformity conformity = unknown,
{
/**
* Utility function to convert "dofs per object" information
- * of a @p dim dimensional reference cell @p cell_type.
+ * of a @p dim dimensional reference cell @p reference_cell.
*/
internal::GenericDoFsPerObject
expand(const unsigned int dim,
const std::vector<unsigned int> &dofs_per_object,
- const dealii::ReferenceCell cell_type);
+ const dealii::ReferenceCell reference_cell);
} // namespace internal
inline ReferenceCell
FiniteElementData<dim>::reference_cell() const
{
- return cell_type;
+ return reference_cell_kind;
}
/**
* Returns if this instance of Mapping is compatible with the type of cell
- * in @p cell_type.
+ * in @p reference_cell.
*/
virtual bool
- is_compatible_with(const ReferenceCell &cell_type) const = 0;
+ is_compatible_with(const ReferenceCell &reference_cell) const = 0;
/**
* @name Mapping points between reference and real cells
preserves_vertex_locations() const override;
virtual bool
- is_compatible_with(const ReferenceCell &cell_type) const override;
+ is_compatible_with(const ReferenceCell &reference_cell) const override;
/**
* @name Mapping points between reference and real cells
virtual bool
- is_compatible_with(const ReferenceCell &cell_type) const override;
+ is_compatible_with(const ReferenceCell &reference_cell) const override;
/**
* Always returns @p true because the default implementation of functions in
preserves_vertex_locations() const override;
virtual bool
- is_compatible_with(const ReferenceCell &cell_type) const override;
+ is_compatible_with(const ReferenceCell &reference_cell) const override;
/**
* Return the mapped vertices of a cell.
&cell) const override;
virtual bool
- is_compatible_with(const ReferenceCell &cell_type) const override;
+ is_compatible_with(const ReferenceCell &reference_cell) const override;
/**
* Transform the point @p p on the unit cell to the point @p p_real on the
&cell) const override;
virtual bool
- is_compatible_with(const ReferenceCell &cell_type) const override;
+ is_compatible_with(const ReferenceCell &reference_cell) const override;
/**
* @name Mapping points between reference and real cells
template <int dim>
FiniteElementData<dim>::FiniteElementData(
const internal::GenericDoFsPerObject &data,
- const ReferenceCell cell_type,
+ const ReferenceCell reference_cell,
const unsigned int n_components,
const unsigned int degree,
const Conformity conformity,
const BlockIndices & block_indices)
- : cell_type(cell_type)
+ : reference_cell_kind(reference_cell)
, number_unique_quads(data.dofs_per_object_inclusive[2].size())
, number_unique_faces(data.dofs_per_object_inclusive[dim - 1].size())
, dofs_per_vertex(data.dofs_per_object_exclusive[0][0])
template <int dim, int spacedim>
bool
MappingCartesian<dim, spacedim>::is_compatible_with(
- const ReferenceCell &cell_type) const
+ const ReferenceCell &reference_cell) const
{
- Assert(dim == cell_type.get_dimension(),
+ Assert(dim == reference_cell.get_dimension(),
ExcMessage("The dimension of your mapping (" +
Utilities::to_string(dim) +
") and the reference cell cell_type (" +
- Utilities::to_string(cell_type.get_dimension()) +
+ Utilities::to_string(reference_cell.get_dimension()) +
" ) do not agree."));
- return cell_type.is_hyper_cube();
+ return reference_cell.is_hyper_cube();
}
template <int dim, int spacedim>
bool
MappingFE<dim, spacedim>::is_compatible_with(
- const ReferenceCell &cell_type) const
+ const ReferenceCell &reference_cell) const
{
- Assert(dim == cell_type.get_dimension(),
+ Assert(dim == reference_cell.get_dimension(),
ExcMessage("The dimension of your mapping (" +
Utilities::to_string(dim) +
") and the reference cell cell_type (" +
- Utilities::to_string(cell_type.get_dimension()) +
+ Utilities::to_string(reference_cell.get_dimension()) +
" ) do not agree."));
- return fe->reference_cell() == cell_type;
+ return fe->reference_cell() == reference_cell;
}
template <int dim, int spacedim, typename VectorType>
bool
MappingFEField<dim, spacedim, VectorType, void>::is_compatible_with(
- const ReferenceCell &cell_type) const
+ const ReferenceCell &reference_cell) const
{
- Assert(dim == cell_type.get_dimension(),
+ Assert(dim == reference_cell.get_dimension(),
ExcMessage("The dimension of your mapping (" +
Utilities::to_string(dim) +
") and the reference cell cell_type (" +
- Utilities::to_string(cell_type.get_dimension()) +
+ Utilities::to_string(reference_cell.get_dimension()) +
" ) do not agree."));
- return euler_dof_handler->get_fe().reference_cell() == cell_type;
+ return euler_dof_handler->get_fe().reference_cell() == reference_cell;
}
template <int dim, int spacedim>
bool
MappingQ<dim, spacedim>::is_compatible_with(
- const ReferenceCell &cell_type) const
+ const ReferenceCell &reference_cell) const
{
- if (cell_type.get_dimension() != dim)
- return false; // TODO: or is this an error?
-
- if (cell_type.is_hyper_cube())
- return true;
-
- return false;
+ Assert(dim == reference_cell.get_dimension(),
+ ExcMessage("The dimension of your mapping (" +
+ Utilities::to_string(dim) +
+ ") and the reference cell cell_type (" +
+ Utilities::to_string(reference_cell.get_dimension()) +
+ " ) do not agree."));
+
+ return reference_cell.is_hyper_cube();
}
template <int dim, int spacedim>
bool
MappingQGeneric<dim, spacedim>::is_compatible_with(
- const ReferenceCell &cell_type) const
+ const ReferenceCell &reference_cell) const
{
- if (cell_type.get_dimension() != dim)
- return false; // TODO: or is this an error?
-
- if (cell_type.is_hyper_cube())
- return true;
-
- return false;
+ Assert(dim == reference_cell.get_dimension(),
+ ExcMessage("The dimension of your mapping (" +
+ Utilities::to_string(dim) +
+ ") and the reference cell cell_type (" +
+ Utilities::to_string(reference_cell.get_dimension()) +
+ " ) do not agree."));
+
+ return reference_cell.is_hyper_cube();
}