#include <deal.II/fe/fe_q.h>
#include <deal.II/fe/fe_values.h>
#include <deal.II/fe/mapping_q.h>
-#include <deal.II/fe/mapping_q1.h>
#include <deal.II/grid/filtered_iterator.h>
#include <deal.II/grid/grid_reordering.h>
QGauss<dim> quadrature(4);
+ Assert(triangulation.all_reference_cells_are_hyper_cube(),
+ ExcNotImplemented());
+ const auto reference_cell = ReferenceCells::get_hypercube<dim>();
MatrixCreator::create_laplace_matrix(
- StaticMappingQ1<dim>::mapping, dof_handler, quadrature, S, coefficient);
+ reference_cell.template get_default_linear_mapping<dim, dim>(),
+ dof_handler,
+ quadrature,
+ S,
+ coefficient);
// set up the boundary values for the laplace problem
std::array<AffineConstraints<double>, dim> constraints;
Assert(this->reference_cell().is_hyper_cube(), ExcNotImplemented());
const TriaRawIterator<CellAccessor<dim_, spacedim_>> cell_iterator(*this);
- const Point<dim_> p_unit =
- StaticMappingQ1<dim_, spacedim_>::mapping.transform_real_to_unit_cell(
- cell_iterator, p);
+
+ const Point<dim_> p_unit =
+ this->reference_cell().template get_default_linear_mapping<dim_, spacedim_>()
+ .transform_real_to_unit_cell(cell_iterator, p);
return GeometryInfo<dim_>::is_inside_unit_cell(p_unit);
}
else
n_postprocessor_outputs[dataset] = 0;
+ Assert(!this->triangulation->is_mixed_mesh(), ExcNotImplemented());
+ const auto reference_cell =
+ this->triangulation->get_reference_cells()[0];
internal::DataOutRotationImplementation::ParallelData<dim, spacedim>
- thread_data(n_datasets,
- n_subdivisions,
- n_patches_per_circle,
- n_postprocessor_outputs,
- StaticMappingQ1<dim, spacedim>::mapping,
- this->get_fes(),
- update_flags);
+ thread_data(
+ n_datasets,
+ n_subdivisions,
+ n_patches_per_circle,
+ n_postprocessor_outputs,
+ reference_cell.template get_default_linear_mapping<dim, spacedim>(),
+ this->get_fes(),
+ update_flags);
std::vector<DataOutBase::Patch<patch_dim, patch_spacedim>> new_patches(
n_patches_per_circle);
for (unsigned int i = 0; i < new_patches.size(); ++i)
#include <deal.II/fe/fe.h>
#include <deal.II/fe/fe_values.h>
-#include <deal.II/fe/mapping_q1.h>
#include <deal.II/grid/filtered_iterator.h>
#include <deal.II/grid/grid_tools.h>
Vector<float> & derivative_norm,
const unsigned int component)
{
+ Assert(!dof_handler.get_triangulation().is_mixed_mesh(),
+ ExcNotImplemented());
+ const auto reference_cell =
+ dof_handler.get_triangulation().get_reference_cells()[0];
internal::approximate_derivative<internal::Gradient<dim>, dim>(
- StaticMappingQ1<dim>::mapping,
+ reference_cell.template get_default_linear_mapping<dim, spacedim>(),
dof_handler,
solution,
component,
Vector<float> & derivative_norm,
const unsigned int component)
{
+ Assert(!dof_handler.get_triangulation().is_mixed_mesh(),
+ ExcNotImplemented());
+ const auto reference_cell =
+ dof_handler.get_triangulation().get_reference_cells()[0];
internal::approximate_derivative<internal::SecondDerivative<dim>, dim>(
- StaticMappingQ1<dim>::mapping,
+ reference_cell.template get_default_linear_mapping<dim, spacedim>(),
dof_handler,
solution,
component,
const types::material_id material_id,
const Strategy strategy)
{
- estimate(StaticMappingQ1<1, spacedim>::mapping,
+ const auto reference_cell = ReferenceCells::Line;
+ estimate(reference_cell.template get_default_linear_mapping<1, spacedim>(),
dof_handler,
quadrature,
neumann_bc,
const types::material_id material_id,
const Strategy strategy)
{
- estimate(StaticMappingQ1<1, spacedim>::mapping,
+ const auto reference_cell = ReferenceCells::Line;
+ estimate(reference_cell.template get_default_linear_mapping<1, spacedim>(),
dof_handler,
quadrature,
neumann_bc,
const types::material_id material_id,
const Strategy strategy)
{
- estimate(StaticMappingQ1<1, spacedim>::mapping,
+ const auto reference_cell = ReferenceCells::Line;
+ estimate(reference_cell.template get_default_linear_mapping<1, spacedim>(),
dof_handler,
quadrature,
neumann_bc,
const types::material_id material_id,
const Strategy strategy)
{
- estimate(StaticMappingQ1<1, spacedim>::mapping,
+ const auto reference_cell = ReferenceCells::Line;
+ estimate(reference_cell.template get_default_linear_mapping<1, spacedim>(),
dof_handler,
quadrature,
neumann_bc,
typename std::vector<
internal::PointValueHistoryImplementation::PointGeometryData<dim>>::iterator
point = point_geometry_data.begin();
+ Assert(!dof_handler->get_triangulation().is_mixed_mesh(), ExcNotImplemented());
+ const auto reference_cell =
+ dof_handler->get_triangulation().get_reference_cells()[0];
for (unsigned int data_store_index = 0; point != point_geometry_data.end();
++point, ++data_store_index)
{
// we now have a point to query, need to know what cell it is in
const Point<dim> requested_location = point->requested_location;
const typename DoFHandler<dim>::active_cell_iterator cell =
- GridTools::find_active_cell_around_point(StaticMappingQ1<dim>::mapping,
- *dof_handler,
- requested_location)
+ GridTools::find_active_cell_around_point(
+ reference_cell.template get_default_linear_mapping<dim, dim>(),
+ *dof_handler,
+ requested_location)
.first;
typename std::vector<
internal::PointValueHistoryImplementation::PointGeometryData<dim>>::iterator
point = point_geometry_data.begin();
+ Assert(!dof_handler->get_triangulation().is_mixed_mesh(), ExcNotImplemented());
+ const auto reference_cell =
+ dof_handler->get_triangulation().get_reference_cells()[0];
for (unsigned int data_store_index = 0; point != point_geometry_data.end();
++point, ++data_store_index)
{
// need to know what cell it is in
Point<dim> requested_location = point->requested_location;
typename DoFHandler<dim>::active_cell_iterator cell =
- GridTools::find_active_cell_around_point(StaticMappingQ1<dim>::mapping,
- *dof_handler,
- requested_location)
+ GridTools::find_active_cell_around_point(
+ reference_cell.template get_default_linear_mapping<dim, dim>(),
+ *dof_handler,
+ requested_location)
.first;
fe_values.reinit(cell);