]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Rename VectorTools::evaluate_at_points() -> VectorTools::point_values() 12332/head
authorPeter Munch <peterrmuench@gmail.com>
Fri, 28 May 2021 06:46:20 +0000 (08:46 +0200)
committerPeter Munch <peterrmuench@gmail.com>
Sun, 30 May 2021 05:17:51 +0000 (07:17 +0200)
doc/news/9.2.0-vs-9.3.0.h
include/deal.II/numerics/vector_tools_evaluate.h
tests/remote_point_evaluation/mapping_01.cc
tests/remote_point_evaluation/remote_point_evaluation_03.cc
tests/remote_point_evaluation/vector_tools_evaluate_at_points_01.cc
tests/remote_point_evaluation/vector_tools_evaluate_at_points_02.cc
tests/remote_point_evaluation/vector_tools_evaluate_at_points_03.cc
tests/remote_point_evaluation/vector_tools_evaluate_at_points_04.cc
tests/remote_point_evaluation/vector_tools_evaluate_at_points_05.cc

index b4f5417c55b53ec0723055f64365abd6ba25b5d9..c1bbd78d60e85ba6739a91411842c554fbcb3091 100644 (file)
@@ -518,7 +518,7 @@ inconvenience this causes.
 
  <li>
   New: The class Utilities::MPI::RemotePointEvaluation and the function
-  VectorTools::evaluate_at_points() allow to work on arbitrary distributed
+  VectorTools::point_values() allow to work on arbitrary distributed
   points.
   <br>
   (Peter Munch, Martin Kronbichler, Magdalena Schreter, Niklas Fehn, 2021/02/28)
