]> https://gitweb.dealii.org/ - dealii.git/commitdiff
modernize-return-braced-init-list
authorDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Tue, 29 Jan 2019 09:52:18 +0000 (10:52 +0100)
committerDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Tue, 29 Jan 2019 10:01:48 +0000 (11:01 +0100)
27 files changed:
examples/step-33/step-33.cc
examples/step-42/step-42.cc
examples/step-49/step-49.cc
examples/step-53/step-53.cc
include/deal.II/base/geometry_info.h
include/deal.II/base/index_set.h
include/deal.II/base/symmetric_tensor.h
include/deal.II/fe/fe_values.h
include/deal.II/grid/tria_accessor.templates.h
include/deal.II/lac/block_indices.h
include/deal.II/lac/chunk_sparsity_pattern.h
include/deal.II/lac/dynamic_sparsity_pattern.h
include/deal.II/lac/linear_operator.h
include/deal.II/lac/sparsity_pattern.h
include/deal.II/lac/trilinos_sparse_matrix.h
include/deal.II/matrix_free/matrix_free.h
source/base/data_out_base.cc
source/base/function_lib.cc
source/base/hdf5.cc
source/dofs/dof_handler_policy.cc
source/fe/fe.cc
source/fe/mapping_q_generic.cc
source/grid/grid_tools.cc
source/grid/manifold.cc
source/grid/manifold_lib.cc
source/grid/tria_accessor.cc
source/opencascade/manifold_lib.cc

index a3ce08eb58b4f792509c50fc99d535bca6b4e26a..917b51fcd30db0b143390d4cc6adc5f75a2b83ca 100644 (file)
@@ -2152,8 +2152,7 @@ namespace Step33
 
             direct.solve(system_matrix, newton_update, right_hand_side);
 
-            return std::pair<unsigned int, double>(solver_control.last_step(),
-                                                   solver_control.last_value());
+            return {solver_control.last_step(), solver_control.last_value()};
           }
 
         // Likewise, if we are to use an iterative solver, we use Aztec's GMRES
@@ -2215,13 +2214,12 @@ namespace Step33
             solver.Iterate(parameters.max_iterations,
                            parameters.linear_residual);
 
-            return std::pair<unsigned int, double>(solver.NumIters(),
-                                                   solver.TrueResidual());
+            return {solver.NumIters(), solver.TrueResidual()};
           }
       }
 
     Assert(false, ExcNotImplemented());
-    return std::pair<unsigned int, double>(0, 0);
+    return {0, 0};
   }
 
 
index 2006200602e52744ade671342ffb291186fc5f7f..94cc9e445aa904608b80d47bdaf878ecc92ff694 100644 (file)
@@ -897,7 +897,7 @@ namespace Step42
   // indicator one.
   Point<3> rotate_half_sphere(const Point<3> &in)
   {
-    return Point<3>(in(2), in(1), -in(0));
+    return {in(2), in(1), -in(0)};
   }
 
   template <int dim>
index a40312e76b402cfd43b1149b52b044bb9d0f5111..c99e66a0e32a896d735c96a5afb40a4b9f92f327 100644 (file)
@@ -278,7 +278,7 @@ struct Grid6Func
 
   Point<2> operator()(const Point<2> &in) const
   {
-    return Point<2>(in(0), trans(in(1)));
+    return {in(0), trans(in(1))};
   }
 };
 
index f60c0755e1ee0a4f348a33360c96b06ea01c44c2..3e4eb436a5c960638b7ffd46eaacd5bff58bcef9 100644 (file)
@@ -277,10 +277,9 @@ namespace Step53
     const double R_bar = R / std::sqrt(1 - (ellipticity * ellipticity *
                                             std::sin(theta) * std::sin(theta)));
 
-    return Point<3>((R_bar + d) * std::cos(phi) * std::cos(theta),
-                    (R_bar + d) * std::sin(phi) * std::cos(theta),
-                    ((1 - ellipticity * ellipticity) * R_bar + d) *
-                      std::sin(theta));
+    return {(R_bar + d) * std::cos(phi) * std::cos(theta),
+            (R_bar + d) * std::sin(phi) * std::cos(theta),
+            ((1 - ellipticity * ellipticity) * R_bar + d) * std::sin(theta)};
   }
 
   Point<3> AfricaGeometry::pull_back_wgs84(const Point<3> &x) const
