]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Don't use namespace std in tests 14936/head
authorDaniel Arndt <arndtd@ornl.gov>
Tue, 21 Mar 2023 21:47:34 +0000 (17:47 -0400)
committerDaniel Arndt <arndtd@ornl.gov>
Tue, 21 Mar 2023 21:48:28 +0000 (17:48 -0400)
82 files changed:
tests/base/polynomials_bdm_01.cc
tests/base/polynomials_bdm_02.cc
tests/base/polynomials_rt.cc
tests/base/polynomials_tensor.cc
tests/bits/count_dofs_per_component_hp_01.cc
tests/bits/count_dofs_per_component_hp_02.cc
tests/bits/map_dofs_to_support_points_hp_01.cc
tests/bits/map_dofs_to_support_points_hp_02.cc
tests/codim_one/bem_integration.cc
tests/codim_one/boundary_indicator_01.cc
tests/codim_one/direction_flag_01.cc
tests/codim_one/direction_flag_02.cc
tests/codim_one/direction_flag_03.cc
tests/codim_one/extract_boundary_mesh_00.cc
tests/codim_one/extract_boundary_mesh_01.cc
tests/codim_one/extract_boundary_mesh_02.cc
tests/codim_one/extract_boundary_mesh_03.cc
tests/codim_one/extract_boundary_mesh_04.cc
tests/codim_one/extract_boundary_mesh_05.cc
tests/codim_one/extract_boundary_mesh_06.cc
tests/codim_one/integrate_log_2.cc
tests/codim_one/integrate_one_over_r.cc
tests/codim_one/integrate_one_over_r_telles.cc
tests/codim_one/integrate_one_over_r_telles_middle.cc
tests/grid/mesh_3d_22.cc
tests/grid/mesh_3d_25.cc
tests/grid/mesh_3d_26.cc
tests/multigrid/boundary_01.cc
tests/multigrid/constrained_dofs_01.cc
tests/multigrid/constrained_dofs_02.cc
tests/multigrid/constrained_dofs_03.cc
tests/multigrid/count_01.cc
tests/multigrid/dof_01.cc
tests/multigrid/dof_02.cc
tests/multigrid/mg_level_obj_01.cc
tests/multigrid/mg_output_dirichlet.cc
tests/multigrid/mg_output_neumann.cc
tests/multigrid/renumbering_01.cc
tests/multigrid/renumbering_02.cc
tests/multigrid/renumbering_03.cc
tests/multigrid/renumbering_04.cc
tests/multigrid/renumbering_05.cc
tests/multigrid/renumbering_06.cc
tests/multigrid/renumbering_07.cc
tests/multigrid/renumbering_08.cc
tests/multigrid/sparse_matrix_collection_01.cc
tests/multigrid/transfer_01.cc
tests/multigrid/transfer_02.cc
tests/multigrid/transfer_03.cc
tests/multigrid/transfer_04.cc
tests/multigrid/transfer_04a.cc
tests/multigrid/transfer_04b.cc
tests/multigrid/transfer_05.cc
tests/multigrid/transfer_06.cc
tests/multigrid/transfer_block.cc
tests/multigrid/transfer_block_select.cc
tests/multigrid/transfer_compare_01.cc
tests/multigrid/transfer_prebuilt_01.cc
tests/multigrid/transfer_prebuilt_02.cc
tests/multigrid/transfer_prebuilt_03.cc
tests/multigrid/transfer_select.cc
tests/multigrid/transfer_system_01.cc
tests/multigrid/transfer_system_02.cc
tests/multigrid/transfer_system_03.cc
tests/multigrid/transfer_system_04.cc
tests/multigrid/transfer_system_05.cc
tests/multigrid/transfer_system_adaptive_01.cc
tests/multigrid/transfer_system_adaptive_02.cc
tests/multigrid/transfer_system_adaptive_03.cc
tests/multigrid/transfer_system_adaptive_04.cc
tests/multigrid/transfer_system_adaptive_05.cc
tests/multigrid/transfer_system_adaptive_06.cc
tests/multigrid/transfer_system_adaptive_07.cc
tests/multigrid/transfer_system_adaptive_08.cc
tests/multigrid/transfer_system_adaptive_09.cc
tests/numerics/derivative_approximation_02.cc
tests/numerics/derivative_approximation_03.cc
tests/numerics/interpolate_to_different_mesh_01.cc
tests/numerics/interpolate_to_different_mesh_02.cc
tests/numerics/interpolate_to_different_mesh_03.cc
tests/numerics/interpolate_to_different_mesh_04.cc
tests/trilinos/mg_transfer_prebuilt_01.cc

index fee75eea17c5d53866274d4c01fbd2500651cdf1..a2e60998e854825ed12c8f3832452cd4dbcc4cbf 100644 (file)
@@ -25,8 +25,6 @@
 
 #include "../tests.h"
 
-using namespace std;
-
 template <int dim>
 void
 plot(const PolynomialsBDM<dim> &poly)
index 16e88addb7748e29d43ed330dbbcace0354e43fb..948323d7d3b960b11f71c4ea5f775cd541dbd027 100644 (file)
@@ -25,8 +25,6 @@
 
 #include "../tests.h"
 
-using namespace std;
-
 template <int dim>
 void
 plot(const PolynomialsBDM<dim> &poly)
index 836f8122fe385bb5c9d7166cdb4c91cc7675e044..693aea4df085bf88f0b3f4e1f4dc163007233483 100644 (file)
@@ -24,8 +24,6 @@
 
 #include "../tests.h"
 
-using namespace std;
-
 template <int dim>
 void
 plot(const PolynomialsRaviartThomas<dim> &poly)
index abc98635f7ea3909005f6ae31a13dd4ab72372e0..db4b6be1e503fa20414543593227822cf1d402a5 100644 (file)
@@ -26,8 +26,6 @@
 
 #include "../tests.h"
 
-using namespace std;
-
 template <int dim, class PolynomialType>
 void
 check_point(const Point<dim> &x, const PolynomialType &p)
index bb3f29548b6d32e460d2fb68ca855b71380059cd..81ee3376a237cdca3baa2c8a484a54e65933ddca 100644 (file)
@@ -31,8 +31,6 @@
 // for the hp-case
 
 
-using namespace std;
-
 template <int dim>
 void
 test()
index 02265cfd6cc537319ae54626a32e67cf25a571af..b174d4952c5d626e6d3b4050de9dd87df01bed62 100644 (file)
@@ -38,8 +38,6 @@
 // collection has more than one element
 
 
-using namespace std;
-
 template <int dim>
 void
 test()
index 580f63ad08ca209d884cd4802d43419ddf1fb473..014b9514b56d31cc5077f822f6fee19dc17a8c2a 100644 (file)
@@ -34,8 +34,6 @@
 // for the hp-case
 
 
-using namespace std;
-
 template <int dim>
 void
 test()
index aedc353269defc935064690b81cee0aa97036b3a..8b2ae4447289c1e433610ef66aecc4475f4ea6b8 100644 (file)
@@ -36,8 +36,6 @@
 // on different cells.
 
 
-using namespace std;
-
 template <int dim>
 void
 test()
index 3b397343bb8e9712240a29e7b70fe30d13ee37d1..b97d686a1e12da38b207b358f79ecc218ce7543f 100644 (file)
@@ -57,9 +57,7 @@
 #include <iostream>
 #include <string>
 
-using namespace std;
-
-ofstream logfile("output");
+std::ofstream logfile("output");
 
 
 template <int dim>
@@ -74,7 +72,7 @@ public:
 
   void
   compute_SD_integral_on_cell(
-    vector<double> &                                         dst,
+    std::vector<double> &                                    dst,
     typename DoFHandler<dim, dim + 1>::active_cell_iterator &cell,
     const Point<dim + 1> &                                   point);
 
