From: hartmann Date: Mon, 13 Jun 2005 11:47:55 +0000 (+0000) Subject: The lexicographic <-> hierarchic numbering functions now take a FiniteElementData... X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=76df61eb11a259f4627725b26c40149fa3115089;p=dealii-svn.git The lexicographic <-> hierarchic numbering functions now take a FiniteElementData instead of a FE_Q object. Then this function can also be called by the FE_Q constructor. git-svn-id: https://svn.dealii.org/trunk@10857 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/deal.II/include/fe/fe_tools.h b/deal.II/deal.II/include/fe/fe_tools.h index b8ea6de429..aec40f3c17 100644 --- a/deal.II/deal.II/include/fe/fe_tools.h +++ b/deal.II/deal.II/include/fe/fe_tools.h @@ -25,7 +25,7 @@ template class Vector; template class FiniteElement; template class DoFHandler; template class hpDoFHandler; -template class FE_Q; +template class FiniteElementData; class ConstraintMatrix; @@ -566,8 +566,13 @@ class FETools * Note that since this function * uses specifics of the * continuous finite elements, it - * can only operate on objects of - * type FE_Q(). + * can only operate on + * FiniteElementData objects + * inherent in FE_Q(). However, + * this function does not take a + * FE_Q object as it is also + * invoked by the FE_Q() + * constructor. * * It is assumed that the size of * the output argument already @@ -578,8 +583,8 @@ class FETools */ template static void - hierarchic_to_lexicographic_numbering (const FE_Q &fe, - std::vector &h2l); + hierarchic_to_lexicographic_numbering (const FiniteElementData &fe_data, + std::vector &h2l); /** * This is the reverse function @@ -592,8 +597,8 @@ class FETools */ template static void - lexicographic_to_hierarchic_numbering (const FE_Q &fe, - std::vector &l2h); + lexicographic_to_hierarchic_numbering (const FiniteElementData &fe_data, + std::vector &l2h); /** * Given a name in the form which diff --git a/deal.II/deal.II/source/fe/fe_tools.cc b/deal.II/deal.II/source/fe/fe_tools.cc index 3d0d6198a4..f38b1c24a6 100644 --- a/deal.II/deal.II/source/fe/fe_tools.cc +++ b/deal.II/deal.II/source/fe/fe_tools.cc @@ -1073,7 +1073,7 @@ void FETools::extrapolate(const DoFHandler &dof1, template void -FETools::hierarchic_to_lexicographic_numbering (const FE_Q &fe, +FETools::hierarchic_to_lexicographic_numbering (const FiniteElementData &fe, std::vector &h2l) { Assert (fe.n_components() == 1, ExcInvalidFE()); @@ -1233,8 +1233,8 @@ FETools::hierarchic_to_lexicographic_numbering (const FE_Q &fe, template void -FETools::lexicographic_to_hierarchic_numbering (const FE_Q &fe, - std::vector &l2h) +FETools::lexicographic_to_hierarchic_numbering (const FiniteElementData &fe, + std::vector &l2h) { // note: this function does the // reverse operation of the @@ -2078,13 +2078,13 @@ void FETools::extrapolate template void FETools::hierarchic_to_lexicographic_numbering -(const FE_Q &fe, - std::vector &h2l); +(const FiniteElementData &fe, + std::vector &h2l); template void FETools::lexicographic_to_hierarchic_numbering -(const FE_Q &fe, - std::vector &h2l); +(const FiniteElementData &fe, + std::vector &h2l); template FiniteElement *