]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Erronius VectorTools::NormType::* has been replaced with VectorTools::* in all files... 16259/head
authorVladimir Yushutin <vyushut@clemson.edu>
Fri, 10 Nov 2023 19:45:42 +0000 (14:45 -0500)
committerVladimir Yushutin <vyushut@clemson.edu>
Fri, 10 Nov 2023 19:45:42 +0000 (14:45 -0500)
20 files changed:
doc/news/8.2.1-vs-8.3.0.h
include/deal.II/distributed/grid_refinement.h
include/deal.II/grid/grid_refinement.h
source/distributed/grid_refinement.cc
source/grid/grid_refinement.cc
tests/grid/refine_and_coarsen_fixed_fraction_03.cc
tests/grid/refine_and_coarsen_fixed_fraction_04.cc
tests/matrix_free/poisson_dg_hp.cc
tests/matrix_free/step-37-inhomogeneous-1.cc
tests/mpi/refine_and_coarsen_fixed_fraction_08.cc
tests/mpi/refine_and_coarsen_fixed_fraction_09.cc
tests/multigrid-global-coarsening/step-37-inhomogeneous-1.cc
tests/remote_point_evaluation/vector_tools_evaluate_at_points_01.cc
tests/remote_point_evaluation/vector_tools_evaluate_at_points_03.cc
tests/remote_point_evaluation/vector_tools_evaluate_at_points_05.cc
tests/simplex/matrix_free_02.cc
tests/simplex/matrix_free_03.cc
tests/simplex/matrix_free_04.cc
tests/simplex/poisson_01.cc
tests/simplex/step-40.cc

index ce7cf9389b60c66a570483579d91bec79491a2f0..ddf6b79e85a310e25160e83dd2b971c519f112bf 100644 (file)
@@ -753,7 +753,7 @@ inconvenience this causes.
 
   <li> New: The VectorTools::integrate_difference() function can now
   also compute the $H_\text{div}$ seminorm, using the
-  VectorTools::NormType::Hdiv_seminorm argument.
+  VectorTools::Hdiv_seminorm argument.
   <br>
   (Zhen Tao, Arezou Ghesmati, Wolfgang Bangerth, 2015/04/17)
   </li>
index 0c557c79b793f37eaa2459ba19850648e457e65d..0c87c717ba226225201216242b86343bf007927a 100644 (file)
@@ -204,8 +204,8 @@ namespace parallel
        * @param[in] norm_type To determine thresholds, combined errors on
        * subsets of cells are calculated as norms of the criteria on these
        * cells. Different types of norms can be used for this purpose, from
-       * which VectorTools::NormType::L1_norm and
-       * VectorTools::NormType::L2_norm are currently supported.
+       * which VectorTools::L1_norm and
+       * VectorTools::L2_norm are currently supported.
        */
       template <int dim, typename Number, int spacedim>
       void
@@ -214,7 +214,7 @@ namespace parallel
         const dealii::Vector<Number>         &criteria,
         const double                          top_fraction_of_error,
         const double                          bottom_fraction_of_error,
-        const VectorTools::NormType norm_type = VectorTools::NormType::L1_norm);
+        const VectorTools::NormType           norm_type = VectorTools::L1_norm);
     } // namespace GridRefinement
   }   // namespace distributed
 } // namespace parallel
index 5e354a505dd0e147ee9730a068ffc55a95faa705..c34406617353fa46d9ae1119c0659ce0ac3c61c4 100644 (file)
@@ -226,8 +226,8 @@ namespace GridRefinement
    * @param[in] norm_type To determine thresholds, combined errors on
    * subsets of cells are calculated as norms of the criteria on these
    * cells. Different types of norms can be used for this purpose, from
-   * which VectorTools::NormType::L1_norm and
-   * VectorTools::NormType::L2_norm are currently supported.
+   * which VectorTools::L1_norm and
+   * VectorTools::L2_norm are currently supported.
    */
   template <int dim, typename Number, int spacedim>
   void
@@ -237,7 +237,7 @@ namespace GridRefinement
     const double                  top_fraction,
     const double                  bottom_fraction,
     const unsigned int max_n_cells = std::numeric_limits<unsigned int>::max(),
-    const VectorTools::NormType norm_type = VectorTools::NormType::L1_norm);
+    const VectorTools::NormType norm_type = VectorTools::L1_norm);
 
 
 
