]> https://gitweb.dealii.org/ - dealii.git/commitdiff
unit removed from support point function
authorGuido Kanschat <dr.guido.kanschat@gmail.com>
Mon, 17 Oct 2005 05:28:43 +0000 (05:28 +0000)
committerGuido Kanschat <dr.guido.kanschat@gmail.com>
Mon, 17 Oct 2005 05:28:43 +0000 (05:28 +0000)
git-svn-id: https://svn.dealii.org/trunk@11605 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/deal.II/include/fe/fe_raviart_thomas.h
deal.II/deal.II/source/fe/fe_raviart_thomas.cc
deal.II/deal.II/source/fe/fe_raviart_thomas_nodal.cc

index 9adc531bd2c003beff888dbf0d116babc1de60dc..6b50cae56b51e5a4e8c102c54cbad813cd52cbe4 100644 (file)
@@ -443,7 +443,7 @@ class FE_RaviartThomas : public FiniteElement<dim>
                                      * class. Called from the
                                      * constructor.
                                      */
-    void initialize_unit_support_points ();
+    void initialize_support_points (const unsigned int rt_degree);
 
                                     /**
                                      * Initialize the
@@ -452,8 +452,7 @@ class FE_RaviartThomas : public FiniteElement<dim>
                                      * class. Called from the
                                      * constructor.
                                      */
-    void initialize_unit_face_support_points ();
-    
+    void initialize_face_support_points ();
                                     /**
                                      * Given a set of flags indicating
                                      * what quantities are requested
@@ -663,20 +662,12 @@ class FE_RaviartThomasNodal
     get_ria_vector (const unsigned int degree);
                                     /**
                                      * Initialize the
-                                     * FiniteElement<dim>::unit_support_points
-                                     * and FiniteElement<dim>::unit_face_support_points
+                                     * FiniteElement<dim>::generalized_support_points
+                                     * and FiniteElement<dim>::generalized_face_support_points
                                      * fields. Called from the
                                      * constructor.
                                      */
-    void initialize_unit_support_points (const unsigned int degree);
-
-                                    /**
-                                     * Initialize the
-                                     * #inverse_node_matrix
-                                     * field. Called from the
-                                     * constructor.
-                                     */
-    void initialize_node_matrix ();
+    void initialize_support_points (const unsigned int rt_degree);
 };
 
 
@@ -687,7 +678,7 @@ class FE_RaviartThomasNodal
 #ifndef DOXYGEN
 
 template <>
-void FE_RaviartThomas<1>::initialize_unit_face_support_points ();
+void FE_RaviartThomas<1>::initialize_face_support_points ();
 
 template <>
 std::vector<unsigned int> FE_RaviartThomas<1>::get_dpo_vector (const unsigned int);
index 6becd13f1a0ab8228f76644cd7af99661dd7a8b0..28aeebe84cc3f611c4986b799072f175ec829f63 100644 (file)
@@ -167,8 +167,8 @@ FE_RaviartThomas<dim>::FE_RaviartThomas (const unsigned int rt_order)
 
                                   // finally fill in support points
                                   // on cell and face
-  initialize_unit_support_points ();
-  initialize_unit_face_support_points ();
+  initialize_support_points (rt_order);
+  initialize_face_support_points ();
 
                                    // then make
                                    // system_to_component_table
@@ -809,10 +809,21 @@ FE_RaviartThomas<3>::initialize_restriction ()
 #endif
 
 
+//TODO: Unit support points should go away according to new definition.
+
 template <int dim>
 void
-FE_RaviartThomas<dim>::initialize_unit_support_points ()
+FE_RaviartThomas<dim>::initialize_support_points (const unsigned int)
 {
+//   unsigned int n_face_points = (dim>1) ? 1 : 0;
+//                                // compute (deg+1)^(dim-1)
+//   for (unsigned int d=1;d<dim;++d)
+//     n_face_points *= deg+1;
+  
+//   this->unit_generalized_support_points.resize (this->dofs_per_cell);
+//   this->generalized_face_support_points.resize (this->dofs_per_face);
+  
+  
   this->unit_support_points.resize (this->dofs_per_cell);
   switch (dim) 
     {
@@ -893,7 +904,7 @@ FE_RaviartThomas<dim>::initialize_unit_support_points ()
 #if deal_II_dimension == 1
 
 template <>
-void FE_RaviartThomas<1>::initialize_unit_face_support_points ()
+void FE_RaviartThomas<1>::initialize_face_support_points ()
 {
                                   // no faces in 1d, so nothing to do
 }
@@ -902,7 +913,7 @@ void FE_RaviartThomas<1>::initialize_unit_face_support_points ()
 
 
 template <int dim>
-void FE_RaviartThomas<dim>::initialize_unit_face_support_points ()
+void FE_RaviartThomas<dim>::initialize_face_support_points ()
 {
   this->unit_face_support_points.resize (this->dofs_per_face);
 
index dcefd4fb678e6c93b1934b324355514ad000a2fe..54b3059ad5ce43487519437ee64e5382724917ba 100644 (file)
@@ -54,7 +54,7 @@ FE_RaviartThomasNodal<dim>::FE_RaviartThomasNodal (const unsigned int deg)
 
                                   // Set up the generalized support
                                   // points
-  initialize_unit_support_points (deg);
+  initialize_support_points (deg);
 
                                   //Now compute the inverse node
                                   //matrix, generating the correct
@@ -338,7 +338,7 @@ FE_RaviartThomasNodal<dim>::get_ria_vector (const unsigned int deg)
 
 template <int dim>
 void
-FE_RaviartThomasNodal<dim>::initialize_unit_support_points (const unsigned int deg)
+FE_RaviartThomasNodal<dim>::initialize_support_points (const unsigned int deg)
 {
   this->generalized_support_points.resize (this->dofs_per_cell);
   this->generalized_face_support_points.resize (this->dofs_per_face);
@@ -390,12 +390,4 @@ FE_RaviartThomasNodal<dim>::initialize_unit_support_points (const unsigned int d
 }
 
 
-template <int dim>
-void
-FE_RaviartThomasNodal<dim>::initialize_node_matrix ()
-{
-}
-
-
-
 template class FE_RaviartThomasNodal<deal_II_dimension>;

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.