index 31e75d1f0e0e7549e09a4142e9cc3e609c195703..f5b35f8fddc891ad4815421a8f970d316c4da80b 100644 (file)
@@ -2519,7 +2519,7 @@ GeometryInfo<2>::unit_cell_vertex(const unsigned int vertex)
   Assert(vertex < vertices_per_cell,
          ExcIndexRange(vertex, 0, vertices_per_cell));
 
-  return Point<2>(vertex % 2, vertex / 2);
+  return {static_cast<double>(vertex % 2), static_cast<double>(vertex / 2)};
 }
 
 
@@ -2531,7 +2531,9 @@ GeometryInfo<3>::unit_cell_vertex(const unsigned int vertex)
   Assert(vertex < vertices_per_cell,
          ExcIndexRange(vertex, 0, vertices_per_cell));
 
-  return Point<3>(vertex % 2, vertex / 2 % 2, vertex / 4);
+  return {static_cast<double>(vertex % 2),
+          static_cast<double>(vertex / 2 % 2),
+          static_cast<double>(vertex / 4)};
 }
 
 
index 439775a1309ffe0419b126cc6519554a5e47fe0c..fec38b883f22fdb178578a1b1158a94032d747d3 100644 (file)
@@ -1030,9 +1030,7 @@ inline IndexSet::ElementIterator
 IndexSet::IntervalAccessor::begin() const
 {
   Assert(is_valid(), ExcMessage("invalid iterator"));
-  return IndexSet::ElementIterator(index_set,
-                                   range_idx,
-                                   index_set->ranges[range_idx].begin);
+  return {index_set, range_idx, index_set->ranges[range_idx].begin};
 }
 
 
@@ -1044,9 +1042,7 @@ IndexSet::IntervalAccessor::end() const
 
   // point to first index in next interval unless we are the last interval.
   if (range_idx < index_set->ranges.size() - 1)
-    return IndexSet::ElementIterator(index_set,
-                                     range_idx + 1,
-                                     index_set->ranges[range_idx + 1].begin);
+    return {index_set, range_idx + 1, index_set->ranges[range_idx + 1].begin};
   else
     return index_set->end();
 }
@@ -1479,7 +1475,7 @@ IndexSet::begin() const
 {
   compress();
   if (ranges.size() > 0)
-    return IndexSet::ElementIterator(this, 0, ranges[0].begin);
+    return {this, 0, ranges[0].begin};
   else
     return end();
 }
@@ -1530,9 +1526,9 @@ IndexSet::at(const size_type global_index) const
   // [a,b[ and we will return an iterator pointing directly at global_index
   // (else branch).
   if (global_index < p->begin)
-    return IndexSet::ElementIterator(this, p - ranges.begin(), p->begin);
+    return {this, static_cast<size_type>(p - ranges.begin()), p->begin};
   else
-    return IndexSet::ElementIterator(this, p - ranges.begin(), global_index);
+    return {this, static_cast<size_type>(p - ranges.begin()), global_index};
 }
 
 
index f903c4078da677cb5e942fb986adf20a5f518787..f164142472344b77f9113aa1266b27ecaa1fd2d0 100644 (file)
@@ -101,9 +101,9 @@ namespace internal
       Assert(position < 2, ExcIndexRange(position, 0, 2));
 
       if (position == 0)
-        return TableIndices<2>(new_index, numbers::invalid_unsigned_int);
+        return {new_index, numbers::invalid_unsigned_int};
       else
-        return TableIndices<2>(previous_indices[0], new_index);
+        return {previous_indices[0], new_index};
     }
 
 