index 55ca56fa1ad02e2f2baba7633d862c9014f2ac94..2a7fb94068cedb4c56c59030bf02316b35251f8a 100644 (file)
@@ -595,7 +595,7 @@ namespace parallel
 
         switch (norm_type)
           {
-            case VectorTools::NormType::L1_norm:
+            case VectorTools::L1_norm:
               // evaluate norms on subsets and compare them as
               //   c_0 + c_1 + ... < fraction * l1-norm(c)
               refine_and_coarsen_fixed_fraction_via_l1_norm(
@@ -605,7 +605,7 @@ namespace parallel
                 bottom_fraction_of_error);
               break;
 
-            case VectorTools::NormType::L2_norm:
+            case VectorTools::L2_norm:
               {
                 // we do not want to evaluate norms on subsets as:
                 //   sqrt(c_0^2 + c_1^2 + ...) < fraction * l2-norm(c)
index 9163212f094947bc516598388aeb68f5f0dbb6a7..9d5fd9d40271050811762a426a7504f4e03080c7 100644 (file)
@@ -404,14 +404,14 @@ GridRefinement::refine_and_coarsen_fixed_fraction(
 
   switch (norm_type)
     {
-      case VectorTools::NormType::L1_norm:
+      case VectorTools::L1_norm:
         // evaluate norms on subsets and compare them as
         //   c_0 + c_1 + ... < fraction * l1-norm(c)
         refine_and_coarsen_fixed_fraction_via_l1_norm(
           tria, criteria, top_fraction, bottom_fraction, max_n_cells);
         break;
 
-      case VectorTools::NormType::L2_norm:
+      case VectorTools::L2_norm:
         {
           // we do not want to evaluate norms on subsets as:
           //   sqrt(c_0^2 + c_1^2 + ...) < fraction * l2-norm(c)
index 103d6ecc4feebd5e3dff36f9b20c5744560a1ea2..a6240e6ddc4bb5a1e782d81d781165488d4e80eb 100644 (file)
@@ -73,7 +73,7 @@ test()
     0.3,
     0.3,
     std::numeric_limits<unsigned int>::max(),
-    VectorTools::NormType::L1_norm);
+    VectorTools::L1_norm);
   count_flags(tria);
   deallog << std::endl;
 
@@ -91,7 +91,7 @@ test()
     0.3,
     0.3,
     std::numeric_limits<unsigned int>::max(),
-    VectorTools::NormType::L2_norm);
+    VectorTools::L2_norm);
   count_flags(tria);
   deallog << std::endl;
 }
index ca8655c23ca4a78fb1f27e8281e9d6eebb100814..f074d892aa2a461982be7a295486bb5ea17f6630 100644 (file)
@@ -74,7 +74,7 @@ test()
     0.3,
     0.3,
     std::numeric_limits<unsigned int>::max(),
-    VectorTools::NormType::L1_norm);
+    VectorTools::L1_norm);
   count_flags(tria);
   deallog << std::endl;
 
@@ -92,7 +92,7 @@ test()
     0.3,
     0.3,
     std::numeric_limits<unsigned int>::max(),
-    VectorTools::NormType::L2_norm);
+    VectorTools::L2_norm);
   count_flags(tria);
   deallog << std::endl;
 }
index 4d55716f34e584fb7666ac494cb100a51fe0b9dd..1103e253ae90f64acd63ca262147f88dd45dc3b7 100644 (file)
@@ -301,12 +301,10 @@ test(const unsigned int degree)
                                       Functions::ZeroFunction<dim>(),
                                       difference,
                                       quad,
-                                      VectorTools::NormType::L2_norm);
+                                      VectorTools::L2_norm);
 
     const double error =
-      VectorTools::compute_global_error(tria,
-                                        difference,
-                                        VectorTools::NormType::L2_norm);
+      VectorTools::compute_global_error(tria, difference, VectorTools::L2_norm);
 
     if (Utilities::MPI::this_mpi_process(MPI_COMM_WORLD) == 0)
       printf("Error %f.\n", error);
index fb203c6eb6134157e2d7034411c4152e024ad90a..1653e8545369ad0394ad030595962939b68722c2 100644 (file)
@@ -595,7 +595,7 @@ namespace Step37
                                       ManufacturedSolution<dim>(),
                                       errors,
                                       QIterated<dim>(QTrapezoid<1>(), 4),
