]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Use more copydoc 9668/head
authorAlexander Grayver <agrayver@erdw.ethz.ch>
Fri, 20 Mar 2020 09:15:08 +0000 (10:15 +0100)
committerAlexander Grayver <agrayver@erdw.ethz.ch>
Fri, 20 Mar 2020 09:15:08 +0000 (10:15 +0100)
contrib/python-bindings/include/cell_accessor_wrapper.h
contrib/python-bindings/include/mapping_wrapper.h
contrib/python-bindings/include/point_wrapper.h
contrib/python-bindings/include/quadrature_wrapper.h
contrib/python-bindings/include/tria_accessor_wrapper.h

index 91ceb2e312851d843dfce49bb1581cea2803eec2..a1338d6464eddc2845c4e1c6e824cad542209e79 100644 (file)
@@ -71,39 +71,33 @@ namespace python
     std::string
     get_refine_flag() const;
 
-    /**
-     * Set the coarsen flag to true or false.
+    /*! @copydoc CellAccessor::set_coarsen_flag
      */
     void
     set_coarsen_flag(const bool coarsen_flag);
 
-    /**
-     * Get the coarsen flag.
+    /*! @copydoc CellAccessor::coarsen_flag_set
      */
     bool
     get_coarsen_flag() const;
 
-    /**
-     * Get the barycenter of the cell.
+    /*! @copydoc TriaAccessor::barycenter
      */
     PointWrapper
     get_barycenter() const;
 
-    /**
-     * Get the center of the cell.
+    /*! @copydoc TriaAccessor::center
      */
     PointWrapper
     get_center(const bool respect_manifold             = false,
                const bool interpolate_from_surrounding = false) const;
 
-    /**
-     * Set the material id.
+    /*! @copydoc CellAccessor::set_material_id
      */
     void
     set_material_id(const int material_id);
 
-    /**
-     * Get the material id.
+    /*! @copydoc CellAccessor::material_id
      */
     int
     get_material_id() const;
@@ -114,50 +108,37 @@ namespace python
     void
     set_vertex(const int i, PointWrapper &point_wrapper);
 
-    /**
-     * Return the ith vertex of the cell.
+    /*! @copydoc TriaAccessor::vertex
      */
     PointWrapper
     get_vertex(const int i) const;
 
-    /**
-     * Set the manifold id.
+    /*! @copydoc TriaAccessor::set_manifold_id
      */
     void
     set_manifold_id(const int manifold_id);
 
-    /**
-     * Get the manifold id.
+    /*! @copydoc TriaAccessor::manifold_id
      */
     int
     get_manifold_id() const;
 
-    /**
-     * Do as set_manifold_id() but also set the manifold indicators of
-     * the objects that bound the current object.
+    /*! @copydoc TriaAccessor::set_all_manifold_ids
      */
     void
     set_all_manifold_ids(const int manifold_id);
 
-    /**
-     * Return the ith neighbor of a cell. If the neighbor does not exist,
-     * i.e., if the ith face of the current object is at the boundary,
-     * then an exception is thrown.
+    /*! @copydoc CellAccessor::neighbor
      */
     CellAccessorWrapper
     neighbor(const int i) const;
 
-    /**
-     * Return whether the cell is at the boundary.
+    /*! @copydoc CellAccessor::at_boundary
      */
     bool
     at_boundary() const;
 
-    /**
-     * This is a slight variation to the at_boundary function:
-     * for 2 dimensions it is equivalent, for three
-     * dimensions it returns whether at least one of the 12
-     * lines of the hexahedron is at a boundary.
+    /*! @copydoc CellAccessor::has_boundary_lines
      */
     bool
     has_boundary_lines() const;
@@ -168,55 +149,37 @@ namespace python
     boost::python::list
     faces() const;
 
-    /**
-     * Compute the dim-dimensional measure of the object.
-     * For a dim-dimensional cell in dim-dimensional space,
-     * this equals its volume. On the other hand, for a 2d
-     * cell in 3d space, or if the current object pointed to
-     * is a 2d face of a 3d cell in 3d space, then the function
-     * computes the area the object occupies. For a
-     * one-dimensional object, return its length.
+    /*! @copydoc TriaAccessor::measure
      */
     double
     measure() const;
 
-    /**
-     * Test whether the cell has children (this is the criterion for activity of
-     * a cell).
+    /*! @copydoc CellAccessor::active
      */
     bool
     active() const;
 
-    /**
-     * Return the level within the mesh hierarchy at which this cell is
-     * located.
+    /*! @copydoc TriaAccessor::level
      */
     int
     level() const;
 
-    /**
-     * Return the index of the element presently pointed to on the present
-     * level.
+    /*! @copydoc TriaAccessor::index
      */
     int
     index() const;
 
-    /**
-     * Return whether the neighbor is coarser then the present cell.
+    /*! @copydoc CellAccessor::neighbor_is_coarser
      */
     bool
     neighbor_is_coarser(const unsigned int neighbor) const;
 
-    /**
-     * Return the how-many'th neighbor this cell is of cell->neighbor(neighbor),
-     * i.e. return the face_no such that
-     * cell->neighbor(neighbor)->neighbor(face_no)==cell.
+    /*! @copydoc CellAccessor::neighbor_of_neighbor
      */
     unsigned int
     neighbor_of_neighbor(const unsigned int neighbor) const;
 
-    /**
-     * Return the global index of i-th vertex of a cell.
+    /*! @copydoc TriaAccessor::vertex_index
      */
     unsigned int
     vertex_index(const unsigned int i) const;