@@ -124,28 +124,28 @@ namespace internal
       switch (position)
         {
           case 0:
-            return TableIndices<4>(new_index,
-                                   numbers::invalid_unsigned_int,
-                                   numbers::invalid_unsigned_int,
-                                   numbers::invalid_unsigned_int);
+            return {new_index,
+                    numbers::invalid_unsigned_int,
+                    numbers::invalid_unsigned_int,
+                    numbers::invalid_unsigned_int};
           case 1:
-            return TableIndices<4>(previous_indices[0],
-                                   new_index,
-                                   numbers::invalid_unsigned_int,
-                                   numbers::invalid_unsigned_int);
+            return {previous_indices[0],
+                    new_index,
+                    numbers::invalid_unsigned_int,
+                    numbers::invalid_unsigned_int};
           case 2:
-            return TableIndices<4>(previous_indices[0],
-                                   previous_indices[1],
-                                   new_index,
-                                   numbers::invalid_unsigned_int);
+            return {previous_indices[0],
+                    previous_indices[1],
+                    new_index,
+                    numbers::invalid_unsigned_int};
           case 3:
-            return TableIndices<4>(previous_indices[0],
-                                   previous_indices[1],
-                                   previous_indices[2],
-                                   new_index);
+            return {previous_indices[0],
+                    previous_indices[1],
+                    previous_indices[2],
+                    new_index};
         }
       Assert(false, ExcInternalError());
-      return TableIndices<4>();
+      return {};
     }
 
 
@@ -2463,7 +2463,7 @@ namespace internal
         {
           case 1:
             {
-              return TableIndices<2>(0, 0);
+              return {0, 0};
             }
 
           case 2:
@@ -2487,16 +2487,16 @@ namespace internal
 
           default:
             if (i < dim)
-              return TableIndices<2>(i, i);
+              return {i, i};
 
             for (unsigned int d = 0, c = 0; d < dim; ++d)
               for (unsigned int e = d + 1; e < dim; ++e, ++c)
                 if (c == i)
-                  return TableIndices<2>(d, e);
+                  return {d, e};
 
             // should never get here:
             Assert(false, ExcInternalError());
-            return TableIndices<2>(0, 0);
+            return {0, 0};
         }
     }
 
index 311cbbd64e12c1fbf63334fc68bda1645c16691a..3e03139485d1b5768b197498a2a74edea07ae3e8 100644 (file)
@@ -4363,8 +4363,7 @@ namespace FEValuesViews
       Assert(n < 1, ExcIndexRange(n, 0, 1));
       (void)n;
 
-      const double array[1] = {t[0]};
-      return dealii::SymmetricTensor<2, 1>(array);
+      return {{t[0]}};
     }
 
 
@@ -4376,18 +4375,16 @@ namespace FEValuesViews
         {
           case 0:
             {
-              const double array[3] = {t[0], 0, t[1] / 2};
-              return dealii::SymmetricTensor<2, 2>(array);
+              return {{t[0], 0, t[1] / 2}};
             }
           case 1:
             {
-              const double array[3] = {0, t[1], t[0] / 2};
-              return dealii::SymmetricTensor<2, 2>(array);
+              return {{0, t[1], t[0] / 2}};
             }
           default:
             {
               Assert(false, ExcIndexRange(n, 0, 2));
-              return dealii::SymmetricTensor<2, 2>();
+              return {};
             }
         }
     }
@@ -4401,23 +4398,20 @@ namespace FEValuesViews
         {
           case 0:
             {
-              const double array[6] = {t[0], 0, 0, t[1] / 2, t[2] / 2, 0};
-              return dealii::SymmetricTensor<2, 3>(array);
+              return {{t[0], 0, 0, t[1] / 2, t[2] / 2, 0}};
             }
           case 1:
             {
-              const double array[6] = {0, t[1], 0, t[0] / 2, 0, t[2] / 2};
-              return dealii::SymmetricTensor<2, 3>(array);
+              return {{0, t[1], 0, t[0] / 2, 0, t[2] / 2}};
             }
           case 2:
             {
-              const double array[6] = {0, 0, t[2], 0, t[0] / 2, t[1] / 2};
-              return dealii::SymmetricTensor<2, 3>(array);
+              return {{0, 0, t[2], 0, t[0] / 2, t[1] / 2}};
             }
           default:
             {
               Assert(false, ExcIndexRange(n, 0, 3));
-              return dealii::SymmetricTensor<2, 3>();
+              return {};
             }
         }
     }
index 03fa332247bcc7dd2e57b4d1cdac32b5265b9b33..bd9bc7b43cd2a786b32cfa53147ac243a3641fd6 100644 (file)
@@ -2586,7 +2586,7 @@ template <int dim, int spacedim>
 inline RefinementCase<0>
 TriaAccessor<0, dim, spacedim>::refinement_case()
 {
-  return RefinementCase<0>(RefinementPossibilities<0>::no_refinement);
+  return {RefinementPossibilities<0>::no_refinement};
 }
 
 