-                                      VectorTools::NormType::Linfty_norm);
+                                      VectorTools::Linfty_norm);
     double max_cell_error = 1.0;
     if (errors.begin() != errors.end())
       max_cell_error = *std::max_element(errors.begin(), errors.end());
index 6dcbc18c4b1f827b288b69be9bf85db29b4b8c38..61fdaed94786d4ad7ab437beefa39f2e96efab42 100644 (file)
@@ -77,7 +77,7 @@ test()
 
   deallog << "l1-norm: ";
   parallel::distributed::GridRefinement::refine_and_coarsen_fixed_fraction(
-    tria, indicator, 0.3, 0.3, VectorTools::NormType::L1_norm);
+    tria, indicator, 0.3, 0.3, VectorTools::L1_norm);
   count_flags(tria);
   deallog << std::endl;
 
@@ -91,7 +91,7 @@ test()
 
   deallog << "l2-norm: ";
   parallel::distributed::GridRefinement::refine_and_coarsen_fixed_fraction(
-    tria, indicator, 0.3, 0.3, VectorTools::NormType::L2_norm);
+    tria, indicator, 0.3, 0.3, VectorTools::L2_norm);
   count_flags(tria);
   deallog << std::endl;
 }
index 56391b08e3cb0a7b320779a46492ec8ae8900be5..529d29ecd91fa1aa976923f527c721262c65f206 100644 (file)
@@ -78,7 +78,7 @@ test()
 
   deallog << "l1-norm: ";
   parallel::distributed::GridRefinement::refine_and_coarsen_fixed_fraction(
-    tria, indicator, 0.3, 0.3, VectorTools::NormType::L1_norm);
+    tria, indicator, 0.3, 0.3, VectorTools::L1_norm);
   count_flags(tria);
   deallog << std::endl;
 
@@ -92,7 +92,7 @@ test()
 
   deallog << "l2-norm: ";
   parallel::distributed::GridRefinement::refine_and_coarsen_fixed_fraction(
-    tria, indicator, 0.3, 0.3, VectorTools::NormType::L2_norm);
+    tria, indicator, 0.3, 0.3, VectorTools::L2_norm);
   count_flags(tria);
   deallog << std::endl;
 }
index 0f7412cd2b9405dd557eafb83a12febf39c6865a..151c5d4105865bad74f7c34d3893dbab98359770 100644 (file)
@@ -595,7 +595,7 @@ namespace Step37
                                       ManufacturedSolution<dim>(),
                                       errors,
                                       QIterated<dim>(QTrapezoid<1>(), 4),
-                                      VectorTools::NormType::Linfty_norm);
+                                      VectorTools::Linfty_norm);
     double max_cell_error = 1.0;
     if (errors.begin() != errors.end())
       max_cell_error = *std::max_element(errors.begin(), errors.end());
index c0d2a0a9ad1cbe1220c975a032a3ea06a382076e..db593557b0aaaf06b0412f39e8829e83289f2980 100644 (file)
@@ -249,12 +249,10 @@ test()
                                     AnalyticalFunction<dim>(),
                                     difference,
                                     quadrature_2,
-                                    VectorTools::NormType::L2_norm);
+                                    VectorTools::L2_norm);
 
   double error =
-    VectorTools::compute_global_error(tria_2,
-                                      difference,
-                                      VectorTools::NormType::L2_norm);
+    VectorTools::compute_global_error(tria_2, difference, VectorTools::L2_norm);
 
 
   if (Utilities::MPI::this_mpi_process(MPI_COMM_WORLD))
index 078b5a12a652ac3b9ade259e30e8ee7f5d6f8735..ee45e9846699613a1a61e79e23ffe42c57e8f7c4 100644 (file)
@@ -228,12 +228,10 @@ test()
                                     Functions::CosineFunction<2>(),
                                     difference,
                                     quadrature_2,
-                                    VectorTools::NormType::L2_norm);
+                                    VectorTools::L2_norm);
 
   double error =
-    VectorTools::compute_global_error(tria_2,
-                                      difference,
-                                      VectorTools::NormType::L2_norm);
+    VectorTools::compute_global_error(tria_2, difference, VectorTools::L2_norm);
 
 
   if (Utilities::MPI::this_mpi_process(MPI_COMM_WORLD))
