From a7e2963f31b691ef4df835fd3a96ec2da40cf597 Mon Sep 17 00:00:00 2001 From: bangerth Date: Sat, 4 Aug 2012 21:40:00 +0000 Subject: [PATCH] More links into the glossary. git-svn-id: https://svn.dealii.org/trunk@25749 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/include/deal.II/fe/fe.h | 8 ++++++++ deal.II/include/deal.II/fe/fe_abf.h | 5 +++++ deal.II/include/deal.II/fe/fe_bdm.h | 2 ++ deal.II/include/deal.II/fe/fe_dg_vector.h | 3 +++ deal.II/include/deal.II/fe/fe_nedelec.h | 3 +++ deal.II/include/deal.II/fe/fe_raviart_thomas.h | 6 ++++++ 6 files changed, 27 insertions(+) diff --git a/deal.II/include/deal.II/fe/fe.h b/deal.II/include/deal.II/fe/fe.h index cd900b3507..63ebb18a03 100644 --- a/deal.II/include/deal.II/fe/fe.h +++ b/deal.II/include/deal.II/fe/fe.h @@ -288,6 +288,8 @@ namespace hp * FETools::compute_node_matrix(). It relies on the existence of * #generalized_support_points and implementation of interpolate() * with VectorSlice argument. + * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points" + * for more information. * * The piece of code in the constructor of a finite element * responsible for this looks like @@ -1755,6 +1757,9 @@ class FiniteElement : public Subscriptor, /** * Return a support point vector * for generalized interpolation. + * + * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points" + * for more information. */ const std::vector > & get_generalized_support_points () const; @@ -1765,6 +1770,9 @@ class FiniteElement : public Subscriptor, * vectors either from * get_unit_support_points() or * get_generalized_support_points(). + * + * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points" + * for more information. */ bool has_generalized_support_points () const; diff --git a/deal.II/include/deal.II/fe/fe_abf.h b/deal.II/include/deal.II/fe/fe_abf.h index 4513bdd891..9bf152acfb 100644 --- a/deal.II/include/deal.II/fe/fe_abf.h +++ b/deal.II/include/deal.II/fe/fe_abf.h @@ -88,6 +88,8 @@ template class MappingQ; * sufficient accuracy. The points needed are those of * QGaussk+1 on each face as well as QGaussk in * the interior of the cell (or none for RT0). + * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points" + * for more information. * * * @author Oliver Kayser-Herold, 2006, based on previous work @@ -171,6 +173,9 @@ class FE_ABF : public FE_PolyTensor, dim> * (#boundary_weights and * #interior_weights). Called * from the constructor. + * + * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points" + * for more information. */ void initialize_support_points (const unsigned int rt_degree); diff --git a/deal.II/include/deal.II/fe/fe_bdm.h b/deal.II/include/deal.II/fe/fe_bdm.h index 152af7ee98..885af7af8f 100644 --- a/deal.II/include/deal.II/fe/fe_bdm.h +++ b/deal.II/include/deal.II/fe/fe_bdm.h @@ -110,6 +110,8 @@ class FE_BDM * and FiniteElement::generalized_face_support_points * fields. Called from the * constructor. + * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points" + * for more information. */ void initialize_support_points (const unsigned int rt_degree); /** diff --git a/deal.II/include/deal.II/fe/fe_dg_vector.h b/deal.II/include/deal.II/fe/fe_dg_vector.h index 132f551ecf..2cba994788 100644 --- a/deal.II/include/deal.II/fe/fe_dg_vector.h +++ b/deal.II/include/deal.II/fe/fe_dg_vector.h @@ -116,6 +116,9 @@ class FE_DGVector * class and fill the tables with * @p interior_weights. Called * from the constructor. + * + * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points" + * for more information. */ void initialize_support_points (const unsigned int degree); diff --git a/deal.II/include/deal.II/fe/fe_nedelec.h b/deal.II/include/deal.II/fe/fe_nedelec.h index 7874f62358..aef972339b 100644 --- a/deal.II/include/deal.II/fe/fe_nedelec.h +++ b/deal.II/include/deal.II/fe/fe_nedelec.h @@ -392,6 +392,9 @@ class FE_Nedelec : public FE_PolyTensor, dim> * #generalized_face_support_points * when computing the * integration. + * + * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points" + * for more information. */ Table<2, double> boundary_weights; diff --git a/deal.II/include/deal.II/fe/fe_raviart_thomas.h b/deal.II/include/deal.II/fe/fe_raviart_thomas.h index 0302cc3202..525e7bcddf 100644 --- a/deal.II/include/deal.II/fe/fe_raviart_thomas.h +++ b/deal.II/include/deal.II/fe/fe_raviart_thomas.h @@ -252,6 +252,9 @@ class FE_RaviartThomas * face support point and one * column for each degree of * freedom on the face. + * + * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points" + * for more information. */ Table<2, double> boundary_weights; /** @@ -413,6 +416,9 @@ class FE_RaviartThomasNodal * and FiniteElement::generalized_face_support_points * fields. Called from the * constructor. + * + * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points" + * for more information. */ void initialize_support_points (const unsigned int rt_degree); }; -- 2.39.5