@@ -2998,7 +2998,7 @@ template <int spacedim>
 inline RefinementCase<0>
 TriaAccessor<0, 1, spacedim>::refinement_case()
 {
-  return RefinementCase<0>(RefinementPossibilities<0>::no_refinement);
+  return {RefinementPossibilities<0>::no_refinement};
 }
 
 template <int spacedim>
index 4860a039b9fda1c25f049fb2340de7647f84f0b6..6ada38375a72900283fc3957572e4f2d62d76122 100644 (file)
@@ -337,7 +337,7 @@ BlockIndices::global_to_local(const size_type i) const
   while (i < start_indices[block])
     --block;
 
-  return std::pair<unsigned int, size_type>(block, i - start_indices[block]);
+  return {block, i - start_indices[block]};
 }
 
 
index 261786b52663f29d41d7c4458b70518d488c46aa..4a458f598213509ea9374176c067f13910b390f0 100644 (file)
@@ -1105,14 +1105,14 @@ namespace ChunkSparsityPatternIterators
 inline ChunkSparsityPattern::iterator
 ChunkSparsityPattern::begin() const
 {
-  return iterator(this, 0);
+  return {this, 0};
 }
 
 
 inline ChunkSparsityPattern::iterator
 ChunkSparsityPattern::end() const
 {
-  return iterator(this, n_rows());
+  return {this, n_rows()};
 }
 
 
@@ -1121,7 +1121,7 @@ inline ChunkSparsityPattern::iterator
 ChunkSparsityPattern::begin(const unsigned int r) const
 {
   Assert(r < n_rows(), ExcIndexRange(r, 0, n_rows()));
-  return iterator(this, r);
+  return {this, r};
 }
 
 
@@ -1129,8 +1129,8 @@ ChunkSparsityPattern::begin(const unsigned int r) const
 inline ChunkSparsityPattern::iterator
 ChunkSparsityPattern::end(const unsigned int r) const
 {
-  Assert(r < n_rows(), ExcIndexRange(r, 0, n_rows())) return iterator(this,
-                                                                      r + 1);
+  Assert(r < n_rows(), ExcIndexRange(r, 0, n_rows()));
+  return {this, r + 1};
 }
 
 
index 2feb05a52d16eeb90f7bd627550bebf48ef3b641..b5f1dd36a1d55c5db415a5e7c6bdb4948dfc8ada 100644 (file)
@@ -1089,7 +1089,7 @@ DynamicSparsityPattern::begin() const
 inline DynamicSparsityPattern::iterator
 DynamicSparsityPattern::end() const
 {
-  return iterator(this);
+  return {this};
 }
 
 
@@ -1100,7 +1100,7 @@ DynamicSparsityPattern::begin(const size_type r) const
   Assert(r < n_rows(), ExcIndexRangeType<size_type>(r, 0, n_rows()));
 
   if (!have_entries)
-    return iterator(this);
+    return {this};
 
   if (rowset.size() > 0)
     {
@@ -1131,7 +1131,7 @@ DynamicSparsityPattern::begin(const size_type r) const
       if (it == rowset.end())
         return end();
       else
-        return iterator(this, *it, 0);
+        return {this, *it, 0};
     }
 
   // Without an index set we have to do a linear search starting at
@@ -1145,9 +1145,9 @@ DynamicSparsityPattern::begin(const size_type r) const
     }
 
   if (row == n_rows())
-    return iterator(this);
+    return {this};
   else
-    return iterator(this, row, 0);
+    return {this, row, 0};
 }
 
 
@@ -1159,7 +1159,7 @@ DynamicSparsityPattern::end(const size_type r) const
 
   unsigned int row = r + 1;
   if (row == n_rows())
-    return iterator(this);
+    return {this};
   else
     return begin(row);
 }
index 5278b34ee65bd2cc8ef6bcc2dffa183022971852..e066190781cd43e7ff033a85b9af792e409217fe 100644 (file)
@@ -1022,7 +1022,7 @@ namespace internal
     inline EmptyPayload
     operator+(const EmptyPayload &, const EmptyPayload &)
     {
-      return EmptyPayload();
+      return {};
     }
 
     /**
@@ -1031,7 +1031,7 @@ namespace internal
      */
     inline EmptyPayload operator*(const EmptyPayload &, const EmptyPayload &)
     {
-      return EmptyPayload();
+      return {};
     }
 
 