@@ -95,14 +93,14 @@ private:
 template <>
 LaplaceKernelIntegration<2>::LaplaceKernelIntegration()
 {
-  static FE_DGP<2, 3> fe(0);
-  vector<Point<2>>    qps(5);
+  static FE_DGP<2, 3>   fe(0);
+  std::vector<Point<2>> qps(5);
   qps[0] = Point<2>(0, 0);
   qps[1] = Point<2>(0, 1);
   qps[2] = Point<2>(1, 0);
   qps[3] = Point<2>(1, 1);
   qps[4] = Point<2>(.5, .5);
-  vector<double>       ws(5, 1.);
+  std::vector<double>  ws(5, 1.);
   static Quadrature<2> quadrature(qps, ws);
   fe_values = new FEValues<2, 3>(
     fe, quadrature, update_values | update_jacobians | update_normal_vectors);
@@ -120,22 +118,22 @@ LaplaceKernelIntegration<dim>::~LaplaceKernelIntegration()
 template <>
 void
 LaplaceKernelIntegration<2>::compute_SD_integral_on_cell(
-  vector<double> &                        dst,
+  std::vector<double> &                   dst,
   DoFHandler<2, 3>::active_cell_iterator &cell,
   const Point<3> &                        point)
 {
   Assert(dst.size() == 2, ExcDimensionMismatch(dst.size(), 2));
   fe_values->reinit(cell);
-  vector<DerivativeForm<1, 2, 3>> jacobians = fe_values->get_jacobians();
-  vector<Tensor<1, 3>>            normals   = fe_values->get_normal_vectors();
+  std::vector<DerivativeForm<1, 2, 3>> jacobians = fe_values->get_jacobians();
+  std::vector<Tensor<1, 3>> normals = fe_values->get_normal_vectors();
 
   Tensor<1, 3> n, n_c;
   Tensor<1, 3> r_c = point - cell->center();
   n_c              = normals[4];
 
-  double         rn_c = r_c * n_c;
-  vector<double> i_S(4);
-  vector<double> i_D(4);
+  double              rn_c = r_c * n_c;
+  std::vector<double> i_S(4);
+  std::vector<double> i_D(4);
   for (unsigned int q_point = 0; q_point < 4; ++q_point)
     {
       const Tensor<1, 3> r  = point - cell->vertex(q_point);
@@ -198,7 +196,7 @@ integration(Point<3> point)
   DoFHandler<2, 3>::active_cell_iterator cell = dof_handler.begin_active();
 
   LaplaceKernelIntegration<2> laplace;
-  vector<double>              integrals(2);
+  std::vector<double>         integrals(2);
   laplace.compute_SD_integral_on_cell(integrals, cell, point);
   return integrals[0];
 }
@@ -215,17 +213,17 @@ main()
   Point<3> point(.5, .5, 0);
   double   true_result = -3.163145629 / numbers::PI;
   deallog << "Error on  " << point << " : " << integration(point) - true_result
-          << endl;
+          << std::endl;
 
   point       = Point<3>(3, 3, 0);
   true_result = -.2306783616;
   deallog << "Error on  " << point << " : " << integration(point) - true_result
-          << endl;
+          << std::endl;
 
   point       = Point<3>(1.5, .5, 0);
   true_result = -1.006860525;
   deallog << "Error on  " << point << " : " << integration(point) - true_result
-          << endl;
+          << std::endl;
 
   return 0;
 }
index 3228002318978ef6ab0b0ce3f2e57c2d0006590b..8b7fb29c4806fce3f95744de220ceed1fc450608 100644 (file)
@@ -35,8 +35,6 @@
 
 #include "../tests.h"
 
-using namespace std;
-
 
 
 template <int dim, int spacedim>
@@ -56,7 +54,7 @@ main()
   // Extract the boundary of 3/4 of a sphere
   {
     const int dim = 3;
-    deallog << "Testing hyper_cube in dim: " << dim << "..." << endl;
+    deallog << "Testing hyper_cube in dim: " << dim << "..." << std::endl;
 
     const SphericalManifold<dim> boundary_description;
     Triangulation<dim>           volume_mesh;
index cca0cf7399639ce7682cc8c0b13a3c02472287a7..98fbf83782337cb141f02b4179153a7368b9c7d8 100644 (file)
@@ -24,8 +24,6 @@
 
 #include "../tests.h"
 
-using namespace std;
-
 
 void
 test()
index d2a7a422cd638575f57470bf6dfc8b11445f6a06..785ad3d5f8e931faa18013682dde928e37e69a08 100644 (file)
@@ -24,8 +24,6 @@
 
 #include "../tests.h"
 
-using namespace std;
-
 
 void
 test()
index 9bb62f6af16cd8c8ef331b551f72de6137fe7ab5..e14b26ca166fa1e7310e6f3beb1b86abfacf24de 100644 (file)
@@ -25,8 +25,6 @@
 
 #include "../tests.h"
 
-using namespace std;
-
 
 template <int dim>
 void
index 078fc1be8a7daaec7dcb64560052073587ada1f3..55dad10897c80d26cb4f7f9e272049cf595a8f9b 100644 (file)
@@ -32,8 +32,6 @@
 
 #include "../tests.h"
 
-using namespace std;
-
 
 template <int dim, int spacedim>
 void
@@ -53,9 +51,9 @@ main()
     // Extract the whole boundary of a hyper-cube
     const int dim = 2;
 
-    deallog << "Testing hyper_cube in dim: " << dim << "..." << endl;
-    map<Triangulation<dim - 1, dim>::cell_iterator,
-        Triangulation<dim, dim>::face_iterator>
+    deallog << "Testing hyper_cube in dim: " << dim << "..." << std::endl;
+    std::map<Triangulation<dim - 1, dim>::cell_iterator,
+             Triangulation<dim, dim>::face_iterator>
       surface_to_volume_mapping;
 
     Triangulation<dim> volume_mesh;
@@ -77,9 +75,9 @@ main()
     // Extract the whole boundary of a hyper-cube
     const int dim = 3;
 
-    deallog << "Testing hyper_cube in dim: " << dim << "..." << endl;
-    map<Triangulation<dim - 1, dim>::cell_iterator,
-        Triangulation<dim, dim>::face_iterator>
+    deallog << "Testing hyper_cube in dim: " << dim << "..." << std::endl;
+    std::map<Triangulation<dim - 1, dim>::cell_iterator,
+             Triangulation<dim, dim>::face_iterator>
       surface_to_volume_mapping;
 
     Triangulation<dim> volume_mesh;
@@ -102,10 +100,10 @@ main()
     // Extract a piece of the boundary of a hyper-cube
 
     const int dim = 3;
-    deallog << "Testing hyper_cube in dim: " << dim << "..." << endl;
+    deallog << "Testing hyper_cube in dim: " << dim << "..." << std::endl;
 
-    map<Triangulation<dim - 1, dim>::cell_iterator,
-        Triangulation<dim, dim>::face_iterator>
+    std::map<Triangulation<dim - 1, dim>::cell_iterator,
+             Triangulation<dim, dim>::face_iterator>
       surface_to_volume_mapping;
 
     Triangulation<dim> volume_mesh;
@@ -115,8 +113,8 @@ main()
 
     save_mesh(volume_mesh);
 
-    Triangulation<dim - 1, dim>   boundary_mesh;
-    const set<types::boundary_id> boundary_ids = {0};
+    Triangulation<dim - 1, dim>        boundary_mesh;
+    const std::set<types::boundary_id> boundary_ids = {0};
 
     surface_to_volume_mapping =
       GridGenerator::extract_boundary_mesh(volume_mesh,
index b348ce8dbf1ce2b5b987c71584d4b6c4aac18047..836e73ee5bf713dd27216c90404e6698e0d17e35 100644 (file)
 
 #include "../tests.h"
 
-using namespace std;
-
 
 template <int s_dim, int spacedim>
 bool
 test_vertices_orientation(
   const Triangulation<s_dim, spacedim> &boundary_mesh,
-  map<typename Triangulation<s_dim, spacedim>::cell_iterator,
-      typename Triangulation<s_dim + 1, spacedim>::face_iterator>
+  std::map<typename Triangulation<s_dim, spacedim>::cell_iterator,
+           typename Triangulation<s_dim + 1, spacedim>::face_iterator>
     &       surface_to_volume_mapping,
   const int verbosity = 1)
 {
@@ -55,13 +53,13 @@ test_vertices_orientation(
 
   if (verbosity > 1)
     {
-      deallog << "The last column should be 0" << endl;
+      deallog << "The last column should be 0" << std::endl;
       deallog << "Vol faces"
               << "\t\t"
               << "Surf cell"
               << "\t\t"
-              << "Distance" << endl
-              << endl;
+              << "Distance" << std::endl
+              << std::endl;
     }
 
   for (; cell != endc; ++cell)
@@ -73,7 +71,7 @@ test_vertices_orientation(
       if (verbosity > 1)
         {
           deallog << face->center() << "\t\t";
-          deallog << cell->center() << "\t\t\t" << diff.square() << endl;
+          deallog << cell->center() << "\t\t\t" << diff.square() << std::endl;
         }
       if (diff.square() > 0)
         {
@@ -81,7 +79,7 @@ test_vertices_orientation(
           break;
         }
       if (verbosity > 1)
-        deallog << endl;
+        deallog << std::endl;
     }
   return success;
 }
@@ -105,10 +103,10 @@ main()
     // Extract the boundary of a hyper-sphere
 
     const int dim = 3;
-    deallog << "Testing hyper_ball in dim: " << dim << "..." << endl;
+    deallog << "Testing hyper_ball in dim: " << dim << "..." << std::endl;
 
-    map<Triangulation<dim - 1, dim>::cell_iterator,
-        Triangulation<dim, dim>::face_iterator>
+    std::map<Triangulation<dim - 1, dim>::cell_iterator,
+             Triangulation<dim, dim>::face_iterator>
                        surface_to_volume_mapping;
     Triangulation<dim> volume_mesh;
     GridGenerator::hyper_ball(volume_mesh);
index c31bb631e58a929122ea87cfdaadcc0c8dc9f0b0..f77a1145a9a438e7542bde78e284dd9fb2401d83 100644 (file)
 
 #include "../tests.h"
 
-using namespace std;
-
 
 template <int s_dim, int spacedim>
 void
 test_vertices_orientation(
   const Triangulation<s_dim, spacedim> &boundary_mesh,
-  map<typename Triangulation<s_dim, spacedim>::cell_iterator,
-      typename Triangulation<s_dim + 1, spacedim>::face_iterator>
+  std::map<typename Triangulation<s_dim, spacedim>::cell_iterator,
+           typename Triangulation<s_dim + 1, spacedim>::face_iterator>
     &surface_to_volume_mapping)
 {
   typename Triangulation<s_dim, spacedim>::active_cell_iterator
@@ -88,10 +86,10 @@ main()
     // Extract the boundary of a hyper-sphere
 
     const int dim = 3;
-    deallog << "Testing hyper_cube in dim: " << dim << "..." << endl;
+    deallog << "Testing hyper_cube in dim: " << dim << "..." << std::endl;
 
-    map<Triangulation<dim - 1, dim>::cell_iterator,
-        Triangulation<dim, dim>::face_iterator>
+    std::map<Triangulation<dim - 1, dim>::cell_iterator,
+             Triangulation<dim, dim>::face_iterator>
                                  surface_to_volume_mapping;
     const SphericalManifold<dim> boundary_description;
     Triangulation<dim>           volume_mesh;
index 45de924f933f1ad3fe1274365cfb0216945e8496..11d0d84e6fc6d252c1b6f6050bb1712f0e469c97 100644 (file)
 
 #include "../tests.h"
 
-using namespace std;
-
 
 template <int s_dim, int spacedim>
 void
 test_vertices_orientation(
   const Triangulation<s_dim, spacedim> &boundary_mesh,
-  map<typename Triangulation<s_dim, spacedim>::cell_iterator,
-      typename Triangulation<s_dim + 1, spacedim>::face_iterator>
+  std::map<typename Triangulation<s_dim, spacedim>::cell_iterator,
+           typename Triangulation<s_dim + 1, spacedim>::face_iterator>
     &surface_to_volume_mapping)
 {
   typename Triangulation<s_dim, spacedim>::active_cell_iterator
@@ -98,10 +96,10 @@ main()
     // Extract the boundary of a hyper-sphere
 
     const int dim = 3;
-    deallog << "Testing hyper_ball in dim: " << dim << "..." << endl;
+    deallog << "Testing hyper_ball in dim: " << dim << "..." << std::endl;
 
-    map<Triangulation<dim - 1, dim>::cell_iterator,
-        Triangulation<dim, dim>::face_iterator>
+    std::map<Triangulation<dim - 1, dim>::cell_iterator,
+             Triangulation<dim, dim>::face_iterator>
                                  surface_to_volume_mapping;
     const SphericalManifold<dim> boundary_description;
     Triangulation<dim>           volume_mesh;
index 738254a7875ea688b27d827e7a1ba58a1a93bf7f..b9de1824c072914cda78e166ddd4d8c6f9e9d719 100644 (file)
 
 #include "../tests.h"
 
-using namespace std;
-
 
 template <int s_dim, int spacedim>
 void
 test_vertices_orientation(
   const Triangulation<s_dim, spacedim> &boundary_mesh,
-  map<typename Triangulation<s_dim, spacedim>::cell_iterator,
-      typename Triangulation<s_dim + 1, spacedim>::face_iterator>
+  std::map<typename Triangulation<s_dim, spacedim>::cell_iterator,
+           typename Triangulation<s_dim + 1, spacedim>::face_iterator>
     &surface_to_volume_mapping)
 {
   typename Triangulation<s_dim, spacedim>::active_cell_iterator
@@ -98,10 +96,10 @@ main()
     // Extract the boundary of a hyper-sphere
 
     const int dim = 3;
-    deallog << "Testing hyper_cube in dim: " << dim << "..." << endl;
+    deallog << "Testing hyper_cube in dim: " << dim << "..." << std::endl;
 
-    map<Triangulation<dim - 1, dim>::cell_iterator,
-        Triangulation<dim, dim>::face_iterator>
+    std::map<Triangulation<dim - 1, dim>::cell_iterator,
+             Triangulation<dim, dim>::face_iterator>
                                  surface_to_volume_mapping;
     const SphericalManifold<dim> boundary_description;
     Triangulation<dim>           volume_mesh;
@@ -123,7 +121,7 @@ main()
     boundary_mesh.set_manifold(1, surface_description);
     boundary_mesh.set_manifold(0, surface_description);
 
-    set<types::boundary_id> boundary_ids;
+    std::set<types::boundary_id> boundary_ids;
     boundary_ids.insert(1);
 
     surface_to_volume_mapping =
index 403e8f17ffb5faea5a7cd737c10020143b850e07..e187246d8109fa6bd5eb5e00648115751835e81a 100644 (file)
@@ -29,8 +29,6 @@
 
 #include "../tests.h"
 
-using namespace std;
-
 
 void
 test()
@@ -38,8 +36,8 @@ test()
   const unsigned int dim = 2;
 
   Triangulation<dim - 1, dim> boundary_mesh;
-  map<Triangulation<dim - 1, dim>::cell_iterator,
-      Triangulation<dim, dim>::face_iterator>
+  std::map<Triangulation<dim - 1, dim>::cell_iterator,
+           Triangulation<dim, dim>::face_iterator>
                      surface_to_volume_mapping;
   Triangulation<dim> volume_mesh;
   GridGenerator::hyper_cube(volume_mesh);
index 4f3abf512896c1ba6a918f58e62d9c46a9cf5380..3f8bac13615e9ae81bb47246b1f77aec45f4bd58 100644 (file)
@@ -28,8 +28,6 @@
 
 #include "../tests.h"
 
-using namespace std;
-
 
 void
 test()
@@ -38,8 +36,8 @@ test()
   const unsigned int dim      = spacedim - 1;
 
   Triangulation<dim, spacedim> boundary_mesh;
-  map<Triangulation<dim, spacedim>::cell_iterator,
-      Triangulation<spacedim, spacedim>::face_iterator>
+  std::map<Triangulation<dim, spacedim>::cell_iterator,
+           Triangulation<spacedim, spacedim>::face_iterator>
                           surface_to_volume_mapping;
   Triangulation<spacedim> volume_mesh;
   GridGenerator::hyper_cube(volume_mesh);
index 5656b63f8dfbb6ef15b921d229d24a939ebd0efc..df955691054bf5dd6afb08d497ccb0ab2f85c49a 100644 (file)
@@ -43,8 +43,6 @@
 
 #include <string>
 
-using namespace std;
-
 // Returns the following integral: /int_0^1 x^N * ln(|x-point|/alpha) dx
 double
 log_integral(const unsigned int N, const double point, const double alpha);
@@ -58,7 +56,7 @@ main()
   deallog << std::setprecision(10);
 
 
-  vector<Point<1>> origins;
+  std::vector<Point<1>> origins;
   origins.push_back(Point<1>());
   origins.push_back(Point<1>(1.));
   origins.push_back(Point<1>(1. / 3.));
@@ -66,7 +64,7 @@ main()
   origins.push_back(Point<1>(1. / 5.));
   origins.push_back(Point<1>(3. / 5.));
 
-  vector<double> alphas;
+  std::vector<double> alphas;
   alphas.push_back(1.);
   alphas.push_back(1. / 3.);
   alphas.push_back(3. / 2.);
@@ -84,10 +82,10 @@ main()
               exact_integral =
                 log_integral(power, origins[nos][0], alphas[nas]);
               deallog << "=================================================="
-                      << endl;
+                      << std::endl;
               deallog << "int_0^1 x^" << power << " ln(|x-" << origins[nos]
                       << "|/" << alphas[nas] << ") = " << exact_integral
-                      << endl;
+                      << std::endl;
               for (unsigned int nq = 2; nq < 13; ++nq)
                 {
                   QGaussLogR<1> quad(nq, origins[nos], alphas[nas]);
@@ -127,11 +125,11 @@ main()
                     deallog
                       << ", difference between factored and unfactored: "
                       << std::abs(approx_integral - approx_integral_factored);
-                  deallog << endl;
+                  deallog << std::endl;
                 }
             }
           deallog << "=================================================="
-                  << endl;
+                  << std::endl;
         }
     }
 }
index c87374d3df836587fbd6b683b0ae9744d5ed3e0d..b01d7764a791bbb361c787b18590290254a03730 100644 (file)
@@ -32,9 +32,7 @@
 
 #include "../base/simplex.h"
 
-using namespace std;
-
-ofstream logfile("output");
+std::ofstream logfile("output");
 
 int
 main()
@@ -42,26 +40,28 @@ main()
   deallog.attach(logfile);
   deallog << std::fixed;
 
-  deallog << endl
-          << "Calculation of the integral of f(x,y)*1/R on [0,1]x[0,1]" << endl
+  deallog << std::endl
+          << "Calculation of the integral of f(x,y)*1/R on [0,1]x[0,1]"
+          << std::endl
           << "for f(x,y) = x^i y^j, with i,j ranging from 0 to 5, and R being"
-          << endl
-          << "the distance from (x,y) to four vertices of the square." << endl
-          << endl;
+          << std::endl
+          << "the distance from (x,y) to four vertices of the square."
+          << std::endl
+          << std::endl;
 
   double eps = 1e-10;
 
   for (unsigned int m = 1; m < 7; ++m)
     {
       deallog << " =========Quadrature Order: " << m
-              << " =============================== " << endl;
+              << " =============================== " << std::endl;
       deallog
         << " ============================================================ "
-        << endl;
+        << std::endl;
       for (unsigned int index = 0; index < 4; ++index)
         {
           deallog << " ===============Vertex Index: " << index
-                  << " ============================= " << endl;
+                  << " ============================= " << std::endl;
           QGaussOneOverR<2> quad(m, index);
           QGaussOneOverR<2> quad_de(m, index, true);
           for (unsigned int i = 0; i < 6; ++i)
@@ -90,11 +90,11 @@ main()
                   deallog << "f(x,y) = x^" << i << " y^" << j
                           << ", Error = " << approx_integral - exact_integral;
                   if (std::abs(approx_integral - approx_integral_2) < eps)
-                    deallog << endl;
+                    deallog << std::endl;
                   else
                     deallog
                       << ", desing: " << approx_integral_2 - exact_integral
-                      << endl;
+                      << std::endl;
                 }
             }
         }
index e7945c0a558ce2dfda3e35dd30d8909594d48e6c..75541b1689faf4b0206db7fbcfd7d68e7c238b1c 100644 (file)
 
 #include "../base/simplex.h"
 
-using namespace std;
-
 int
 main()
 {
   initlog();
   deallog << std::fixed;
 
-  deallog << endl
-          << "Calculation of the integral of f(x,y)*1/R on [0,1]x[0,1]" << endl
+  deallog << std::endl
+          << "Calculation of the integral of f(x,y)*1/R on [0,1]x[0,1]"
+          << std::endl
           << "for f(x,y) = x^i y^j, with i,j ranging from 0 to 5, and R being"
-          << endl
-          << "the distance from (x,y) to four vertices of the square." << endl
-          << endl;
+          << std::endl
+          << "the distance from (x,y) to four vertices of the square."
+          << std::endl
+          << std::endl;
 
 
   std::vector<Point<2>> vertices = FE_Q<2>(1).get_unit_support_points();
@@ -50,14 +50,14 @@ main()
   for (unsigned int m = 1; m < 7; ++m)
     {
       deallog << " =========Quadrature Order: " << m
-              << " =============================== " << endl;
+              << " =============================== " << std::endl;
       deallog
         << " ============================================================ "
-        << endl;
+        << std::endl;
       unsigned int index = 0;
       {
         deallog << " ===============Vertex: " << vertices[index]
-                << " ============================= " << endl;
+                << " ============================= " << std::endl;
         QTelles<2>        quad(m, vertices[index]);
         QGaussOneOverR<2> quad2(m, vertices[index]);
 
index ad6efc1127d85601d9654fe9808acbbebab8f2eb..1f3e262338141eab11ed47382c1c2985fc92f2d1 100644 (file)
@@ -29,8 +29,6 @@
 
 #include "../base/simplex.h"
 
-using namespace std;
-
 // We test the integration of singular kernels with a singularity of kind 1/R
 // We multiply this function with a polynomial up to degree 6.
 
@@ -40,24 +38,25 @@ main()
   initlog();
   deallog << std::fixed;
 
-  deallog << endl
-          << "Calculation of the integral of f(x,y)*1/R on [0,1]x[0,1]" << endl
+  deallog << std::endl
+          << "Calculation of the integral of f(x,y)*1/R on [0,1]x[0,1]"
+          << std::endl
           << "for f(x,y) = x^i y^j, with i,j ranging from 0 to 5, and R being"
-          << endl
-          << "the distance from (x,y) to [0.5,0.5]." << endl
-          << endl;
+          << std::endl
+          << "the distance from (x,y) to [0.5,0.5]." << std::endl
+          << std::endl;
 
 
   Point<2> center(0.5, 0.5);
   for (unsigned int m = 1; m < 6; ++m)
     {
       deallog << " =========Quadrature Order: " << m
-              << " =============================== " << endl;
+              << " =============================== " << std::endl;
       deallog
         << " ============================================================ "
-        << endl;
+        << std::endl;
       deallog << " ===============Vertex: " << center
-              << " ============================= " << endl;
+              << " ============================= " << std::endl;
       QTelles<2>        quad(4 * m, center);
       QGaussOneOverR<2> quad_2(m, center, true);
 
index 4d9a8b63dec39619e2bbec57dffccb83427857b0..b27ce3632f0a7c77d54a4bbb8d43e629b2265766 100644 (file)
@@ -48,8 +48,6 @@
 
 #include "../tests.h"
 
-using namespace std;
-
 template <int dim>
 class F : public Function<dim>
 {
index e354fde6ea6c9aed79d2d34528f5b3d20832e5f7..2fbf9602938a616cc4b53939ec68ef32ff9b48ae 100644 (file)
@@ -45,8 +45,6 @@
 
 #include "../grid/mesh_3d.h"
 
-using namespace std;
-
 template <int dim>
 class F : public Function<dim>
 {
index 13c89c2fe55fd1c2837e778fc6ec40d0024be9a5..f83fc1099aa7eefbf108d16de5b362af619c3e95 100644 (file)
@@ -44,8 +44,6 @@
 
 #include "../tests.h"
 
-using namespace std;
-
 template <int dim>
 class F : public Function<dim>
 {
index e8b6f73157639cc9733fd5849a1f8de9ba10a4c7..2ead93a2e8a6d943260faac2a41768cddfeeff4c 100644 (file)
@@ -39,7 +39,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 void
 log_vector(const std::vector<std::set<types::global_dof_index>> &count)
index c82b35918836fdf0cc8fe3c4901426f6d0d850d5..4029cadc894ce045948428f8fa5f666f2a10be71 100644 (file)
@@ -42,7 +42,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim>
 void
index 2881ea85f0bc49fa2c4f7bed2c5524b120896aeb..16a12731b034589e66b6a2722f7e30ac323348db 100644 (file)
@@ -42,7 +42,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim>
 void
index 77aab997d7eb95ac33828c543577eed4f3006df1..e0db3b31c68988387eb1e73c6f43a9e4e5ef674d 100644 (file)
@@ -42,7 +42,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim>
 void
index bef29b0ea646569ad80465f5f118e9201fd8f7ec..58c84a7186049de5dd45764ee2802877a1f66e5d 100644 (file)
@@ -35,7 +35,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 void
 log_vector(const std::vector<std::vector<types::global_dof_index>> &count)
index 716cf1af4f0e067a6e5233e3ec51d4b66019a205..44974152bc537829b515c067822127f67bdc6843 100644 (file)
@@ -39,7 +39,6 @@
 
 #include "../tests.h"
 
-using namespace std;
 
 
 template <int dim>
index d1f46435ed6440e23c365ac145652042ab953767..7bbdd8aa43a93dfcffeab9c4dd11fe52ed010b4a 100644 (file)
@@ -39,7 +39,6 @@
 
 #include "../tests.h"
 
-using namespace std;
 
 
 template <int dim>
index e622cab0f1a8a67a6652473926ccd5261a8db344..ca29fb229b733083481ceaceb7ab24ea917dc45f 100644 (file)
@@ -22,7 +22,6 @@
 
 #include "../tests.h"
 
-using namespace std;
 
 
 template <class T>
index 8de985f29da22d8591ce9068215475e023f5e808..b3b4ca2e4c982aaea782349b5be5ed27b308cc5f 100644 (file)
@@ -48,7 +48,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim, typename number, int spacedim>
 void
index 93c8e69289df1aa43b36dd233f7052165cd1b4ce..73871ee6a5f74fbd0ffd18eac873c71e86e6b59e 100644 (file)
@@ -48,7 +48,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim, typename number, int spacedim>
 void
index bcfa26b24770603a390163644ec539dc8d7c8abf..07ad682628eec20c2f246c8943cabbd6c851d17d 100644 (file)
@@ -35,7 +35,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim>
 void
index 71546bf2832bb186829b9d1fcb9af5fcd959bd1b..66fd1709097184a8fe863f1c330b36ff21709448 100644 (file)
@@ -36,7 +36,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim>
 void
@@ -73,5 +73,5 @@ main()
   check<2>();
   check<3>();
 
-  deallog << "OK" << endl;
+  deallog << "OK" << std::endl;
 }
index 80b35202f7cdc8628aa634e01ca99f35e23a292a..8fe14cd417e2b6525d7c9d7ee0b527fceb722d78 100644 (file)
@@ -38,7 +38,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim>
 void
@@ -62,8 +62,8 @@ check()
   mg_dof_handler.distribute_mg_dofs();
   for (unsigned int level = 0; level < tria.n_levels(); ++level)
     {
-      const types::global_dof_index   n_dofs = mg_dof_handler.n_dofs(level);
-      vector<types::global_dof_index> new_numbers(n_dofs);
+      const types::global_dof_index n_dofs = mg_dof_handler.n_dofs(level);
+      std::vector<types::global_dof_index> new_numbers(n_dofs);
       for (unsigned int i = 0; i < n_dofs; ++i)
         new_numbers[i] = n_dofs - 1 - i;
 
@@ -80,5 +80,5 @@ main()
   check<2>();
   check<3>();
 
-  deallog << "OK" << endl;
+  deallog << "OK" << std::endl;
 }
index e01915dd1c7fcc3680a01a0446b0e63df2f399a0..6eef56b0771a93b60dd55b22ca332bdbb859ad35 100644 (file)
@@ -35,7 +35,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim>
 void
@@ -125,5 +125,5 @@ main()
     check<3>(fe);
   }
 
-  deallog << "OK" << endl;
+  deallog << "OK" << std::endl;
 }
index cee50d2b95ff5692252a8a7c63f7bff07ee4521f..6fb39bb5ef18849ca39e2b4d4c55000e4ffc1f71 100644 (file)
@@ -30,7 +30,6 @@
 
 #include "../tests.h"
 
-using namespace std;
 
 
 template <int dim>
index e0fa84be43b7abb2bb5483d82b4a409dd595981f..40765a0d27a5c2dd40dbbdaa17ad40b8aaacbe9a 100644 (file)
@@ -37,7 +37,6 @@
 
 #include "../tests.h"
 
-using namespace std;
 
 
 template <int dim>
index 6ce9cb2ac0b37c7ccdab048e6ffa6582272ce8f7..a328fae21de0240aaafbc77de1ad97bec248f21b 100644 (file)
@@ -37,7 +37,6 @@
 
 #include "../tests.h"
 
-using namespace std;
 
 
 template <int dim>
index ac572e514c5cdace62041e25c488930ac36bfe31..229c9d9ef74fb5b459c39ec66c144c024342031c 100644 (file)
@@ -30,7 +30,6 @@
 
 #include "../tests.h"
 
-using namespace std;
 
 
 template <int dim>
index 551cd02bddfeaa8959e9a87d68b0d3b0db7cfce6..d980d1ea35464733b153046f7cfdea42a60d3ecf 100644 (file)
@@ -19,8 +19,6 @@
 
 #include "../tests.h"
 
-using namespace std;
-
 
 
 int
index 32b048fffa60450075098e0ba30a1db9db594ad7..8cf981609f368b9fb447c7c85a8296d767855d20 100644 (file)
@@ -40,7 +40,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim, typename number, int spacedim>
 void
index e74411e3101a2403375f2858eb119f9021a5609a..16df3c61be185875ce47c69a4f5d71d1c16b8bea 100644 (file)
@@ -44,7 +44,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim, typename number, int spacedim>
 void
index bd9b8411c62b69855cbc2340fc3e43b67806c49d..8d02a395bc31cdc39da3e9f9fef6b422276ca90f 100644 (file)
@@ -46,7 +46,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim, typename number, int spacedim>
 void
index 9efc6df25aa3f2ffd0fd1488d8f85a783fd56722..fc378eb63fb040a3b89d1561f2cc1e1ba9a669e9 100644 (file)
@@ -46,7 +46,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim>
 void
index 80e48b8201002786802b027a6dccbb9a39b249b7..644ee252b8cd89d1360fca3cb0af06366d030628 100644 (file)
@@ -46,7 +46,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim>
 void
index 9f107b365c7c68521eb1be3f8198224e2d9fc4f1..dcd63c8540f07838b5052b9c12970fe26dbb3f22 100644 (file)
@@ -46,7 +46,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim>
 void
index 6127a6a9b831edcad23a201e53d3d5d4bd7bfea5..f22cbf60fa8363c9acb0769030bae5ea1f726db6 100644 (file)
@@ -39,7 +39,6 @@
 
 #include "../tests.h"
 
-using namespace std;
 
 
 template <int dim, typename Number>
index 2d1edd53f216d714554c404b9d15d8444aece727..d04459a5fdd926fa5f664563b65a30c51a336e5a 100644 (file)
@@ -40,7 +40,6 @@
 
 #include "../tests.h"
 
-using namespace std;
 
 
 template <int dim, typename Number>
index 1bcc426558f153a54d90afc6557c0a3b1bffcca1..4f3b3e361054a623875e56bd3a8b3aa5ac6a8378 100644 (file)
@@ -40,7 +40,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim, typename number, int spacedim>
 void
@@ -82,9 +82,9 @@ reinit_vector_by_blocks(
 
 template <int dim>
 void
-check_block(const FiniteElement<dim> &fe,
-            const vector<bool> &      selected,
-            const vector<double> &    factors)
+check_block(const FiniteElement<dim> & fe,
+            const std::vector<bool> &  selected,
+            const std::vector<double> &factors)
 {
   deallog << fe.get_name() << std::endl << "selected ";
   for (unsigned int i = 0; i < selected.size(); ++i)
@@ -100,7 +100,7 @@ check_block(const FiniteElement<dim> &fe,
   mgdof.distribute_dofs(fe);
   mgdof.distribute_mg_dofs();
   DoFRenumbering::component_wise(mgdof);
-  const vector<types::global_dof_index> ndofs =
+  const std::vector<types::global_dof_index> ndofs =
     DoFTools::count_dofs_per_fe_block(mgdof);
   Assert(ndofs.size() == fe.n_blocks(), ExcInternalError());
 
@@ -166,7 +166,7 @@ check_block(const FiniteElement<dim> &fe,
   deallog << std::endl;
 
   // Check copy to mg and back
-  // Fill a global vector by counting
+  // Fill a global std::vector by counting
   // from one up
   BlockVector<double> v;
   v.reinit(ndofs);
@@ -183,7 +183,7 @@ check_block(const FiniteElement<dim> &fe,
   deallog << std::endl;
 
   // Now do the opposite: fill a
-  // multigrid vector counting the
+  // multigrid std::vector counting the
   // dofs and see where the numbers go
   for (unsigned int i = 0; i < u[2].size(); ++i)
     u[2](i) = i + 1;
@@ -214,7 +214,7 @@ main()
   FESystem<2> fe0(rt1, 1, q1, 1);
   FESystem<2> fe1(rt0, 2, q0, 2);
 
-  vector<bool> s1(2, true);
+  std::vector<bool> s1(2, true);
   deallog << "All" << std::endl;
   check_block(fe0, s1, factors);
 
index 3264d1adcb337ed7834f15290996db12fa62899f..0d526e6d38faac455d098921d02d86ace39bb77e 100644 (file)
@@ -40,7 +40,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim, typename number, int spacedim>
 void
@@ -86,7 +86,7 @@ check_select(const FiniteElement<dim> &fe, unsigned int selected)
   mgdof.distribute_dofs(fe);
   mgdof.distribute_mg_dofs();
   DoFRenumbering::component_wise(mgdof);
-  const vector<types::global_dof_index> ndofs =
+  const std::vector<types::global_dof_index> ndofs =
     DoFTools::count_dofs_per_fe_block(mgdof);
 
   for (unsigned int l = 0; l < tr.n_levels(); ++l)
@@ -127,7 +127,7 @@ check_select(const FiniteElement<dim> &fe, unsigned int selected)
   deallog << "u0\t" << (int)(u[0] * u[0] + .4) << std::endl
           << "u1\t" << (int)(u[1] * u[1] + .4) << std::endl
           << "u2\t" << (int)(u[2] * u[2] + .4) << std::endl;
-  // Now restrict the same vectors.
+  // Now restrict the same std::vectors.
   u[1] = 0.;
   u[0] = 0.;
   transfer.restrict_and_add(2, u[1], u[2]);
@@ -136,7 +136,7 @@ check_select(const FiniteElement<dim> &fe, unsigned int selected)
           << "u0\t" << (int)(u[0] * u[0] + .5) << std::endl;
 
   // Check copy to mg and back
-  // Fill a global vector by counting
+  // Fill a global std::vector by counting
   // from one up
   BlockVector<double> v;
   v.reinit(ndofs);
@@ -153,7 +153,7 @@ check_select(const FiniteElement<dim> &fe, unsigned int selected)
   deallog << std::endl;
 
   // Now do the opposite: fill a
-  // multigrid vector counting the
+  // multigrid std::vector counting the
   // dofs and see where the numbers go
   for (unsigned int i = 0; i < u[2].size(); ++i)
     u[2](i) = i + 1;
index f3d126c59369a3f0dff2e24870617efa67b162c4..ef2c667d1a6935cf4921b6e9692da236b59085b0 100644 (file)
@@ -42,7 +42,6 @@
 
 #include "../tests.h"
 
-using namespace std;
 
 
 template <int dim, typename number, int spacedim>
@@ -144,7 +143,7 @@ check_block(const FiniteElement<dim> &fe)
     }
 
   // Store sizes
-  const vector<types::global_dof_index> ndofs =
+  const std::vector<types::global_dof_index> ndofs =
     DoFTools::count_dofs_per_fe_block(mgdof);
   std::vector<std::vector<types::global_dof_index>> mg_ndofs(
     mgdof.get_triangulation().n_levels(),
@@ -244,7 +243,7 @@ check_block(const FiniteElement<dim> &fe)
     }
   deallog << std::endl << "copy from mg ";
   // Now do the opposite: fill a
-  // multigrid vector counting the
+  // multigrid std::vector counting the
   // dofs and see where the numbers go
   u = 0.;
   for (unsigned int i = 0; i < v[2].size(); ++i)
index 844eb7d78f62769ba9c6fda71814f38244f9aea4..461600753234d7c1f7c4c189c72ce6dbc833f12d 100644 (file)
@@ -40,7 +40,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim>
 void
index 39d1451919552f539c04833903e090c573a1d957..8d852fb5666c78ac602404feacd0ed5097f66543 100644 (file)
@@ -42,7 +42,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim>
 void
index a478eb2837c2dc55f4b00fc5c6d58dc2c40c8e73..2f0e00456ec47590dc884c340829da4fff6c9654 100644 (file)
@@ -43,7 +43,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim>
 void
index c4b32870c3a4cd097c60d61076944e442e42390d..38dd30bc3a4d105d19a0e05402718e485449bd2f 100644 (file)
@@ -38,7 +38,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim>
 void
@@ -59,7 +59,7 @@ check_select(const FiniteElement<dim> &fe,
   mgdof.distribute_dofs(fe);
   mgdof.distribute_mg_dofs();
   DoFRenumbering::component_wise(mgdof, target_component);
-  const vector<types::global_dof_index> ndofs =
+  const std::vector<types::global_dof_index> ndofs =
     DoFTools::count_dofs_per_fe_component(mgdof, true, target_component);
   Assert(ndofs.size() ==
            *std::max_element(target_component.begin(), target_component.end()) +
index c71ea7e2527f79ae46e0ba2b19f6cf39d75a0ba3..53029cf2be7d4c9c8fa570a47f3e824dfd2301ad 100644 (file)
@@ -37,7 +37,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim, typename number, int spacedim>
 void
index 8464bccc7ad84d82b67486fb040025970d8c0346..4db029043221aea93d1eb32e60625b872658c1c1 100644 (file)
@@ -38,7 +38,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim, typename number, int spacedim>
 void
index 528f92357cf1b3824e01b00ea071f552b35bfb63..6177c670d1f2b5b45d9074ac1ed83d5079453bd4 100644 (file)
@@ -39,7 +39,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim, typename number, int spacedim>
 void
index 70d05e2d9978b2151cba2ff9c8eba161dc6e3004..60327246a70c6d3e92386d95913b60332ef42c6d 100644 (file)
@@ -39,7 +39,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim, typename number, int spacedim>
 void
index cd385a2fb3fb12e46b6bb045c711054603ed1bdc..dca2411dcbaba8f80d8e7ab9c7047891a3caff3c 100644 (file)
@@ -38,7 +38,6 @@
 
 #include "../tests.h"
 
-using namespace std;
 
 
 template <int dim>
index 1f4237bb28f75fcff425025b234aeea083fc5e7b..88b191019e84976d7f8d787d11cacf8ee41a3fb7 100644 (file)
@@ -40,7 +40,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim, typename number, int spacedim>
 void
index 7cabda4f3fda70ead494062a97e51f381e8fdc2c..e4ca2f00761a67d177c8a8a9f8496ea51c641337 100644 (file)
@@ -40,7 +40,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim, typename number, int spacedim>
 void
index 1ba7efec908e4ae5dc70845d9977dad99e94b400..7bdb78b343470f4066f510e12375a584573a8f13 100644 (file)
@@ -41,7 +41,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim, typename number, int spacedim>
 void
index 8088753f34abf078ffae98e848082611f15f3ab5..a0677c5354c1937b15fb417c745e2ff7428cc6fb 100644 (file)
@@ -40,7 +40,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim, typename number, int spacedim>
 void
index 6ff42903efdd8bf34aea40a75de4c6b3d9e02748..4b394c4b494ca8068e629331a8b8701bf8c35a5d 100644 (file)
@@ -42,7 +42,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim, typename number, int spacedim>
 void
index 51df602298373879a8119f03326aab17cad4f0d2..b5a9f7f132f8c4e8eeb3540f8f2b99f087433710 100644 (file)
@@ -40,7 +40,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim, typename number, int spacedim>
 void
index 1a640522fd881d89fed8fc1fe0cf22ae2183d602..a1cd3970315d52175210f687fcc93f45fe579e6b 100644 (file)
@@ -42,7 +42,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim, typename number, int spacedim>
 void
index 6bdb0c678425cca96981c9a7c9be57c85ddccb18..803187909d0ab6c8fc2dd418f1ffe796f40ce629 100644 (file)
@@ -41,7 +41,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim, typename number, int spacedim>
 void
index a41074a63b0841dd7420159a5b6a3a542cd41748..8ecfb37470eebd983d9043991b71f608c5944d91 100644 (file)
@@ -41,7 +41,6 @@
 
 #include "../tests.h"
 
-using namespace std;
 
 
 template <int dim>
index 55944d4551efe8bd012747bfbf70c11c37941d90..66eb132689ba287a5ce4914a46ef14fdab1b15f3 100644 (file)
@@ -40,7 +40,7 @@
 #include <vector>
 
 #include "../tests.h"
-using namespace std;
+
 
 const double a = 4, b = 5;
 
@@ -213,19 +213,20 @@ derivatives()
       double ex_normthird = DerivativeApproximation::derivative_norm(ex_third);
 
       // output of all values for comparison
-      deallog << "cell " << cell << endl;
-      deallog << "approx. gradient: " << grad << " , norm: " << normgrad << endl
+      deallog << "cell " << cell << std::endl;
+      deallog << "approx. gradient: " << grad << " , norm: " << normgrad
+              << std::endl
               << "  exact gradient: " << ex_grad << " , norm: " << ex_normgrad
-              << endl;
+              << std::endl;
       deallog << "approx. second derivative (hessian): " << second
-              << " , norm: " << normsecond << endl
+              << " , norm: " << normsecond << std::endl
               << "  exact second derivative (hessian): " << ex_second
-              << " , norm: " << ex_normsecond << endl;
+              << " , norm: " << ex_normsecond << std::endl;
       deallog << "approx. third derivative: " << third
-              << " , norm: " << normthird << endl
+              << " , norm: " << normthird << std::endl
               << "  exact third derivative: " << ex_third
-              << " , norm: " << ex_normthird << endl
-              << endl;
+              << " , norm: " << ex_normthird << std::endl
+              << std::endl;
     }
 }
 
@@ -235,8 +236,10 @@ main()
 {
   initlog();
 
-  deallog << "------------ 2D ------------" << endl << endl;
+  deallog << "------------ 2D ------------" << std::endl << std::endl;
   derivatives<2>();
-  deallog << endl << "------------ 3D ------------" << endl << endl;
+  deallog << std::endl
+          << "------------ 3D ------------" << std::endl
+          << std::endl;
   derivatives<3>();
 }
index 851ccce36ff302471595f984189ef4ef6ff67b6a..602329111d23825d4f1c1b2e2694c967ec2aa370 100644 (file)
@@ -39,7 +39,7 @@
 #include <vector>
 
 #include "../tests.h"
-using namespace std;
+
 
 const double a = 4, b = 5;
 
@@ -211,19 +211,20 @@ derivatives()
       double ex_normthird = DerivativeApproximation::derivative_norm(ex_third);
 
       // output of all values for comparison
-      deallog << "cell " << cell << endl;
-      deallog << "approx. gradient: " << grad << " , norm: " << normgrad << endl
+      deallog << "cell " << cell << std::endl;
+      deallog << "approx. gradient: " << grad << " , norm: " << normgrad
+              << std::endl
               << "  exact gradient: " << ex_grad << " , norm: " << ex_normgrad
-              << endl;
+              << std::endl;
       deallog << "approx. second derivative (hessian): " << second
-              << " , norm: " << normsecond << endl
+              << " , norm: " << normsecond << std::endl
               << "  exact second derivative (hessian): " << ex_second
-              << " , norm: " << ex_normsecond << endl;
+              << " , norm: " << ex_normsecond << std::endl;
       deallog << "approx. third derivative: " << third
-              << " , norm: " << normthird << endl
+              << " , norm: " << normthird << std::endl
               << "  exact third derivative: " << ex_third
-              << " , norm: " << ex_normthird << endl
-              << endl;
+              << " , norm: " << ex_normthird << std::endl
+              << std::endl;
     }
 }
 
@@ -233,8 +234,10 @@ main()
 {
   initlog();
 
-  deallog << "------------ 2D ------------" << endl << endl;
+  deallog << "------------ 2D ------------" << std::endl << std::endl;
   derivatives<2>();
-  deallog << endl << "------------ 3D ------------" << endl << endl;
+  deallog << std::endl
+          << "------------ 3D ------------" << std::endl
+          << std::endl;
   derivatives<3>();
 }
index 29bd9c69d273276d8e188bdcf6a6850aad2790e6..53aeb1f396cbf7bb9b6574cd4c213f134339eeac 100644 (file)
@@ -31,7 +31,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int spacedim>
 class F1 : public Function<spacedim>
@@ -75,9 +75,9 @@ check(const unsigned int refinement_1, const unsigned int refinement_2)
                                              dof_handler_2,
                                              u_2);
 
-  Point<spacedim>                 support_point, unit_support_point;
-  vector<types::global_dof_index> local_dof_indices(fe.n_dofs_per_cell());
-  deallog << "dof values of dof_handler_1:" << endl;
+  Point<spacedim>                      support_point, unit_support_point;
+  std::vector<types::global_dof_index> local_dof_indices(fe.n_dofs_per_cell());
+  deallog << "dof values of dof_handler_1:" << std::endl;
   for (const auto &cell : dof_handler_1.active_cell_iterators())
     {
       cell->get_dof_indices(local_dof_indices);
@@ -89,11 +89,11 @@ check(const unsigned int refinement_1, const unsigned int refinement_2)
           support_point =
             mapping.transform_unit_to_real_cell(cell, unit_support_point);
           deallog << ' ' << support_point << ":\n "
-                  << u_1[local_dof_indices[shapefun]] << endl
-                  << endl;
+                  << u_1[local_dof_indices[shapefun]] << std::endl
+                  << std::endl;
         }
     }
-  deallog << endl << "dof values of dof_handler_2:" << endl;
+  deallog << std::endl << "dof values of dof_handler_2:" << std::endl;
   for (const auto &cell : dof_handler_2.active_cell_iterators())
 
     {
@@ -106,8 +106,8 @@ check(const unsigned int refinement_1, const unsigned int refinement_2)
           support_point =
             mapping.transform_unit_to_real_cell(cell, unit_support_point);
           deallog << ' ' << support_point << ":\n "
-                  << u_2[local_dof_indices[shapefun]] << endl
-                  << endl;
+                  << u_2[local_dof_indices[shapefun]] << std::endl
+                  << std::endl;
         }
     }
 }
@@ -122,30 +122,30 @@ main(int argc, char **argv)
   deallog
     << "### 2D-Case, first cell refined once, second cell unrefined###\n\n";
   check<2>(1, 0);
-  deallog << endl;
+  deallog << std::endl;
 
   deallog
     << "### 2D-Case, first cell unrefined, second cell refined once###\n\n";
   check<2>(0, 1);
-  deallog << endl;
+  deallog << std::endl;
 
   deallog
     << "### 2D-Case, first cell refined once, second cell refined once###\n\n";
   check<2>(1, 1);
-  deallog << endl;
+  deallog << std::endl;
 
   deallog
     << "### 3D-Case, first cell refined once, second cell unrefined###\n\n";
   check<3>(1, 0);
-  deallog << endl;
+  deallog << std::endl;
 
   deallog
     << "### 3D-Case, first cell unrefined, second cell refined once###\n\n";
   check<3>(0, 1);
-  deallog << endl;
+  deallog << std::endl;
 
   deallog
     << "### 3D-Case, first cell refined once, second cell refined once###\n\n";
   check<3>(1, 1);
-  deallog << endl;
+  deallog << std::endl;
 }
index eaa9a2ad368f6ff9c30f7d95f3fa8b5f8fd3c49a..0e0e0bd114f9c8baa15f2c77813d9e3c1b0fdab9 100644 (file)
@@ -33,7 +33,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int spacedim>
 class F1 : public Function<spacedim>
@@ -86,12 +86,12 @@ check(const unsigned int refinement_1, const unsigned int refinement_2)
                                              dof_handler_2,
                                              u_2);
 
-  Point<spacedim>                 support_point, unit_support_point;
-  vector<types::global_dof_index> local_dof_indices_1(
+  Point<spacedim>                      support_point, unit_support_point;
+  std::vector<types::global_dof_index> local_dof_indices_1(
     fe_collection[0].n_dofs_per_cell());
-  vector<types::global_dof_index> local_dof_indices_2(
+  std::vector<types::global_dof_index> local_dof_indices_2(
     fe_collection[1].n_dofs_per_cell());
-  deallog << "dof values of dof_handler_1:" << endl;
+  deallog << "dof values of dof_handler_1:" << std::endl;
   for (const auto &cell : dof_handler_1.active_cell_iterators())
     {
       cell->get_dof_indices(local_dof_indices_1);
@@ -103,11 +103,11 @@ check(const unsigned int refinement_1, const unsigned int refinement_2)
           support_point =
             mapping.transform_unit_to_real_cell(cell, unit_support_point);
           deallog << ' ' << support_point << ":\n "
-                  << u_1[local_dof_indices_1[shapefun]] << endl
-                  << endl;
+                  << u_1[local_dof_indices_1[shapefun]] << std::endl
+                  << std::endl;
         }
     }
-  deallog << endl << "dof values of dof_handler_2:" << endl;
+  deallog << std::endl << "dof values of dof_handler_2:" << std::endl;
   for (const auto &cell : dof_handler_2.active_cell_iterators())
     {
       cell->get_dof_indices(local_dof_indices_2);
@@ -119,8 +119,8 @@ check(const unsigned int refinement_1, const unsigned int refinement_2)
           support_point =
             mapping.transform_unit_to_real_cell(cell, unit_support_point);
           deallog << ' ' << support_point << ":\n "
-                  << u_2[local_dof_indices_2[shapefun]] << endl
-                  << endl;
+                  << u_2[local_dof_indices_2[shapefun]] << std::endl
+                  << std::endl;
         }
     }
 }
@@ -135,30 +135,30 @@ main(int argc, char **argv)
   deallog
     << "### 2D-Case, first cell refined once, second cell unrefined###\n\n";
   check<2>(1, 0);
-  deallog << endl;
+  deallog << std::endl;
 
   deallog
     << "### 2D-Case, first cell unrefined, second cell refined once###\n\n";
   check<2>(0, 1);
-  deallog << endl;
+  deallog << std::endl;
 
   deallog
     << "### 2D-Case, first cell refined once, second cell refined once###\n\n";
   check<2>(1, 1);
-  deallog << endl;
+  deallog << std::endl;
 
   deallog
     << "### 3D-Case, first cell refined once, second cell unrefined###\n\n";
   check<3>(1, 0);
-  deallog << endl;
+  deallog << std::endl;
 
   deallog
     << "### 3D-Case, first cell unrefined, second cell refined once###\n\n";
   check<3>(0, 1);
-  deallog << endl;
+  deallog << std::endl;
 
   deallog
     << "### 3D-Case, first cell refined once, second cell refined once###\n\n";
   check<3>(1, 1);
-  deallog << endl;
+  deallog << std::endl;
 }
index dbeabc131cceca0360f866e5bf69d290b466fe88..c60f544f8c13b98f11acca45cb1375c1a44eece0 100644 (file)
@@ -35,7 +35,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <unsigned int spacedim>
 void
@@ -74,7 +74,7 @@ check(const unsigned int refinement_1, const unsigned int refinement_2)
 
   d = u_1;
   d.sadd(-1.0, u_1_back);
-  deallog << "distance=" << d.l2_norm() << endl;
+  deallog << "distance=" << d.l2_norm() << std::endl;
 }
 
 int
