45 template <
int dim,
int spacedim>
47 compute_embedding_matrices(
48 const ::FE_Q_Bubbles<dim, spacedim> &fe,
50 const bool isotropic_only)
52 const unsigned int dpc = fe.n_dofs_per_cell();
53 const unsigned int degree = fe.degree;
56 std::unique_ptr<Quadrature<dim>> q_fine;
58 std::vector<double>(1, 1.));
63 q_fine = std::make_unique<QGauss<dim>>(degree + 1);
64 else if (spacedim == 2)
66 std::make_unique<QAnisotropic<dim>>(
QGauss<1>(degree + 1),
70 std::make_unique<QAnisotropic<dim>>(
QGauss<1>(degree + 1),
76 q_fine = std::make_unique<QGauss<dim>>(degree + 1);
79 std::make_unique<QAnisotropic<dim>>(
QGauss<1>(degree + 1),
84 q_fine = std::make_unique<QGauss<dim>>(degree + 1);
91 const unsigned int nq = q_fine->size();
94 for (
unsigned int ref_case =
97 ref_case <= RefinementCase<dim>::isotropic_refinement;
100 const unsigned int nc =
103 for (
unsigned int i = 0; i < nc; ++i)
105 Assert(matrices[ref_case - 1][i].n() == dpc,
108 Assert(matrices[ref_case - 1][i].m() == dpc,
129 const unsigned int n_dofs = dh.
n_dofs();
134 std::vector<std::vector<types::global_dof_index>> child_ldi(
135 nc, std::vector<types::global_dof_index>(fe.n_dofs_per_cell()));
138 unsigned int child_no = 0;
141 for (; cell != dh.
end(); ++cell, ++child_no)
144 cell->get_dof_indices(child_ldi[child_no]);
146 for (
unsigned int q = 0; q < nq; ++q)
147 for (
unsigned int i = 0; i < dpc; ++i)
148 for (
unsigned int j = 0; j < dpc; ++j)
150 const unsigned int gdi = child_ldi[child_no][i];
151 const unsigned int gdj = child_ldi[child_no][j];
156 for (
unsigned int k = 0; k < dim; ++k)
158 coarse_rhs_matrix(gdi, j) +=
159 fine.
shape_value(i, q) * fe.shape_value(j, quad_tmp) *
167 fine_mass.
mmult(solution, coarse_rhs_matrix);
170 for (
unsigned int child_no = 0; child_no < nc; ++child_no)
171 for (
unsigned int i = 0; i < dpc; ++i)
172 for (
unsigned int j = 0; j < dpc; ++j)
174 const unsigned int gdi = child_ldi[child_no][i];
176 if (std::fabs(solution(gdi, j)) > 1.e-12)
177 matrices[ref_case - 1][child_no](i, j) = solution(gdi, j);
186template <
int dim,
int spacedim>
195 get_riaf_vector(q_degree))
196 , n_bubbles((q_degree <= 1) ? 1 : dim)
199 ExcMessage(
"This element can only be used for polynomial degrees "
200 "greater than zero"));
206 for (
unsigned int d = 0; d < dim; ++d)
208 for (
unsigned int i = 0; i <
n_bubbles; ++i)
215 internal::FE_Q_Bubbles::compute_embedding_matrices(*
this,
225template <
int dim,
int spacedim>
229 Polynomials::generate_complete_Lagrange_basis(points.get_points())),
234 get_riaf_vector(points.
size() - 1))
235 , n_bubbles((points.
size() - 1 <= 1) ? 1 : dim)
238 ExcMessage(
"This element can only be used for polynomial degrees "
245 for (
unsigned int d = 0; d < dim; ++d)
247 for (
unsigned int i = 0; i <
n_bubbles; ++i)
254 internal::FE_Q_Bubbles::compute_embedding_matrices(*
this,
264template <
int dim,
int spacedim>
272 std::ostringstream namebuf;
274 const unsigned int n_points = this->degree;
275 std::vector<double> points(n_points);
276 const unsigned int dofs_per_cell = this->n_dofs_per_cell();
277 const std::vector<Point<dim>> &unit_support_points =
278 this->unit_support_points;
279 unsigned int index = 0;
282 for (
unsigned int j = 0; j < dofs_per_cell; ++j)
284 if ((dim > 1) ? (unit_support_points[j][1] == 0 &&
285 ((dim > 2) ? unit_support_points[j][2] == 0 :
true)) :
289 points[index] = unit_support_points[j][0];
291 points[n_points - 1] = unit_support_points[j][0];
293 points[index - 1] = unit_support_points[j][0];
299 Assert(index == n_points || (dim == 1 && index == n_points + n_bubbles),
301 "Could not decode support points in one coordinate direction."));
304 for (
unsigned int j = 0; j < n_points; ++j)
305 if (std::fabs(points[j] -
static_cast<double>(j) / (this->degree - 1)) >
314 if (this->degree > 3)
316 <<
">(QIterated(QTrapezoid()," << this->degree - 1 <<
"))";
319 <<
">(" << this->degree - 1 <<
")";
326 for (
unsigned int j = 0; j < n_points; ++j)
327 if (points[j] != points_gl.point(j)[0])
334 <<
">(" << this->degree - 1 <<
")";
337 <<
">(QUnknownNodes(" << this->degree <<
"))";
339 return namebuf.str();
344template <
int dim,
int spacedim>
345std::unique_ptr<FiniteElement<dim, spacedim>>
348 return std::make_unique<FE_Q_Bubbles<dim, spacedim>>(*this);
353template <
int dim,
int spacedim>
358 std::vector<double> &nodal_values)
const
360 Assert(support_point_values.size() == this->unit_support_points.size(),
362 this->unit_support_points.size()));
363 Assert(nodal_values.size() == this->n_dofs_per_cell(),
365 Assert(support_point_values[0].
size() == this->n_components(),
367 this->n_components()));
369 for (
unsigned int i = 0; i < this->n_dofs_per_cell() - 1; ++i)
371 const std::pair<unsigned int, unsigned int> index =
372 this->system_to_component_index(i);
373 nodal_values[i] = support_point_values[i](index.first);
377 for (
unsigned int i = 0; i < n_bubbles; ++i)
378 nodal_values[nodal_values.size() - i - 1] = 0.;
383template <
int dim,
int spacedim>
395 (x_source_fe.
get_name().find(
"FE_Q_Bubbles<") == 0) ||
396 (
dynamic_cast<const FEQBUBBLES *
>(&x_source_fe) !=
nullptr),
398 Assert(interpolation_matrix.
m() == this->n_dofs_per_cell(),
400 this->n_dofs_per_cell()));
406 auto casted_fe =
dynamic_cast<const FEQBUBBLES *
>(&x_source_fe);
407 if (casted_fe !=
nullptr && casted_fe->degree == this->degree)
408 for (
unsigned int i = 0; i < interpolation_matrix.
m(); ++i)
409 interpolation_matrix.
set(i, i, 1.);
415 spacedim>::ExcInterpolationNotImplemented()));
420template <
int dim,
int spacedim>
424 const unsigned int n_cont_dofs = Utilities::fixed_power<dim>(q_deg + 1);
425 const unsigned int n_bubbles = (q_deg <= 1 ? 1 : dim);
426 return std::vector<bool>(n_cont_dofs + n_bubbles,
true);
431template <
int dim,
int spacedim>
432std::vector<unsigned int>
435 std::vector<unsigned int> dpo(dim + 1, 1U);
436 for (
unsigned int i = 1; i < dpo.size(); ++i)
437 dpo[i] = dpo[i - 1] * (q_deg - 1);
441 dpo[dim] += (q_deg <= 1 ? 1 : dim);
447template <
int dim,
int spacedim>
450 const unsigned int shape_index,
451 const unsigned int face_index)
const
454 if (shape_index >= this->n_dofs_per_cell() - n_bubbles)
463template <
int dim,
int spacedim>
466 const unsigned int child,
473 "Prolongation matrices are only available for refined cells!"));
476 Assert(this->prolongation[refinement_case - 1][child].n() != 0,
477 ExcMessage(
"This prolongation matrix has not been computed yet!"));
479 return this->prolongation[refinement_case - 1][child];
484template <
int dim,
int spacedim>
487 const unsigned int child,
494 "Restriction matrices are only available for refined cells!"));
497 Assert(this->restriction[refinement_case - 1][child].n() != 0,
498 ExcMessage(
"This restriction matrix has not been computed yet!"));
501 return this->restriction[refinement_case - 1][child];
506template <
int dim,
int spacedim>
510 const unsigned int codim)
const
529 if (this->degree < fe_bubbles_other->degree)
531 else if (this->degree == fe_bubbles_other->degree)
539 if (fe_nothing->is_dominating())
554#include "fe_q_bubbles.inst"
cell_iterator end() const
void distribute_dofs(const FiniteElement< dim, spacedim > &fe)
active_cell_iterator begin_active(const unsigned int level=0) const
types::global_dof_index n_dofs() const
const Point< spacedim > & quadrature_point(const unsigned int q_point) const
double JxW(const unsigned int q_point) const
const double & shape_value(const unsigned int i, const unsigned int q_point) const
void reinit(const TriaIterator< DoFCellAccessor< dim, spacedim, level_dof_access > > &cell)
const unsigned int q_degree
void initialize(const std::vector< Point< 1 > > &support_points_1d)
virtual bool has_support_on_face(const unsigned int shape_index, const unsigned int face_index) const override
virtual bool has_support_on_face(const unsigned int shape_index, const unsigned int face_index) const override
static std::vector< bool > get_riaf_vector(const unsigned int degree)
virtual void get_interpolation_matrix(const FiniteElement< dim, spacedim > &source, FullMatrix< double > &matrix) const override
virtual const FullMatrix< double > & get_restriction_matrix(const unsigned int child, const RefinementCase< dim > &refinement_case) const override
virtual FiniteElementDomination::Domination compare_for_domination(const FiniteElement< dim, spacedim > &fe_other, const unsigned int codim=0) const override final
virtual const FullMatrix< double > & get_prolongation_matrix(const unsigned int child, const RefinementCase< dim > &refinement_case) const override
const unsigned int n_bubbles
virtual void convert_generalized_support_point_values_to_dof_values(const std::vector< Vector< double > > &support_point_values, std::vector< double > &nodal_values) const override
virtual std::unique_ptr< FiniteElement< dim, spacedim > > clone() const override
FE_Q_Bubbles(const unsigned int p)
virtual std::string get_name() const override
static std::vector< unsigned int > get_dpo_vector(const unsigned int degree)
unsigned int n_dofs_per_cell() const
virtual std::string get_name() const =0
std::vector< std::vector< FullMatrix< double > > > restriction
void reinit_restriction_and_prolongation_matrices(const bool isotropic_restriction_only=false, const bool isotropic_prolongation_only=false)
std::vector< Point< dim > > unit_support_points
std::vector< std::vector< FullMatrix< double > > > prolongation
void mmult(FullMatrix< number2 > &C, const FullMatrix< number2 > &B, const bool adding=false) const
void set(const size_type i, const size_type j, const number value)
const std::vector< Point< dim > > & get_points() const
unsigned int size() const
virtual void execute_coarsening_and_refinement()
active_cell_iterator begin_active(const unsigned int level=0) const
#define DEAL_II_NAMESPACE_OPEN
#define DEAL_II_NAMESPACE_CLOSE
#define Assert(cond, exc)
static ::ExceptionBase & ExcImpossibleInDim(int arg1)
#define AssertDimension(dim1, dim2)
#define AssertIndexRange(index, range)
static ::ExceptionBase & ExcInternalError()
static ::ExceptionBase & ExcDimensionMismatch(std::size_t arg1, std::size_t arg2)
static ::ExceptionBase & ExcMessage(std::string arg1)
#define AssertThrow(cond, exc)
typename ActiveSelector::active_cell_iterator active_cell_iterator
@ update_values
Shape function values.
@ update_JxW_values
Transformed quadrature weights.
@ update_quadrature_points
Transformed quadrature points.
#define DEAL_II_ASSERT_UNREACHABLE()
#define DEAL_II_NOT_IMPLEMENTED()
const Mapping< dim, spacedim > & get_default_linear_mapping(const Triangulation< dim, spacedim > &triangulation)
@ either_element_can_dominate
@ other_element_dominates
@ neither_element_dominates
void hyper_cube(Triangulation< dim, spacedim > &tria, const double left=0., const double right=1., const bool colorize=false)
std::string dim_string(const int dim, const int spacedim)
static unsigned int n_children(const RefinementCase< dim > &refinement_case)