index 3f58fe14135876bcac1c9415fd3e0f2b96c63b17..4182a1fd73496c0ecfec3598f2576789a9c48852 100644 (file)
@@ -1254,7 +1254,7 @@ inline SparsityPattern::iterator
 SparsityPattern::begin() const
 {
   if (n_rows() > 0)
-    return iterator(this, rowstart[0]);
+    return {this, rowstart[0]};
   else
     return end();
 }
@@ -1265,9 +1265,9 @@ inline SparsityPattern::iterator
 SparsityPattern::end() const
 {
   if (n_rows() > 0)
-    return iterator(this, rowstart[rows]);
+    return {this, rowstart[rows]};
   else
-    return iterator(nullptr, 0);
+    return {nullptr, 0};
 }
 
 
@@ -1277,7 +1277,7 @@ SparsityPattern::begin(const size_type r) const
 {
   Assert(r < n_rows(), ExcIndexRangeType<size_type>(r, 0, n_rows()));
 
-  return iterator(this, rowstart[r]);
+  return {this, rowstart[r]};
 }
 
 
@@ -1287,7 +1287,7 @@ SparsityPattern::end(const size_type r) const
 {
   Assert(r < n_rows(), ExcIndexRangeType<size_type>(r, 0, n_rows()));
 
-  return iterator(this, rowstart[r + 1]);
+  return {this, rowstart[r + 1]};
 }
 
 
index ed9f193523f50efb1c6abe60e9d2eea6c4c1f4dc..25478951f673c370aa0073afa751dc75b9664bcd 100644 (file)
@@ -2745,7 +2745,7 @@ namespace TrilinosWrappers
     Accessor<false>::value() const
     {
       Assert(a_row < matrix->m(), ExcBeyondEndOfMatrix());
-      return Reference(*this);
+      return {*this};
     }
 
 
index d38ed5055f0072f64f0c2510d42b1def66bfb2d0..15a1e5e32dc744b80d5f58ef7a5901d6fc48200b 100644 (file)
@@ -2032,14 +2032,13 @@ MatrixFree<dim, Number>::create_cell_subrange_hp(
       if (dof_info[dof_handler_component].fe_index_conversion[0][0] == degree)
         return range;
       else
-        return std::pair<unsigned int, unsigned int>(range.second,
-                                                     range.second);
+        return {range.second, range.second};
     }
 
   const unsigned int fe_index =
     dof_info[dof_handler_component].fe_index_from_degree(0, degree);
   if (fe_index >= dof_info[dof_handler_component].max_fe_index)
-    return std::pair<unsigned int, unsigned int>(range.second, range.second);
+    return {range.second, range.second};
   else
     return create_cell_subrange_hp_by_index(range,
                                             fe_index,
index 9983825260044b4672faf8d9643ca1fd39312d56..65336ef191547ad05e7a69c6ae7aa86ea6b9d434 100644 (file)
@@ -7630,7 +7630,7 @@ DataOutInterface<dim, spacedim>::create_xdmf_entry(
     }
   else
     {
-      return XDMFEntry();
+      return {};
     }
 }
 
index 891cf67524d3cb178acd764f9ecac814ca2d0959..5ec40c4431126327eb6dcdb5f72ae79f8be8d999 100644 (file)
@@ -1435,7 +1435,7 @@ namespace Functions
                                      const unsigned int /*component*/) const
   {
     Assert(false, ExcNotImplemented());
-    return Tensor<1, 2>();
+    return {};
   }
 
 
index 2e4f3c02de5f38b3164668db2e33605ae3a20c88..d8fe0dca80c122cd02d5ec343c86563fce3edd87 100644 (file)
@@ -1313,7 +1313,7 @@ namespace HDF5
   Group
   Group::open_group(const std::string &name) const
   {
-    return Group(name, *this, mpi, GroupAccessMode::open);
+    return {name, *this, mpi, GroupAccessMode::open};
   }
 
 
@@ -1321,7 +1321,7 @@ namespace HDF5
   Group
   Group::create_group(const std::string &name) const
   {
-    return Group(name, *this, mpi, GroupAccessMode::create);
+    return {name, *this, mpi, GroupAccessMode::create};
   }
 
 
