]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix compiling with clang-3.7.1
authorDaniel Arndt <arndtd@ornl.gov>
Thu, 14 Nov 2019 20:33:07 +0000 (15:33 -0500)
committerDaniel Arndt <arndtd@ornl.gov>
Thu, 14 Nov 2019 20:33:07 +0000 (15:33 -0500)
examples/step-13/step-13.cc
examples/step-27/step-27.cc
examples/step-38/step-38.cc
examples/step-4/step-4.cc
examples/step-41/step-41.cc
examples/step-51/step-51.cc
examples/step-61/step-61.cc
examples/step-63/step-63.cc
examples/step-7/step-7.cc
source/grid/manifold_lib.cc

index 688d598e7175e80cc569bcf348ed49dcc3612ced..d12cc57ddfcedbdca39f7bc9a2c41fd683517f06 100644 (file)
@@ -1359,8 +1359,8 @@ namespace Step13
     triangulation.refine_global(2);
     const FE_Q<dim>          fe(1);
     const QGauss<dim>        quadrature(4);
-    const RightHandSide<dim> rhs_function;
-    const Solution<dim>      boundary_values;
+    const RightHandSide<dim> rhs_function{};
+    const Solution<dim>      boundary_values{};
 
     // Create a solver object of the kind indicated by the argument to this
     // function. If the name is not recognized, throw an exception!
index 9185c2d526e34d45533bc3bbe694a03135b874f3..5d108c7e8b6a59219178719d594d900ff19220fe 100644 (file)
@@ -317,7 +317,7 @@ namespace Step27
                                      update_quadrature_points |
                                      update_JxW_values);
 
-    const RightHandSide<dim> rhs_function;
+    const RightHandSide<dim> rhs_function{};
 
     FullMatrix<double> cell_matrix;
     Vector<double>     cell_rhs;
index f4f33dbe2ac9ec23f3b504443b1eb891c1aac6e7..6694241c55e3797e3d7fd0668bb84437f4668119 100644 (file)
@@ -370,7 +370,7 @@ namespace Step38
     std::vector<double>                  rhs_values(n_q_points);
     std::vector<types::global_dof_index> local_dof_indices(dofs_per_cell);
 
-    const RightHandSide<spacedim> rhs;
+    const RightHandSide<spacedim> rhs{};
 
     for (const auto &cell : dof_handler.active_cell_iterators())
       {
index 80076d7a928509d56c3f5ba86fb27fe3ec402ae7..9d1506db9e802119bf647c2b0fbeaabecd63e14c 100644 (file)
@@ -324,7 +324,7 @@ void Step4<dim>::assemble_system()
   // the class declared above to generate the necessary data. Since this right
   // hand side object is only used locally in the present function, we declare
   // it here as a local variable:
-  const RightHandSide<dim> right_hand_side;
+  const RightHandSide<dim> right_hand_side{};
 
   // Compared to the previous example, in order to evaluate the non-constant
   // right hand side function we now also need the quadrature points on the
index 2bbbf13f5500b1cc44e6fbe7e635d78bf164e494..02dd3889ad5bed3e700f22ecab2a1d11707eeabd 100644 (file)
@@ -269,7 +269,7 @@ namespace Step41
     system_rhs    = 0;
 
     const QGauss<dim>        quadrature_formula(fe.degree + 1);
-    const RightHandSide<dim> right_hand_side;
+    const RightHandSide<dim> right_hand_side{};
 
     FEValues<dim> fe_values(fe,
                             quadrature_formula,
index 946063f9da4973ce0720e29a1ce44dec478d7998..1178fd47ad44cb365abf3fc6bbbb9306e9b5f887 100644 (file)
@@ -545,6 +545,7 @@ namespace Step51
       , trace_values(face_quadrature_formula.size())
       , fe_local_support_on_face(GeometryInfo<dim>::faces_per_cell)
       , fe_support_on_face(GeometryInfo<dim>::faces_per_cell)
+      , exact_solution()
     {
       for (unsigned int face = 0; face < GeometryInfo<dim>::faces_per_cell;
            ++face)
@@ -587,6 +588,7 @@ namespace Step51
       , trace_values(sd.trace_values)
       , fe_local_support_on_face(sd.fe_local_support_on_face)
       , fe_support_on_face(sd.fe_support_on_face)
+      , exact_solution()
     {}
   };
 
index 6b397a437f05246e21223a4d2066a68b556c4916..6683c339f3693c97bf3b25acab9d6a99d37a7ad4 100644 (file)
@@ -419,7 +419,7 @@ namespace Step61
 
     const unsigned int n_face_q_points = fe_face_values.get_quadrature().size();
 
-    const RightHandSide<dim> right_hand_side;
+    const RightHandSide<dim> right_hand_side{};
     std::vector<double>      right_hand_side_values(n_q_points);
 
     const Coefficient<dim>      coefficient;
index a3437c7553e1c6e728f5fa54cc92fb93fb6b199c..010b16f1fa6e23ee3c604eac1f0233fab426c6c6 100644 (file)
@@ -716,7 +716,7 @@ namespace Step63
 
     scratch_data.fe_values.reinit(cell);
 
-    const RightHandSide<dim> right_hand_side;
+    const RightHandSide<dim> right_hand_side{};
     std::vector<double>      rhs_values(n_q_points);
 
     right_hand_side.value_list(scratch_data.fe_values.get_quadrature_points(),
index b0fbccf4386997ff0b6ec2c6f9873066945a3ca2..e1838cbf091c3691f48236a4eea7bb37b5fc7527 100644 (file)
@@ -587,7 +587,7 @@ namespace Step7
     // Note that the operations we will do with the right hand side object are
     // only querying data, never changing the object. We can therefore declare
     // it <code>const</code>:
-    const RightHandSide<dim> right_hand_side;
+    const RightHandSide<dim> right_hand_side{};
     std::vector<double>      rhs_values(n_q_points);
 
     // Finally we define an object denoting the exact solution function. We
@@ -597,7 +597,7 @@ namespace Step7
     // Neumann values are prescribed. We will, however, be a little bit lazy
     // and use what we already have in information. Real-life programs would
     // to go other ways here, of course.
-    const Solution<dim> exact_solution;
+    const Solution<dim> exact_solution{};
 
     // Now for the main loop over all cells. This is mostly unchanged from
     // previous examples, so we only comment on the things that have changed.
index 75138e0dbd624b353b3b1d773cd977fb585edef1..d9723307e9b5fa8e3d186ae42068505a85baaf6d 100644 (file)
@@ -1308,6 +1308,7 @@ FunctionManifold<dim, spacedim, chartdim>::FunctionManifold(
   const Tensor<1, chartdim> &periodicity,
   const double               tolerance)
   : ChartManifold<dim, spacedim, chartdim>(periodicity)
+  , const_map()
   , push_forward_function(&push_forward_function)
   , pull_back_function(&pull_back_function)
   , tolerance(tolerance)

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.