@@ -89,20 +89,20 @@ main(int argc, char **argv)
   deallog
     << "### 2D-Case, first cell unrefined, second cell refined once###\n\n";
   check<2>(0, 1);
-  deallog << endl;
+  deallog << std::endl;
 
   deallog
     << "### 2D-Case, first cell refined once, second cell refined three times###\n\n";
   check<2>(1, 3);
-  deallog << endl;
+  deallog << std::endl;
 
   deallog
     << "### 3D-Case, first cell unrefined, second cell refined once###\n\n";
   check<3>(0, 1);
-  deallog << endl;
+  deallog << std::endl;
 
   deallog
     << "### 3D-Case, first cell refined once, second cell refined three times###\n\n";
   check<3>(1, 3);
-  deallog << endl;
+  deallog << std::endl;
 }
index faf3e3a51cf9413f7a96a59bce136eedee49e293..d6c4c5d67e0b4934c4ec94d005e3f18e6e90b972 100644 (file)
@@ -37,7 +37,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <unsigned int spacedim>
 void
@@ -85,7 +85,7 @@ check(const unsigned int refinement_1, const unsigned int refinement_2)
 
   d = u_1;
   d.sadd(-1.0, u_1_back);
-  deallog << "distance=" << d.l2_norm() << endl;
+  deallog << "distance=" << d.l2_norm() << std::endl;
 }
 
 int
