From 67f89af12ca5c859546689fa34b13dac2d6cb1b6 Mon Sep 17 00:00:00 2001 From: guido Date: Tue, 4 May 1999 16:27:13 +0000 Subject: [PATCH] regular names for FEDG git-svn-id: https://svn.dealii.org/trunk@1267 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/deal.II/include/fe/fe_lib.dg.h | 49 ++++++++++--------- deal.II/deal.II/source/fe/fe_lib.dg.cc | 40 +++++++-------- .../deal.II/source/fe/fe_lib.dg.constant.cc | 24 ++++----- 3 files changed, 59 insertions(+), 54 deletions(-) diff --git a/deal.II/deal.II/include/fe/fe_lib.dg.h b/deal.II/deal.II/include/fe/fe_lib.dg.h index 03b996dc34..821f8975f3 100644 --- a/deal.II/deal.II/include/fe/fe_lib.dg.h +++ b/deal.II/deal.II/include/fe/fe_lib.dg.h @@ -8,6 +8,11 @@ #include +#define FEDGConstant FEDG_Q0 +#define FEDGLinear FEDG_Q1 +#define FEDGQuadraticSub FEDG_Q2 +#define FEDGCubicSub FEDG_Q3 +#define FEDGQuarticSub FEDG_Q4 /** * Define a constant discontinuous finite element in #dim# @@ -16,12 +21,12 @@ * @author Ralf Hartmann, 1998 */ template -class FEDGConstant : public FELinearMapping { +class FEDG_Q0 : public FELinearMapping { public: /** * Constructor */ - FEDGConstant (); + FEDG_Q0 (); /** * Return the value of the #i#th shape @@ -104,9 +109,9 @@ class FEDGConstant : public FELinearMapping { * * * This class is derived from and provides substantially the same - * as the #FELinear# class. The only difference is the new constructor that - * calls #FELinear::FELinear(const int)#, the protected constructor of the - * #FELinear# class using a #FiniteElement# with no dofs in the vertices and + * as the #FEQ1# class. The only difference is the new constructor that + * calls #FEQ1::FEQ1(const int)#, the protected constructor of the + * #FEQ1# class using a #FiniteElement# with no dofs in the vertices and * $2^d$ dofs per cell. As now the cells do not share any vertex-dof with * a neighboring cell the $2^d$ dofs per cell can be choosen independently not * needing any constraints and allowing the use of discontinuous Galerkin @@ -118,12 +123,12 @@ class FEDGConstant : public FELinearMapping { * @author Ralf Hartmann, 1998 */ template -class FEDGLinear : public FELinear{ +class FEDG_Q1 : public FEQ1{ public: /** * Constructor */ - FEDGLinear(); + FEDG_Q1(); /** * Refer to the base class for detailed @@ -150,9 +155,9 @@ class FEDGLinear : public FELinear{ * unit cell to the real cell allowing discontinuous Galerkin methods. * * This class is derived from and provides substantially the same - * as the #FEQuadraticSub# class. The only difference is the new constructor that - * calls #FEQuadraticSub::FEQuadraticSub(const int)#, the protected constructor of the - * #FEQuadraticSub# class using a #FiniteElement# with no dofs in the vertices, no dofs on the lines and + * as the #FEQ2# class. The only difference is the new constructor that + * calls #FEQ2::FEQ2(const int)#, the protected constructor of the + * #FEQ2# class using a #FiniteElement# with no dofs in the vertices, no dofs on the lines and * $3^d$ dofs per cell. As now the cells do not share any vertex-dof with * a neighboring cell the $3^d$ dofs per cell can be choosen independently not * needing any constraints and allowing the use of discontinuous Galerkin @@ -164,12 +169,12 @@ class FEDGLinear : public FELinear{ * @author Ralf Hartmann, 1998 */ template -class FEDGQuadraticSub : public FEQuadraticSub{ +class FEDG_Q2 : public FEQ2{ public: /** * Constructor */ - FEDGQuadraticSub(); + FEDG_Q2(); /** * Refer to the base class for detailed @@ -196,9 +201,9 @@ class FEDGQuadraticSub : public FEQuadraticSub{ * unit cell to the real cell allowing discontinuous Galerkin methods. * * This class is derived from and provides substantially the same - * as the #FECubicSub# class. The only difference is the new constructor that - * calls #FECubicSub::FECubicSub(const int)#, the protected constructor of the - * #FECubicSub# class using a #FiniteElement# with no dofs in the vertices, no dofs on the lines and + * as the #FEQ3# class. The only difference is the new constructor that + * calls #FEQ3::FEQ3(const int)#, the protected constructor of the + * #FEQ3# class using a #FiniteElement# with no dofs in the vertices, no dofs on the lines and * $4^d$ dofs per cell. As now the cells do not share any vertex-dof with * a neighboring cell the $4^d$ dofs per cell can be choosen independently not * needing any constraints and allowing the use of discontinuous Galerkin @@ -210,12 +215,12 @@ class FEDGQuadraticSub : public FEQuadraticSub{ * @author Ralf Hartmann, 1998 */ template -class FEDGCubicSub : public FECubicSub{ +class FEDG_Q3 : public FEQ3{ public: /** * Constructor */ - FEDGCubicSub(); + FEDG_Q3(); /** * Refer to the base class for detailed @@ -241,9 +246,9 @@ class FEDGCubicSub : public FECubicSub{ * unit cell to the real cell allowing discontinuous Galerkin methods. * * This class is derived from and provides substantially the same - * as the #FEQuarticSub# class. The only difference is the new constructor that - * calls #FEQuarticSub::FEQuarticSub(const int)#, the protected constructor of the - * #FEQuarticSub# class using a #FiniteElement# with no dofs in the vertices, no dofs on the lines and + * as the #FEQ4# class. The only difference is the new constructor that + * calls #FEQ4::FEQ4(const int)#, the protected constructor of the + * #FEQ4# class using a #FiniteElement# with no dofs in the vertices, no dofs on the lines and * $5^d$ dofs per cell. As now the cells do not share any vertex-dof with * a neighboring cell the $5^d$ dofs per cell can be choosen independently not * needing any constraints and allowing the use of discontinuous Galerkin @@ -255,12 +260,12 @@ class FEDGCubicSub : public FECubicSub{ * @author Ralf Hartmann, 1998 */ template -class FEDGQuarticSub : public FEQuarticSub{ +class FEDG_Q4 : public FEQ4{ public: /** * Constructor */ - FEDGQuarticSub(); + FEDG_Q4(); /** * Refer to the base class for detailed diff --git a/deal.II/deal.II/source/fe/fe_lib.dg.cc b/deal.II/deal.II/source/fe/fe_lib.dg.cc index 4936b59682..a51421a299 100644 --- a/deal.II/deal.II/source/fe/fe_lib.dg.cc +++ b/deal.II/deal.II/source/fe/fe_lib.dg.cc @@ -6,29 +6,29 @@ template -FEDGLinear::FEDGLinear(): - FELinear(1) {}; +FEDG_Q1::FEDG_Q1(): + FEQ1(1) {}; template -FEDGQuadraticSub::FEDGQuadraticSub(): - FEQuadraticSub(1) {}; +FEDG_Q2::FEDG_Q2(): + FEQ2(1) {}; template -FEDGCubicSub::FEDGCubicSub(): - FECubicSub(1) {}; +FEDG_Q3::FEDG_Q3(): + FEQ3(1) {}; template -FEDGQuarticSub::FEDGQuarticSub(): - FEQuarticSub(1) {}; +FEDG_Q4::FEDG_Q4(): + FEQ4(1) {}; template void -FEDGLinear::get_face_support_points (const typename DoFHandler::face_iterator &, +FEDG_Q1::get_face_support_points (const typename DoFHandler::face_iterator &, vector > &support_points) const { Assert ((support_points.size() == 0), ExcWrongFieldDimension (support_points.size(),0)); @@ -37,7 +37,7 @@ FEDGLinear::get_face_support_points (const typename DoFHandler::face_i template const FullMatrix & -FEDGLinear::restrict (const unsigned int child) const { +FEDG_Q1::restrict (const unsigned int child) const { Assert (false, ExcNotImplemented()); return restriction[child]; }; @@ -46,7 +46,7 @@ FEDGLinear::restrict (const unsigned int child) const { template void -FEDGQuadraticSub::get_face_support_points (const typename DoFHandler::face_iterator &, +FEDG_Q2::get_face_support_points (const typename DoFHandler::face_iterator &, vector > &support_points) const { Assert ((support_points.size() == 0), ExcWrongFieldDimension (support_points.size(),0)); @@ -55,7 +55,7 @@ FEDGQuadraticSub::get_face_support_points (const typename DoFHandler:: template const FullMatrix & -FEDGQuadraticSub::restrict (const unsigned int child) const { +FEDG_Q2::restrict (const unsigned int child) const { Assert (false, ExcNotImplemented()); return restriction[child]; }; @@ -64,7 +64,7 @@ FEDGQuadraticSub::restrict (const unsigned int child) const { template void -FEDGCubicSub::get_face_support_points (const typename DoFHandler::face_iterator &, +FEDG_Q3::get_face_support_points (const typename DoFHandler::face_iterator &, vector > &support_points) const { Assert ((support_points.size() == 0), ExcWrongFieldDimension (support_points.size(),0)); @@ -73,7 +73,7 @@ FEDGCubicSub::get_face_support_points (const typename DoFHandler::face template const FullMatrix & -FEDGCubicSub::restrict (const unsigned int child) const { +FEDG_Q3::restrict (const unsigned int child) const { Assert (false, ExcNotImplemented()); return restriction[child]; }; @@ -83,7 +83,7 @@ FEDGCubicSub::restrict (const unsigned int child) const { template void -FEDGQuarticSub::get_face_support_points (const typename DoFHandler::face_iterator &, +FEDG_Q4::get_face_support_points (const typename DoFHandler::face_iterator &, vector > &support_points) const { Assert ((support_points.size() == 0), ExcWrongFieldDimension (support_points.size(),0)); @@ -92,7 +92,7 @@ FEDGQuarticSub::get_face_support_points (const typename DoFHandler::fa template const FullMatrix & -FEDGQuarticSub::restrict (const unsigned int child) const { +FEDG_Q4::restrict (const unsigned int child) const { Assert (false, ExcNotImplemented()); return restriction[child]; }; @@ -101,7 +101,7 @@ FEDGQuarticSub::restrict (const unsigned int child) const { // explicit instantiations -template class FEDGLinear; -template class FEDGQuadraticSub; -template class FEDGCubicSub; -template class FEDGQuarticSub; +template class FEDG_Q1; +template class FEDG_Q2; +template class FEDG_Q3; +template class FEDG_Q4; diff --git a/deal.II/deal.II/source/fe/fe_lib.dg.constant.cc b/deal.II/deal.II/source/fe/fe_lib.dg.constant.cc index 10ced322ca..700e54f419 100644 --- a/deal.II/deal.II/source/fe/fe_lib.dg.constant.cc +++ b/deal.II/deal.II/source/fe/fe_lib.dg.constant.cc @@ -13,7 +13,7 @@ #if deal_II_dimension == 1 template <> -FEDGConstant<1>::FEDGConstant () : +FEDG_Q0<1>::FEDG_Q0 () : FELinearMapping<1> (0, 1) { // for restriction and prolongation matrices: @@ -45,7 +45,7 @@ FEDGConstant<1>::FEDGConstant () : template <> void -FEDGConstant<1>::get_face_support_points (const typename DoFHandler<1>::face_iterator &, +FEDG_Q0<1>::get_face_support_points (const typename DoFHandler<1>::face_iterator &, vector > &) const { Assert (false, ExcInternalError()); }; @@ -58,7 +58,7 @@ FEDGConstant<1>::get_face_support_points (const typename DoFHandler<1>::face_ite #if deal_II_dimension == 2 template <> -FEDGConstant<2>::FEDGConstant () : +FEDG_Q0<2>::FEDG_Q0 () : FELinearMapping<2> (0, 0, 1) { // The restriction matrices got crazy values @@ -90,7 +90,7 @@ FEDGConstant<2>::FEDGConstant () : template inline double -FEDGConstant::shape_value (const unsigned int i, +FEDG_Q0::shape_value (const unsigned int i, const Point&) const { Assert((i::shape_value (const unsigned int i, template inline Tensor<1,dim> -FEDGConstant::shape_grad (const unsigned int i, +FEDG_Q0::shape_grad (const unsigned int i, const Point&) const { Assert((i::shape_grad (const unsigned int i, template inline Tensor<2,dim> -FEDGConstant::shape_grad_grad (const unsigned int i, +FEDG_Q0::shape_grad_grad (const unsigned int i, const Point &) const { Assert((i::shape_grad_grad (const unsigned int i, template -void FEDGConstant::get_local_mass_matrix (const DoFHandler::cell_iterator &cell, +void FEDG_Q0::get_local_mass_matrix (const DoFHandler::cell_iterator &cell, FullMatrix &local_mass_matrix) const { Assert (local_mass_matrix.n() == total_dofs, ExcWrongFieldDimension(local_mass_matrix.n(),total_dofs)); @@ -139,7 +139,7 @@ void FEDGConstant::get_local_mass_matrix (const DoFHandler::cell_itera template void -FEDGConstant::get_unit_support_points (vector > &unit_points) const { +FEDG_Q0::get_unit_support_points (vector > &unit_points) const { Assert (unit_points.size() == total_dofs, ExcWrongFieldDimension (unit_points.size(), total_dofs)); for (unsigned int d=0; d::get_unit_support_points (vector > &unit_points) co template void -FEDGConstant::get_support_points (const typename DoFHandler::cell_iterator &cell, +FEDG_Q0::get_support_points (const typename DoFHandler::cell_iterator &cell, vector > &support_points) const { Assert (support_points.size() == total_dofs, ExcWrongFieldDimension (support_points.size(), total_dofs)); @@ -160,7 +160,7 @@ FEDGConstant::get_support_points (const typename DoFHandler::cell_iter template void -FEDGConstant::get_face_support_points (const typename DoFHandler::face_iterator &, +FEDG_Q0::get_face_support_points (const typename DoFHandler::face_iterator &, vector > &support_points) const { Assert ((support_points.size() == 0), ExcWrongFieldDimension (support_points.size(),0)); @@ -170,7 +170,7 @@ FEDGConstant::get_face_support_points (const typename DoFHandler::face template const FullMatrix & -FEDGConstant::restrict (const unsigned int child) const { +FEDG_Q0::restrict (const unsigned int child) const { Assert (false, ExcNotImplemented()); return restriction[child]; }; @@ -179,4 +179,4 @@ FEDGConstant::restrict (const unsigned int child) const { // explicit instantiations -template class FEDGConstant; +template class FEDG_Q0; -- 2.39.5