index 8a1b1af150356100242e27d31c2c5cfc54f19b43..cde9f9508f719045ccd82ab07724ec5d0f58539a 100644 (file)
@@ -32,12 +32,12 @@ DEAL_II_NAMESPACE_OPEN
 namespace VectorTools
 {
   /**
-   * Namespace for the flags for evaluate_at_points().
+   * Namespace for the flags for point_values().
    */
   namespace EvaluationFlags
   {
     /**
-     * Flags for evaluate_at_points().
+     * Flags for point_values().
      */
     enum EvaluationFlags
     {
@@ -73,7 +73,7 @@ namespace VectorTools
    */
   template <int n_components, int dim, int spacedim, typename VectorType>
   std::vector<typename FEPointEvaluation<n_components, dim>::value_type>
-  evaluate_at_points(
+  point_values(
     const Mapping<dim> &                                  mapping,
     const DoFHandler<dim, spacedim> &                     dof_handler,
     const VectorType &                                    vector,
@@ -94,7 +94,7 @@ namespace VectorTools
    */
   template <int n_components, int dim, int spacedim, typename VectorType>
   std::vector<typename FEPointEvaluation<n_components, dim>::value_type>
-  evaluate_at_points(
+  point_values(
     const Utilities::MPI::RemotePointEvaluation<dim, spacedim> &cache,
     const DoFHandler<dim, spacedim> &                           dof_handler,
     const VectorType &                                          vector,
@@ -108,17 +108,16 @@ namespace VectorTools
 #ifndef DOXYGEN
   template <int n_components, int dim, int spacedim, typename VectorType>
   inline std::vector<typename FEPointEvaluation<n_components, dim>::value_type>
-  evaluate_at_points(
-    const Mapping<dim> &                                  mapping,
-    const DoFHandler<dim, spacedim> &                     dof_handler,
-    const VectorType &                                    vector,
-    const std::vector<Point<spacedim>> &                  evaluation_points,
-    Utilities::MPI::RemotePointEvaluation<dim, spacedim> &cache,
-    const EvaluationFlags::EvaluationFlags                flags)
+  point_values(const Mapping<dim> &                mapping,
+               const DoFHandler<dim, spacedim> &   dof_handler,
+               const VectorType &                  vector,
+               const std::vector<Point<spacedim>> &evaluation_points,
+               Utilities::MPI::RemotePointEvaluation<dim, spacedim> &cache,
+               const EvaluationFlags::EvaluationFlags                flags)
   {
     cache.reinit(evaluation_points, dof_handler.get_triangulation(), mapping);
 
-    return evaluate_at_points<n_components>(cache, dof_handler, vector, flags);
+    return point_values<n_components>(cache, dof_handler, vector, flags);
   }
 
 
@@ -184,7 +183,7 @@ namespace VectorTools
 
   template <int n_components, int dim, int spacedim, typename VectorType>
   inline std::vector<typename FEPointEvaluation<n_components, dim>::value_type>
-  evaluate_at_points(
+  point_values(
     const Utilities::MPI::RemotePointEvaluation<dim, spacedim> &cache,
     const DoFHandler<dim, spacedim> &                           dof_handler,
     const VectorType &                                          vector,
@@ -197,7 +196,7 @@ namespace VectorTools
            ExcMessage(
              "Utilities::MPI::RemotePointEvaluation is not ready yet! "
              "Please call Utilities::MPI::RemotePointEvaluation::reinit() "
-             "yourself or the other evaluate_at_points(), which does this for"
+             "yourself or the other point_values(), which does this for"
              "you."));
 
     Assert(
index 31e5562b777076c56f062c91d44f8b45830aad3a..601d35648a658f7663a30623b80bf19fb94ef1ba 100644 (file)
@@ -62,17 +62,17 @@ test(const bool enforce_unique_map)
   Utilities::MPI::RemotePointEvaluation<dim> eval(1e-6, enforce_unique_map);
 
   const auto result_avg =
-    VectorTools::evaluate_at_points<1>(mapping,
-                                       dof_handler,
-                                       vec,
-                                       evaluation_points,
-                                       eval,
-                                       VectorTools::EvaluationFlags::avg);
-  const auto result_min = VectorTools::evaluate_at_points<1>(
+    VectorTools::point_values<1>(mapping,
+                                 dof_handler,
+                                 vec,
+                                 evaluation_points,
+                                 eval,
+                                 VectorTools::EvaluationFlags::avg);
+  const auto result_min = VectorTools::point_values<1>(
     eval, dof_handler, vec, VectorTools::EvaluationFlags::min);
-  const auto result_max = VectorTools::evaluate_at_points<1>(
+  const auto result_max = VectorTools::point_values<1>(
     eval, dof_handler, vec, VectorTools::EvaluationFlags::max);
-  const auto result_insert = VectorTools::evaluate_at_points<1>(
+  const auto result_insert = VectorTools::point_values<1>(
     eval, dof_handler, vec, VectorTools::EvaluationFlags::insert);
 
   for (unsigned int i = 0; i < evaluation_points.size(); ++i)
index 83a65d2f5d12d4c00a92ba364b445572cc23a154..bfacec3499635906d076898dcd3446ed4933b37e 100644 (file)
@@ -312,9 +312,7 @@ test_2(const Triangulation<dim, spacedim> &surface_mesh,
   eval.reinit(integration_points, dof_handler_dim.get_triangulation(), mapping);
 
   const auto evaluation_point_results =
-    VectorTools::evaluate_at_points<spacedim>(eval,
-                                              dof_handler_dim,
-                                              normal_solution);
+    VectorTools::point_values<spacedim>(eval, dof_handler_dim, normal_solution);
 
   for (unsigned int i = 0; i < evaluation_point_results.size(); ++i)
     {
index b62e68bcdd7f355c545ace928c9a147eeaadd3e5..b1ce1f6556c5ccea068e926b4d5fd948ca53665d 100644 (file)
@@ -212,7 +212,7 @@ test()
 
   vector_1.update_ghost_values();
   Utilities::MPI::RemotePointEvaluation<dim> evaluation_cache;
-  const auto evaluation_point_results = VectorTools::evaluate_at_points<1>(
+  const auto evaluation_point_results = VectorTools::point_values<1>(
     mapping_1, dof_handler_1, vector_1, evaluation_points, evaluation_cache);
   vector_1.zero_out_ghosts();
 
index 04d5e07f3844111ff9f9b0885ae22a01534bf5d0..a6a5f7ae4f82e98b03361ae58dc93b5bc6523cea 100644 (file)
@@ -180,11 +180,11 @@ public:
       solution_other.update_ghost_values();
       Utilities::MPI::RemotePointEvaluation<dim> evaluation_cache;
       const auto                                 evaluation_point_results =
-        VectorTools::evaluate_at_points<1>(mapping_other,
-                                           dof_handler_other,
-                                           solution_other,
-                                           evaluation_points,
-                                           evaluation_cache);
+        VectorTools::point_values<1>(mapping_other,
+                                     dof_handler_other,
+                                     solution_other,
+                                     evaluation_points,
+                                     evaluation_cache);
       solution_other.zero_out_ghosts();
       for (unsigned int i = 0; i < evaluation_points.size(); ++i)
         {
index 3ee52bf96a08da63cbdcf811fd86170a84f264a7..c1cc3f82aad7bd14faad25c1c85cc0a60497e416 100644 (file)
@@ -190,7 +190,7 @@ test()
 
   vector_1.update_ghost_values();
   Utilities::MPI::RemotePointEvaluation<dim> evaluation_cache;
-  const auto evaluation_point_results = VectorTools::evaluate_at_points<1>(
+  const auto evaluation_point_results = VectorTools::point_values<1>(
     mapping_1, dof_handler_1, vector_1, evaluation_points, evaluation_cache);
   vector_1.zero_out_ghosts();
 
index 83b4bb31b374bd74aa9b1c1cd983204f92cab803..1e15ae272751873a62e6b0c217b828fca26c81c1 100644 (file)
@@ -153,7 +153,7 @@ test()
 
   vector_1.update_ghost_values();
   Utilities::MPI::RemotePointEvaluation<dim> evaluation_cache;
-  const auto evaluation_point_results = VectorTools::evaluate_at_points<1>(
+  const auto evaluation_point_results = VectorTools::point_values<1>(
     mapping_1, dof_handler_1, vector_1, evaluation_points, evaluation_cache);
   vector_1.zero_out_ghosts();
 
index d2d251bb33cb797f709465ac62f4645d374cf658..808f485c34c256b1394366aa2fe350489d0b1c9f 100644 (file)
@@ -178,7 +178,7 @@ test()
   // evaluate vector of background mesh for slice support points
   vector_1.update_ghost_values();
   Utilities::MPI::RemotePointEvaluation<dim> evaluation_cache;
-  const auto evaluation_point_results = VectorTools::evaluate_at_points<1>(
+  const auto evaluation_point_results = VectorTools::point_values<1>(
     mapping_1, dof_handler_1, vector_1, evaluation_points, evaluation_cache);
   vector_1.zero_out_ghosts();
 

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.