]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Use nullptr 5729/head
authorDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Sat, 13 Jan 2018 16:37:31 +0000 (17:37 +0100)
committerDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Sat, 13 Jan 2018 20:51:26 +0000 (21:51 +0100)
include/deal.II/differentiation/ad/ad_number_traits.h
include/deal.II/fe/fe_values.h
source/base/parameter_acceptor.cc
source/lac/petsc_matrix_base.cc
source/particles/particle.cc
source/particles/particle_accessor.cc

index a1a98589cc9d5f4e4edd3582ce4aacc31b7b8720..ec0b74a37a359617ab121ba12bc2b85150a30824 100644 (file)
@@ -621,7 +621,7 @@ namespace Differentiation
         value (const F &f,
                typename std::enable_if<
                !is_ad_number<F>::value
-               >::type * = 0)
+               >::type * = nullptr)
         -> decltype (dealii::internal::NumberType<T>::value(f))
         {
           // We call the other function defined in the numbers
index b9074bd405ec68d069a1714c51d002f3fba2b978..df7bd6f8f70d248b066c2ff12968d35f6d88b214 100644 (file)
@@ -4365,7 +4365,7 @@ FEValuesBase<dim,spacedim>::shape_value (const unsigned int i,
           ExcAccessToUninitializedField("update_values"));
   Assert (fe->is_primitive (i),
           ExcShapeFunctionNotPrimitive(i));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   // if the entire FE is primitive,
   // then we can take a short-cut:
@@ -4402,7 +4402,7 @@ FEValuesBase<dim,spacedim>::shape_value_component (const unsigned int i,
           ExcAccessToUninitializedField("update_values"));
   Assert (component < fe->n_components(),
           ExcIndexRange(component, 0, fe->n_components()));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
 
   // check whether the shape function
@@ -4433,7 +4433,7 @@ FEValuesBase<dim,spacedim>::shape_grad (const unsigned int i,
           ExcAccessToUninitializedField("update_gradients"));
   Assert (fe->is_primitive (i),
           ExcShapeFunctionNotPrimitive(i));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   // if the entire FE is primitive,
   // then we can take a short-cut:
@@ -4470,7 +4470,7 @@ FEValuesBase<dim,spacedim>::shape_grad_component (const unsigned int i,
           ExcAccessToUninitializedField("update_gradients"));
   Assert (component < fe->n_components(),
           ExcIndexRange(component, 0, fe->n_components()));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   // check whether the shape function
   // is non-zero at all within
@@ -4500,7 +4500,7 @@ FEValuesBase<dim,spacedim>::shape_hessian (const unsigned int i,
           ExcAccessToUninitializedField("update_hessians"));
   Assert (fe->is_primitive (i),
           ExcShapeFunctionNotPrimitive(i));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   // if the entire FE is primitive,
   // then we can take a short-cut:
@@ -4537,7 +4537,7 @@ FEValuesBase<dim,spacedim>::shape_hessian_component (const unsigned int i,
           ExcAccessToUninitializedField("update_hessians"));
   Assert (component < fe->n_components(),
           ExcIndexRange(component, 0, fe->n_components()));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   // check whether the shape function
   // is non-zero at all within
@@ -4567,7 +4567,7 @@ FEValuesBase<dim,spacedim>::shape_3rd_derivative (const unsigned int i,
           ExcAccessToUninitializedField("update_3rd_derivatives"));
   Assert (fe->is_primitive (i),
           ExcShapeFunctionNotPrimitive(i));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   // if the entire FE is primitive,
   // then we can take a short-cut:
@@ -4604,7 +4604,7 @@ FEValuesBase<dim,spacedim>::shape_3rd_derivative_component (const unsigned int i
           ExcAccessToUninitializedField("update_3rd_derivatives"));
   Assert (component < fe->n_components(),
           ExcIndexRange(component, 0, fe->n_components()));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   // check whether the shape function
   // is non-zero at all within
@@ -4658,7 +4658,7 @@ FEValuesBase<dim,spacedim>::get_quadrature_points () const
 {
   Assert (this->update_flags & update_quadrature_points,
           ExcAccessToUninitializedField("update_quadrature_points"));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   return this->mapping_output.quadrature_points;
 }
@@ -4672,7 +4672,7 @@ FEValuesBase<dim,spacedim>::get_JxW_values () const
 {
   Assert (this->update_flags & update_JxW_values,
           ExcAccessToUninitializedField("update_JxW_values"));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   return this->mapping_output.JxW_values;
 }
@@ -4686,7 +4686,7 @@ FEValuesBase<dim,spacedim>::get_jacobians () const
 {
   Assert (this->update_flags & update_jacobians,
           ExcAccessToUninitializedField("update_jacobians"));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   return this->mapping_output.jacobians;
 }
@@ -4700,7 +4700,7 @@ FEValuesBase<dim,spacedim>::get_jacobian_grads () const
 {
   Assert (this->update_flags & update_jacobian_grads,
           ExcAccessToUninitializedField("update_jacobians_grads"));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   return this->mapping_output.jacobian_grads;
 }
@@ -4714,7 +4714,7 @@ FEValuesBase<dim,spacedim>::jacobian_pushed_forward_grad (const unsigned int i)
 {
   Assert (this->update_flags & update_jacobian_pushed_forward_grads,
           ExcAccessToUninitializedField("update_jacobian_pushed_forward_grads"));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   return this->mapping_output.jacobian_pushed_forward_grads[i];
 }
@@ -4728,7 +4728,7 @@ FEValuesBase<dim,spacedim>::get_jacobian_pushed_forward_grads () const
 {
   Assert (this->update_flags & update_jacobian_pushed_forward_grads,
           ExcAccessToUninitializedField("update_jacobian_pushed_forward_grads"));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   return this->mapping_output.jacobian_pushed_forward_grads;
 }
@@ -4742,7 +4742,7 @@ FEValuesBase<dim,spacedim>::jacobian_2nd_derivative (const unsigned int i) const
 {
   Assert (this->update_flags & update_jacobian_2nd_derivatives,
           ExcAccessToUninitializedField("update_jacobian_2nd_derivatives"));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   return this->mapping_output.jacobian_2nd_derivatives[i];
 }
@@ -4756,7 +4756,7 @@ FEValuesBase<dim,spacedim>::get_jacobian_2nd_derivatives () const
 {
   Assert (this->update_flags & update_jacobian_2nd_derivatives,
           ExcAccessToUninitializedField("update_jacobian_2nd_derivatives"));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   return this->mapping_output.jacobian_2nd_derivatives;
 }
@@ -4770,7 +4770,7 @@ FEValuesBase<dim,spacedim>::jacobian_pushed_forward_2nd_derivative (const unsign
 {
   Assert (this->update_flags & update_jacobian_pushed_forward_2nd_derivatives,
           ExcAccessToUninitializedField("update_jacobian_pushed_forward_2nd_derivatives"));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   return this->mapping_output.jacobian_pushed_forward_2nd_derivatives[i];
 }
@@ -4784,7 +4784,7 @@ FEValuesBase<dim,spacedim>::get_jacobian_pushed_forward_2nd_derivatives () const
 {
   Assert (this->update_flags & update_jacobian_pushed_forward_2nd_derivatives,
           ExcAccessToUninitializedField("update_jacobian_pushed_forward_2nd_derivatives"));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   return this->mapping_output.jacobian_pushed_forward_2nd_derivatives;
 }
@@ -4798,7 +4798,7 @@ FEValuesBase<dim,spacedim>::jacobian_3rd_derivative (const unsigned int i) const
 {
   Assert (this->update_flags & update_jacobian_3rd_derivatives,
           ExcAccessToUninitializedField("update_jacobian_3rd_derivatives"));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   return this->mapping_output.jacobian_3rd_derivatives[i];
 }
@@ -4812,7 +4812,7 @@ FEValuesBase<dim,spacedim>::get_jacobian_3rd_derivatives () const
 {
   Assert (this->update_flags & update_jacobian_3rd_derivatives,
           ExcAccessToUninitializedField("update_jacobian_3rd_derivatives"));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   return this->mapping_output.jacobian_3rd_derivatives;
 }
@@ -4826,7 +4826,7 @@ FEValuesBase<dim,spacedim>::jacobian_pushed_forward_3rd_derivative (const unsign
 {
   Assert (this->update_flags & update_jacobian_pushed_forward_3rd_derivatives,
           ExcAccessToUninitializedField("update_jacobian_pushed_forward_3rd_derivatives"));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   return this->mapping_output.jacobian_pushed_forward_3rd_derivatives[i];
 }
@@ -4840,7 +4840,7 @@ FEValuesBase<dim,spacedim>::get_jacobian_pushed_forward_3rd_derivatives () const
 {
   Assert (this->update_flags & update_jacobian_pushed_forward_3rd_derivatives,
           ExcAccessToUninitializedField("update_jacobian_pushed_forward_3rd_derivatives"));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   return this->mapping_output.jacobian_pushed_forward_3rd_derivatives;
 }
@@ -4853,7 +4853,7 @@ FEValuesBase<dim,spacedim>::get_inverse_jacobians () const
 {
   Assert (this->update_flags & update_inverse_jacobians,
           ExcAccessToUninitializedField("update_inverse_jacobians"));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   return this->mapping_output.inverse_jacobians;
 }
@@ -4869,7 +4869,7 @@ FEValuesBase<dim,spacedim>::quadrature_point (const unsigned int i) const
           ExcAccessToUninitializedField("update_quadrature_points"));
   Assert (i<this->mapping_output.quadrature_points.size(),
           ExcIndexRange(i, 0, this->mapping_output.quadrature_points.size()));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
 
   return this->mapping_output.quadrature_points[i];
@@ -4887,7 +4887,7 @@ FEValuesBase<dim,spacedim>::JxW (const unsigned int i) const
           ExcAccessToUninitializedField("update_JxW_values"));
   Assert (i<this->mapping_output.JxW_values.size(),
           ExcIndexRange(i, 0, this->mapping_output.JxW_values.size()));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
 
   return this->mapping_output.JxW_values[i];
@@ -4904,7 +4904,7 @@ FEValuesBase<dim,spacedim>::jacobian (const unsigned int i) const
           ExcAccessToUninitializedField("update_jacobians"));
   Assert (i<this->mapping_output.jacobians.size(),
           ExcIndexRange(i, 0, this->mapping_output.jacobians.size()));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
 
   return this->mapping_output.jacobians[i];
