// First, create a local mass matrix for the unit cell
Triangulation<dim, spacedim> tr;
- GridGenerator::reference_cell(reference_cell, tr);
+ GridGenerator::reference_cell(tr, reference_cell);
const auto &mapping =
reference_cell.template get_default_linear_mapping<dim, spacedim>();
// Set up meshes, one with a single
// reference cell and refine it once
Triangulation<dim, spacedim> tria;
- GridGenerator::reference_cell(reference_cell, tria);
+ GridGenerator::reference_cell(tria, reference_cell);
tria.begin_active()->set_refine_flag(RefinementCase<dim>(ref_case));
tria.execute_coarsening_and_refinement();
{
// set up a triangulation for coarse cell
Triangulation<dim, spacedim> tr;
- GridGenerator::reference_cell(reference_cell, tr);
+ GridGenerator::reference_cell(tr, reference_cell);
FEValues<dim, spacedim> coarse(mapping,
fe,
// create a respective refinement on the triangulation
Triangulation<dim, spacedim> tr;
- GridGenerator::reference_cell(reference_cell, tr);
+ GridGenerator::reference_cell(tr, reference_cell);
tr.begin_active()->set_refine_flag(RefinementCase<dim>(ref_case));
tr.execute_coarsening_and_refinement();
*/
template <int dim, int spacedim>
void
- reference_cell(const ReferenceCell & reference_cell,
- Triangulation<dim, spacedim> &tria);
+ reference_cell(Triangulation<dim, spacedim> &tria,
+ const ReferenceCell & reference_cell);
/**
template <int dim, int spacedim>
void
- reference_cell(const ReferenceCell & reference_cell,
- Triangulation<dim, spacedim> &tria)
+ reference_cell(Triangulation<dim, spacedim> &tria,
+ const ReferenceCell & reference_cell)
{
AssertDimension(dim, reference_cell.get_dimension());
#if deal_II_dimension <= deal_II_space_dimension
template void
reference_cell<deal_II_dimension, deal_II_space_dimension>(
- const ReferenceCell &,
- Triangulation<deal_II_dimension, deal_II_space_dimension> &);
+ Triangulation<deal_II_dimension, deal_II_space_dimension> &,
+ const ReferenceCell &);
template void
convert_hypercube_to_simplex_mesh(
// reference cell
const auto create_quadrature = [](const ReferenceCell &reference_cell) {
Triangulation<dim> tria;
- GridGenerator::reference_cell(reference_cell, tria);
+ GridGenerator::reference_cell(tria, reference_cell);
return Quadrature<dim>(tria.get_vertices());
};
const Quadrature<dim> q_gauss =
type.get_gauss_type_quadrature<dim>(fe.tensor_degree() + 1);
Triangulation<dim, spacedim> tria;
- GridGenerator::reference_cell(type, tria);
+ GridGenerator::reference_cell(tria, type);
const Mapping<dim, spacedim> &mapping =
type.template get_default_linear_mapping<dim, spacedim>();
Triangulation<3> dummy, tria;
- GridGenerator::reference_cell(ReferenceCells::Tetrahedron, dummy);
+ GridGenerator::reference_cell(dummy, ReferenceCells::Tetrahedron);
auto vertices = dummy.get_vertices();