index a3c38bbcaf8f816ba9e071f97ab197ab3530eed2..b36002642d96cfab6d555819e3443d70a22072e8 100644 (file)
@@ -218,12 +218,10 @@ test()
                                     AnalyticalFunction<dim>(),
                                     difference,
                                     quadrature_2,
-                                    VectorTools::NormType::L2_norm);
+                                    VectorTools::L2_norm);
 
   double error =
-    VectorTools::compute_global_error(tria_2,
-                                      difference,
-                                      VectorTools::NormType::L2_norm);
+    VectorTools::compute_global_error(tria_2, difference, VectorTools::L2_norm);
 
 
   if (Utilities::MPI::this_mpi_process(MPI_COMM_WORLD))
index 2b436ac0ae3b7d0d9aeaf6495648f05c9e5567d1..4cd341c4d20f3ae61ac4c731ff35b87fd4a372cf 100644 (file)
@@ -206,7 +206,7 @@ test(const unsigned version, const unsigned int degree, const bool do_helmholtz)
                                       Functions::ZeroFunction<dim>(),
                                       difference,
                                       quads,
-                                      VectorTools::NormType::L2_norm);
+                                      VectorTools::L2_norm);
 
     std::tuple<unsigned int, double, double, double> result(
       reduction_control.last_step(),
@@ -214,7 +214,7 @@ test(const unsigned version, const unsigned int degree, const bool do_helmholtz)
       x.linfty_norm(),
       VectorTools::compute_global_error(tria,
                                         difference,
-                                        VectorTools::NormType::L2_norm));
+                                        VectorTools::L2_norm));
 
     return result;
   };
index 266dc440250e5b083250b87e9645bea486b44a0c..6395f2c429843b69d62e819ee542900ef7bebb82 100644 (file)
@@ -363,11 +363,11 @@ test(const unsigned int degree)
                                       Functions::ZeroFunction<dim>(),
                                       difference,
                                       quadrature,
-                                      VectorTools::NormType::L2_norm);
+                                      VectorTools::L2_norm);
 
     deallog << VectorTools::compute_global_error(tria,
                                                  difference,
-                                                 VectorTools::NormType::L2_norm)
+                                                 VectorTools::L2_norm)
             << std::endl;
 
     return {reduction_control.last_step(), reduction_control.last_value()};
index 14d126a7b0da2f58575cc03e6634527fdd25fec0..60b815e44b2084467094ac8a5df3921649c1b536 100644 (file)
@@ -312,12 +312,10 @@ test(const unsigned version, const unsigned int degree)
                                       Functions::ZeroFunction<dim>(),
                                       difference,
                                       quads,
-                                      VectorTools::NormType::L2_norm);
+                                      VectorTools::L2_norm);
 
     const double error =
-      VectorTools::compute_global_error(tria,
-                                        difference,
-                                        VectorTools::NormType::L2_norm);
+      VectorTools::compute_global_error(tria, difference, VectorTools::L2_norm);
 
     if (error < 0.042)
       deallog << "OK" << std::endl;
index a1df1fd504d879d5e240c4a6e628dabc64b09f22..3556f77e1d252d250d5c2a8acf2d445e884bfbe9 100644 (file)
@@ -317,10 +317,11 @@ test(const Triangulation<dim, spacedim> &tria,
                                         Functions::ZeroFunction<dim>(),
                                         difference,
                                         quad,
-                                        VectorTools::NormType::L2_norm);
+                                        VectorTools::L2_norm);
 
-      deallog << VectorTools::compute_global_error(
-                   tria, difference, VectorTools::NormType::L2_norm)
+      deallog << VectorTools::compute_global_error(tria,
+                                                   difference,
+                                                   VectorTools::L2_norm)
               << std::endl;
       DataOut<dim> data_out;
 
index 5f9be617039de19013dd7255a24ed3957c9d3652..8a8305010e415b84b7d8fdff7f6007542797d16d 100644 (file)
@@ -310,11 +310,11 @@ namespace Step40
                                       Functions::ZeroFunction<dim>(),
                                       difference,
                                       quadrature_formula,
-                                      VectorTools::NormType::L2_norm);
+                                      VectorTools::L2_norm);
 
     deallog << VectorTools::compute_global_error(triangulation,
                                                  difference,
-                                                 VectorTools::NormType::L2_norm)
+                                                 VectorTools::L2_norm)
             << std::endl;
   }
 

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.