@@ -1329,7 +1329,7 @@ namespace HDF5
   DataSet
   Group::open_dataset(const std::string &name) const
   {
-    return DataSet(name, *hdf5_reference, mpi);
+    return {name, *hdf5_reference, mpi};
   }
 
 
@@ -1340,7 +1340,7 @@ namespace HDF5
                         const std::vector<hsize_t> &dimensions) const
   {
     std::shared_ptr<hid_t> t_type = internal::get_hdf5_datatype<number>();
-    return DataSet(name, *hdf5_reference, dimensions, t_type, mpi);
+    return {name, *hdf5_reference, dimensions, t_type, mpi};
   }
 
 
index bdb9b68d537b1634d5d379378ac192cdab6d3e53..aa9b53c7037255ac3f03edc87c08df5ccfc24d57 100644 (file)
@@ -4206,7 +4206,7 @@ namespace internal
         // multigrid is not currently implemented for shared triangulations
         Assert(false, ExcNotImplemented());
 
-        return NumberCache();
+        return {};
       }
 
 
index a45d0b0fd377b49e38e538c167bc0305347e6c37..861777b5840256750f62eb4b241ade0304cf4c43 100644 (file)
@@ -446,7 +446,7 @@ FiniteElement<dim, spacedim>::component_mask(const BlockMask &block_mask) const
   // if we get a block mask that represents all blocks, then
   // do the same for the returned component mask
   if (block_mask.represents_the_all_selected_mask())
-    return ComponentMask();
+    return {};
 
   AssertDimension(block_mask.size(), this->n_blocks());
 
@@ -502,7 +502,7 @@ FiniteElement<dim, spacedim>::block_mask(
   // if we get a component mask that represents all component, then
   // do the same for the returned block mask
   if (component_mask.represents_the_all_selected_mask())
-    return BlockMask();
+    return {};
 
   AssertDimension(component_mask.size(), this->n_components());
 
@@ -859,20 +859,18 @@ FiniteElement<dim, spacedim>::interface_constraints_size() const
   switch (dim)
     {
       case 1:
-        return TableIndices<2>(0U, 0U);
+        return {0U, 0U};
       case 2:
-        return TableIndices<2>(this->dofs_per_vertex + 2 * this->dofs_per_line,
-                               this->dofs_per_face);
+        return {this->dofs_per_vertex + 2 * this->dofs_per_line,
+                this->dofs_per_face};
       case 3:
-        return TableIndices<2>(5 * this->dofs_per_vertex +
-                                 12 * this->dofs_per_line +
-                                 4 * this->dofs_per_quad,
-                               this->dofs_per_face);
+        return {5 * this->dofs_per_vertex + 12 * this->dofs_per_line +
+                  4 * this->dofs_per_quad,
+                this->dofs_per_face};
       default:
         Assert(false, ExcNotImplemented());
     }
-  return TableIndices<2>(numbers::invalid_unsigned_int,
-                         numbers::invalid_unsigned_int);
+  return {numbers::invalid_unsigned_int, numbers::invalid_unsigned_int};
 }
 
 