@@ -4921,7 +4921,7 @@ FEValuesBase<dim,spacedim>::jacobian_grad (const unsigned int i) const
           ExcAccessToUninitializedField("update_jacobians_grads"));
   Assert (i<this->mapping_output.jacobian_grads.size(),
           ExcIndexRange(i, 0, this->mapping_output.jacobian_grads.size()));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
 
   return this->mapping_output.jacobian_grads[i];
@@ -4938,7 +4938,7 @@ FEValuesBase<dim,spacedim>::inverse_jacobian (const unsigned int i) const
           ExcAccessToUninitializedField("update_inverse_jacobians"));
   Assert (i<this->mapping_output.inverse_jacobians.size(),
           ExcIndexRange(i, 0, this->mapping_output.inverse_jacobians.size()));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
 
   return this->mapping_output.inverse_jacobians[i];
@@ -4954,7 +4954,7 @@ FEValuesBase<dim,spacedim>::normal_vector (const unsigned int i) const
           (typename FEValuesBase<dim,spacedim>::ExcAccessToUninitializedField("update_normal_vectors")));
   Assert (i<this->mapping_output.normal_vectors.size(),
           ExcIndexRange(i, 0, this->mapping_output.normal_vectors.size()));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
 
   return this->mapping_output.normal_vectors[i];
