]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Rename add_new_points as get_new_points.
authorDavid Wells <wellsd2@rpi.edu>
Mon, 11 Sep 2017 02:52:27 +0000 (22:52 -0400)
committerDavid Wells <wellsd2@rpi.edu>
Mon, 11 Sep 2017 18:17:09 +0000 (14:17 -0400)
This function no longer appends new points to a vector so a name change is in
order.

include/deal.II/grid/manifold.h
include/deal.II/grid/manifold_lib.h
source/fe/mapping_q_generic.cc
source/grid/manifold.cc
source/grid/manifold_lib.cc

index 8febab05471adb3cacf60c78d9e9d7256018ec75..64e12e0f434b0d03822ddb5f1d498a5fe89ccb91 100644 (file)
@@ -419,7 +419,7 @@ public:
    */
   virtual
   void
-  add_new_points (const ArrayView<const Point<spacedim>> &surrounding_points,
+  get_new_points (const ArrayView<const Point<spacedim>> &surrounding_points,
                   const Table<2,double>                  &weights,
                   ArrayView<Point<spacedim>>              new_points) const;
 
@@ -738,7 +738,7 @@ public:
    */
   virtual
   void
-  add_new_points (const ArrayView<const Point<spacedim>> &surrounding_points,
+  get_new_points (const ArrayView<const Point<spacedim>> &surrounding_points,
                   const Table<2,double>                  &weights,
                   ArrayView<Point<spacedim>>              new_points) const override;
 
@@ -964,7 +964,7 @@ public:
    */
   virtual
   void
-  add_new_points (const ArrayView<const Point<spacedim>> &surrounding_points,
+  get_new_points (const ArrayView<const Point<spacedim>> &surrounding_points,
                   const Table<2,double>                  &weights,
                   ArrayView<Point<spacedim>>              new_points) const override;
   /**
index 23346d4147a178a0e521d44f0349fe1a9d48517c..6af780a6d0c8da5d2d866e6ec0367f54bf520848 100644 (file)
@@ -619,7 +619,7 @@ private:
  * the case for PolarManifold but not for Spherical manifold, so be careful
  * when using the latter. In case the quality of the manifold is not good
  * enough, upon mesh refinement it may happen that the transformation to a
- * chart inside the get_new_point() or add_new_points() methods produces
+ * chart inside the get_new_point() or get_new_points() methods produces
  * points that are outside the unit cell. Then this class throws an exception
  * of type Mapping::ExcTransformationFailed. In that case, the mesh should be
  * refined before attaching this class, as done in the following example:
@@ -721,7 +721,7 @@ public:
    */
   virtual
   void
-  add_new_points (const ArrayView<const Point<spacedim>> &surrounding_points,
+  get_new_points (const ArrayView<const Point<spacedim>> &surrounding_points,
                   const Table<2,double>                  &weights,
                   ArrayView<Point<spacedim>>              new_points) const override;
 
index 4a3987ffb4b492ad0f1b8a523c102cd188a143c9..653d9d0c65de146d07c9e3127f81287dae7d65f3 100644 (file)
@@ -3821,7 +3821,7 @@ add_line_support_points (const typename Triangulation<dim,spacedim>::cell_iterat
               const std::size_t n_rows = support_point_weights_perimeter_to_interior[0].size(0);
               a.resize(a.size() + n_rows);
               auto a_view = make_array_view(a.end() - n_rows, a.end());
-              manifold.add_new_points(make_array_view(vertices.begin(),
+              manifold.get_new_points(make_array_view(vertices.begin(),
                                                       vertices.end()),
                                       support_point_weights_perimeter_to_interior[0],
                                       a_view);
@@ -3916,7 +3916,7 @@ add_quad_support_points(const Triangulation<3,3>::cell_iterator &cell,
           const std::size_t n_rows = support_point_weights_perimeter_to_interior[1].size(0);
           a.resize(a.size() + n_rows);
           auto a_view = make_array_view(a.end() - n_rows, a.end());
-          face->get_manifold().add_new_points (make_array_view(tmp_points.begin(),
+          face->get_manifold().get_new_points (make_array_view(tmp_points.begin(),
                                                                tmp_points.end()),
                                                support_point_weights_perimeter_to_interior[1],
                                                a_view);
@@ -3959,7 +3959,7 @@ add_quad_support_points(const Triangulation<2,3>::cell_iterator &cell,
       const std::size_t n_rows = weights.size(0);
       a.resize(a.size() + n_rows);
       auto a_view = make_array_view(a.end() - n_rows, a.end());
-      cell->get_manifold().add_new_points(make_array_view(vertices.begin(),
+      cell->get_manifold().get_new_points(make_array_view(vertices.begin(),
                                                           vertices.end()),
                                           weights,
                                           a_view);
@@ -4016,7 +4016,7 @@ compute_mapping_support_points(const typename Triangulation<dim,spacedim>::cell_
           const std::size_t n_rows = support_point_weights_cell.size(0);
           a.resize(a.size() + n_rows);
           auto a_view = make_array_view(a.end() - n_rows, a.end());
-          cell->get_manifold().add_new_points(make_array_view(a.begin(),
+          cell->get_manifold().get_new_points(make_array_view(a.begin(),
                                                               a.end() - n_rows),
                                               support_point_weights_cell,
                                               a_view);
@@ -4040,7 +4040,7 @@ compute_mapping_support_points(const typename Triangulation<dim,spacedim>::cell_
                 const std::size_t n_rows = support_point_weights_perimeter_to_interior[1].size(0);
                 a.resize(a.size() + n_rows);
                 auto a_view = make_array_view(a.end() - n_rows, a.end());
-                cell->get_manifold().add_new_points(make_array_view(a.begin(),
+                cell->get_manifold().get_new_points(make_array_view(a.begin(),
                                                                     a.end() - n_rows),
                                                     support_point_weights_perimeter_to_interior[1],
                                                     a_view);
@@ -4057,7 +4057,7 @@ compute_mapping_support_points(const typename Triangulation<dim,spacedim>::cell_
               const std::size_t n_rows = support_point_weights_perimeter_to_interior[2].size(0);
               a.resize(a.size() + n_rows);
               auto a_view = make_array_view(a.end() - n_rows, a.end());
-              cell->get_manifold().add_new_points(make_array_view(a.begin(),
+              cell->get_manifold().get_new_points(make_array_view(a.begin(),
                                                                   a.end() - n_rows),
                                                   support_point_weights_perimeter_to_interior[2],
                                                   a_view);
index c455a8a75992b60181a14b6cf74d482c9d567c8b..19940e1c068e476d5b9aeb310876159ed3b9dd06 100644 (file)
@@ -116,7 +116,7 @@ get_new_point (const ArrayView<const Point<spacedim>> &surrounding_points,
 template <int dim, int spacedim>
 void
 Manifold<dim, spacedim>::
-add_new_points (const ArrayView<const Point<spacedim>> &surrounding_points,
+get_new_points (const ArrayView<const Point<spacedim>> &surrounding_points,
                 const Table<2,double>                  &weights,
                 ArrayView<Point<spacedim>>              new_points) const
 {
@@ -573,7 +573,7 @@ get_new_point (const ArrayView<const Point<spacedim>> &surrounding_points,
 template <int dim, int spacedim>
 void
 FlatManifold<dim, spacedim>::
-add_new_points (const ArrayView<const Point<spacedim>> &surrounding_points,
+get_new_points (const ArrayView<const Point<spacedim>> &surrounding_points,
                 const Table<2,double>                  &weights,
                 ArrayView<Point<spacedim>>              new_points) const
 {
@@ -731,7 +731,7 @@ get_new_point (const ArrayView<const Point<spacedim>> &surrounding_points,
 template <int dim, int spacedim, int chartdim>
 void
 ChartManifold<dim,spacedim,chartdim>::
-add_new_points (const ArrayView<const Point<spacedim>> &surrounding_points,
+get_new_points (const ArrayView<const Point<spacedim>> &surrounding_points,
                 const Table<2,double>                  &weights,
                 ArrayView<Point<spacedim>>              new_points) const
 {
@@ -745,7 +745,7 @@ add_new_points (const ArrayView<const Point<spacedim>> &surrounding_points,
     chart_points[i] = pull_back(surrounding_points[i]);
 
   boost::container::small_vector<Point<chartdim>, 200> new_points_on_chart(weights.size(0));
-  sub_manifold.add_new_points(make_array_view(chart_points.begin(),
+  sub_manifold.get_new_points(make_array_view(chart_points.begin(),
                                               chart_points.end()),
                               weights,
                               make_array_view(new_points_on_chart.begin(),
index fd8c68c321e2c6c836981c1e5e56124711b1304a..7de1cede1a3e7d31f56535d1ee61eb5c3002c6eb 100644 (file)
@@ -1146,7 +1146,7 @@ TransfiniteInterpolationManifold<dim, spacedim>
 template <int dim, int spacedim>
 void
 TransfiniteInterpolationManifold<dim,spacedim>::
-add_new_points (const ArrayView<const Point<spacedim>> &surrounding_points,
+get_new_points (const ArrayView<const Point<spacedim>> &surrounding_points,
                 const Table<2,double>                  &weights,
                 ArrayView<Point<spacedim> >             new_points) const
 {
@@ -1159,7 +1159,7 @@ add_new_points (const ArrayView<const Point<spacedim>> &surrounding_points,
   const auto cell = compute_chart_points(surrounding_points, chart_points_view);
 
   boost::container::small_vector<Point<dim>, 100> new_points_on_chart(weights.size(0));
-  chart_manifold.add_new_points(chart_points_view,
+  chart_manifold.get_new_points(chart_points_view,
                                 weights,
                                 make_array_view(new_points_on_chart.begin(),
                                                 new_points_on_chart.end()));

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.