@@ -100,34 +100,34 @@ main(int argc, char **argv)
   deallog
     << "### 2D-Case, first cell unrefined, second cell refined once###\n\n";
   check<2>(0, 1);
-  deallog << endl;
+  deallog << std::endl;
 
   deallog
     << "### 2D-Case, first cell refined once, second cell refined three times###\n\n";
   check<2>(1, 3);
-  deallog << endl;
+  deallog << std::endl;
 
   // this should still be an identity operation although interpolation is from
   // fine to coarse mesh because second mesh uses quadratic elements
   deallog
     << "### 2D-Case, first cell refined twice, second cell refined once###\n\n";
   check<2>(2, 1);
-  deallog << endl;
+  deallog << std::endl;
 
   deallog
     << "### 3D-Case, first cell unrefined, second cell refined once###\n\n";
   check<3>(0, 1);
-  deallog << endl;
+  deallog << std::endl;
 
   deallog
     << "### 3D-Case, first cell refined once, second cell refined three times###\n\n";
   check<3>(1, 3);
-  deallog << endl;
+  deallog << std::endl;
 
   // this should still be an identity operation although interpolation is from
   // fine to coarse mesh because second mesh uses quadratic elements
   deallog
     << "### 3D-Case, first cell refined twice, second cell refined once###\n\n";
   check<3>(2, 1);
-  deallog << endl;
+  deallog << std::endl;
 }
index 780ec11ca3d3c61f11e9a14edf23c1939141ce67..e920cb8fadb3ae19673ed2572b891012b4fb2bb5 100644 (file)
@@ -39,7 +39,7 @@
 
 #include "../tests.h"
 
-using namespace std;
+
 
 template <int dim, int spacedim>
 void

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.