Reference documentation for deal.II version 9.1.0-pre
fe_raviart_thomas_nodal.cc
1 // ---------------------------------------------------------------------
2 //
3 // Copyright (C) 2003 - 2018 by the deal.II authors
4 //
5 // This file is part of the deal.II library.
6 //
7 // The deal.II library is free software; you can use it, redistribute
8 // it, and/or modify it under the terms of the GNU Lesser General
9 // Public License as published by the Free Software Foundation; either
10 // version 2.1 of the License, or (at your option) any later version.
11 // The full text of the license can be found in the file LICENSE.md at
12 // the top level directory of deal.II.
13 //
14 // ---------------------------------------------------------------------
15 
16 
17 #include <deal.II/base/qprojector.h>
18 #include <deal.II/base/quadrature_lib.h>
19 #include <deal.II/base/std_cxx14/memory.h>
20 #include <deal.II/base/table.h>
21 
22 #include <deal.II/dofs/dof_accessor.h>
23 
24 #include <deal.II/fe/fe.h>
25 #include <deal.II/fe/fe_nothing.h>
26 #include <deal.II/fe/fe_raviart_thomas.h>
27 #include <deal.II/fe/fe_tools.h>
28 #include <deal.II/fe/fe_values.h>
29 #include <deal.II/fe/mapping.h>
30 
31 #include <deal.II/grid/tria.h>
32 #include <deal.II/grid/tria_iterator.h>
33 
34 #include <sstream>
35 
36 
37 DEAL_II_NAMESPACE_OPEN
38 
39 
40 template <int dim>
43  deg,
44  FiniteElementData<dim>(get_dpo_vector(deg),
45  dim,
46  deg + 1,
47  FiniteElementData<dim>::Hdiv),
48  get_ria_vector(deg),
49  std::vector<ComponentMask>(PolynomialsRaviartThomas<dim>::compute_n_pols(
50  deg),
51  std::vector<bool>(dim, true)))
52 {
53  Assert(dim >= 2, ExcImpossibleInDim(dim));
54  const unsigned int n_dofs = this->dofs_per_cell;
55 
57  // First, initialize the
58  // generalized support points and
59  // quadrature weights, since they
60  // are required for interpolation.
62 
63  // Now compute the inverse node matrix, generating the correct
64  // basis functions from the raw ones. For a discussion of what
65  // exactly happens here, see FETools::compute_node_matrix.
67  this->inverse_node_matrix.reinit(n_dofs, n_dofs);
68  this->inverse_node_matrix.invert(M);
69  // From now on, the shape functions provided by FiniteElement::shape_value
70  // and similar functions will be the correct ones, not
71  // the raw shape functions from the polynomial space anymore.
72 
73  // Reinit the vectors of
74  // prolongation matrices to the
75  // right sizes. There are no
76  // restriction matrices implemented
77  for (unsigned int ref_case = RefinementCase<dim>::cut_x;
78  ref_case < RefinementCase<dim>::isotropic_refinement + 1;
79  ++ref_case)
80  {
81  const unsigned int nc =
83 
84  for (unsigned int i = 0; i < nc; ++i)
85  this->prolongation[ref_case - 1][i].reinit(n_dofs, n_dofs);
86  }
87  // Fill prolongation matrices with embedding operators
89  // TODO[TL]: for anisotropic refinement we will probably need a table of
90  // submatrices with an array for each refine case
92  for (unsigned int i = 0; i < GeometryInfo<dim>::max_children_per_face; ++i)
93  face_embeddings[i].reinit(this->dofs_per_face, this->dofs_per_face);
94  FETools::compute_face_embedding_matrices<dim, double>(*this,
95  face_embeddings,
96  0,
97  0);
98  this->interface_constraints.reinit((1 << (dim - 1)) * this->dofs_per_face,
99  this->dofs_per_face);
100  unsigned int target_row = 0;
101  for (unsigned int d = 0; d < GeometryInfo<dim>::max_children_per_face; ++d)
102  for (unsigned int i = 0; i < face_embeddings[d].m(); ++i)
103  {
104  for (unsigned int j = 0; j < face_embeddings[d].n(); ++j)
105  this->interface_constraints(target_row, j) = face_embeddings[d](i, j);
106  ++target_row;
107  }
108 }
109 
110 
111 
112 template <int dim>
113 std::string
115 {
116  // note that the
117  // FETools::get_fe_by_name
118  // function depends on the
119  // particular format of the string
120  // this function returns, so they
121  // have to be kept in synch
122 
123  // note that this->degree is the maximal
124  // polynomial degree and is thus one higher
125  // than the argument given to the
126  // constructor
127  std::ostringstream namebuf;
128  namebuf << "FE_RaviartThomasNodal<" << dim << ">(" << this->degree - 1 << ")";
129 
130  return namebuf.str();
131 }
132 
133 
134 template <int dim>
135 std::unique_ptr<FiniteElement<dim, dim>>
137 {
138  return std_cxx14::make_unique<FE_RaviartThomasNodal<dim>>(*this);
139 }
140 
141 
142 //---------------------------------------------------------------------------
143 // Auxiliary and internal functions
144 //---------------------------------------------------------------------------
145 
146 
147 
148 template <int dim>
149 void
151 {
152  this->generalized_support_points.resize(this->dofs_per_cell);
154 
155  // Number of the point being entered
156  unsigned int current = 0;
157 
158  // On the faces, we choose as many
159  // Gauss points as necessary to
160  // determine the normal component
161  // uniquely. This is the deg of
162  // the Raviart-Thomas element plus
163  // one.
164  if (dim > 1)
165  {
166  QGauss<dim - 1> face_points(deg + 1);
167  Assert(face_points.size() == this->dofs_per_face, ExcInternalError());
168  for (unsigned int k = 0; k < this->dofs_per_face; ++k)
169  this->generalized_face_support_points[k] = face_points.point(k);
170  Quadrature<dim> faces =
172  for (unsigned int k = 0;
173  k < this->dofs_per_face * GeometryInfo<dim>::faces_per_cell;
174  ++k)
175  this->generalized_support_points[k] =
177  0, true, false, false, this->dofs_per_face));
178 
179  current = this->dofs_per_face * GeometryInfo<dim>::faces_per_cell;
180  }
181 
182  if (deg == 0)
183  return;
184  // In the interior, we need
185  // anisotropic Gauss quadratures,
186  // different for each direction.
187  QGauss<1> high(deg + 1);
188  QGauss<1> low(deg);
189 
190  for (unsigned int d = 0; d < dim; ++d)
191  {
192  std::unique_ptr<QAnisotropic<dim>> quadrature;
193  switch (dim)
194  {
195  case 1:
196  quadrature = std_cxx14::make_unique<QAnisotropic<dim>>(high);
197  break;
198  case 2:
199  quadrature = std_cxx14::make_unique<QAnisotropic<dim>>(
200  ((d == 0) ? low : high), ((d == 1) ? low : high));
201  break;
202  case 3:
203  quadrature =
204  std_cxx14::make_unique<QAnisotropic<dim>>(((d == 0) ? low : high),
205  ((d == 1) ? low : high),
206  ((d == 2) ? low :
207  high));
208  break;
209  default:
210  Assert(false, ExcNotImplemented());
211  }
212 
213  for (unsigned int k = 0; k < quadrature->size(); ++k)
214  this->generalized_support_points[current++] = quadrature->point(k);
215  }
216  Assert(current == this->dofs_per_cell, ExcInternalError());
217 }
218 
219 
220 
221 template <int dim>
222 std::vector<unsigned int>
224 {
225  // the element is face-based and we have
226  // (deg+1)^(dim-1) DoFs per face
227  unsigned int dofs_per_face = 1;
228  for (unsigned int d = 1; d < dim; ++d)
229  dofs_per_face *= deg + 1;
230 
231  // and then there are interior dofs
232  const unsigned int interior_dofs = dim * deg * dofs_per_face;
233 
234  std::vector<unsigned int> dpo(dim + 1);
235  dpo[dim - 1] = dofs_per_face;
236  dpo[dim] = interior_dofs;
237 
238  return dpo;
239 }
240 
241 
242 
243 template <>
244 std::vector<bool>
246 {
247  Assert(false, ExcImpossibleInDim(1));
248  return std::vector<bool>();
249 }
250 
251 
252 
253 template <int dim>
254 std::vector<bool>
256 {
257  const unsigned int dofs_per_cell =
259  unsigned int dofs_per_face = deg + 1;
260  for (unsigned int d = 2; d < dim; ++d)
261  dofs_per_face *= deg + 1;
262  // all face dofs need to be
263  // non-additive, since they have
264  // continuity requirements.
265  // however, the interior dofs are
266  // made additive
267  std::vector<bool> ret_val(dofs_per_cell, false);
268  for (unsigned int i = GeometryInfo<dim>::faces_per_cell * dofs_per_face;
269  i < dofs_per_cell;
270  ++i)
271  ret_val[i] = true;
272 
273  return ret_val;
274 }
275 
276 
277 template <int dim>
278 bool
280  const unsigned int shape_index,
281  const unsigned int face_index) const
282 {
283  Assert(shape_index < this->dofs_per_cell,
284  ExcIndexRange(shape_index, 0, this->dofs_per_cell));
287 
288  // The first degrees of freedom are
289  // on the faces and each face has
290  // degree degrees.
291  const unsigned int support_face = shape_index / this->degree;
292 
293  // The only thing we know for sure
294  // is that shape functions with
295  // support on one face are zero on
296  // the opposite face.
297  if (support_face < GeometryInfo<dim>::faces_per_cell)
298  return (face_index != GeometryInfo<dim>::opposite_face[support_face]);
299 
300  // In all other cases, return true,
301  // which is safe
302  return true;
303 }
304 
305 
306 
307 template <int dim>
308 void
311  const std::vector<Vector<double>> &support_point_values,
312  std::vector<double> & nodal_values) const
313 {
314  Assert(support_point_values.size() == this->generalized_support_points.size(),
315  ExcDimensionMismatch(support_point_values.size(),
316  this->generalized_support_points.size()));
317  Assert(nodal_values.size() == this->dofs_per_cell,
318  ExcDimensionMismatch(nodal_values.size(), this->dofs_per_cell));
319  Assert(support_point_values[0].size() == this->n_components(),
320  ExcDimensionMismatch(support_point_values[0].size(),
321  this->n_components()));
322 
323  // First do interpolation on
324  // faces. There, the component
325  // evaluated depends on the face
326  // direction and orientation.
327  unsigned int fbase = 0;
328  unsigned int f = 0;
329  for (; f < GeometryInfo<dim>::faces_per_cell;
330  ++f, fbase += this->dofs_per_face)
331  {
332  for (unsigned int i = 0; i < this->dofs_per_face; ++i)
333  {
334  nodal_values[fbase + i] = support_point_values[fbase + i](
336  }
337  }
338 
339  // The remaining points form dim
340  // chunks, one for each component.
341  const unsigned int istep = (this->dofs_per_cell - fbase) / dim;
342  Assert((this->dofs_per_cell - fbase) % dim == 0, ExcInternalError());
343 
344  f = 0;
345  while (fbase < this->dofs_per_cell)
346  {
347  for (unsigned int i = 0; i < istep; ++i)
348  {
349  nodal_values[fbase + i] = support_point_values[fbase + i](f);
350  }
351  fbase += istep;
352  ++f;
353  }
354  Assert(fbase == this->dofs_per_cell, ExcInternalError());
355 }
356 
357 
358 
359 // TODO: There are tests that check that the following few functions don't
360 // produce assertion failures, but none that actually check whether they do the
361 // right thing. one example for such a test would be to project a function onto
362 // an hp space and make sure that the convergence order is correct with regard
363 // to the lowest used polynomial degree
364 
365 template <int dim>
366 bool
368 {
369  return true;
370 }
371 
372 
373 template <int dim>
374 std::vector<std::pair<unsigned int, unsigned int>>
376  const FiniteElement<dim> &fe_other) const
377 {
378  // we can presently only compute these
379  // identities if both FEs are
380  // FE_RaviartThomasNodals or the other is FE_Nothing.
381  // In either case, no dofs are assigned on the vertex,
382  // so we shouldn't be getting here at all.
383  if (dynamic_cast<const FE_RaviartThomasNodal<dim> *>(&fe_other) != nullptr)
384  return std::vector<std::pair<unsigned int, unsigned int>>();
385  else if (dynamic_cast<const FE_Nothing<dim> *>(&fe_other) != nullptr)
386  return std::vector<std::pair<unsigned int, unsigned int>>();
387  else
388  {
389  Assert(false, ExcNotImplemented());
390  return std::vector<std::pair<unsigned int, unsigned int>>();
391  }
392 }
393 
394 
395 
396 template <int dim>
397 std::vector<std::pair<unsigned int, unsigned int>>
399  const FiniteElement<dim> &fe_other) const
400 {
401  // we can presently only compute
402  // these identities if both FEs are
403  // FE_RaviartThomasNodals or if the other
404  // one is FE_Nothing
405  if (const FE_RaviartThomasNodal<dim> *fe_q_other =
406  dynamic_cast<const FE_RaviartThomasNodal<dim> *>(&fe_other))
407  {
408  // dofs are located on faces; these are
409  // only lines in 2d
410  if (dim != 2)
411  return std::vector<std::pair<unsigned int, unsigned int>>();
412 
413  // dofs are located along lines, so two
414  // dofs are identical only if in the
415  // following two cases (remember that
416  // the face support points are Gauss
417  // points):
418  // 1. this->degree = fe_q_other->degree,
419  // in the case, all the dofs on
420  // the line are identical
421  // 2. this->degree-1 and fe_q_other->degree-1
422  // are both even, i.e. this->dof_per_line
423  // and fe_q_other->dof_per_line are both odd,
424  // there exists only one point (the middle one)
425  // such that dofs are identical on this point
426  //
427  // to understand this, note that
428  // this->degree is the *maximal*
429  // polynomial degree, and is thus one
430  // higher than the argument given to
431  // the constructor
432  const unsigned int p = this->degree - 1;
433  const unsigned int q = fe_q_other->degree - 1;
434 
435  std::vector<std::pair<unsigned int, unsigned int>> identities;
436 
437  if (p == q)
438  for (unsigned int i = 0; i < p + 1; ++i)
439  identities.emplace_back(i, i);
440 
441  else if (p % 2 == 0 && q % 2 == 0)
442  identities.emplace_back(p / 2, q / 2);
443 
444  return identities;
445  }
446  else if (dynamic_cast<const FE_Nothing<dim> *>(&fe_other) != nullptr)
447  {
448  // the FE_Nothing has no degrees of freedom, so there are no
449  // equivalencies to be recorded
450  return std::vector<std::pair<unsigned int, unsigned int>>();
451  }
452  else
453  {
454  Assert(false, ExcNotImplemented());
455  return std::vector<std::pair<unsigned int, unsigned int>>();
456  }
457 }
458 
459 
460 template <int dim>
461 std::vector<std::pair<unsigned int, unsigned int>>
463  const FiniteElement<dim> &fe_other) const
464 {
465  // we can presently only compute
466  // these identities if both FEs are
467  // FE_RaviartThomasNodals or if the other
468  // one is FE_Nothing
469  if (const FE_RaviartThomasNodal<dim> *fe_q_other =
470  dynamic_cast<const FE_RaviartThomasNodal<dim> *>(&fe_other))
471  {
472  // dofs are located on faces; these are
473  // only quads in 3d
474  if (dim != 3)
475  return std::vector<std::pair<unsigned int, unsigned int>>();
476 
477  // this works exactly like the line
478  // case above
479  const unsigned int p = this->dofs_per_quad;
480  const unsigned int q = fe_q_other->dofs_per_quad;
481 
482  std::vector<std::pair<unsigned int, unsigned int>> identities;
483 
484  if (p == q)
485  for (unsigned int i = 0; i < p; ++i)
486  identities.emplace_back(i, i);
487 
488  else if (p % 2 != 0 && q % 2 != 0)
489  identities.emplace_back(p / 2, q / 2);
490 
491  return identities;
492  }
493  else if (dynamic_cast<const FE_Nothing<dim> *>(&fe_other) != nullptr)
494  {
495  // the FE_Nothing has no degrees of freedom, so there are no
496  // equivalencies to be recorded
497  return std::vector<std::pair<unsigned int, unsigned int>>();
498  }
499  else
500  {
501  Assert(false, ExcNotImplemented());
502  return std::vector<std::pair<unsigned int, unsigned int>>();
503  }
504 }
505 
506 
507 template <int dim>
510  const FiniteElement<dim> &fe_other) const
511 {
512  if (const FE_RaviartThomasNodal<dim> *fe_q_other =
513  dynamic_cast<const FE_RaviartThomasNodal<dim> *>(&fe_other))
514  {
515  if (this->degree < fe_q_other->degree)
517  else if (this->degree == fe_q_other->degree)
519  else
521  }
522  else if (const FE_Nothing<dim> *fe_q_other =
523  dynamic_cast<const FE_Nothing<dim> *>(&fe_other))
524  {
525  if (fe_q_other->is_dominating())
526  {
528  }
529  else
530  {
531  // FE_Nothing has no degrees of freedom and is typically
532  // used in a context where there are no continuity
533  // requirements along the interface
535  }
536  }
537 
538  Assert(false, ExcNotImplemented());
540 }
541 
542 
543 
544 template <>
545 void
547  const FiniteElement<1, 1> & /*x_source_fe*/,
548  FullMatrix<double> & /*interpolation_matrix*/) const
549 {
550  Assert(false, ExcImpossibleInDim(1));
551 }
552 
553 
554 template <>
555 void
557  const FiniteElement<1, 1> & /*x_source_fe*/,
558  const unsigned int /*subface*/,
559  FullMatrix<double> & /*interpolation_matrix*/) const
560 {
561  Assert(false, ExcImpossibleInDim(1));
562 }
563 
564 
565 
566 template <int dim>
567 void
569  const FiniteElement<dim> &x_source_fe,
570  FullMatrix<double> & interpolation_matrix) const
571 {
572  // this is only implemented, if the
573  // source FE is also a
574  // RaviartThomasNodal element
575  AssertThrow((x_source_fe.get_name().find("FE_RaviartThomasNodal<") == 0) ||
576  (dynamic_cast<const FE_RaviartThomasNodal<dim> *>(
577  &x_source_fe) != nullptr),
579 
580  Assert(interpolation_matrix.n() == this->dofs_per_face,
581  ExcDimensionMismatch(interpolation_matrix.n(), this->dofs_per_face));
582  Assert(interpolation_matrix.m() == x_source_fe.dofs_per_face,
583  ExcDimensionMismatch(interpolation_matrix.m(),
584  x_source_fe.dofs_per_face));
585 
586  // ok, source is a RaviartThomasNodal element, so
587  // we will be able to do the work
588  const FE_RaviartThomasNodal<dim> &source_fe =
589  dynamic_cast<const FE_RaviartThomasNodal<dim> &>(x_source_fe);
590 
591  // Make sure, that the element,
592  // for which the DoFs should be
593  // constrained is the one with
594  // the higher polynomial degree.
595  // Actually the procedure will work
596  // also if this assertion is not
597  // satisfied. But the matrices
598  // produced in that case might
599  // lead to problems in the
600  // hp procedures, which use this
601  // method.
602  Assert(this->dofs_per_face <= source_fe.dofs_per_face,
604 
605  // generate a quadrature
606  // with the generalized support points.
607  // This is later based as a
608  // basis for the QProjector,
609  // which returns the support
610  // points on the face.
611  Quadrature<dim - 1> quad_face_support(
613 
614  // Rule of thumb for FP accuracy,
615  // that can be expected for a
616  // given polynomial degree.
617  // This value is used to cut
618  // off values close to zero.
619  double eps = 2e-13 * this->degree * (dim - 1);
620 
621  // compute the interpolation
622  // matrix by simply taking the
623  // value at the support points.
624  const Quadrature<dim> face_projection =
625  QProjector<dim>::project_to_face(quad_face_support, 0);
626 
627  for (unsigned int i = 0; i < source_fe.dofs_per_face; ++i)
628  {
629  const Point<dim> &p = face_projection.point(i);
630 
631  for (unsigned int j = 0; j < this->dofs_per_face; ++j)
632  {
633  double matrix_entry =
634  this->shape_value_component(this->face_to_cell_index(j, 0), p, 0);
635 
636  // Correct the interpolated
637  // value. I.e. if it is close
638  // to 1 or 0, make it exactly
639  // 1 or 0. Unfortunately, this
640  // is required to avoid problems
641  // with higher order elements.
642  if (std::fabs(matrix_entry - 1.0) < eps)
643  matrix_entry = 1.0;
644  if (std::fabs(matrix_entry) < eps)
645  matrix_entry = 0.0;
646 
647  interpolation_matrix(i, j) = matrix_entry;
648  }
649  }
650 
651  // make sure that the row sum of
652  // each of the matrices is 1 at
653  // this point. this must be so
654  // since the shape functions sum up
655  // to 1
656  for (unsigned int j = 0; j < source_fe.dofs_per_face; ++j)
657  {
658  double sum = 0.;
659 
660  for (unsigned int i = 0; i < this->dofs_per_face; ++i)
661  sum += interpolation_matrix(j, i);
662 
663  Assert(std::fabs(sum - 1) < 2e-13 * this->degree * (dim - 1),
664  ExcInternalError());
665  }
666 }
667 
668 
669 template <int dim>
670 void
672  const FiniteElement<dim> &x_source_fe,
673  const unsigned int subface,
674  FullMatrix<double> & interpolation_matrix) const
675 {
676  // this is only implemented, if the
677  // source FE is also a
678  // RaviartThomasNodal element
679  AssertThrow((x_source_fe.get_name().find("FE_RaviartThomasNodal<") == 0) ||
680  (dynamic_cast<const FE_RaviartThomasNodal<dim> *>(
681  &x_source_fe) != nullptr),
683 
684  Assert(interpolation_matrix.n() == this->dofs_per_face,
685  ExcDimensionMismatch(interpolation_matrix.n(), this->dofs_per_face));
686  Assert(interpolation_matrix.m() == x_source_fe.dofs_per_face,
687  ExcDimensionMismatch(interpolation_matrix.m(),
688  x_source_fe.dofs_per_face));
689 
690  // ok, source is a RaviartThomasNodal element, so
691  // we will be able to do the work
692  const FE_RaviartThomasNodal<dim> &source_fe =
693  dynamic_cast<const FE_RaviartThomasNodal<dim> &>(x_source_fe);
694 
695  // Make sure, that the element,
696  // for which the DoFs should be
697  // constrained is the one with
698  // the higher polynomial degree.
699  // Actually the procedure will work
700  // also if this assertion is not
701  // satisfied. But the matrices
702  // produced in that case might
703  // lead to problems in the
704  // hp procedures, which use this
705  // method.
706  Assert(this->dofs_per_face <= source_fe.dofs_per_face,
708 
709  // generate a quadrature
710  // with the generalized support points.
711  // This is later based as a
712  // basis for the QProjector,
713  // which returns the support
714  // points on the face.
715  Quadrature<dim - 1> quad_face_support(
717 
718  // Rule of thumb for FP accuracy,
719  // that can be expected for a
720  // given polynomial degree.
721  // This value is used to cut
722  // off values close to zero.
723  double eps = 2e-13 * this->degree * (dim - 1);
724 
725  // compute the interpolation
726  // matrix by simply taking the
727  // value at the support points.
728 
729  const Quadrature<dim> subface_projection =
730  QProjector<dim>::project_to_subface(quad_face_support, 0, subface);
731 
732  for (unsigned int i = 0; i < source_fe.dofs_per_face; ++i)
733  {
734  const Point<dim> &p = subface_projection.point(i);
735 
736  for (unsigned int j = 0; j < this->dofs_per_face; ++j)
737  {
738  double matrix_entry =
739  this->shape_value_component(this->face_to_cell_index(j, 0), p, 0);
740 
741  // Correct the interpolated
742  // value. I.e. if it is close
743  // to 1 or 0, make it exactly
744  // 1 or 0. Unfortunately, this
745  // is required to avoid problems
746  // with higher order elements.
747  if (std::fabs(matrix_entry - 1.0) < eps)
748  matrix_entry = 1.0;
749  if (std::fabs(matrix_entry) < eps)
750  matrix_entry = 0.0;
751 
752  interpolation_matrix(i, j) = matrix_entry;
753  }
754  }
755 
756  // make sure that the row sum of
757  // each of the matrices is 1 at
758  // this point. this must be so
759  // since the shape functions sum up
760  // to 1
761  for (unsigned int j = 0; j < source_fe.dofs_per_face; ++j)
762  {
763  double sum = 0.;
764 
765  for (unsigned int i = 0; i < this->dofs_per_face; ++i)
766  sum += interpolation_matrix(j, i);
767 
768  Assert(std::fabs(sum - 1) < 2e-13 * this->degree * (dim - 1),
769  ExcInternalError());
770  }
771 }
772 
773 
774 
775 // explicit instantiations
776 #include "fe_raviart_thomas_nodal.inst"
777 
778 
779 DEAL_II_NAMESPACE_CLOSE
std::vector< Point< dim > > generalized_support_points
Definition: fe.h:2470
void compute_embedding_matrices(const FiniteElement< dim, spacedim > &fe, std::vector< std::vector< FullMatrix< number >>> &matrices, const bool isotropic_only=false, const double threshold=1.e-12)
FullMatrix< double > interface_constraints
Definition: fe.h:2445
const std::vector< Point< dim-1 > > & get_generalized_face_support_points() const
FE_RaviartThomasNodal(const unsigned int p)
const unsigned int dofs_per_quad
Definition: fe_base.h:252
const unsigned int degree
Definition: fe_base.h:313
virtual std::unique_ptr< FiniteElement< dim, dim > > clone() const override
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
STL namespace.
static unsigned int compute_n_pols(unsigned int degree)
#define AssertThrow(cond, exc)
Definition: exceptions.h:1329
FullMatrix< double > compute_node_matrix(const FiniteElement< dim, spacedim > &fe)
std::vector< Point< dim-1 > > generalized_face_support_points
Definition: fe.h:2476
static::ExceptionBase & ExcIndexRange(int arg1, int arg2, int arg3)
const Point< dim > & point(const unsigned int i) const
static std::vector< unsigned int > get_dpo_vector(const unsigned int degree)
virtual bool hp_constraints_are_implemented() const override
size_type n() const
static::ExceptionBase & ExcImpossibleInDim(int arg1)
std::vector< std::vector< FullMatrix< double > > > prolongation
Definition: fe.h:2433
void invert(const FullMatrix< number2 > &M)
void reinit(const TableIndices< N > &new_size, const bool omit_default_initialization=false)
#define Assert(cond, exc)
Definition: exceptions.h:1227
static::ExceptionBase & ExcDimensionMismatch(std::size_t arg1, std::size_t arg2)
void initialize_support_points(const unsigned int rt_degree)
virtual double shape_value_component(const unsigned int i, const Point< dim > &p, const unsigned int component) const override
virtual std::string get_name() const =0
unsigned int n_components() const
size_type m() const
const unsigned int dofs_per_cell
Definition: fe_base.h:297
virtual std::string get_name() const override
static unsigned int n_children(const RefinementCase< dim > &refinement_case)
static void project_to_subface(const SubQuadrature &quadrature, const unsigned int face_no, const unsigned int subface_no, std::vector< Point< dim >> &q_points, const RefinementCase< dim-1 > &ref_case=RefinementCase< dim-1 >::isotropic_refinement)
static Quadrature< dim > project_to_all_faces(const SubQuadrature &quadrature)
static void project_to_face(const SubQuadrature &quadrature, const unsigned int face_no, std::vector< Point< dim >> &q_points)
virtual unsigned int face_to_cell_index(const unsigned int face_dof_index, const unsigned int face, const bool face_orientation=true, const bool face_flip=false, const bool face_rotation=false) const
virtual bool has_support_on_face(const unsigned int shape_index, const unsigned int face_index) const override
const unsigned int dofs_per_face
Definition: fe_base.h:290
static::ExceptionBase & ExcNotImplemented()
static::ExceptionBase & ExcInternalError()
static std::vector< bool > get_ria_vector(const unsigned int degree)