index e065144564b388fb6ae4384e8ac30f69ba51c475..d717199e84071e7aca621be6d7d2ac2a2ae2b790 100644 (file)
@@ -38,7 +38,7 @@ ParameterAcceptor::ParameterAcceptor(const std::string &name) :
 
 ParameterAcceptor::~ParameterAcceptor()
 {
-  class_list[acceptor_id] = 0;
+  class_list[acceptor_id] = nullptr;
 }
 
 std::string ParameterAcceptor::get_section_name() const
@@ -154,7 +154,7 @@ void ParameterAcceptor::parse_parameters(ParameterHandler &)
 void ParameterAcceptor::parse_all_parameters(ParameterHandler &prm)
 {
   for (unsigned int i=0; i< class_list.size(); ++i)
-    if (class_list[i] != NULL)
+    if (class_list[i] != nullptr)
       {
         class_list[i]->enter_my_subsection(prm);
         class_list[i]->parse_parameters(prm);
@@ -166,7 +166,7 @@ void ParameterAcceptor::parse_all_parameters(ParameterHandler &prm)
 void ParameterAcceptor::declare_all_parameters(ParameterHandler &prm)
 {
   for (unsigned int i=0; i< class_list.size(); ++i)
-    if (class_list[i] != NULL)
+    if (class_list[i] != nullptr)
       {
         class_list[i]->enter_my_subsection(prm);
         class_list[i]->declare_parameters(prm);
@@ -198,7 +198,7 @@ ParameterAcceptor::get_section_path() const
       // trailing /, then the full path is used, else only the path except the
       // last one
       for (int i=acceptor_id-1; i>=0; --i)
-        if (class_list[i] != NULL)
+        if (class_list[i] != nullptr)
           {
             bool has_trailing  = class_list[i]->get_section_name().back() == sep;
             auto previous_path = class_list[i]->get_section_path();
index cd1e821f99722e8f4285a21aba87b6d66259b0e2..f43df8ae5530c15c0cc7e93045bcd6fb0535109d 100644 (file)
@@ -544,7 +544,7 @@ namespace PETScWrappers
               ierr = MatTranspose(tmp, MAT_REUSE_MATRIX, &tmp);
               AssertThrow (ierr == 0, ExcPETScError(ierr));
             }
-          ierr = MatDiagonalScale (tmp, NULL, V);
+          ierr = MatDiagonalScale (tmp, nullptr, V);
           AssertThrow (ierr == 0, ExcPETScError(ierr));
           ierr = MatMatMult (tmp,
                              inputright,
index e06fe14bca5ef7ae9285d1d394900e2ca357a151..d1dbc5b643e3c5a8412fb822f1618f69dad2d5aa 100644 (file)
@@ -25,7 +25,7 @@ namespace Particles
     location (),
     reference_location(),
     id (0),
-    property_pool(NULL),
+    property_pool(nullptr),
     properties(PropertyPool::invalid_handle)
   {
   }
@@ -40,7 +40,7 @@ namespace Particles
     location (location),
     reference_location (reference_location),
     id (id),
-    property_pool(NULL),
+    property_pool(nullptr),
     properties (PropertyPool::invalid_handle)
   {
   }
@@ -292,7 +292,7 @@ namespace Particles
   const ArrayView<const double>
   Particle<dim,spacedim>::get_properties () const
   {
-    Assert(property_pool != NULL,
+    Assert(property_pool != nullptr,
            ExcInternalError());
 
     return property_pool->get_properties(properties);
@@ -304,7 +304,7 @@ namespace Particles
   const ArrayView<double>
   Particle<dim,spacedim>::get_properties ()
   {
-    Assert(property_pool != NULL,
+    Assert(property_pool != nullptr,
            ExcInternalError());
 
     return property_pool->get_properties(properties);
@@ -316,7 +316,7 @@ namespace Particles
   bool
   Particle<dim,spacedim>::has_properties () const
   {
-    return (property_pool != NULL)
+    return (property_pool != nullptr)
            && (properties != PropertyPool::invalid_handle);
   }
 }
index f7f3eb62b665ed1ea7693f7be52e98df1ff85bb7..115765269bb78bab337279e8f227f32f722b8b76 100644 (file)
@@ -22,7 +22,7 @@ namespace Particles
   template <int dim, int spacedim>
   ParticleAccessor<dim,spacedim>::ParticleAccessor ()
     :
-    map (NULL),
+    map (nullptr),
     particle ()
   {}
 

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.