const std::vector<Point<dim> > &
fe2_support_points = fe2.get_unit_support_points ();
- typedef FiniteElement<dim,spacedim> FEL;
Assert(fe2_support_points.size()==fe2.dofs_per_cell,
- typename FEL::ExcFEHasNoSupportPoints());
+ (typename FiniteElement<dim,spacedim>::
+ ExcFEHasNoSupportPoints()));
for (unsigned int i=0; i<fe2.dofs_per_cell; ++i)
{
// cannot check this.
if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == nullptr)
{
- typedef FiniteElement<dim> FEL;
AssertThrow (dynamic_cast<const FE_Nedelec<dim>*> (&cell->get_fe ()) != nullptr,
-
- typename FEL::ExcInterpolationNotImplemented ());
+ (typename FiniteElement<dim>::ExcInterpolationNotImplemented ()));
}
for (unsigned int dof = 0; dof < dofs_per_face; ++dof)
// check this.
if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == nullptr)
{
- typedef FiniteElement<dim> FEL;
-
AssertThrow (dynamic_cast<const FE_Nedelec<dim>*> (&cell->get_fe ()) != nullptr,
- typename FEL::ExcInterpolationNotImplemented ());
+ typename FiniteElement<dim>::ExcInterpolationNotImplemented ());
}
for (unsigned int dof = 0; dof < dofs_per_face; ++dof)
// element. If the FE is a FESystem we cannot check this.
if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == nullptr)
{
- typedef FiniteElement<dim> FEL;
-
AssertThrow (dynamic_cast<const FE_Nedelec<dim>*> (&cell->get_fe ()) != nullptr,
- typename FEL::ExcInterpolationNotImplemented ());
+ typename FiniteElement<dim>::ExcInterpolationNotImplemented ());
}
const unsigned int dofs_per_face = cell->get_fe ().dofs_per_face;
// element. If the FE is a FESystem we cannot check this.
if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == nullptr)
{
- typedef FiniteElement<dim> FEL;
-
AssertThrow (dynamic_cast<const FE_Nedelec<dim>*> (&cell->get_fe ()) != nullptr,
- typename FEL::ExcInterpolationNotImplemented ());
+ typename FiniteElement<dim>::ExcInterpolationNotImplemented ());
}
const unsigned int superdegree = cell->get_fe ().degree;
// If the FE is a FESystem we cannot check this.
if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == nullptr)
{
- typedef FiniteElement<dim> FEL;
AssertThrow (dynamic_cast<const FE_Nedelec<dim>*> (&cell->get_fe ()) != nullptr,
- typename FEL::ExcInterpolationNotImplemented ());
+ typename FiniteElement<dim>::ExcInterpolationNotImplemented ());
}
// If the FE is a FESystem we cannot check this.
if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == nullptr)
{
- typedef FiniteElement<dim> FEL;
-
AssertThrow (dynamic_cast<const FE_Nedelec<dim>*> (&cell->get_fe ()) != nullptr,
- typename FEL::ExcInterpolationNotImplemented ());
+ typename FiniteElement<dim>::ExcInterpolationNotImplemented ());
}
const unsigned int superdegree = cell->get_fe ().degree;
// check this.
if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == nullptr)
{
- typedef FiniteElement<dim> FEL;
-
AssertThrow (dynamic_cast<const FE_RaviartThomas<dim>*> (&cell->get_fe ()) != nullptr,
- typename FEL::ExcInterpolationNotImplemented ());
+ typename FiniteElement<dim>::ExcInterpolationNotImplemented ());
}
fe_values.reinit (cell, face + cell->active_fe_index ()
// check this.
if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == nullptr)
{
- typedef FiniteElement<dim> FEL;
-
AssertThrow (dynamic_cast<const FE_RaviartThomas<dim>*> (&cell->get_fe ()) != nullptr,
- typename FEL::ExcInterpolationNotImplemented ());
+ typename FiniteElement<dim>::ExcInterpolationNotImplemented ());
}
fe_values.reinit (cell, face + cell->active_fe_index ()
// check this.
if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == nullptr)
{
- typedef FiniteElement<dim> FEL;
-
AssertThrow (dynamic_cast<const FE_RaviartThomas<dim>*> (&cell->get_fe ()) != nullptr,
- typename FEL::ExcInterpolationNotImplemented ());
+ typename FiniteElement<dim>::ExcInterpolationNotImplemented ());
}
fe_values.reinit (cell, face + cell->active_fe_index ()
// check this.
if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == nullptr)
{
- typedef FiniteElement<dim> FEL;
-
AssertThrow (dynamic_cast<const FE_RaviartThomas<dim>*> (&cell->get_fe ()) != nullptr,
- typename FEL::ExcInterpolationNotImplemented ());
+ typename FiniteElement<dim>::ExcInterpolationNotImplemented ());
}
fe_values.reinit (cell, face + cell->active_fe_index ()
// by default, no interpolation
// implemented. so throw exception,
// as documentation says
- typedef FiniteElement<dim,spacedim> FEE;
AssertThrow (false,
- typename FEE::
- ExcInterpolationNotImplemented());
+ (typename FiniteElement<dim,spacedim>::
+ ExcInterpolationNotImplemented()));
}
// by default, no interpolation
// implemented. so throw exception,
// as documentation says
- typedef FiniteElement<dim,spacedim> FEE;
AssertThrow (false,
- typename FEE::
- ExcInterpolationNotImplemented());
+ (typename FiniteElement<dim,spacedim>::
+ ExcInterpolationNotImplemented()));
}
// by default, no interpolation
// implemented. so throw exception,
// as documentation says
- typedef FiniteElement<dim,spacedim> FEE;
AssertThrow (false,
- typename FEE::ExcInterpolationNotImplemented());
+ (typename FiniteElement<dim,spacedim>::
+ ExcInterpolationNotImplemented()));
}
FullMatrix<double> &) const
{
// no interpolation possible. throw exception, as documentation says
- typedef FiniteElement<dim,spacedim> FEE;
AssertThrow (false,
- typename FEE::ExcInterpolationNotImplemented());
+ (typename FiniteElement<dim,spacedim>::
+ ExcInterpolationNotImplemented()));
}
FE_Bernstein<dim,spacedim>::get_restriction_matrix (const unsigned int,
const RefinementCase<dim> &) const
{
- typedef FiniteElement<dim,spacedim> FEE;
AssertThrow (false,
- typename FEE::ExcProjectionVoid());
+ (typename FiniteElement<dim,spacedim>::ExcProjectionVoid()));
// return dummy, nothing will happen because the base class FE_Q_Base
// implements lazy evaluation of those matrices
return this->restriction[0][0];
FE_Bernstein<dim,spacedim>::get_prolongation_matrix (const unsigned int,
const RefinementCase<dim> &) const
{
- typedef FiniteElement<dim,spacedim> FEE;
AssertThrow (false,
- typename FEE::ExcEmbeddingVoid());
+ (typename FiniteElement<dim,spacedim>::ExcEmbeddingVoid()));
// return dummy, nothing will happen because the base class FE_Q_Base
// implements lazy evaluation of those matrices
return this->prolongation[0][0];
// is necessarily empty -- i.e. there isn't
// much we need to do here.
(void)interpolation_matrix;
- typedef FiniteElement<dim,spacedim> FEE;
AssertThrow ((x_source_fe.get_name().find ("FE_DGPNonparametric<") == 0)
||
(dynamic_cast<const FE_DGPNonparametric<dim,spacedim>*>(&x_source_fe) != nullptr),
- typename FEE::
- ExcInterpolationNotImplemented());
+ (typename FiniteElement<dim,spacedim>::
+ ExcInterpolationNotImplemented()));
Assert (interpolation_matrix.m() == 0,
ExcDimensionMismatch (interpolation_matrix.m(),
// is necessarily empty -- i.e. there isn't
// much we need to do here.
(void)interpolation_matrix;
- typedef FiniteElement<dim,spacedim> FEE;
AssertThrow ((x_source_fe.get_name().find ("FE_DGPNonparametric<") == 0)
||
(dynamic_cast<const FE_DGPNonparametric<dim,spacedim>*>(&x_source_fe) != nullptr),
- typename FEE::
- ExcInterpolationNotImplemented());
+ (typename FiniteElement<dim,spacedim>::ExcInterpolationNotImplemented()));
Assert (interpolation_matrix.m() == 0,
ExcDimensionMismatch (interpolation_matrix.m(),
}
else
{
- typedef FiniteElement<dim,spacedim> FEL;
- AssertThrow(false,typename FEL::ExcInterpolationNotImplemented());
+ AssertThrow(false, (typename FiniteElement<dim,spacedim>::
+ ExcInterpolationNotImplemented()));
}
}
}
else
{
- typedef FiniteElement<dim,spacedim> FEL;
- AssertThrow(false,typename FEL::ExcInterpolationNotImplemented());
+ AssertThrow(false,(typename FiniteElement<dim,spacedim>::
+ ExcInterpolationNotImplemented()));
}
}
// this is only implemented, if the
// source FE is also a
// Nedelec element
- typedef FE_Nedelec<dim> FEN;
- typedef FiniteElement<dim> FEL;
-
AssertThrow ((source.get_name ().find ("FE_Nedelec<") == 0) ||
- (dynamic_cast<const FEN *> (&source) != nullptr),
- typename FEL::ExcInterpolationNotImplemented());
+ (dynamic_cast<const FE_Nedelec<dim> *> (&source) != nullptr),
+ (typename FiniteElement<dim>::
+ ExcInterpolationNotImplemented()));
Assert (interpolation_matrix.m () == source.dofs_per_face,
ExcDimensionMismatch (interpolation_matrix.m (),
source.dofs_per_face));
// hp procedures, which use this
// method.
Assert (this->dofs_per_face <= source_fe.dofs_per_face,
- typename FEL::ExcInterpolationNotImplemented ());
+ (typename FiniteElement<dim>::
+ ExcInterpolationNotImplemented ()));
interpolation_matrix = 0;
// On lines we can just identify
// this is only implemented, if the
// source FE is also a
// Nedelec element
- typedef FE_Nedelec<dim> FEN;
- typedef FiniteElement<dim> FEL;
-
AssertThrow ((source.get_name ().find ("FE_Nedelec<") == 0) ||
- (dynamic_cast<const FEN *> (&source) != nullptr),
- typename FEL::ExcInterpolationNotImplemented ());
+ (dynamic_cast<const FE_Nedelec<dim> *> (&source) != nullptr),
+ typename FiniteElement<dim>::
+ ExcInterpolationNotImplemented ());
Assert (interpolation_matrix.m () == source.dofs_per_face,
ExcDimensionMismatch (interpolation_matrix.m (),
source.dofs_per_face));
// hp procedures, which use this
// method.
Assert (this->dofs_per_face <= source_fe.dofs_per_face,
- typename FEL::ExcInterpolationNotImplemented ());
+ (typename FiniteElement<dim>::
+ ExcInterpolationNotImplemented ()));
interpolation_matrix = 0.0;
// Perform projection-based interpolation
// as usual.
(const unsigned int, const Point<dim> &) const
{
- typedef FiniteElement<dim,spacedim> FEE;
- Assert(false, typename FEE::ExcFENotPrimitive());
+ Assert(false, (typename FiniteElement<dim,spacedim>::ExcFENotPrimitive()));
return 0.;
}
FE_PolyTensor<PolynomialType,dim,spacedim>::shape_grad (const unsigned int,
const Point<dim> &) const
{
- typedef FiniteElement<dim,spacedim> FEE;
- Assert(false, typename FEE::ExcFENotPrimitive());
+ Assert(false, (typename FiniteElement<dim,spacedim>::ExcFENotPrimitive()));
return Tensor<1,dim>();
}
(const unsigned int,
const Point<dim> &) const
{
- typedef FiniteElement<dim,spacedim> FEE;
- Assert(false, typename FEE::ExcFENotPrimitive());
+ Assert(false, (typename FiniteElement<dim,spacedim>::ExcFENotPrimitive()));
return Tensor<2,dim>();
}
// However, for SolutionTransfer to work we need to provide an implementation
// for the case that the x_source_fe is identical to this FE
typedef FE_Q_Bubbles<dim,spacedim> FEQBUBBLES;
- typedef FiniteElement<dim,spacedim> FEL;
AssertThrow ((x_source_fe.get_name().find ("FE_Q_Bubbles<") == 0)
||
(dynamic_cast<const FEQBUBBLES *>(&x_source_fe) != nullptr)
,
- typename FEL::
- ExcInterpolationNotImplemented());
+ (typename FiniteElement<dim,spacedim>::
+ ExcInterpolationNotImplemented()));
Assert (interpolation_matrix.m() == this->dofs_per_cell,
ExcDimensionMismatch (interpolation_matrix.m(),
this->dofs_per_cell));
interpolation_matrix.set(i,i,1.);
//else we need to do more...
else
- Assert(false, typename FEL::ExcInterpolationNotImplemented())
- }
+ Assert(false, (typename FiniteElement<dim,spacedim>::
+ ExcInterpolationNotImplemented()));
+}
{
// this is only implemented, if the source FE is also a Q_DG0 element
typedef FE_Q_DG0<dim,spacedim> FEQDG0;
- typedef FiniteElement<dim,spacedim> FEL;
AssertThrow ((x_source_fe.get_name().find ("FE_Q_DG0<") == 0)
||
(dynamic_cast<const FEQDG0 *>(&x_source_fe) != nullptr),
- typename FEL::
- ExcInterpolationNotImplemented());
+ (typename FiniteElement<dim,spacedim>::
+ ExcInterpolationNotImplemented()));
Assert (interpolation_matrix.m() == this->dofs_per_cell,
ExcDimensionMismatch (interpolation_matrix.m(),
// source FE is also a
// Q_Hierarchical element
typedef FE_Q_Hierarchical<dim> FEQHierarchical;
- typedef FiniteElement<dim> FEL;
AssertThrow ((x_source_fe.get_name().find ("FE_Q_Hierarchical<") == 0)
||
(dynamic_cast<const FEQHierarchical *>(&x_source_fe) != nullptr),
- typename FEL::
- ExcInterpolationNotImplemented());
+ (typename FiniteElement<dim>::ExcInterpolationNotImplemented()));
Assert (interpolation_matrix.n() == this->dofs_per_face,
ExcDimensionMismatch (interpolation_matrix.n(),
// hp procedures, which use this
// method.
Assert (this->dofs_per_face <= source_fe.dofs_per_face,
- typename FEL::
- ExcInterpolationNotImplemented ());
+ (typename FiniteElement<dim>::
+ ExcInterpolationNotImplemented ()));
interpolation_matrix = 0;
switch (dim)
// source FE is also a
// Q_Hierarchical element
typedef FE_Q_Hierarchical<dim> FEQHierarchical;
- typedef FiniteElement<dim> FEL;
AssertThrow ((x_source_fe.get_name().find ("FE_Q_Hierarchical<") == 0)
||
(dynamic_cast<const FEQHierarchical *>(&x_source_fe) != nullptr),
- typename FEL::
- ExcInterpolationNotImplemented());
+ (typename FiniteElement<dim>::ExcInterpolationNotImplemented()));
Assert (interpolation_matrix.n() == this->dofs_per_face,
ExcDimensionMismatch (interpolation_matrix.n(),
// hp procedures, which use this
// method.
Assert (this->dofs_per_face <= source_fe.dofs_per_face,
- typename FEL::
- ExcInterpolationNotImplemented ());
+ (typename FiniteElement<dim>::
+ ExcInterpolationNotImplemented ()));
switch (dim)
{
//
// condition 1: the other element must also be a system element
- typedef FiniteElement<dim,spacedim> FEL;
AssertThrow ((x_source_fe.get_name().find ("FESystem<") == 0)
||
(dynamic_cast<const FESystem<dim,spacedim>*>(&x_source_fe) != nullptr),
- typename FEL::
- ExcInterpolationNotImplemented());
+ (typename FiniteElement<dim,spacedim>::
+ ExcInterpolationNotImplemented()));
// ok, source is a system element, so we may be able to do the work
const FESystem<dim,spacedim> &source_fe
// condition 2: same number of basis elements
AssertThrow (this->n_base_elements() == source_fe.n_base_elements(),
- typename FEL::
- ExcInterpolationNotImplemented());
+ (typename FiniteElement<dim,spacedim>::
+ ExcInterpolationNotImplemented()));
// condition 3: same number of basis elements
for (unsigned int i=0; i< this->n_base_elements(); ++i)
AssertThrow (this->element_multiplicity(i) ==
source_fe.element_multiplicity(i),
- typename FEL::
- ExcInterpolationNotImplemented());
+ (typename FiniteElement<dim,spacedim>::
+ ExcInterpolationNotImplemented()));
// ok, so let's try whether it works:
get_face_interpolation_matrix (const FiniteElement<dim,spacedim> &x_source_fe,
FullMatrix<double> &interpolation_matrix) const
{
- typedef FiniteElement<dim,spacedim> FEL;
AssertThrow ((x_source_fe.get_name().find ("FE_System<") == 0)
||
(dynamic_cast<const FESystem<dim,spacedim>*>(&x_source_fe) != nullptr),
- typename FEL::
- ExcInterpolationNotImplemented());
+ (typename FiniteElement<dim,spacedim>::
+ ExcInterpolationNotImplemented()));
Assert (interpolation_matrix.n() == this->dofs_per_face,
ExcDimensionMismatch (interpolation_matrix.n(),
const unsigned int subface,
FullMatrix<double> &interpolation_matrix) const
{
- typedef FiniteElement<dim,spacedim> FEL;
AssertThrow ((x_source_fe.get_name().find ("FE_System<") == 0)
||
(dynamic_cast<const FESystem<dim,spacedim>*>(&x_source_fe) != nullptr),
- typename FEL::
- ExcInterpolationNotImplemented());
+ (typename FiniteElement<dim,spacedim>::
+ ExcInterpolationNotImplemented()));
Assert (interpolation_matrix.n() == this->dofs_per_face,
ExcDimensionMismatch (interpolation_matrix.n(),
{
Assert (index < this->dofs_per_cell,
ExcIndexRange (index, 0, this->dofs_per_cell));
- typedef FiniteElement<dim,spacedim> FEL;
Assert ((this->unit_support_points.size() == this->dofs_per_cell) ||
(this->unit_support_points.size() == 0),
- typename FEL::ExcFEHasNoSupportPoints ());
+ (typename FiniteElement<dim,spacedim>::ExcFEHasNoSupportPoints ()));
// let's see whether we have the information pre-computed
if (this->unit_support_points.size() != 0)
{
Assert (index < this->dofs_per_face,
ExcIndexRange (index, 0, this->dofs_per_face));
- typedef FiniteElement<dim,spacedim> FEL;
Assert ((this->unit_face_support_points.size() == this->dofs_per_face) ||
(this->unit_face_support_points.size() == 0),
- typename FEL::ExcFEHasNoSupportPoints ());
+ (typename FiniteElement<dim,spacedim>::ExcFEHasNoSupportPoints ()));
// let's see whether we have the information pre-computed
if (this->unit_face_support_points.size() != 0)