index 44400569ddce0627bbb2bb2de97d5c127a81732b..4dfaf968dc6c651b2ca121a9f2737a895b5f81d3 100644 (file)
@@ -174,7 +174,7 @@ namespace internal
         if (std::abs(xi_denominator0) > 1e-10 * max_x)
           {
             const double xi = (x + subexpr0) / xi_denominator0;
-            return Point<2>(xi, eta);
+            return {xi, static_cast<double>(eta)};
           }
         else
           {
@@ -187,7 +187,7 @@ namespace internal
             if (std::abs(xi_denominator1) > 1e-10 * max_y)
               {
                 const double xi = (subexpr1 + y) / xi_denominator1;
-                return Point<2>(xi, eta);
+                return {xi, static_cast<double>(eta)};
               }
             else // give up and try Newton iteration
               {
@@ -200,8 +200,8 @@ namespace internal
         // bogus return to placate compiler. It should not be possible to get
         // here.
         Assert(false, ExcInternalError());
-        return Point<2>(std::numeric_limits<double>::quiet_NaN(),
-                        std::numeric_limits<double>::quiet_NaN());
+        return {std::numeric_limits<double>::quiet_NaN(),
+                std::numeric_limits<double>::quiet_NaN()};
       }
 
 
@@ -2517,7 +2517,7 @@ MappingQGeneric<1, 3>::transform_real_to_unit_cell_internal(
   const Point<1> &) const
 {
   Assert(false, ExcNotImplemented());
-  return Point<1>();
+  return {};
 }
 
 
index 2b50ee5f4056290f18b1edd23b6e41b851372679..201dfe03f9eeabff92323e8065a4437e10bea052 100644 (file)
@@ -815,8 +815,8 @@ namespace GridTools
       Point<2>
       operator()(const Point<2> &p) const
       {
-        return Point<2>(std::cos(angle) * p(0) - std::sin(angle) * p(1),
-                        std::sin(angle) * p(0) + std::cos(angle) * p(1));
+        return {std::cos(angle) * p(0) - std::sin(angle) * p(1),
+                std::sin(angle) * p(0) + std::cos(angle) * p(1)};
       }
 
     private:
@@ -836,17 +836,17 @@ namespace GridTools
       operator()(const Point<3> &p) const
       {
         if (axis == 0)
-          return Point<3>(p(0),
-                          std::cos(angle) * p(1) - std::sin(angle) * p(2),
-                          std::sin(angle) * p(1) + std::cos(angle) * p(2));
+          return {p(0),
+                  std::cos(angle) * p(1) - std::sin(angle) * p(2),
+                  std::sin(angle) * p(1) + std::cos(angle) * p(2)};
         else if (axis == 1)
-          return Point<3>(std::cos(angle) * p(0) + std::sin(angle) * p(2),
-                          p(1),
-                          -std::sin(angle) * p(0) + std::cos(angle) * p(2));
+          return {std::cos(angle) * p(0) + std::sin(angle) * p(2),
+                  p(1),
+                  -std::sin(angle) * p(0) + std::cos(angle) * p(2)};
         else
-          return Point<3>(std::cos(angle) * p(0) - std::sin(angle) * p(1),
-                          std::sin(angle) * p(0) + std::cos(angle) * p(1),
-                          p(2));
+          return {std::cos(angle) * p(0) - std::sin(angle) * p(1),
+                  std::sin(angle) * p(0) + std::cos(angle) * p(1),
+                  p(2)};
       }
 
     private:
index 35d213df01a3e8bab23fbd459a087ad1361b8fbd..e668286c4a2e57e75a3eba99a067d4e9b5a43af1 100644 (file)
@@ -379,7 +379,7 @@ Manifold<1, 1>::get_new_point_on_face(
   const Triangulation<1, 1>::face_iterator &) const
 {
   Assert(false, ExcImpossibleInDim(1));
-  return Point<1>();
+  return {};
 }
 
 
@@ -390,7 +390,7 @@ Manifold<1, 2>::get_new_point_on_face(
   const Triangulation<1, 2>::face_iterator &) const
 {
   Assert(false, ExcImpossibleInDim(1));
-  return Point<2>();
+  return {};
 }
 
 
@@ -401,7 +401,7 @@ Manifold<1, 3>::get_new_point_on_face(
   const Triangulation<1, 3>::face_iterator &) const
 {
   Assert(false, ExcImpossibleInDim(1));
-  return Point<3>();
+  return {};
 }
 
 
@@ -412,7 +412,7 @@ Manifold<1, 1>::get_new_point_on_quad(
   const Triangulation<1, 1>::quad_iterator &) const
 {
   Assert(false, ExcImpossibleInDim(1));
-  return Point<1>();
+  return {};
 }
 
 
@@ -423,7 +423,7 @@ Manifold<1, 2>::get_new_point_on_quad(
   const Triangulation<1, 2>::quad_iterator &) const
 {
   Assert(false, ExcImpossibleInDim(1));
-  return Point<2>();
+  return {};
 }
 
 
@@ -434,7 +434,7 @@ Manifold<1, 3>::get_new_point_on_quad(
   const Triangulation<1, 3>::quad_iterator &) const
 {
   Assert(false, ExcImpossibleInDim(1));
-  return Point<3>();
+  return {};
 }
 
 
@@ -492,7 +492,7 @@ namespace internal
       // the implementation below is bogus for this case anyway
       // (see the assert at the beginning of that function).
       Assert(false, ExcNotImplemented());
-      return Tensor<1, 3>();
+      return {};
     }
 
 