index e892cd0c942d5abad8fd47d93bbbb8a7fc3cede2..2d3316f88237608ea2da0eacac603426a23b060c 100644 (file)
@@ -52,27 +52,17 @@ namespace python
      */
     ~MappingQGenericWrapper();
 
-    /**
-     * Map the point p on the unit cell to the corresponding point on the real
-     * cell.
+    /*! @copydoc Mapping::transform_unit_to_real_cell
      */
     PointWrapper
     transform_unit_to_real_cell(CellAccessorWrapper &cell, PointWrapper &point);
 
-    /**
-     * Map the point p on the real cell to the corresponding point on the unit
-     * cell.
+    /*! @copydoc Mapping::transform_real_to_unit_cell
      */
     PointWrapper
     transform_real_to_unit_cell(CellAccessorWrapper &cell, PointWrapper &point);
 
-    /**
-     * Transform the point on the real cell to the corresponding point on the
-     * unit cell, and then projects it to a dim-1 point on the face with the
-     * given face number 'face_no'. Ideally the point 'point' is near the
-     * face 'face_no', but any point in the cell can technically be projected.
-     * The returned point is of dimension dim with dim-1 coodinate value
-     * explicitly set to zero.
+    /*! @copydoc Mapping::project_real_point_to_unit_point_on_face
      */
     PointWrapper
     project_real_point_to_unit_point_on_face(CellAccessorWrapper &cell,
index 49b290fb9b958a1f9bbd405836e08ab3ee47f3dd..10b818544963bd3d786b8e76a73b15d37d87f2b9 100644 (file)
@@ -56,22 +56,17 @@ namespace python
      */
     ~PointWrapper();
 
-    /**
-     * Return the Euclidean distance of this point to the point p, i.e., the
-     * l2_norm of the difference between the vectors representing the two
-     * points.
+    /*! @copydoc Point::distance
      */
     double
     distance(const PointWrapper &p) const;
 
-    /**
-     * Return the l2_norm of the vector connecting the origin to the point.
+    /*! @copydoc Tensor::norm
      */
     double
     norm() const;
 
-    /**
-     * Return the sum of the absolute squares of all entries.
+    /*! @copydoc Tensor::norm_square
      */
     double
     norm_square() const;
@@ -97,7 +92,7 @@ namespace python
     operator!=(const PointWrapper &p) const;
 
     /**
-     * Test for equality of two tensors.
+     * Test for equality of two points.
      */
     bool
     operator==(const PointWrapper &p) const;
index 2e1a893448751b62603092d3fad99f171d9cda39..025521a86827f56ffe8efb229418846542d0ac3f 100644 (file)
@@ -56,14 +56,12 @@ namespace python
     void
     create_gauss_lobatto(const unsigned int n);
 
-    /**
-     * Return list of quadrature points.
+    /*! @copydoc Quadrature::get_points
      */
     boost::python::list
     get_points() const;
 
-    /**
-     * Return list of quadrature weights.
+    /*! @copydoc Quadrature::get_weights
      */
     boost::python::list
     get_weights() const;
index 71411552f3ca4ae2a2bd39589efde2fcd0ca99b4..9cb4b226866f45f4c3d8957febc2cebb23de1a16 100644 (file)
@@ -48,14 +48,12 @@ namespace python
      */
     ~TriaAccessorWrapper();
 
-    /**
-     * Get the barycenter of the cell.
+    /*! @copydoc TriaAccessor::barycenter
      */
     PointWrapper
     get_barycenter() const;
 
-    /**
-     * Get the center of the cell.
+    /*! @copydoc TriaAccessor::center
      */
     PointWrapper
     get_center(const bool respect_manifold             = false,
@@ -67,56 +65,42 @@ namespace python
     void
     set_vertex(const int i, PointWrapper &point_wrapper);
 
-    /**
-     * Return the ith vertex of the cell.
+    /*! @copydoc TriaAccessor::vertex
      */
     PointWrapper
     get_vertex(const int i) const;
 
-    /**
-     * Set the manifold id.
+    /*! @copydoc TriaAccessor::set_manifold_id
      */
     void
     set_manifold_id(const int manifold_id);
 
-    /**
-     * Get the manifold id.
+    /*! @copydoc TriaAccessor::manifold_id
      */
     int
     get_manifold_id() const;
 
-    /**
-     * Set the boundary id.
+    /*! @copydoc TriaAccessor::set_boundary_id
      */
     void
     set_boundary_id(const int boundary_id);
 
-    /**
-     * Get the boundary id.
+    /*! @copydoc TriaAccessor::boundary_id
      */
     int
     get_boundary_id() const;
 
-    /**
-     * Set the boundary id for all objects.
+    /*! @copydoc TriaAccessor::set_all_boundary_ids
      */
     void
     set_all_boundary_ids(const int boundary_id);
 
-    /**
-     * Return whether the cell is at the boundary.
+    /*! @copydoc TriaAccessor::at_boundary
      */
     bool
     at_boundary() const;
 
-    /**
-     * Compute the dim-dimensional measure of the object.
-     * For a dim-dimensional cell in dim-dimensional space,
-     * this equals its volume. On the other hand, for a 2d
-     * cell in 3d space, or if the current object pointed to
-     * is a 2d face of a 3d cell in 3d space, then the function
-     * computes the area the object occupies. For a
-     * one-dimensional object, return its length.
+    /*! @copydoc TriaAccessor::measure
      */
     double
     measure() 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.