From: kanschat Date: Mon, 8 Aug 2011 10:41:19 +0000 (+0000) Subject: use Polynomials::LagrangeEquidistant X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=8fc8cab4cb78ef8c3380c48b23ea612b5d8c57a8;p=dealii-svn.git use Polynomials::LagrangeEquidistant git-svn-id: https://svn.dealii.org/trunk@24030 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/include/deal.II/fe/fe_face.h b/deal.II/include/deal.II/fe/fe_face.h index 1e4f0fa7b3..d6bda39f22 100644 --- a/deal.II/include/deal.II/fe/fe_face.h +++ b/deal.II/include/deal.II/fe/fe_face.h @@ -1,7 +1,7 @@ //--------------------------------------------------------------------------- // $Id$ // -// Copyright (C) 2009, 2010 by the deal.II authors +// Copyright (C) 2009, 2010, 2011 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -20,15 +20,27 @@ DEAL_II_NAMESPACE_OPEN /** - * @warning This class has not been tested - * * A finite element, which is a tensor product polynomial on each face - * and undefined in the interior of the cells. + * and undefined in the interior of the cells. The basis functions on + * the faces are from Polynomials::LagrangeEquidistant * * This finite element is the trace space of FE_RaviartThomas on the * faces and serves in hybridized methods. * - * @author Guido Kanschat, 2009 + * @note Since these are only finite elements on faces, only + * FEFaceValues and FESubfaceValues will be able to extract reasonable + * values from any face polynomial. In order to make the use of + * FESystem simpler, FEValues objects will not fail using this finite + * element space, but all shape function values extracted will equal + * to zero. + * + * @todo Polynomials::LagrangeEquidistant should be and will be + * replaced by Polynomials::LagrangeGaussLobatto as soon as such a + * polynomial set exists. + * + * @ingroup fe + * @author Guido Kanschat + * @date 2009, 2011 */ template class FE_FaceQ : public FE_PolyFace, dim, spacedim> diff --git a/deal.II/source/fe/fe_face.cc b/deal.II/source/fe/fe_face.cc index 13c1f4dc5e..248163be00 100644 --- a/deal.II/source/fe/fe_face.cc +++ b/deal.II/source/fe/fe_face.cc @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2009 by the deal.II authors +// Copyright (C) 2009, 2011 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -21,7 +21,7 @@ template FE_FaceQ::FE_FaceQ (const unsigned int degree) : FE_PolyFace, dim, spacedim> ( - TensorProductPolynomials(Polynomials::Legendre::generate_complete_basis(degree)), + TensorProductPolynomials(Polynomials::LagrangeEquidistant::generate_complete_basis(degree)), FiniteElementData(get_dpo_vector(degree), 1, degree, FiniteElementData::L2), std::vector(1,true)) {}