]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove again quintic element, since it didn't worl in the first place, would not...
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Thu, 2 Jul 1998 17:52:50 +0000 (17:52 +0000)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Thu, 2 Jul 1998 17:52:50 +0000 (17:52 +0000)
git-svn-id: https://svn.dealii.org/trunk@432 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/deal.II/include/fe/fe_lib.lagrange.h

index ae8288027cb046c60eca63e41eab3c96322d41f9..d11198b085050528e3373dbe7da6efd4378df9e3 100644 (file)
@@ -604,160 +604,6 @@ class FEQuarticSub : public FiniteElement<dim> {
 
 
 
-/**
- * Define a (bi-, tri-, etc)quintic finite element in #dim# space dimensions.
- * A linear (subparametric) mapping from the unit cell
- * to the real cell is implemented.
- *
- * The numbering of degrees of freedom in one spatial dimension is as follows:
- * \begin{verbatim}
- *   0--2--3--4--5--1
- * \end{verbatim}
- *
- * The numbering of degrees of freedom in two spatial dimension is as follows:
- * \begin{verbatim}
- *   3--12-13-14-15-2
- *   |              |
- *   19 23 28 29 22 11
- *   |              |
- *   18 31 35 34 27 10
- *   |              |
- *   17 30 32 33 26 9
- *   |              |
- *   16 20 24 25 21 8
- *   |              |
- *   0--4--5--6---7-1
- * \end{verbatim}
- * Note the reverse ordering of degrees of freedom on the left and upper
- * line and the numbering of the interior degrees of
- * freedom.
- */
-template <int dim>
-class FEQuinticSub : public FiniteElement<dim> {
-  public:
-                                    /**
-                                     * Constructor
-                                     */
-    FEQuinticSub ();
-
-                                    /**
-                                     * Return the value of the #i#th shape
-                                     * function at point #p# on the unit cell.
-                                     */
-    virtual double shape_value(const unsigned int i,
-                              const Point<dim>& p) const;
-
-                                    /**
-                                     * Return the gradient of the #i#th shape
-                                     * function at point #p# on the unit cell.
-                                     */
-    virtual Point<dim> shape_grad(const unsigned int i,
-                                 const Point<dim>& p) const;
-
-                                    /**
-                                     * Refer to the base class for detailed
-                                     * information on this function.
-                                     *
-                                     * For one dimensional elements, this
-                                     * function simply passes through to
-                                     * the one implemented in the base class.
-                                     */
-    virtual void fill_fe_values (const DoFHandler<dim>::cell_iterator &cell,
-                                const vector<Point<dim> >            &unit_points,
-                                vector<dFMatrix>    &jacobians,
-                                const bool           compute_jacobians,
-                                vector<Point<dim> > &ansatz_points,
-                                const bool           compute_ansatz_points,
-                                vector<Point<dim> > &q_points,
-                                const bool           compute_q_points,
-                                const Boundary<dim> &boundary) const;
-
-                                    /**
-                                     * Refer to the base class for detailed
-                                     * information on this function.
-                                     */
-    virtual void get_ansatz_points (const DoFHandler<dim>::cell_iterator &cell,
-                                   const Boundary<dim> &boundary,
-                                   vector<Point<dim> > &ansatz_points) const;
-
-                                    /**
-                                     * Refer to the base class for detailed
-                                     * information on this function.
-                                     */
-    virtual void get_face_ansatz_points (const DoFHandler<dim>::face_iterator &face,
-                                        const Boundary<dim> &boundary,
-                                        vector<Point<dim> > &ansatz_points) const;
-
-                                    /**
-                                     * Refer to the base class for detailed
-                                     * information on this function.
-                                     */
-    virtual void get_face_jacobians (const DoFHandler<dim>::face_iterator &face,
-                                    const Boundary<dim>         &boundary,
-                                    const vector<Point<dim-1> > &unit_points,
-                                    vector<double>      &face_jacobi_determinants) const;
-
-                                    /**
-                                     * Refer to the base class for detailed
-                                     * information on this function.
-                                     */
-    virtual void get_subface_jacobians (const DoFHandler<dim>::face_iterator &face,
-                                       const unsigned int           subface_no,
-                                       const vector<Point<dim-1> > &unit_points,
-                                       vector<double>      &face_jacobi_determinants) const;
-
-                                    /**
-                                     * Refer to the base class for detailed
-                                     * information on this function.
-                                     */
-    virtual void get_normal_vectors (const DoFHandler<dim>::cell_iterator &cell,
-                                    const unsigned int          face_no,
-                                    const Boundary<dim>         &boundary,
-                                    const vector<Point<dim-1> > &unit_points,
-                                    vector<Point<dim> >         &normal_vectors) const;    
-
-                                    /**
-                                     * Refer to the base class for detailed
-                                     * information on this function.
-                                     */
-    virtual void get_normal_vectors (const DoFHandler<dim>::cell_iterator &cell,
-                                    const unsigned int           subface_no,
-                                    const unsigned int           face_no,
-                                    const vector<Point<dim-1> > &unit_points,
-                                    vector<Point<dim> >         &normal_vectors) const;    
-
-                                    /**
-                                     * Refer to the base class for detailed
-                                     * information on this function.
-                                     */
-    virtual void get_local_mass_matrix (const DoFHandler<dim>::cell_iterator &cell,
-                                       const Boundary<dim> &boundary,
-                                       dFMatrix &local_mass_matrix) const;
-
-  private:
-                                    /**
-                                     * Return the value of the #i#th shape
-                                     * function at point #p# on the unit cell.
-                                     * Here, the (bi-)linear basis functions
-                                     * are meant, which are used for the
-                                     * computation of the transformation from
-                                     * unit cell to real space cell.
-                                     */
-    double linear_shape_value(const unsigned int i,
-                             const Point<dim>& p) const;
-
-                                    /**
-                                     * Return the gradient of the #i#th shape
-                                     * function at point #p# on the unit cell.
-                                     * Here, the (bi-)linear basis functions
-                                     * are meant, which are used for the
-                                     * computation of the transformation from
-                                     * unit cell to real space cell.
-                                     */
-    Point<dim> linear_shape_grad(const unsigned int i,
-                                const Point<dim>& p) const;
-};
-
 
 
 

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.