17 #include <deal.II/base/quadrature_lib.h> 18 #include <deal.II/base/std_cxx14/memory.h> 20 #include <deal.II/fe/fe_dgq.h> 21 #include <deal.II/fe/fe_nothing.h> 22 #include <deal.II/fe/fe_q.h> 24 #include <deal.II/lac/vector.h> 29 DEAL_II_NAMESPACE_OPEN
39 get_QGaussLobatto_points(
const unsigned int degree)
48 return std::vector<Point<1>>();
56 template <
int dim,
int spacedim>
66 std::vector<bool>(1, false))
73 template <
int dim,
int spacedim>
77 Polynomials::generate_complete_Lagrange_basis(points.get_points())),
82 std::vector<bool>(1, false))
89 template <
int dim,
int spacedim>
97 std::ostringstream namebuf;
98 bool equidistant =
true;
99 std::vector<double> points(this->degree + 1);
102 std::vector<unsigned int> lexicographic =
103 this->poly_space.get_numbering_inverse();
104 for (
unsigned int j = 0; j <= this->degree; j++)
105 points[j] = this->unit_support_points[lexicographic[j]][0];
108 for (
unsigned int j = 0; j <= this->degree; j++)
109 if (std::fabs(points[j] - static_cast<double>(j) / this->degree) > 1e-15)
115 if (equidistant ==
true)
117 if (this->degree > 2)
119 <<
">(QIterated(QTrapez()," << this->degree <<
"))";
122 << this->degree <<
")";
128 bool gauss_lobatto =
true;
129 for (
unsigned int j = 0; j <= this->degree; j++)
130 if (points[j] != points_gl.
point(j)(0))
132 gauss_lobatto =
false;
135 if (gauss_lobatto ==
true)
137 << this->degree <<
")";
140 <<
">(QUnknownNodes(" << this->degree <<
"))";
142 return namebuf.str();
147 template <
int dim,
int spacedim>
151 std::vector<double> & nodal_values)
const 154 this->get_unit_support_points().size());
158 for (
unsigned int i = 0; i < this->dofs_per_cell; ++i)
162 nodal_values[i] = support_point_values[i](0);
168 template <
int dim,
int spacedim>
169 std::unique_ptr<FiniteElement<dim, spacedim>>
172 return std_cxx14::make_unique<FE_Q<dim, spacedim>>(*this);
177 template <
int dim,
int spacedim>
181 const unsigned int codim)
const 200 if (this->degree < fe_q_other->degree)
202 else if (this->degree == fe_q_other->degree)
210 if (fe_nothing->is_dominating())
227 DEAL_II_NAMESPACE_CLOSE
virtual std::string get_name() const override
#define AssertDimension(dim1, dim2)
virtual std::unique_ptr< FiniteElement< dim, spacedim > > clone() const override
FE_Q(const unsigned int p)
const std::vector< Point< dim > > & get_points() const
const unsigned int degree
const Point< dim > & point(const unsigned int i) const
#define AssertThrow(cond, exc)
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
static ::ExceptionBase & ExcImpossibleInDim(int arg1)
#define Assert(cond, exc)
std::string dim_string(const int dim, const int spacedim)
void initialize(const std::vector< Point< 1 >> &support_points_1d)
virtual FiniteElementDomination::Domination compare_for_domination(const FiniteElement< dim, spacedim > &fe_other, const unsigned int codim=0) const override final
static ::ExceptionBase & ExcNotImplemented()