@@ -808,7 +808,7 @@ FlatManifold<1, 1>::normal_vector(const Triangulation<1, 1>::face_iterator &,
                                   const Point<1> &) const
 {
   Assert(false, ExcNotImplemented());
-  return Tensor<1, 1>();
+  return {};
 }
 
 
@@ -819,7 +819,7 @@ FlatManifold<1, 2>::normal_vector(const Triangulation<1, 2>::face_iterator &,
                                   const Point<2> &) const
 {
   Assert(false, ExcNotImplemented());
-  return Tensor<1, 2>();
+  return {};
 }
 
 
@@ -830,7 +830,7 @@ FlatManifold<1, 3>::normal_vector(const Triangulation<1, 3>::face_iterator &,
                                   const Point<3> &) const
 {
   Assert(false, ExcNotImplemented());
-  return Tensor<1, 3>();
+  return {};
 }
 
 
index c13d73f4053767e3a0f046df3575934244881509..4dd1c9a31d05a003ef2c49d53610f2e27cd2ef6c 100644 (file)
@@ -1268,7 +1268,7 @@ EllipticalManifold<2, 2>::pull_back(const Point<2> &space_point) const
     }
   const double eta = std::acos(cos_eta);
   const double pt1 = (std::signbit(y) ? 2.0 * numbers::PI - eta : eta);
-  return Point<2>(pt0, pt1);
+  return {pt0, pt1};
 }
 
 
@@ -1279,7 +1279,7 @@ EllipticalManifold<dim, spacedim>::push_forward_gradient(
   const Point<spacedim> &) const
 {
   Assert(false, ExcNotImplemented());
-  return DerivativeForm<1, spacedim, spacedim>();
+  return {};
 }
 
 
@@ -1481,7 +1481,7 @@ TorusManifold<dim>::pull_back(const Point<3> &p) const
   double w     = std::sqrt(std::pow(y - std::sin(phi) * R, 2.0) +
                        std::pow(x - std::cos(phi) * R, 2.0) + z * z) /
              r;
-  return Point<3>(phi, theta, w);
+  return {phi, theta, w};
 }
 
 
@@ -1494,9 +1494,9 @@ TorusManifold<dim>::push_forward(const Point<3> &chart_point) const
   double theta = chart_point(1);
   double w     = chart_point(2);
 
-  return Point<3>(std::cos(phi) * R + r * w * std::cos(theta) * std::cos(phi),
-                  r * w * std::sin(theta),
-                  std::sin(phi) * R + r * w * std::cos(theta) * std::sin(phi));
+  return {std::cos(phi) * R + r * w * std::cos(theta) * std::cos(phi),
+          r * w * std::sin(theta),
+          std::sin(phi) * R + r * w * std::cos(theta) * std::sin(phi)};
 }
 
 
index 4e62fde8deb470b1e96afa80aa669863c381a97a..c7a1bfdee33ce6f39dbb2dca3c335120779ff898 100644 (file)
@@ -210,7 +210,7 @@ namespace
                        t9 * y[1] - t11 * y[0] + x[0] * t53 - t59 * x[2] +
                        t59 * x[1] - t39 * x[0];
 
-    return Point<2>(t27 * t37 / 3, t63 * t37 / 3);
+    return {t27 * t37 / 3, t63 * t37 / 3};
   }
 
 
@@ -1233,7 +1233,7 @@ namespace
     s2                    = s3 * s4;
     const double unknown2 = s1 * s2;
 
-    return Point<3>(unknown0, unknown1, unknown2);
+    return {unknown0, unknown1, unknown2};
   }
 
 
@@ -2218,7 +2218,7 @@ CellAccessor<dim, spacedim>::id() const
   Assert(ptr.level() == 0, ExcInternalError());
   const unsigned int coarse_index = ptr.index();
 
-  return CellId(coarse_index, n_child_indices, id.data());
+  return {coarse_index, n_child_indices, id.data()};
 }
 
 
index c872b0d2fcbe3c636b663fb994852bd9f3918938..209043ef6b8a292fdca7167c37551014ccfc7fdb 100644 (file)
@@ -404,7 +404,7 @@ namespace OpenCASCADE
     double u = proj_params.X();
     double v = proj_params.Y();
 
-    return Point<2>(u, v);
+    return {u, v};
   }
 
   template <int dim, int spacedim>

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.