]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Use nullptr for null pointers
authorDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Thu, 6 Apr 2017 23:08:28 +0000 (01:08 +0200)
committerDaniel Arndt <d.arndt@math.uni-goettingen.de>
Sat, 8 Apr 2017 18:43:54 +0000 (20:43 +0200)
292 files changed:
examples/step-13/step-13.cc
examples/step-17/step-17.cc
examples/step-18/step-18.cc
examples/step-32/step-32.cc
examples/step-34/step-34.cc
include/deal.II/algorithms/any_data.h
include/deal.II/algorithms/operator.templates.h
include/deal.II/algorithms/theta_timestepping.templates.h
include/deal.II/base/aligned_vector.h
include/deal.II/base/array_view.h
include/deal.II/base/data_out_base.h
include/deal.II/base/function.templates.h
include/deal.II/base/index_set.h
include/deal.II/base/logstream.h
include/deal.II/base/memory_consumption.h
include/deal.II/base/parameter_handler.h
include/deal.II/base/smartpointer.h
include/deal.II/base/subscriptor.h
include/deal.II/base/thread_management.h
include/deal.II/base/time_stepping.templates.h
include/deal.II/base/work_stream.h
include/deal.II/dofs/dof_accessor.templates.h
include/deal.II/dofs/dof_handler.h
include/deal.II/fe/fe_enriched.h
include/deal.II/fe/fe_poly.templates.h
include/deal.II/fe/fe_poly_face.templates.h
include/deal.II/fe/fe_tools.h
include/deal.II/grid/filtered_iterator.h
include/deal.II/grid/grid_out.h
include/deal.II/grid/grid_tools.h
include/deal.II/grid/tria.h
include/deal.II/grid/tria_accessor.h
include/deal.II/grid/tria_accessor.templates.h
include/deal.II/grid/tria_iterator.h
include/deal.II/grid/tria_iterator.templates.h
include/deal.II/grid/tria_objects.h
include/deal.II/hp/dof_handler.h
include/deal.II/lac/block_matrix_base.h
include/deal.II/lac/block_sparse_matrix.templates.h
include/deal.II/lac/block_vector.h
include/deal.II/lac/block_vector_base.h
include/deal.II/lac/chunk_sparse_matrix.h
include/deal.II/lac/chunk_sparse_matrix.templates.h
include/deal.II/lac/constraint_matrix.h
include/deal.II/lac/constraint_matrix.templates.h
include/deal.II/lac/iterative_inverse.h
include/deal.II/lac/la_parallel_block_vector.templates.h
include/deal.II/lac/la_parallel_vector.templates.h
include/deal.II/lac/la_vector.templates.h
include/deal.II/lac/packaged_operation.h
include/deal.II/lac/petsc_compatibility.h
include/deal.II/lac/pointer_matrix.h
include/deal.II/lac/precondition.h
include/deal.II/lac/precondition_block.h
include/deal.II/lac/precondition_block.templates.h
include/deal.II/lac/precondition_selector.h
include/deal.II/lac/read_write_vector.h
include/deal.II/lac/read_write_vector.templates.h
include/deal.II/lac/relaxation_block.h
include/deal.II/lac/relaxation_block.templates.h
include/deal.II/lac/solver_bicgstab.h
include/deal.II/lac/solver_cg.h
include/deal.II/lac/solver_gmres.h
include/deal.II/lac/solver_minres.h
include/deal.II/lac/solver_richardson.h
include/deal.II/lac/sparse_decomposition.h
include/deal.II/lac/sparse_decomposition.templates.h
include/deal.II/lac/sparse_matrix.h
include/deal.II/lac/sparse_matrix.templates.h
include/deal.II/lac/sparse_matrix_ez.h
include/deal.II/lac/sparse_vanka.h
include/deal.II/lac/sparse_vanka.templates.h
include/deal.II/lac/sparsity_pattern.h
include/deal.II/lac/trilinos_precondition.h
include/deal.II/lac/trilinos_sparse_matrix.h
include/deal.II/lac/trilinos_sparsity_pattern.h
include/deal.II/lac/trilinos_vector.h
include/deal.II/lac/trilinos_vector_base.h
include/deal.II/lac/vector.h
include/deal.II/lac/vector.templates.h
include/deal.II/lac/vector_memory.h
include/deal.II/lac/vector_memory.templates.h
include/deal.II/lac/vector_operations_internal.h
include/deal.II/lac/vector_view.h
include/deal.II/matrix_free/dof_info.h
include/deal.II/matrix_free/dof_info.templates.h
include/deal.II/matrix_free/fe_evaluation.h
include/deal.II/matrix_free/mapping_info.templates.h
include/deal.II/matrix_free/matrix_free.h
include/deal.II/matrix_free/matrix_free.templates.h
include/deal.II/matrix_free/operators.h
include/deal.II/matrix_free/shape_info.templates.h
include/deal.II/meshworker/assembler.h
include/deal.II/meshworker/dof_info.h
include/deal.II/meshworker/integration_info.h
include/deal.II/meshworker/loop.h
include/deal.II/meshworker/output.h
include/deal.II/meshworker/simple.h
include/deal.II/multigrid/mg_block_smoother.h
include/deal.II/multigrid/mg_coarse.h
include/deal.II/multigrid/mg_smoother.h
include/deal.II/multigrid/mg_transfer.templates.h
include/deal.II/multigrid/mg_transfer_component.templates.h
include/deal.II/multigrid/multigrid.h
include/deal.II/multigrid/multigrid.templates.h
include/deal.II/numerics/data_postprocessor.h
include/deal.II/numerics/dof_output_operator.templates.h
include/deal.II/numerics/error_estimator.h
include/deal.II/numerics/error_estimator.templates.h
include/deal.II/numerics/matrix_creator.templates.h
include/deal.II/numerics/matrix_tools.h
include/deal.II/numerics/solution_transfer.h
include/deal.II/numerics/vector_tools.h
include/deal.II/numerics/vector_tools.templates.h
source/base/exceptions.cc
source/base/function_parser.cc
source/base/index_set.cc
source/base/job_identifier.cc
source/base/logstream.cc
source/base/mpi.cc
source/base/multithread_info.cc
source/base/parameter_handler.cc
source/base/path_search.cc
source/base/polynomial.cc
source/base/subscriptor.cc
source/base/thread_management.cc
source/base/timer.cc
source/base/utilities.cc
source/distributed/p4est_wrappers.cc
source/distributed/shared_tria.cc
source/distributed/solution_transfer.cc
source/distributed/tria.cc
source/dofs/dof_accessor.cc
source/dofs/dof_accessor_get.cc
source/dofs/dof_accessor_set.cc
source/dofs/dof_handler.cc
source/dofs/dof_handler_policy.cc
source/dofs/dof_tools.cc
source/dofs/dof_tools_constraints.cc
source/dofs/dof_tools_sparsity.cc
source/fe/fe_bernstein.cc
source/fe/fe_dgp.cc
source/fe/fe_dgp_monomial.cc
source/fe/fe_dgp_nonparametric.cc
source/fe/fe_dgq.cc
source/fe/fe_enriched.cc
source/fe/fe_face.cc
source/fe/fe_nedelec.cc
source/fe/fe_nothing.cc
source/fe/fe_poly.cc
source/fe/fe_poly_tensor.cc
source/fe/fe_q_base.cc
source/fe/fe_q_bubbles.cc
source/fe/fe_q_dg0.cc
source/fe/fe_q_hierarchical.cc
source/fe/fe_raviart_thomas_nodal.cc
source/fe/fe_system.cc
source/fe/fe_tools.cc
source/fe/fe_tools_extrapolate.cc
source/fe/fe_tools_interpolate.cc
source/fe/fe_trace.cc
source/fe/fe_values.cc
source/fe/mapping_cartesian.cc
source/fe/mapping_fe_field.cc
source/fe/mapping_manifold.cc
source/fe/mapping_q.cc
source/fe/mapping_q_generic.cc
source/grid/grid_generator.cc
source/grid/grid_in.cc
source/grid/grid_out.cc
source/grid/grid_tools.cc
source/grid/intergrid_map.cc
source/grid/manifold_lib.cc
source/grid/tria.cc
source/grid/tria_boundary.cc
source/hp/dof_handler.cc
source/hp/fe_values.cc
source/lac/block_matrix_array.cc
source/lac/block_sparsity_pattern.cc
source/lac/chunk_sparsity_pattern.cc
source/lac/constraint_matrix.cc
source/lac/exceptions.cc
source/lac/lapack_full_matrix.cc
source/lac/petsc_matrix_base.cc
source/lac/petsc_matrix_free.cc
source/lac/petsc_parallel_sparse_matrix.cc
source/lac/petsc_parallel_vector.cc
source/lac/petsc_precondition.cc
source/lac/petsc_solver.cc
source/lac/petsc_sparse_matrix.cc
source/lac/petsc_vector_base.cc
source/lac/slepc_solver.cc
source/lac/slepc_spectral_transformation.cc
source/lac/sparse_direct.cc
source/lac/sparsity_pattern.cc
source/lac/sparsity_tools.cc
source/lac/tridiagonal_matrix.cc
source/lac/trilinos_block_sparse_matrix.cc
source/lac/trilinos_epetra_vector.cc
source/lac/trilinos_precondition.cc
source/lac/trilinos_precondition_ml.cc
source/lac/trilinos_precondition_muelu.cc
source/lac/trilinos_sparse_matrix.cc
source/lac/trilinos_sparsity_pattern.cc
source/lac/trilinos_vector.cc
source/lac/trilinos_vector_base.cc
source/multigrid/mg_level_global_transfer.cc
source/multigrid/mg_transfer_block.cc
source/multigrid/mg_transfer_internal.cc
source/multigrid/mg_transfer_prebuilt.cc
source/multigrid/multigrid.cc
source/numerics/data_out.cc
source/numerics/data_out_dof_data.cc
source/numerics/data_out_faces.cc
source/numerics/data_out_rotation.cc
source/numerics/data_out_stack.cc
source/numerics/error_estimator_1d.cc
source/numerics/point_value_history.cc
source/numerics/solution_transfer.cc
source/numerics/time_dependent.cc
tests/algorithms/any_data_01.cc
tests/algorithms/newton_02.cc
tests/aniso/up_and_down.cc
tests/base/array_view_06.cc
tests/base/memory_consumption_02.cc
tests/base/patterns_01.cc
tests/bits/error_estimator_01.cc
tests/bits/error_estimator_02.cc
tests/bits/step-13.cc
tests/bits/step-14.cc
tests/codim_one/bem_integration.cc
tests/codim_one/error_estimator_01.cc
tests/codim_one/error_estimator_02.cc
tests/dofs/dof_renumbering_02.cc
tests/dofs/dof_renumbering_03.cc
tests/dofs/dof_renumbering_04.cc
tests/dofs/dof_renumbering_05.cc
tests/dofs/dof_renumbering_06.cc
tests/dofs/dof_renumbering_07.cc
tests/dofs/dof_renumbering_08.cc
tests/dofs/dof_renumbering_zorder_01.cc
tests/dofs/dof_renumbering_zorder_02.cc
tests/dofs/dof_test.cc
tests/dofs/dof_tools_14.cc
tests/dofs/dof_tools_16a.cc
tests/dofs/dof_tools_16b.cc
tests/dofs/dof_tools_16c.cc
tests/dofs/dof_tools_16d.cc
tests/fail/hp-step-14.cc
tests/fail/rt_6.cc
tests/fe/abf_01.cc
tests/fe/abf_02.cc
tests/fe/deformed_projection.h
tests/fe/up_and_down.cc
tests/grid/grid_transform_02.cc
tests/grid/grid_transform_3d.cc
tests/grid/intergrid_constraints.cc
tests/hp/create_laplace_matrix_constraints_02.cc
tests/hp/create_laplace_matrix_constraints_02b.cc
tests/hp/create_mass_matrix_constraints_02.cc
tests/hp/create_mass_matrix_constraints_02b.cc
tests/hp/step-13.cc
tests/integrators/cochain_01.cc
tests/integrators/mesh_worker_03.cc
tests/lac/constraints.cc
tests/mappings/mapping.cc
tests/metis/metis_01a.cc
tests/mpi/tria_ghost_owners_01.cc
tests/mpi/tria_ghost_owners_02.cc
tests/multigrid/mg_renumbered_02.cc
tests/multigrid/mg_renumbered_03.cc
tests/numerics/boundaries.cc
tests/numerics/create_laplace_matrix_constraints_01.cc
tests/numerics/create_laplace_matrix_constraints_02.cc
tests/numerics/create_laplace_matrix_constraints_02b.cc
tests/numerics/create_mass_matrix_constraints_01.cc
tests/numerics/create_mass_matrix_constraints_02.cc
tests/numerics/create_mass_matrix_constraints_02b.cc
tests/numerics/error_estimator.cc
tests/numerics/error_estimator_02.cc
tests/numerics/project_boundary_01.cc
tests/physics/step-18-rotation_matrix.cc
tests/physics/step-18.cc
tests/quick_tests/affinity.cc
tests/serialization/pointer_01.cc
tests/serialization/pointer_05.cc
tests/slepc/00.cc
tests/slepc_complex/00.cc
tests/trilinos/mg_transfer_prebuilt_01.cc
tests/vector_tools/integrate_difference_02.cc
tests/vector_tools/integrate_difference_03.cc
tests/vector_tools/integrate_difference_04.cc

index 0ee0a64f93f9fee44170a452227f9e522bad47fc..a80a185976e5d6cc673448805823bc83df04be3b 100644 (file)
@@ -1466,7 +1466,7 @@ namespace Step13
 
     // Create a solver object of the kind indicated by the argument to this
     // function. If the name is not recognized, throw an exception!
-    LaplaceSolver::Base<dim> *solver = 0;
+    LaplaceSolver::Base<dim> *solver = nullptr;
     if (solver_name == "global")
       solver = new LaplaceSolver::RefinementGlobal<dim> (triangulation, fe,
                                                          quadrature,
index e3966f8f34f63c3c1bf92d15a36505c4caab2b75..e5c5968b685e4e82db99e7e75627e75d2440a5f4 100644 (file)
@@ -782,7 +782,7 @@ namespace Step17
                                         localized_solution,
                                         local_error_per_cell,
                                         ComponentMask(),
-                                        0,
+                                        nullptr,
                                         MultithreadInfo::n_threads(),
                                         this_mpi_process);
 
index 8097a8a6d6d8c8d75899d6f15db04427d3fd24fe..f0e9af6ffee4d2ddeb00abac7653871c09d4d9ed 100644 (file)
@@ -1510,7 +1510,7 @@ namespace Step18
                                         incremental_displacement,
                                         error_per_cell,
                                         ComponentMask(),
-                                        0,
+                                        nullptr,
                                         MultithreadInfo::n_threads(),
                                         this_mpi_process);
 
index 1479a59274fa9ba9542a7333226203c0d6969765..4fbf5042d74a84a60b35ecd75a584ace86784e48 100644 (file)
@@ -3479,7 +3479,7 @@ namespace Step32
                                         temperature_solution,
                                         estimated_error_per_cell,
                                         ComponentMask(),
-                                        0,
+                                        nullptr,
                                         0,
                                         triangulation.locally_owned_subdomain());
 
index fc1981cd56636fbd02524090aad1f0e03a64569a..af57be39f4cc0737443adbb4f0543e046c27d0fc 100644 (file)
@@ -895,7 +895,7 @@ namespace Step34
     Assert(index < fe.dofs_per_cell,
            ExcIndexRange(0, fe.dofs_per_cell, index));
 
-    static Quadrature<1> *q_pointer = NULL;
+    static Quadrature<1> *q_pointer = nullptr;
     if (q_pointer) delete q_pointer;
 
     q_pointer = new QGaussLogR<1>(singular_quadrature_order,
index b1e8c05b1f2f3d30e947064ed705e722eeed6750..23a3027b326ece0b19d027ea8bdbef378ab2a96d 100644 (file)
@@ -215,7 +215,7 @@ AnyData::entry (const unsigned int i)
 {
   AssertIndexRange(i, size());
   type *p = boost::any_cast<type>(&data[i]);
-  Assert(p != 0,
+  Assert(p != nullptr,
          ExcTypeMismatch(typeid(type).name(),data[i].type().name()));
   return *p;
 }
@@ -228,9 +228,9 @@ AnyData::entry (const unsigned int i) const
 {
   AssertIndexRange(i, size());
   const type *p = boost::any_cast<type>(&data[i]);
-  if (p==0 )
+  if (p==nullptr )
     p = boost::any_cast<const type>(&data[i]);
-  Assert(p != 0,
+  Assert(p != nullptr,
          ExcTypeMismatch(typeid(type).name(),data[i].type().name()));
   return *p;
 }
@@ -243,9 +243,9 @@ AnyData::read(const unsigned int i) const
 {
   AssertIndexRange(i, size());
   const type *p = boost::any_cast<type>(&data[i]);
-  if (p==0)
+  if (p==nullptr)
     p = boost::any_cast<const type>(&data[i]);
-  Assert(p != 0,
+  Assert(p != nullptr,
          ExcTypeMismatch(typeid(type).name(),data[i].type().name()));
   return *p;
 }
@@ -258,9 +258,9 @@ AnyData::read_ptr(const unsigned int i) const
 {
   AssertIndexRange(i, size());
   const type *const *p = boost::any_cast<type *>(&data[i]);
-  if (p==0)
+  if (p==nullptr)
     p = boost::any_cast<const type *>(&data[i]);
-  Assert(p != 0,
+  Assert(p != nullptr,
          ExcTypeMismatch(typeid(type *).name(),data[i].type().name()));
   return *p;
 }
@@ -273,10 +273,10 @@ AnyData::try_read_ptr(const unsigned int i) const
 {
   AssertIndexRange(i, size());
   const type *const *p = boost::any_cast<type *>(&data[i]);
-  if (p==0)
+  if (p==nullptr)
     p = boost::any_cast<const type *>(&data[i]);
-  if (p==0)
-    return 0;
+  if (p==nullptr)
+    return nullptr;
   return *p;
 }
 
@@ -357,7 +357,7 @@ AnyData::entry (const std::string &n) const
 {
   const unsigned int i = find(n);
   const type *p = boost::any_cast<type>(&data[i]);
-  Assert(p != 0,
+  Assert(p != nullptr,
          ExcTypeMismatch(typeid(type).name(),data[i].type().name()));
   return *p;
 }
@@ -383,9 +383,9 @@ AnyData::read_ptr(const std::string &n) const
 {
   const unsigned int i = find(n);
   const type *const *p = boost::any_cast<type *>(&data[i]);
-  if (p==0)
+  if (p==nullptr)
     p = boost::any_cast<const type *>(&data[i]);
-  Assert(p != 0,
+  Assert(p != nullptr,
          ExcTypeMismatch(typeid(type).name(),data[i].type().name()));
   return *p;
 }
@@ -417,7 +417,7 @@ AnyData::try_read(const std::string &n) const
     std::find(names.begin(), names.end(), n);
   // Return null pointer if not found
   if (it == names.end())
-    return 0;
+    return nullptr;
 
   // Compute index and return casted pointer
   unsigned int i=it-names.begin();
index 21a40493e823fc2709c5490ce86e0fd02b96b0fa..7b82ebe63f141266346bd1a5c707127c25ee9806 100644 (file)
@@ -32,7 +32,7 @@ namespace Algorithms
   OutputOperator<VectorType>::OutputOperator()
     :
     step (numbers::invalid_unsigned_int),
-    os(0)
+    os(nullptr)
   {}
 
   template <typename VectorType>
@@ -45,13 +45,13 @@ namespace Algorithms
   OutputOperator<VectorType> &
   OutputOperator<VectorType>::operator<< (const AnyData &vectors)
   {
-    if (os == 0)
+    if (os == nullptr)
       {
         deallog << "Step " << step << std::endl;
         for (unsigned int i=0; i<vectors.size(); ++i)
           {
             const VectorType *v = vectors.try_read_ptr<VectorType>(i);
-            if (v == 0) continue;
+            if (v == nullptr) continue;
             deallog << vectors.name(i);
             for (unsigned int j=0; j<v->size(); ++j)
               deallog << ' ' << (*v)(j);
@@ -65,7 +65,7 @@ namespace Algorithms
         for (unsigned int i=0; i<vectors.size(); ++i)
           {
             const VectorType *v = vectors.try_read_ptr<VectorType>(i);
-            if (v == 0) continue;
+            if (v == nullptr) continue;
             for (unsigned int j=0; j<v->size(); ++j)
               (*os) << ' ' << (*v)(j);
           }
index 919c8ae4d080afa7f39d53a5587f77814d0822ee..7b691225abbed359c72b076bed78b9a5e81a403e 100644 (file)
@@ -114,7 +114,7 @@ namespace Algorithms
     src2.add<const double *>(&vtheta, "Theta");
     src2.merge(in);
 
-    if (output != 0)
+    if (output != nullptr)
       (*output) << 0U << out;
 
     for (unsigned int count = 1; d_explicit.time < control.final(); ++count)
@@ -138,7 +138,7 @@ namespace Algorithms
         (*op_explicit)(out1, src1);
         (*op_implicit)(out, src2);
 
-        if (output != 0 && control.print())
+        if (output != nullptr && control.print())
           (*output) << count << out;
 
         d_explicit.time = control.now();
index f4de6d563b682db331f7eb6dd8757d85d5b8d37b..9f3c431e43dccb4f00de4640d2c59fd08f387e31 100644 (file)
@@ -470,9 +470,9 @@ template < class T >
 inline
 AlignedVector<T>::AlignedVector ()
   :
-  _data (0),
-  _end_data (0),
-  _end_allocated (0)
+  _data (nullptr),
+  _end_data (nullptr),
+  _end_allocated (nullptr)
 {}
 
 
@@ -482,9 +482,9 @@ inline
 AlignedVector<T>::AlignedVector (const size_type size,
                                  const T &init)
   :
-  _data (0),
-  _end_data (0),
-  _end_allocated (0)
+  _data (nullptr),
+  _end_data (nullptr),
+  _end_allocated (nullptr)
 {
   if (size > 0)
     resize (size, init);
@@ -505,9 +505,9 @@ template < class T >
 inline
 AlignedVector<T>::AlignedVector (const AlignedVector<T> &vec)
   :
-  _data (0),
-  _end_data (0),
-  _end_allocated (0)
+  _data (nullptr),
+  _end_data (nullptr),
+  _end_allocated (nullptr)
 {
   // copy the data from vec
   reserve (vec._end_data - vec._data);
@@ -650,7 +650,7 @@ AlignedVector<T>::reserve (const size_type size_alloc)
           free(new_data);
         }
       else
-        Assert(new_data == 0, ExcInternalError());
+        Assert(new_data == nullptr, ExcInternalError());
     }
   else if (size_alloc == 0)
     clear();
@@ -663,7 +663,7 @@ inline
 void
 AlignedVector<T>::clear ()
 {
-  if (_data != 0)
+  if (_data != nullptr)
     {
       if (std::is_trivial<T>::value == false)
         while (_end_data != _data)
@@ -671,9 +671,9 @@ AlignedVector<T>::clear ()
 
       free(_data);
     }
-  _data = 0;
-  _end_data = 0;
-  _end_allocated = 0;
+  _data = nullptr;
+  _end_data = nullptr;
+  _end_allocated = nullptr;
 }
 
 
index 6850c1b2a3674333668c212f883422fabe8b3b63..a9f0788161b52fd3a89c0e686f61ef81d07d1539 100644 (file)
@@ -157,7 +157,7 @@ template <typename ElementType>
 inline
 ArrayView<ElementType>::ArrayView()
   :
-  starting_element (NULL),
+  starting_element ((nullptr)),
   n_elements(0)
 {}
 
index b86e49ede706a16d9d058e6ebaa7e2cc96948151..5a9ddd19ac32aab8b23ea5d918f380639f37d573 100644 (file)
@@ -896,8 +896,8 @@ namespace DataOutBase
     /**
      * Constructor.
      */
-    TecplotFlags (const char *tecplot_binary_file_name = NULL,
-                  const char *zone_name = NULL,
+    TecplotFlags (const char *tecplot_binary_file_name = nullptr,
+                  const char *zone_name = nullptr,
                   const double solution_time = -1.0);
 
     /**
index 53f213041c7034bc90f7003a0ea9e362dd006e6d..139bc4737810d9998efc5043687d1ff984d5eb0a 100644 (file)
@@ -451,7 +451,7 @@ ConstantFunction (const Number *begin_ptr, const unsigned int n_components)
   ZeroFunction<dim, Number> (n_components),
   function_value_vector (n_components)
 {
-  Assert (begin_ptr != 0, ExcMessage ("Null pointer encountered!"));
+  Assert (begin_ptr != nullptr, ExcMessage ("Null pointer encountered!"));
   std::copy (begin_ptr, begin_ptr+n_components, function_value_vector.begin());
 }
 
index 2e4864fa344434b2c535976788d3627f33ef0f92..57492087ef1ed83de9935dec4f2f8902590fa0a6 100644 (file)
@@ -917,7 +917,7 @@ IndexSet::size_type IndexSet::IntervalAccessor::n_elements() const
 inline
 bool IndexSet::IntervalAccessor::is_valid() const
 {
-  return index_set != NULL && range_idx < index_set->n_intervals();
+  return index_set !=nullptr&& range_idx < index_set->n_intervals();
 }
 
 inline
@@ -999,7 +999,7 @@ IndexSet::IntervalIterator::IntervalIterator(const IndexSet *idxset, const Index
 
 inline
 IndexSet::IntervalIterator::IntervalIterator()
-  : accessor(NULL)
+  : accessor((nullptr))
 {}
 
 inline
index 6e11df3a49b19fee90bd1022f0a02e686ca8ad15..1ac72713f39146c06e0fb14a098b963b962730d8 100644 (file)
@@ -574,7 +574,7 @@ LogStream::get_stream()
   // note that in all of this we need not worry about thread-safety
   // because we operate on a thread-local object and by definition
   // there can only be one access at a time
-  if (outstreams.get().get() == 0)
+  if (outstreams.get().get() == nullptr)
     {
       outstreams.get().reset (new std::ostringstream);
       outstreams.get()->setf(std::ios::showpoint | std::ios::left);
index 3b85d74db8066073b8be95e523b333a0f8c16406..af99222dd5ca3f198f42e8ba641f16a0f784b0d6 100644 (file)
@@ -280,7 +280,7 @@ namespace MemoryConsumption
   inline
   std::size_t memory_consumption (const char *string)
   {
-    if (string == NULL)
+    if (string == (nullptr))
       {
         return 0;
       }
index bf7dd90e44c8ef025bed6e5f7590e16c9c69e9e8..489ed9cee3b4136b5799dabfd46fd1b899331127 100644 (file)
@@ -288,8 +288,8 @@ namespace Patterns
     /**
      * Creates a new object on the heap using @p new if the given
      * @p description is a valid format (for example created by calling
-     * description() on an existing object), or NULL otherwise. Ownership of
-     * the returned object is transferred to the caller of this function,
+     * description() on an existing object), or nullptr otherwise. Ownership
+     * of the returned object is transferred to the caller of this function,
      * which should be freed using @p delete.
      */
     static Double *create (const std::string &description);
index 3079f9e7aabfc6df4a9d57aa953b3515c556d75a..4c8e5fadfa3b673d505bfc45b48e3cd519c2df12 100644 (file)
@@ -200,7 +200,7 @@ template <typename T, typename P>
 inline
 SmartPointer<T,P>::SmartPointer ()
   :
-  t (0), id(typeid(P).name())
+  t (nullptr), id(typeid(P).name())
 {}
 
 
@@ -211,7 +211,7 @@ SmartPointer<T,P>::SmartPointer (T *t)
   :
   t (t), id(typeid(P).name())
 {
-  if (t != 0)
+  if (t != nullptr)
     t->subscribe(id);
 }
 
@@ -223,7 +223,7 @@ SmartPointer<T,P>::SmartPointer (T *t, const char *id)
   :
   t (t), id(id)
 {
-  if (t != 0)
+  if (t != nullptr)
     t->subscribe(id);
 }
 
@@ -248,7 +248,7 @@ SmartPointer<T,P>::SmartPointer (const SmartPointer<T,P> &tt)
   :
   t (tt.t), id(tt.id)
 {
-  if (t != 0)
+  if (t != nullptr)
     t->subscribe(id);
 }
 
@@ -258,7 +258,7 @@ template <typename T, typename P>
 inline
 SmartPointer<T,P>::~SmartPointer ()
 {
-  if (t != 0)
+  if (t != nullptr)
     t->unsubscribe(id);
 }
 
@@ -288,10 +288,10 @@ SmartPointer<T,P> &SmartPointer<T,P>::operator = (T *tt)
   if (t == tt)
     return *this;
 
-  if (t != 0)
+  if (t != nullptr)
     t->unsubscribe(id);
   t = tt;
-  if (tt != 0)
+  if (tt != nullptr)
     tt->subscribe(id);
   return *this;
 }
@@ -331,10 +331,10 @@ SmartPointer<T,P>::operator = (const SmartPointer<T,P> &tt)
   if (&tt == this)
     return *this;
 
-  if (t != 0)
+  if (t != nullptr)
     t->unsubscribe(id);
   t = static_cast<T *>(tt);
-  if (tt != 0)
+  if (tt != nullptr)
     tt->subscribe(id);
   return *this;
 }
@@ -354,7 +354,7 @@ template <typename T, typename P>
 inline
 T &SmartPointer<T,P>::operator * () const
 {
-  Assert(t != 0, ExcNotInitialized());
+  Assert(t != nullptr, ExcNotInitialized());
   return *t;
 }
 
@@ -364,7 +364,7 @@ template <typename T, typename P>
 inline
 T *SmartPointer<T,P>::operator -> () const
 {
-  Assert(t != 0, ExcNotInitialized());
+  Assert(t != nullptr, ExcNotInitialized());
   return t;
 }
 
index 4e13aef71797b7eba152c674f918e844d9117aea..f826949f8c22cc8dda5b184df12316267271416c 100644 (file)
@@ -101,7 +101,7 @@ public:
    * Subscribes a user of the object. The subscriber may be identified by text
    * supplied as <tt>identifier</tt>.
    */
-  void subscribe (const char *identifier = 0) const;
+  void subscribe (const char *identifier = nullptr) const;
 
   /**
    * Unsubscribes a user from the object.
@@ -109,7 +109,7 @@ public:
    * @note The <tt>identifier</tt> must be the <b>same pointer</b> as the one
    * supplied to subscribe(), not just the same text.
    */
-  void unsubscribe (const char *identifier = 0) const;
+  void unsubscribe (const char *identifier = nullptr) const;
 
   /**
    * Return the present number of subscriptions to this object. This allows to
index d4833cf784775c64789548b1939ac1031a3be475..938729295459b04ec8492f91a6b9a48bd2063b6d 100644 (file)
@@ -192,8 +192,8 @@ namespace Threads
      * raises an exception if the <code>count</code> argument is one.
      */
     DummyBarrier (const unsigned int  count,
-                  const char         *name = 0,
-                  void               *arg  = 0);
+                  const char         *name = nullptr,
+                  void               *arg  = nullptr);
 
     /**
      * Wait for all threads to reach this point. Since there may only be one
@@ -416,8 +416,8 @@ namespace Threads
      * Constructor. Initialize the underlying POSIX barrier data structure.
      */
     PosixThreadBarrier (const unsigned int  count,
-                        const char         *name = 0,
-                        void               *arg  = 0);
+                        const char         *name = nullptr,
+                        void               *arg  = nullptr);
 
     /**
      * Destructor. Release all resources.
@@ -720,7 +720,7 @@ namespace Threads
     private:
       RT *value;
     public:
-      inline return_value () : value(0) {}
+      inline return_value () : value(nullptr) {}
 
       inline RT &get () const
       {
@@ -2782,7 +2782,7 @@ namespace Threads
           {
             internal::handle_unknown_exception ();
           }
-        return 0;
+        return nullptr;
       }
 
       /**
@@ -2900,7 +2900,7 @@ namespace Threads
     TaskDescriptor<RT>::TaskDescriptor (const std::function<RT ()> &function)
       :
       function (function),
-      task(NULL),
+      task((nullptr)),
       task_is_done (false)
     {}
 
@@ -2970,7 +2970,7 @@ namespace Threads
       // of the arena". rather, let's explicitly destroy the empty
       // task object. before that, make sure that the task has been
       // shut down, expressed by a zero reference count
-      AssertNothrow (task != 0, ExcInternalError());
+      AssertNothrow (task != nullptr, ExcInternalError());
       AssertNothrow (task->ref_count()==0, ExcInternalError());
       task->destroy (*task);
     }
index c105d7c56e49af192dade8eff5b1c67944df5295..f7342a1a0e79a58b0fad9c28a54c72dfc24174a9 100644 (file)
@@ -415,7 +415,7 @@ namespace TimeStepping
     refine_tol(refine_tol),
     coarsen_tol(coarsen_tol),
     last_same_as_first(false),
-    last_stage(NULL)
+    last_stage((nullptr))
   {
     initialize(method);
   }
@@ -665,10 +665,10 @@ namespace TimeStepping
   template <typename VectorType>
   void EmbeddedExplicitRungeKutta<VectorType>::free_memory()
   {
-    if (last_stage!=NULL)
+    if (last_stage!=(nullptr))
       delete last_stage;
 
-    last_stage = NULL;
+    last_stage = (nullptr);
   }
 
 
@@ -762,7 +762,7 @@ namespace TimeStepping
     // Save the last stage if necessary
     if (last_same_as_first==true)
       {
-        if (last_stage==NULL)
+        if (last_stage==(nullptr))
           last_stage = new VectorType(f_stages.back());
         else
           *last_stage = f_stages.back();
@@ -817,7 +817,7 @@ namespace TimeStepping
     // of the first stage.
     if (last_same_as_first==true)
       {
-        if (last_stage!=NULL)
+        if (last_stage!=(nullptr))
           {
             f_stages[0] = *last_stage;
             i = 1;
index b15ed0926673adae399e1cd0000ad6ddea529ec0..f57a06d603f1a350f2a2dd05948f8cad3fa55d7b 100644 (file)
@@ -306,8 +306,8 @@ namespace WorkStream
           ItemType ()
             :
             n_items (0),
-            scratch_data (0),
-            sample_scratch_data (0),
+            scratch_data (nullptr),
+            sample_scratch_data (nullptr),
             currently_in_use (false)
           {}
         };
@@ -367,7 +367,7 @@ namespace WorkStream
           // another thread where we release items and set 'false'
           // flags to 'true', but that too does not produce any
           // problems)
-          ItemType *current_item = 0;
+          ItemType *current_item = nullptr;
           for (unsigned int i=0; i<item_buffer.size(); ++i)
             if (item_buffer[i].currently_in_use == false)
               {
@@ -375,7 +375,7 @@ namespace WorkStream
                 current_item = &item_buffer[i];
                 break;
               }
-          Assert (current_item != 0, ExcMessage ("This can't be. There must be a free item!"));
+          Assert (current_item != nullptr, ExcMessage ("This can't be. There must be a free item!"));
 
           // initialize the next item. it may
           // consist of at most chunk_size
@@ -396,7 +396,7 @@ namespace WorkStream
           if (current_item->n_items == 0)
             // there were no items
             // left. terminate the pipeline
-            return 0;
+            return nullptr;
           else
             return current_item;
         }
@@ -513,7 +513,7 @@ namespace WorkStream
           // we can't take an iterator into the list now and expect it to
           // still be valid after calling the worker, but we at least do
           // not have to lock the following section
-          ScratchData *scratch_data = 0;
+          ScratchData *scratch_data = nullptr;
           {
             typename ItemType::ScratchDataList &
             scratch_data_list = current_item->scratch_data->get();
@@ -531,7 +531,7 @@ namespace WorkStream
                 }
 
             // if no object was found, create one and mark it as used
-            if (scratch_data == 0)
+            if (scratch_data == nullptr)
               {
                 scratch_data = new ScratchData(*current_item->sample_scratch_data);
 
@@ -672,7 +672,7 @@ namespace WorkStream
 
           // return an invalid item since we are at the end of the
           // pipeline
-          return 0;
+          return nullptr;
         }
 
 
@@ -790,8 +790,8 @@ namespace WorkStream
           // This means that we can't take an iterator into the list
           // now and expect it to still be valid after calling the worker,
           // but we at least do not have to lock the following section.
-          ScratchData *scratch_data = 0;
-          CopyData    *copy_data    = 0;
+          ScratchData *scratch_data = nullptr;
+          CopyData    *copy_data    = nullptr;
           {
             ScratchAndCopyDataList &scratch_and_copy_data_list = data.get();
 
@@ -809,9 +809,9 @@ namespace WorkStream
                 }
 
             // if no element in the list was found, create one and mark it as used
-            if (scratch_data == 0)
+            if (scratch_data == nullptr)
               {
-                Assert (copy_data==0, ExcInternalError());
+                Assert (copy_data==nullptr, ExcInternalError());
                 scratch_data = new ScratchData(sample_scratch_data);
                 copy_data    = new CopyData(sample_copy_data);
 
index 45043e91f0246313a8d3aa543d47d1c9d22bd482..a3e5fc0ab43f927d02321eb4cd801c86f9f02403 100644 (file)
@@ -60,7 +60,7 @@ DoFAccessor (const Triangulation<DoFHandlerType::dimension,DoFHandlerType::space
                                                index),
   dof_handler(const_cast<DoFHandlerType *>(dof_handler))
 {
-  Assert (tria == NULL || &dof_handler->get_triangulation() == tria,
+  Assert (tria ==nullptr|| &dof_handler->get_triangulation() == tria,
           ExcMessage ("You can't create a DoF accessor in which the DoFHandler object "
                       "uses a different triangulation than the one you pass as argument."));
 }
@@ -83,7 +83,7 @@ inline
 DoFAccessor<structdim,DoFHandlerType,level_dof_access>::DoFAccessor
 (const DoFAccessor<dim2, DoFHandlerType2, level_dof_access2> &other)
   : BaseClass(other),
-    dof_handler(0)
+    dof_handler(nullptr)
 {
   Assert (false, ExcMessage("You are trying to assign iterators that are incompatible. "
                             "Reasons for incompatibility are that they point to different "
@@ -112,7 +112,7 @@ inline
 void
 DoFAccessor<structdim,DoFHandlerType,level_dof_access>::set_dof_handler (DoFHandlerType *dh)
 {
-  Assert (dh != 0, ExcInvalidObject());
+  Assert (dh != nullptr, ExcInvalidObject());
   this->dof_handler = dh;
 }
 
@@ -134,7 +134,7 @@ void
 DoFAccessor<structdim,DoFHandlerType,level_dof_access>::copy_from
 (const TriaAccessorBase<structdim, DoFHandlerType::dimension, DoFHandlerType::space_dimension> &da)
 {
-  Assert (this->dof_handler != 0, ExcInvalidObject());
+  Assert (this->dof_handler != nullptr, ExcInvalidObject());
   BaseClass::copy_from(da);
 }
 
@@ -1088,7 +1088,7 @@ namespace internal
         (void)fe_index;
         Assert ((fe_index == dealii::DoFHandler<dim,spacedim>::default_fe_index),
                 ExcMessage ("Only the default FE index is allowed for non-hp DoFHandler objects"));
-        Assert (dof_handler.selected_fe != 0,
+        Assert (dof_handler.selected_fe != nullptr,
                 ExcMessage ("No finite element collection is associated with "
                             "this DoFHandler"));
         Assert (local_index < dof_handler.selected_fe->dofs_per_vertex,
@@ -1114,7 +1114,7 @@ namespace internal
         Assert ( (fe_index != dealii::hp::DoFHandler<dim,spacedim>::default_fe_index),
                  ExcMessage ("You need to specify a FE index when working "
                              "with hp DoFHandlers"));
-        Assert (dof_handler.finite_elements != 0,
+        Assert (dof_handler.finite_elements != nullptr,
                 ExcMessage ("No finite element collection is associated with "
                             "this DoFHandler"));
         Assert (local_index < (*dof_handler.finite_elements)[fe_index].dofs_per_vertex,
@@ -1177,7 +1177,7 @@ namespace internal
         (void)fe_index;
         Assert ((fe_index == dealii::DoFHandler<dim,spacedim>::default_fe_index),
                 ExcMessage ("Only the default FE index is allowed for non-hp DoFHandler objects"));
-        Assert (dof_handler.selected_fe != 0,
+        Assert (dof_handler.selected_fe != nullptr,
                 ExcMessage ("No finite element collection is associated with "
                             "this DoFHandler"));
         Assert (local_index < dof_handler.selected_fe->dofs_per_vertex,
@@ -1202,7 +1202,7 @@ namespace internal
         Assert ( (fe_index != dealii::hp::DoFHandler<dim,spacedim>::default_fe_index),
                  ExcMessage ("You need to specify a FE index when working "
                              "with hp DoFHandlers"));
-        Assert (dof_handler.finite_elements != 0,
+        Assert (dof_handler.finite_elements != nullptr,
                 ExcMessage ("No finite element collection is associated with "
                             "this DoFHandler"));
         Assert (local_index < (*dof_handler.finite_elements)[fe_index].dofs_per_vertex,
@@ -1255,7 +1255,7 @@ namespace internal
       n_active_vertex_fe_indices (const dealii::hp::DoFHandler<dim,spacedim> &dof_handler,
                                   const unsigned int vertex_index)
       {
-        Assert (dof_handler.finite_elements != 0,
+        Assert (dof_handler.finite_elements != nullptr,
                 ExcMessage ("No finite element collection is associated with "
                             "this DoFHandler"));
 
@@ -1303,7 +1303,7 @@ namespace internal
                                   const unsigned int vertex_index,
                                   const unsigned int n)
       {
-        Assert (dof_handler.finite_elements != 0,
+        Assert (dof_handler.finite_elements != nullptr,
                 ExcMessage ("No finite element collection is associated with "
                             "this DoFHandler"));
         Assert (n < n_active_vertex_fe_indices(dof_handler, vertex_index),
@@ -1606,7 +1606,7 @@ DoFAccessor<structdim, DoFHandlerType,level_dof_access>::mg_vertex_dof_index (co
     const unsigned int fe_index) const
 {
   (void)fe_index;
-  Assert (this->dof_handler != 0, ExcInvalidObject ());
+  Assert (this->dof_handler != nullptr, ExcInvalidObject ());
   Assert (vertex < GeometryInfo<structdim>::vertices_per_cell, ExcIndexRange (vertex, 0, GeometryInfo<structdim>::vertices_per_cell));
   Assert (i < this->dof_handler->get_fe ()[fe_index].dofs_per_vertex, ExcIndexRange (i, 0, this->dof_handler->get_fe ()[fe_index].dofs_per_vertex));
   return this->dof_handler->mg_vertex_dofs[this->vertex_index (vertex)].get_index (level, i);
@@ -1641,7 +1641,7 @@ DoFAccessor<structdim, DoFHandlerType,level_dof_access>::set_mg_vertex_dof_index
  const unsigned int            fe_index) const
 {
   (void)fe_index;
-  Assert (this->dof_handler != 0, ExcInvalidObject ());
+  Assert (this->dof_handler != nullptr, ExcInvalidObject ());
   Assert (vertex < GeometryInfo<structdim>::vertices_per_cell, ExcIndexRange (vertex, 0, GeometryInfo<structdim>::vertices_per_cell));
   Assert (i < this->dof_handler->get_fe ()[fe_index].dofs_per_vertex, ExcIndexRange (i, 0, this->dof_handler->get_fe ()[fe_index].dofs_per_vertex));
   this->dof_handler->mg_vertex_dofs[this->vertex_index (vertex)].set_index (level, i, index);
@@ -1920,7 +1920,7 @@ DoFAccessor<structdim,DoFHandlerType,level_dof_access>::get_dof_indices
 (std::vector<types::global_dof_index> &dof_indices,
  const unsigned int                    fe_index) const
 {
-  Assert (this->dof_handler != 0, ExcNotInitialized());
+  Assert (this->dof_handler != nullptr, ExcNotInitialized());
   Assert (static_cast<unsigned int>(this->level()) < this->dof_handler->levels.size(),
           ExcMessage ("DoFHandler not initialized"));
 
@@ -1983,7 +1983,7 @@ void DoFAccessor<structdim, DoFHandlerType,level_dof_access>::get_mg_dof_indices
  std::vector<types::global_dof_index> &dof_indices,
  const unsigned int                    fe_index) const
 {
-  Assert (this->dof_handler != 0, ExcInvalidObject ());
+  Assert (this->dof_handler != nullptr, ExcInvalidObject ());
 
   switch (structdim)
     {
@@ -2035,7 +2035,7 @@ void DoFAccessor<structdim, DoFHandlerType,level_dof_access>::set_mg_dof_indices
  const std::vector<types::global_dof_index> &dof_indices,
  const unsigned int                          fe_index)
 {
-  Assert (this->dof_handler != 0, ExcInvalidObject ());
+  Assert (this->dof_handler != nullptr, ExcInvalidObject ());
 
   switch (structdim)
     {
@@ -2245,7 +2245,7 @@ DoFAccessor (const Triangulation<1,spacedim> *,
              const int                 ,
              const DoFHandlerType<1,spacedim> *)
   :
-  dof_handler(0)
+  dof_handler(nullptr)
 {
   Assert (false,
           ExcMessage ("This constructor can not be called for face iterators in 1d."));
@@ -2279,7 +2279,7 @@ void
 DoFAccessor<0,DoFHandlerType<1,spacedim>, level_dof_access>::set_dof_handler
 (DoFHandlerType<1,spacedim> *dh)
 {
-  Assert (dh != 0, ExcInvalidObject());
+  Assert (dh != nullptr, ExcInvalidObject());
   this->dof_handler = dh;
 }
 
@@ -2350,7 +2350,7 @@ get_mg_dof_indices (const int,
 {
   (void) dof_indices;
   (void) fe_index;
-  Assert (this->dof_handler != 0, ExcInvalidObject ());
+  Assert (this->dof_handler != nullptr, ExcInvalidObject ());
   Assert (dof_indices.size () ==
           this->dof_handler->get_fe ()[fe_index].dofs_per_vertex,
           ExcVectorDoesNotMatch ());
@@ -2437,7 +2437,7 @@ const FiniteElement<DoFHandlerType<1,spacedim>::dimension,DoFHandlerType<1,space
 DoFAccessor<0,DoFHandlerType<1,spacedim>, level_dof_access>::
 get_fe (const unsigned int fe_index) const
 {
-  Assert (this->dof_handler != 0, ExcInvalidObject());
+  Assert (this->dof_handler != nullptr, ExcInvalidObject());
   return dof_handler->get_fe()[fe_index];
 }
 
@@ -2994,7 +2994,7 @@ namespace internal
                            const unsigned int                                      i)
       {
         typedef dealii::DoFAccessor<dim,DoFHandler<dim,spacedim>, level_dof_access> BaseClass;
-        Assert (accessor.dof_handler != 0,
+        Assert (accessor.dof_handler != nullptr,
                 typename BaseClass::ExcInvalidObject());
         Assert (static_cast<unsigned int>(accessor.level()) <
                 accessor.dof_handler->levels.size(),
@@ -3015,7 +3015,7 @@ namespace internal
                                   OutputVector   &global_destination)
       {
         typedef dealii::DoFAccessor<dim,DoFHandler<dim,spacedim>, level_dof_access> BaseClass;
-        Assert (accessor.dof_handler != 0,
+        Assert (accessor.dof_handler != nullptr,
                 typename BaseClass::ExcInvalidObject());
         Assert (static_cast<unsigned int>(local_source_end-local_source_begin)
                 ==
@@ -3140,7 +3140,7 @@ namespace internal
                                   OutputMatrix                     &global_destination)
       {
         typedef dealii::DoFAccessor<dim,DoFHandler<dim,spacedim>, level_dof_access> BaseClass;
-        Assert (accessor.dof_handler != 0,
+        Assert (accessor.dof_handler != nullptr,
                 typename BaseClass::ExcInvalidObject());
         Assert (local_source.m() == accessor.get_fe().dofs_per_cell,
                 typename BaseClass::ExcMatrixDoesNotMatch());
@@ -3606,7 +3606,7 @@ const FiniteElement<DoFHandlerType::dimension,DoFHandlerType::space_dimension> &
 DoFCellAccessor<DoFHandlerType,level_dof_access>::get_fe () const
 {
   Assert ((dynamic_cast<const dealii::DoFHandler<DoFHandlerType::dimension,DoFHandlerType::space_dimension>*>
-           (this->dof_handler) != 0)
+           (this->dof_handler) != nullptr)
           ||
           (this->has_children() == false),
           ExcMessage ("In hp::DoFHandler objects, finite elements are only associated "
@@ -3623,7 +3623,7 @@ unsigned int
 DoFCellAccessor<DoFHandlerType,level_dof_access>::active_fe_index () const
 {
   Assert ((dynamic_cast<const dealii::DoFHandler<DoFHandlerType::dimension,DoFHandlerType::space_dimension>*>
-           (this->dof_handler) != 0)
+           (this->dof_handler) != nullptr)
           ||
           (this->has_children() == false),
           ExcMessage ("You can not ask for the active_fe_index on a cell that has "
@@ -3641,7 +3641,7 @@ void
 DoFCellAccessor<DoFHandlerType,level_dof_access>::set_active_fe_index (const unsigned int i)
 {
   Assert ((dynamic_cast<const dealii::DoFHandler<DoFHandlerType::dimension,DoFHandlerType::space_dimension>*>
-           (this->dof_handler) != 0)
+           (this->dof_handler) != nullptr)
           ||
           (this->has_children() == false),
           ExcMessage ("You can not set the active_fe_index on a cell that has "
index 03fc17b4d28b96c0375e8dccb43bfc3b446030e0..c9b88b814865930d2f49db5a98a517901e0712f1 100644 (file)
@@ -1214,7 +1214,7 @@ inline
 const FiniteElement<dim,spacedim> &
 DoFHandler<dim,spacedim>::get_fe () const
 {
-  Assert(selected_fe!=0, ExcMessage("You are trying to access the DoFHandler's FiniteElement object before it has been initialized."));
+  Assert(selected_fe!=nullptr, ExcMessage("You are trying to access the DoFHandler's FiniteElement object before it has been initialized."));
   return *selected_fe;
 }
 
@@ -1225,7 +1225,7 @@ inline
 const Triangulation<dim,spacedim> &
 DoFHandler<dim,spacedim>::get_tria () const
 {
-  Assert(tria != 0, ExcNotInitialized());
+  Assert(tria != nullptr, ExcNotInitialized());
   return *tria;
 }
 
@@ -1236,7 +1236,7 @@ inline
 const Triangulation<dim,spacedim> &
 DoFHandler<dim,spacedim>::get_triangulation () const
 {
-  Assert(tria != 0, ExcNotInitialized());
+  Assert(tria != nullptr, ExcNotInitialized());
   return *tria;
 }
 
@@ -1322,7 +1322,7 @@ void DoFHandler<dim,spacedim>::load (Archive &ar,
     delete levels[i];
   levels.resize (0);
   delete faces;
-  faces = 0;
+  faces = nullptr;
 
   ar &levels;
   ar &faces;
index 4163ae8c2fee2e2bd142ee7464732006540c294d..8f2de8c5d8be2862c56f345faa413941efbc3ecb 100644 (file)
@@ -136,7 +136,7 @@ DEAL_II_NAMESPACE_OPEN
  * @code
  *   FE_Enriched<dim> fe_non_enriched(FE_Q<dim>(1),
  *                                    FE_Nothing<dim>(1,true),
- *                                    NULL);
+ *                                    (nullptr));
  * @endcode
  * and will result in the correct constraints for enriched DoFs attributed to
  * support points on the interface between the two regions.
index 8641d8d19293e49410001fe4158d39dfdb1e2fbb..6095450a8157067945ee95cb888c127ed12bc583 100644 (file)
@@ -231,7 +231,7 @@ fill_fe_values (const typename Triangulation<dim,spacedim>::cell_iterator &,
   // data for this class. fails with
   // an exception if that is not
   // possible
-  Assert (dynamic_cast<const InternalData *> (&fe_internal) != 0, ExcInternalError());
+  Assert (dynamic_cast<const InternalData *> (&fe_internal) != nullptr, ExcInternalError());
   const InternalData &fe_data = static_cast<const InternalData &> (fe_internal);
 
   const UpdateFlags flags(fe_data.update_each);
@@ -293,7 +293,7 @@ fill_fe_face_values (const typename Triangulation<dim,spacedim>::cell_iterator
   // data for this class. fails with
   // an exception if that is not
   // possible
-  Assert (dynamic_cast<const InternalData *> (&fe_internal) != 0, ExcInternalError());
+  Assert (dynamic_cast<const InternalData *> (&fe_internal) != nullptr, ExcInternalError());
   const InternalData &fe_data = static_cast<const InternalData &> (fe_internal);
 
   // offset determines which data set
@@ -372,7 +372,7 @@ fill_fe_subface_values (const typename Triangulation<dim,spacedim>::cell_iterato
   // data for this class. fails with
   // an exception if that is not
   // possible
-  Assert (dynamic_cast<const InternalData *> (&fe_internal) != 0, ExcInternalError());
+  Assert (dynamic_cast<const InternalData *> (&fe_internal) != nullptr, ExcInternalError());
   const InternalData &fe_data = static_cast<const InternalData &> (fe_internal);
 
   // offset determines which data set
index 9b3885777653890cecdb71a9b5a7bb1a419e0947..7247e4e9fe059f96a93af5936e5a40acafc161dd 100644 (file)
@@ -105,7 +105,7 @@ fill_fe_face_values (const typename Triangulation<dim,spacedim>::cell_iterator &
   // data for this class. fails with
   // an exception if that is not
   // possible
-  Assert (dynamic_cast<const InternalData *> (&fe_internal) != 0, ExcInternalError());
+  Assert (dynamic_cast<const InternalData *> (&fe_internal) != nullptr, ExcInternalError());
   const InternalData &fe_data = static_cast<const InternalData &> (fe_internal);
 
   if (fe_data.update_each & update_values)
@@ -176,7 +176,7 @@ fill_fe_subface_values (const typename Triangulation<dim,spacedim>::cell_iterato
   // data for this class. fails with
   // an exception if that is not
   // possible
-  Assert (dynamic_cast<const InternalData *> (&fe_internal) != 0, ExcInternalError());
+  Assert (dynamic_cast<const InternalData *> (&fe_internal) != nullptr, ExcInternalError());
   const InternalData &fe_data = static_cast<const InternalData &> (fe_internal);
 
   const unsigned int foffset = fe_data.shape_values.size() * face_no;
index b8aecedbc12af480e6dbe4a8c0c8783780f3ca4e..98275c16668d8e99880a24558fdcb106b5528d6e 100644 (file)
@@ -994,13 +994,13 @@ namespace FETools
     FiniteElementData<dim>
     multiply_dof_numbers (const FiniteElement<dim,spacedim> *fe1,
                           const unsigned int            N1,
-                          const FiniteElement<dim,spacedim> *fe2=NULL,
+                          const FiniteElement<dim,spacedim> *fe2=nullptr,
                           const unsigned int            N2=0,
-                          const FiniteElement<dim,spacedim> *fe3=NULL,
+                          const FiniteElement<dim,spacedim> *fe3=nullptr,
                           const unsigned int            N3=0,
-                          const FiniteElement<dim,spacedim> *fe4=NULL,
+                          const FiniteElement<dim,spacedim> *fe4=nullptr,
                           const unsigned int            N4=0,
-                          const FiniteElement<dim,spacedim> *fe5=NULL,
+                          const FiniteElement<dim,spacedim> *fe5=nullptr,
                           const unsigned int            N5=0);
 
     /**
@@ -1038,13 +1038,13 @@ namespace FETools
     std::vector<bool>
     compute_restriction_is_additive_flags (const FiniteElement<dim,spacedim> *fe1,
                                            const unsigned int        N1,
-                                           const FiniteElement<dim,spacedim> *fe2=NULL,
+                                           const FiniteElement<dim,spacedim> *fe2=nullptr,
                                            const unsigned int        N2=0,
-                                           const FiniteElement<dim,spacedim> *fe3=NULL,
+                                           const FiniteElement<dim,spacedim> *fe3=nullptr,
                                            const unsigned int        N3=0,
-                                           const FiniteElement<dim,spacedim> *fe4=NULL,
+                                           const FiniteElement<dim,spacedim> *fe4=nullptr,
                                            const unsigned int        N4=0,
-                                           const FiniteElement<dim,spacedim> *fe5=NULL,
+                                           const FiniteElement<dim,spacedim> *fe5=nullptr,
                                            const unsigned int        N5=0);
 
     /**
@@ -1091,13 +1091,13 @@ namespace FETools
     std::vector<ComponentMask>
     compute_nonzero_components (const FiniteElement<dim,spacedim> *fe1,
                                 const unsigned int        N1,
-                                const FiniteElement<dim,spacedim> *fe2=NULL,
+                                const FiniteElement<dim,spacedim> *fe2=nullptr,
                                 const unsigned int        N2=0,
-                                const FiniteElement<dim,spacedim> *fe3=NULL,
+                                const FiniteElement<dim,spacedim> *fe3=nullptr,
                                 const unsigned int        N3=0,
-                                const FiniteElement<dim,spacedim> *fe4=NULL,
+                                const FiniteElement<dim,spacedim> *fe4=nullptr,
                                 const unsigned int        N4=0,
-                                const FiniteElement<dim,spacedim> *fe5=NULL,
+                                const FiniteElement<dim,spacedim> *fe5=nullptr,
                                 const unsigned int        N5=0,
                                 const bool do_tensor_product = true);
 
index 00d9c343ebab9ee0fe35c1cc7b18d85aa312e733..0a9df177d3b9e471989272f1b7ce987b53ee30b9 100644 (file)
@@ -945,7 +945,7 @@ FilteredIterator<BaseIterator>::
 ~FilteredIterator ()
 {
   delete predicate;
-  predicate = 0;
+  predicate = nullptr;
 }
 
 
index 2cd4a58d815c071b4e7b5afcfc8c6bd973dea952..8547991e92a436caf793a6d4367a631a9e65e0c8 100644 (file)
@@ -919,7 +919,7 @@ public:
   template <int dim, int spacedim>
   void write_gnuplot (const Triangulation<dim,spacedim> &tria,
                       std::ostream           &out,
-                      const Mapping<dim,spacedim> *mapping=0) const;
+                      const Mapping<dim,spacedim> *mapping=nullptr) const;
 
   /**
    * Write the triangulation in the msh format.
@@ -998,7 +998,7 @@ public:
   template <int dim, int spacedim>
   void write_eps (const Triangulation<dim, spacedim> &tria,
                   std::ostream             &out,
-                  const Mapping<dim, spacedim>       *mapping=0) const;
+                  const Mapping<dim, spacedim>       *mapping=nullptr) const;
 
   /**
    * Write two-dimensional XFig-file.
@@ -1021,7 +1021,7 @@ public:
   template <int dim, int spacedim>
   void write_xfig (const Triangulation<dim, spacedim> &tria,
                    std::ostream              &out,
-                   const Mapping<dim, spacedim>        *mapping=0) const;
+                   const Mapping<dim, spacedim>        *mapping=nullptr) const;
 
   /**
    * Write the triangulation in the SVG format.
@@ -1128,7 +1128,7 @@ public:
   void write (const Triangulation<dim,spacedim> &tria,
               std::ostream                      &out,
               const OutputFormat                 output_format,
-              const Mapping<dim,spacedim>       *mapping=0) const;
+              const Mapping<dim,spacedim>       *mapping=nullptr) const;
 
   /**
    * Write mesh in default format set by ParameterHandler.
@@ -1136,7 +1136,7 @@ public:
   template <int dim, int spacedim>
   void write (const Triangulation<dim,spacedim> &tria,
               std::ostream                      &out,
-              const Mapping<dim,spacedim>       *mapping=0) const;
+              const Mapping<dim,spacedim>       *mapping=nullptr) const;
 
   /**
    * Set flags for DX output
index 8464c04d2a8028525b31cc31802cf1200b3d0b60..51d9284ccf40fe53af9275d9b1af986b6c597a92 100644 (file)
@@ -351,7 +351,7 @@ namespace GridTools
   template <int dim>
   void laplace_transform (const std::map<unsigned int,Point<dim> > &new_points,
                           Triangulation<dim> &tria,
-                          const Function<dim,double> *coefficient = 0,
+                          const Function<dim,double> *coefficient = nullptr,
                           const bool solve_for_absolute_positions = false);
 
   /**
index 0297637e4af4b86f7b3f4ae1d6ace5b4844fe320..56b9f2aba6e29b2bdd1bbe499fae2d4f8e697b1c 100644 (file)
@@ -930,7 +930,7 @@ namespace internal
  * classes. Again, see
  * @ref GlossUserData "the glossary for more information".
  *
- * The value of these user indices or pointers is @p NULL by default. Note
+ * The value of these user indices or pointers is @pnullptrby default. Note
  * that the pointers are not inherited to children upon refinement. Still,
  * after a remeshing they are available on all cells, where they were set on
  * the previous mesh.
index 5266f721e94de6ebaa558fbf1948c8db1ac7fc8f..0c105a5c6243b69f5f291b724d281cf17b3ffa7b 100644 (file)
@@ -284,10 +284,10 @@ protected:
   /**
    * Constructor. Protected, thus only callable from friend classes.
    */
-  TriaAccessorBase (const Triangulation<dim,spacedim> *parent =  0,
+  TriaAccessorBase (const Triangulation<dim,spacedim> *parent =  nullptr,
                     const int                 level  = -1,
                     const int                 index  = -1,
-                    const AccessorData             * =  0);
+                    const AccessorData             * =  nullptr);
 
   /**
    * Copy constructor. Creates an object with exactly the same data.
@@ -592,10 +592,10 @@ public:
   /**
    * Constructor.
    */
-  TriaAccessor (const Triangulation<dim,spacedim> *parent     =  0,
+  TriaAccessor (const Triangulation<dim,spacedim> *parent     =  nullptr,
                 const int                 level      = -1,
                 const int                 index      = -1,
-                const AccessorData       *local_data =  0);
+                const AccessorData       *local_data =  nullptr);
 
   /**
    * Conversion constructor. This constructor exists to make certain
@@ -1104,7 +1104,7 @@ public:
   void set_user_pointer (void *p) const;
 
   /**
-   * Reset the user pointer to a @p NULL pointer. See
+   * Reset the user pointer to a @pnullptrpointer. See
    * @ref GlossUserData
    * for more information.
    */
@@ -1518,10 +1518,10 @@ public:
    * compatibility with the other accessor classes. @p index can be used to
    * set the global index of the vertex we point to.
    */
-  TriaAccessor (const Triangulation<dim,spacedim> *tria  = NULL,
+  TriaAccessor (const Triangulation<dim,spacedim> *tria  = nullptr,
                 const int                          level = 0,
                 const int                          index = 0,
-                const AccessorData                     * = 0);
+                const AccessorData                     * = nullptr);
 
   /**
    * Constructor. Should never be called and thus produces an error.
@@ -1894,10 +1894,10 @@ public:
    * compatibility with the other accessor classes. However, it doesn't do
    * anything useful here and so may not actually be called.
    */
-  TriaAccessor (const Triangulation<1,spacedim> *tria = 0,
+  TriaAccessor (const Triangulation<1,spacedim> *tria = nullptr,
                 const int = 0,
                 const int = 0,
-                const AccessorData * = 0);
+                const AccessorData * = nullptr);
 
   /**
    * Constructor. Should never be called and thus produces an error.
@@ -2302,10 +2302,10 @@ public:
   /**
    * Constructor.
    */
-  CellAccessor (const Triangulation<dim,spacedim> *parent     =  0,
+  CellAccessor (const Triangulation<dim,spacedim> *parent     =  nullptr,
                 const int                 level      = -1,
                 const int                 index      = -1,
-                const AccessorData       *local_data =  0);
+                const AccessorData       *local_data =  nullptr);
 
   /**
    * Copy constructor.
index 37310ca79ab25a51eba9c674ba5051118a82c013..3380734e6693a1ba75ee0778a023aff71d515d23 100644 (file)
@@ -118,7 +118,7 @@ inline
 bool
 TriaAccessorBase<structdim,dim,spacedim>::operator == (const TriaAccessorBase<structdim,dim,spacedim> &a) const
 {
-  Assert (tria == a.tria || tria == 0 || a.tria == 0,
+  Assert (tria == a.tria || tria == nullptr || a.tria == nullptr,
           TriaAccessorExceptions::ExcCantCompareIterators());
   return ((present_level == a.present_level) &&
           (present_index == a.present_index));
@@ -131,7 +131,7 @@ inline
 bool
 TriaAccessorBase<structdim,dim,spacedim>::operator != (const TriaAccessorBase<structdim,dim,spacedim> &a) const
 {
-  Assert (tria == a.tria || tria == 0 || a.tria == 0,
+  Assert (tria == a.tria || tria == nullptr || a.tria == nullptr,
           TriaAccessorExceptions::ExcCantCompareIterators());
   return ((present_level != a.present_level) ||
           (present_index != a.present_index));
@@ -311,7 +311,7 @@ namespace internal
                  const dealii::internal::int2type<1>)
     {
       Assert (false, ExcInternalError());
-      return 0;
+      return nullptr;
     }
 
     inline
@@ -320,7 +320,7 @@ namespace internal
                  const dealii::internal::int2type<2>)
     {
       Assert (false, ExcInternalError());
-      return 0;
+      return nullptr;
     }
 
     inline
@@ -329,7 +329,7 @@ namespace internal
                  const dealii::internal::int2type<3>)
     {
       Assert (false, ExcInternalError());
-      return 0;
+      return nullptr;
     }
 
     /**
@@ -343,7 +343,7 @@ namespace internal
                  const dealii::internal::int2type<3>)
     {
       Assert (false, ExcInternalError());
-      return 0;
+      return nullptr;
     }
 
     /**
@@ -356,7 +356,7 @@ namespace internal
                  const dealii::internal::int2type<structdim>)
     {
       Assert (false, ExcInternalError());
-      return 0;
+      return nullptr;
     }
 
     template <int dim>
@@ -1705,7 +1705,7 @@ template <int structdim, int dim, int spacedim>
 void TriaAccessor<structdim,dim,spacedim>::clear_user_pointer () const
 {
   Assert (this->used(), TriaAccessorExceptions::ExcCellNotUsed());
-  this->objects().user_pointer(this->present_index) = 0;
+  this->objects().user_pointer(this->present_index) = nullptr;
 }
 
 
@@ -2134,7 +2134,7 @@ inline
 TriaAccessor<0, dim, spacedim>::
 TriaAccessor (const TriaAccessor<structdim2,dim2,spacedim2> &)
   :
-  tria (NULL),
+  tria ((nullptr)),
   global_vertex_index (numbers::invalid_unsigned_int)
 {
   Assert(false, ExcImpossibleInDim(0));
@@ -2148,7 +2148,7 @@ inline
 TriaAccessor<0, dim, spacedim>::
 TriaAccessor (const InvalidAccessor<structdim2,dim2,spacedim2> &)
   :
-  tria (NULL),
+  tria ((nullptr)),
   global_vertex_index (numbers::invalid_unsigned_int)
 {
   Assert(false, ExcImpossibleInDim(0));
@@ -2530,7 +2530,7 @@ inline
 TriaAccessor<0, 1, spacedim>::
 TriaAccessor (const TriaAccessor<structdim2,dim2,spacedim2> &)
   :
-  tria (0),
+  tria (nullptr),
   vertex_kind (interior_vertex),
   global_vertex_index (numbers::invalid_unsigned_int)
 {
@@ -2545,7 +2545,7 @@ inline
 TriaAccessor<0, 1, spacedim>::
 TriaAccessor (const InvalidAccessor<structdim2,dim2,spacedim2> &)
   :
-  tria (0),
+  tria (nullptr),
   vertex_kind (interior_vertex),
   global_vertex_index (numbers::invalid_unsigned_int)
 {
@@ -3383,7 +3383,7 @@ CellAccessor<dim,spacedim>::is_locally_owned () const
   const parallel::Triangulation<dim,spacedim> *pt
     = dynamic_cast<const parallel::Triangulation<dim,spacedim> *>(this->tria);
 
-  if (pt == 0)
+  if (pt == nullptr)
     return true;
   else
     return (this->subdomain_id() == pt->locally_owned_subdomain());
@@ -3405,7 +3405,7 @@ CellAccessor<dim,spacedim>::is_locally_owned_on_level () const
   const parallel::Triangulation<dim,spacedim> *pt
     = dynamic_cast<const parallel::Triangulation<dim,spacedim> *>(this->tria);
 
-  if (pt == 0)
+  if (pt == nullptr)
     return true;
   else
     return (this->level_subdomain_id() == pt->locally_owned_subdomain());
@@ -3431,7 +3431,7 @@ CellAccessor<dim,spacedim>::is_ghost () const
   const parallel::Triangulation<dim,spacedim> *pt
     = dynamic_cast<const parallel::Triangulation<dim,spacedim> *>(this->tria);
 
-  if (pt == 0)
+  if (pt == nullptr)
     return false;
   else
     return (this->subdomain_id() != pt->locally_owned_subdomain());
@@ -3455,7 +3455,7 @@ CellAccessor<dim,spacedim>::is_artificial () const
   const parallel::Triangulation<dim,spacedim> *pt
     = dynamic_cast<const parallel::Triangulation<dim,spacedim> *>(this->tria);
 
-  if (pt == 0)
+  if (pt == nullptr)
     return false;
   else
     return this->subdomain_id() == numbers::artificial_subdomain_id;
index f0b23d7fa5fa99e3a8fc016ce4df896fa1938be6..a3a34885154d89d6afed47ff563c58f4bab756a7 100644 (file)
@@ -272,7 +272,7 @@ public:
   TriaRawIterator (const Triangulation<Accessor::dimension,Accessor::space_dimension> *parent,
                    const int level,
                    const int index,
-                   const typename AccessorType::AccessorData *local_data = 0);
+                   const typename AccessorType::AccessorData *local_data = nullptr);
 
   /**
    * This is a conversion operator (constructor) which takes another iterator
@@ -568,7 +568,7 @@ public:
   TriaIterator (const Triangulation<Accessor::dimension,Accessor::space_dimension> *parent,
                 const int                 level,
                 const int                 index,
-                const typename Accessor::AccessorData *local_data = 0);
+                const typename Accessor::AccessorData *local_data = nullptr);
 
   /**
    * Construct from an accessor of type OtherAccessor that is convertible to
index 4dbaa4f16b393d6d908c7e48a02e522073dada62..1b579eebadd7638ea40c111bb2a7b71167955ea5 100644 (file)
@@ -37,7 +37,7 @@ template <typename Accessor>
 inline
 TriaRawIterator<Accessor>::TriaRawIterator ()
   :
-  accessor (0, -2, -2, 0)
+  accessor (nullptr, -2, -2, nullptr)
 {}
 
 
@@ -68,7 +68,7 @@ TriaRawIterator<Accessor>::TriaRawIterator (
   const TriaAccessorBase<Accessor::structure_dimension,Accessor::dimension,Accessor::space_dimension> &tria_accessor,
   const typename Accessor::AccessorData *local_data)
   :
-  accessor(0, -2, -2, local_data)
+  accessor(nullptr, -2, -2, local_data)
 {
   accessor.copy_from(tria_accessor);
 }
index 2357abbbc9c0820698fbd44bf822f407bdcc6c34..77de4e7f59e55879015bd03c2af9d00ed0d7e0f9 100644 (file)
@@ -371,7 +371,7 @@ namespace internal
          */
         UserData()
         {
-          p = 0;
+          p = nullptr;
         }
 
         /**
@@ -693,7 +693,7 @@ namespace internal
     {
       user_data_type = data_unknown;
       for (unsigned int i=0; i<user_data.size(); ++i)
-        user_data[i].p = 0;
+        user_data[i].p = nullptr;
     }
 
 
index aa9c8d32bd1b6bfff9f22b3ccced6f357b575686..2be4054db81c86aeefa388d924090b49b6cce392 100644 (file)
@@ -1042,7 +1042,7 @@ namespace hp
   const hp::FECollection<dim,spacedim> &
   DoFHandler<dim,spacedim>::get_fe () const
   {
-    Assert (finite_elements != 0,
+    Assert (finite_elements != nullptr,
             ExcMessage ("No finite element collection is associated with "
                         "this DoFHandler"));
     return *finite_elements;
index 587b6812fe388410fbec976feef94b49f1d55c38..e775be4483f33eea4e153967da576e944dae6a21 100644 (file)
@@ -1553,7 +1553,7 @@ BlockMatrixBase<MatrixType>::clear ()
     for (unsigned int c=0; c<n_block_cols(); ++c)
       {
         MatrixType *p = this->sub_objects[r][c];
-        this->sub_objects[r][c] = 0;
+        this->sub_objects[r][c] = nullptr;
         delete p;
       }
   sub_objects.reinit (0,0);
index 22fa11a2ca3df8555867a9ab4fc3c0c0f9cb000e..de2d415560558c1be8c39207cf7f775b52da2437 100644 (file)
@@ -45,7 +45,7 @@ BlockSparseMatrix<number>::~BlockSparseMatrix ()
   // delete previous content of
   // the subobjects array
   clear ();
-  sparsity_pattern = 0;
+  sparsity_pattern = nullptr;
 }
 
 
@@ -78,7 +78,7 @@ void
 BlockSparseMatrix<number>::clear ()
 {
   BlockMatrixBase<SparseMatrix<number> >::clear();
-  sparsity_pattern = 0;
+  sparsity_pattern = nullptr;
 }
 
 
index 2d04587fcf338ff2b1c2235917aceb025e6c2e59..f8ce49936ecc71c3d9a43f31d113804e26734633 100644 (file)
@@ -324,7 +324,7 @@ public:
    *
    * This function is deprecated.
    */
-  void print (const char *format = 0) const DEAL_II_DEPRECATED;
+  void print (const char *format = nullptr) const DEAL_II_DEPRECATED;
 
   /**
    * Print to a stream.
index 394b0f40aa518dc6bd7976508e9a65a50d53b794..6902ce35afb94c6602e7535c6632bec6ac136939 100644 (file)
@@ -88,7 +88,7 @@ public:
    * derived from BlockVectorBase<T>).
    */
   static const bool value = (sizeof(check_for_block_vector
-                                    ((VectorType *)0))
+                                    ((VectorType *)nullptr))
                              ==
                              sizeof(yes_type));
 };
index e784ebc0f27af0e649e912a3df57317c19830369..00ec01ebbb1e2952624bb8fd58e59aa3002c5cf8 100644 (file)
@@ -1368,7 +1368,7 @@ inline
 typename ChunkSparseMatrix<number>::size_type
 ChunkSparseMatrix<number>::m () const
 {
-  Assert (cols != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
   return cols->rows;
 }
 
@@ -1378,7 +1378,7 @@ inline
 typename ChunkSparseMatrix<number>::size_type
 ChunkSparseMatrix<number>::n () const
 {
-  Assert (cols != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
   return cols->cols;
 }
 
@@ -1389,7 +1389,7 @@ inline
 const ChunkSparsityPattern &
 ChunkSparseMatrix<number>::get_sparsity_pattern () const
 {
-  Assert (cols != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
   return *cols;
 }
 
@@ -1427,7 +1427,7 @@ void ChunkSparseMatrix<number>::set (const size_type i,
 
   AssertIsFinite(value);
 
-  Assert (cols != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
   // it is allowed to set elements of the matrix that are not part of the
   // sparsity pattern, if the value to which we set it is zero
   const size_type index = compute_location(i,j);
@@ -1450,7 +1450,7 @@ void ChunkSparseMatrix<number>::add (const size_type i,
 
   AssertIsFinite(value);
 
-  Assert (cols != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
 
   if (value != 0.)
     {
@@ -1486,8 +1486,8 @@ inline
 ChunkSparseMatrix<number> &
 ChunkSparseMatrix<number>::operator *= (const number factor)
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
 
   const size_type chunk_size = cols->get_chunk_size();
 
@@ -1513,8 +1513,8 @@ inline
 ChunkSparseMatrix<number> &
 ChunkSparseMatrix<number>::operator /= (const number factor)
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   Assert (factor !=0, ExcDivideByZero());
 
   const number factor_inv = 1. / factor;
@@ -1544,7 +1544,7 @@ inline
 number ChunkSparseMatrix<number>::operator () (const size_type i,
                                                const size_type j) const
 {
-  Assert (cols != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
   AssertThrow (compute_location(i,j) != SparsityPattern::invalid_entry,
                ExcInvalidIndex(i,j));
   return val[compute_location(i,j)];
@@ -1557,7 +1557,7 @@ inline
 number ChunkSparseMatrix<number>::el (const size_type i,
                                       const size_type j) const
 {
-  Assert (cols != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
   const size_type index = compute_location(i,j);
 
   if (index != ChunkSparsityPattern::invalid_entry)
@@ -1572,7 +1572,7 @@ template <typename number>
 inline
 number ChunkSparseMatrix<number>::diag_element (const size_type i) const
 {
-  Assert (cols != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
   Assert (m() == n(),  ExcNotQuadratic());
   AssertIndexRange(i, m());
 
index 6e26eb92710eef2303f2b642f65173e8dca8b51c..a210200b7b73b3a22fbccd43ac579c07583c00d4 100644 (file)
@@ -285,8 +285,8 @@ namespace internal
 template <typename number>
 ChunkSparseMatrix<number>::ChunkSparseMatrix ()
   :
-  cols(0, "ChunkSparseMatrix"),
-  val(0),
+  cols(nullptr, "ChunkSparseMatrix"),
+  val(nullptr),
   max_len(0)
 {}
 
@@ -296,11 +296,11 @@ template <typename number>
 ChunkSparseMatrix<number>::ChunkSparseMatrix (const ChunkSparseMatrix &m)
   :
   Subscriptor (m),
-  cols(0, "ChunkSparseMatrix"),
-  val(0),
+  cols(nullptr, "ChunkSparseMatrix"),
+  val(nullptr),
   max_len(0)
 {
-  Assert (m.cols==0 && m.val==0 && m.max_len==0,
+  Assert (m.cols==nullptr && m.val==nullptr && m.max_len==0,
           ExcMessage("This constructor can only be called if the provided argument "
                      "is an empty matrix. This constructor can not be used to "
                      "copy-construct a non-empty matrix. Use the "
@@ -314,7 +314,7 @@ ChunkSparseMatrix<number> &
 ChunkSparseMatrix<number>::operator = (const ChunkSparseMatrix<number> &m)
 {
   (void)m;
-  Assert (m.cols==0 && m.val==0 && m.max_len==0,
+  Assert (m.cols==nullptr && m.val==nullptr && m.max_len==0,
           ExcMessage("This operator can only be called if the provided right "
                      "hand side is an empty matrix. This operator can not be "
                      "used to copy a non-empty matrix. Use the "
@@ -328,8 +328,8 @@ ChunkSparseMatrix<number>::operator = (const ChunkSparseMatrix<number> &m)
 template <typename number>
 ChunkSparseMatrix<number>::ChunkSparseMatrix (const ChunkSparsityPattern &c)
   :
-  cols(0, "ChunkSparseMatrix"),
-  val(0),
+  cols(nullptr, "ChunkSparseMatrix"),
+  val(nullptr),
   max_len(0)
 {
   reinit (c);
@@ -341,8 +341,8 @@ template <typename number>
 ChunkSparseMatrix<number>::ChunkSparseMatrix (const ChunkSparsityPattern &c,
                                               const IdentityMatrix  &id)
   :
-  cols(0, "ChunkSparseMatrix"),
-  val(0),
+  cols(nullptr, "ChunkSparseMatrix"),
+  val(nullptr),
   max_len(0)
 {
   (void)id;
@@ -359,9 +359,9 @@ ChunkSparseMatrix<number>::ChunkSparseMatrix (const ChunkSparsityPattern &c,
 template <typename number>
 ChunkSparseMatrix<number>::~ChunkSparseMatrix ()
 {
-  cols = 0;
+  cols = nullptr;
 
-  if (val != 0)
+  if (val != nullptr)
     delete[] val;
 }
 
@@ -390,7 +390,7 @@ ChunkSparseMatrix<number>::operator = (const double d)
   (void)d;
   Assert (d==0, ExcScalarAssignmentOnlyForZeroValue());
 
-  Assert (cols != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
   Assert (cols->sparsity_pattern.compressed || cols->empty(),
           ChunkSparsityPattern::ExcNotCompressed());
 
@@ -448,9 +448,9 @@ ChunkSparseMatrix<number>::reinit (const ChunkSparsityPattern &sparsity)
 
   if (cols->empty())
     {
-      if (val != 0)
+      if (val != nullptr)
         delete[] val;
-      val = 0;
+      val = nullptr;
       max_len = 0;
       return;
     }
@@ -462,7 +462,7 @@ ChunkSparseMatrix<number>::reinit (const ChunkSparsityPattern &sparsity)
                       chunk_size * chunk_size;
   if (N > max_len || max_len == 0)
     {
-      if (val != 0)
+      if (val != nullptr)
         delete[] val;
       val = new number[N];
       max_len = N;
@@ -480,9 +480,9 @@ template <typename number>
 void
 ChunkSparseMatrix<number>::clear ()
 {
-  cols = 0;
+  cols = nullptr;
   if (val) delete[] val;
-  val = 0;
+  val = nullptr;
   max_len = 0;
 }
 
@@ -492,7 +492,7 @@ template <typename number>
 bool
 ChunkSparseMatrix<number>::empty () const
 {
-  if (cols == 0)
+  if (cols == nullptr)
     return true;
   else
     return cols->empty();
@@ -504,7 +504,7 @@ template <typename number>
 typename ChunkSparseMatrix<number>::size_type
 ChunkSparseMatrix<number>::n_nonzero_elements () const
 {
-  Assert (cols != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
   return cols->n_nonzero_elements ();
 }
 
@@ -514,7 +514,7 @@ template <typename number>
 typename ChunkSparseMatrix<number>::size_type
 ChunkSparseMatrix<number>::n_actually_nonzero_elements () const
 {
-  Assert (cols != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
 
   // count those elements that are nonzero, even if they lie in the padding
   // around the matrix. since we have the invariant that padding elements are
@@ -532,7 +532,7 @@ template <typename number>
 void
 ChunkSparseMatrix<number>::symmetrize ()
 {
-  Assert (cols != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
   Assert (cols->rows == cols->cols, ExcNotQuadratic());
 
   Assert (false, ExcNotImplemented());
@@ -545,8 +545,8 @@ template <typename somenumber>
 ChunkSparseMatrix<number> &
 ChunkSparseMatrix<number>::copy_from (const ChunkSparseMatrix<somenumber> &matrix)
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   Assert (cols == matrix.cols, ExcDifferentChunkSparsityPatterns());
 
   // copy everything, including padding elements
@@ -584,8 +584,8 @@ void
 ChunkSparseMatrix<number>::add (const number factor,
                                 const ChunkSparseMatrix<somenumber> &matrix)
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   Assert (cols == matrix.cols, ExcDifferentChunkSparsityPatterns());
 
   // add everything, including padding elements
@@ -661,8 +661,8 @@ void
 ChunkSparseMatrix<number>::vmult (OutVector &dst,
                                   const InVector &src) const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   Assert(m() == dst.size(), ExcDimensionMismatch(m(),dst.size()));
   Assert(n() == src.size(), ExcDimensionMismatch(n(),src.size()));
 
@@ -682,15 +682,15 @@ void
 ChunkSparseMatrix<number>::Tvmult (OutVector &dst,
                                    const InVector &src) const
 {
-  Assert (val != 0, ExcNotInitialized());
-  Assert (cols != 0, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
   Assert(n() == dst.size(), ExcDimensionMismatch(n(),dst.size()));
   Assert(m() == src.size(), ExcDimensionMismatch(m(),src.size()));
 
   Assert (!PointerComparison::equal(&src, &dst), ExcSourceEqualsDestination());
 
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   Assert(m() == dst.size(), ExcDimensionMismatch(m(),dst.size()));
   Assert(n() == src.size(), ExcDimensionMismatch(n(),src.size()));
 
@@ -710,8 +710,8 @@ void
 ChunkSparseMatrix<number>::vmult_add (OutVector &dst,
                                       const InVector &src) const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   Assert(m() == dst.size(), ExcDimensionMismatch(m(),dst.size()));
   Assert(n() == src.size(), ExcDimensionMismatch(n(),src.size()));
 
@@ -737,8 +737,8 @@ void
 ChunkSparseMatrix<number>::Tvmult_add (OutVector &dst,
                                        const InVector &src) const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   Assert(m() == dst.size(), ExcDimensionMismatch(m(),dst.size()));
   Assert(n() == src.size(), ExcDimensionMismatch(n(),src.size()));
 
@@ -830,8 +830,8 @@ template <typename somenumber>
 somenumber
 ChunkSparseMatrix<number>::matrix_norm_square (const Vector<somenumber> &v) const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   Assert(m() == v.size(), ExcDimensionMismatch(m(),v.size()));
   Assert(n() == v.size(), ExcDimensionMismatch(n(),v.size()));
 
@@ -940,8 +940,8 @@ somenumber
 ChunkSparseMatrix<number>::matrix_scalar_product (const Vector<somenumber> &u,
                                                   const Vector<somenumber> &v) const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   Assert(m() == u.size(), ExcDimensionMismatch(m(),u.size()));
   Assert(n() == v.size(), ExcDimensionMismatch(n(),v.size()));
 
@@ -1046,8 +1046,8 @@ template <typename number>
 typename ChunkSparseMatrix<number>::real_type
 ChunkSparseMatrix<number>::l1_norm () const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
 
   const size_type n_chunk_rows = cols->sparsity_pattern.n_rows();
 
@@ -1078,8 +1078,8 @@ template <typename number>
 typename ChunkSparseMatrix<number>::real_type
 ChunkSparseMatrix<number>::linfty_norm () const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
 
   // this function works like l1_norm(). it can be made more efficient
   // (without allocating a temporary vector) as is done in the SparseMatrix
@@ -1133,8 +1133,8 @@ ChunkSparseMatrix<number>::residual (Vector<somenumber>       &dst,
                                      const Vector<somenumber> &u,
                                      const Vector<somenumber> &b) const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   Assert(m() == dst.size(), ExcDimensionMismatch(m(),dst.size()));
   Assert(m() == b.size(), ExcDimensionMismatch(m(),b.size()));
   Assert(n() == u.size(), ExcDimensionMismatch(n(),u.size()));
@@ -1249,8 +1249,8 @@ ChunkSparseMatrix<number>::precondition_Jacobi (Vector<somenumber>       &dst,
 {
   (void)dst;
   (void)src;
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   Assert (m() == n(), ExcMessage("This operation is only valid on square matrices."));
 
   Assert (dst.size() == n(), ExcDimensionMismatch (dst.size(), n()));
@@ -1272,8 +1272,8 @@ ChunkSparseMatrix<number>::precondition_SSOR (Vector<somenumber>       &dst,
   // CVS archives to see the original version which is much clearer...
   (void)dst;
   (void)src;
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   Assert (m() == n(), ExcMessage("This operation is only valid on square matrices."));
 
   Assert (dst.size() == n(), ExcDimensionMismatch (dst.size(), n()));
@@ -1290,8 +1290,8 @@ ChunkSparseMatrix<number>::precondition_SOR (Vector<somenumber> &dst,
                                              const Vector<somenumber> &src,
                                              const number om) const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   Assert (m() == n(), ExcMessage("This operation is only valid on square matrices."));
 
 
@@ -1307,8 +1307,8 @@ ChunkSparseMatrix<number>::precondition_TSOR (Vector<somenumber> &dst,
                                               const Vector<somenumber> &src,
                                               const number om) const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   Assert (m() == n(), ExcMessage("This operation is only valid on square matrices."));
 
 
@@ -1324,8 +1324,8 @@ ChunkSparseMatrix<number>::SOR (Vector<somenumber> &dst,
                                 const number /*om*/) const
 {
   (void)dst;
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   Assert (m() == n(), ExcMessage("This operation is only valid on square matrices."));
   Assert (m() == dst.size(), ExcDimensionMismatch(m(),dst.size()));
 
@@ -1340,8 +1340,8 @@ ChunkSparseMatrix<number>::TSOR (Vector<somenumber> &dst,
                                  const number /*om*/) const
 {
   (void)dst;
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   Assert (m() == n(), ExcMessage("This operation is only valid on square matrices."));
   Assert (m() == dst.size(), ExcDimensionMismatch(m(),dst.size()));
 
@@ -1360,8 +1360,8 @@ ChunkSparseMatrix<number>::PSOR (Vector<somenumber> &dst,
   (void)dst;
   (void)permutation;
   (void)inverse_permutation;
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   Assert (m() == n(), ExcMessage("This operation is only valid on square matrices."));
 
   Assert (m() == dst.size(), ExcDimensionMismatch(m(),dst.size()));
@@ -1385,8 +1385,8 @@ ChunkSparseMatrix<number>::TPSOR (Vector<somenumber> &dst,
   (void)dst;
   (void)permutation;
   (void)inverse_permutation;
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   Assert (m() == n(), ExcMessage("This operation is only valid on square matrices."));
 
   Assert (m() == dst.size(), ExcDimensionMismatch(m(),dst.size()));
@@ -1409,8 +1409,8 @@ ChunkSparseMatrix<number>::SOR_step (Vector<somenumber> &v,
 {
   (void)v;
   (void)b;
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   Assert (m() == n(), ExcMessage("This operation is only valid on square matrices."));
 
   Assert (m() == v.size(), ExcDimensionMismatch(m(),v.size()));
@@ -1430,8 +1430,8 @@ ChunkSparseMatrix<number>::TSOR_step (Vector<somenumber> &v,
 {
   (void)v;
   (void)b;
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   Assert (m() == n(), ExcMessage("This operation is only valid on square matrices."));
 
   Assert (m() == v.size(), ExcDimensionMismatch(m(),v.size()));
@@ -1462,8 +1462,8 @@ ChunkSparseMatrix<number>::SSOR (Vector<somenumber> &dst,
                                  const number /*om*/) const
 {
   (void)dst;
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   Assert (m() == n(), ExcMessage("This operation is only valid on square matrices."));
 
   Assert (m() == dst.size(), ExcDimensionMismatch(m(),dst.size()));
@@ -1478,8 +1478,8 @@ void ChunkSparseMatrix<number>::print (std::ostream &out) const
 {
   AssertThrow (out, ExcIO());
 
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
 
   Assert (false, ExcNotImplemented());
 
@@ -1497,8 +1497,8 @@ void ChunkSparseMatrix<number>::print_formatted (std::ostream &out,
 {
   AssertThrow (out, ExcIO());
 
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
 
   unsigned int width = width_;
 
@@ -1545,8 +1545,8 @@ void ChunkSparseMatrix<number>::print_pattern (std::ostream &out,
 {
   AssertThrow (out, ExcIO());
 
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
 
   const size_type chunk_size = cols->get_chunk_size();
 
index ba56b639732cf840f949358d7dfab303af7336bd..365159117e3e8239a15e47153f779001013a4a9c 100644 (file)
@@ -1567,7 +1567,7 @@ ConstraintMatrix::get_constraint_entries (const size_type line) const
   const size_type line_index = calculate_line_index(line);
   if (line_index >= lines_cache.size() ||
       lines_cache[line_index] == numbers::invalid_size_type)
-    return 0;
+    return nullptr;
   else
     return &lines[lines_cache[line_index]].entries;
 }
@@ -1785,7 +1785,7 @@ public:
    * derived from BlockMatrixBase<T>).
    */
   static const bool value = (sizeof(check_for_block_matrix
-                                    ((MatrixType *)0))
+                                    ((MatrixType *)nullptr))
                              ==
                              sizeof(yes_type));
 };
index 88076c6149c3aeb56374405a41d556ee31ee0160..fdc1b1029d7bffce6ae6871fac67c0dd68a278f2 100644 (file)
@@ -680,7 +680,7 @@ distribute_local_to_global (const Vector<LocalType>      &local_vector,
         // global dof index
         const size_type line_index = calculate_line_index (local_dof_indices_col[i]);
         const ConstraintLine *position =
-          lines_cache.size() <= line_index ? 0 : &lines[lines_cache[line_index]];
+          lines_cache.size() <= line_index ? nullptr : &lines[lines_cache[line_index]];
 
         // Gauss elimination of the matrix columns with the inhomogeneity.
         // Go through them one by one and again check whether they are
@@ -757,7 +757,7 @@ namespace internal
       const Epetra_MpiComm *mpi_comm
         = dynamic_cast<const Epetra_MpiComm *>(&vec.trilinos_vector().Comm());
 
-      Assert (mpi_comm != 0, ExcInternalError());
+      Assert (mpi_comm != nullptr, ExcInternalError());
       output.reinit (needed_elements, mpi_comm->GetMpiComm());
 #else
       output.reinit (needed_elements, MPI_COMM_WORLD);
@@ -2283,7 +2283,7 @@ ConstraintMatrix::distribute_local_to_global (
       vals.resize (n_actual_dofs);
     }
   else
-    Assert (sparse_matrix != 0, ExcInternalError());
+    Assert (sparse_matrix != nullptr, ExcInternalError());
 
   // now do the actual job. go through all the global rows that we will touch
   // and call resolve_matrix_row for each of those.
@@ -2512,7 +2512,7 @@ distribute_local_to_global (const FullMatrix<typename MatrixType::value_type>  &
                   SparseMatrix<number> *sparse_matrix
                     = dynamic_cast<SparseMatrix<number> *>(&global_matrix.block(block,
                                                            block_col));
-                  Assert (sparse_matrix != 0, ExcInternalError());
+                  Assert (sparse_matrix != nullptr, ExcInternalError());
                   internals::resolve_matrix_row (global_rows, i, start_block,
                                                  end_block, local_matrix, sparse_matrix);
                 }
index d9ab0537a1f21a513c52dc6c75b8203d935181e3..190936dc43787058457a7ee48016c7187147dec9 100644 (file)
@@ -149,8 +149,8 @@ template <typename VectorType>
 inline void
 IterativeInverse<VectorType>::vmult (VectorType &dst, const VectorType &src) const
 {
-  Assert(matrix.get() != 0, ExcNotInitialized());
-  Assert(preconditioner.get() != 0, ExcNotInitialized());
+  Assert(matrix.get() != nullptr, ExcNotInitialized());
+  Assert(preconditioner.get() != nullptr, ExcNotInitialized());
   dst = 0.;
   solver.solve(*matrix, dst, src, *preconditioner);
 }
index 645f387933c64eacbd17af607c1d961db3f4cd8e..cdce69c73a8d3daf807849caee3b990a539c2bf5 100644 (file)
@@ -316,7 +316,7 @@ namespace LinearAlgebra
     BlockVector<Number>::scale (const VectorSpaceVector<Number> &vv)
     {
       // Downcast. Throws an exception if invalid.
-      Assert(dynamic_cast<const BlockVector<Number> *>(&vv)!=NULL,
+      Assert(dynamic_cast<const BlockVector<Number> *>(&vv)!=nullptr,
              ExcVectorTypeNotCompatible());
       const BlockVector<Number> &v = dynamic_cast<const BlockVector<Number> &>(vv);
       AssertDimension(this->n_blocks(), v.n_blocks());
@@ -332,7 +332,7 @@ namespace LinearAlgebra
                               const VectorSpaceVector<Number> &vv)
     {
       // Downcast. Throws an exception if invalid.
-      Assert(dynamic_cast<const BlockVector<Number> *>(&vv)!=NULL,
+      Assert(dynamic_cast<const BlockVector<Number> *>(&vv)!=nullptr,
              ExcVectorTypeNotCompatible());
       const BlockVector<Number> &v = dynamic_cast<const BlockVector<Number> &>(vv);
       AssertDimension(this->n_blocks(), v.n_blocks());
@@ -362,7 +362,7 @@ namespace LinearAlgebra
     BlockVector<Number>::operator += (const VectorSpaceVector<Number> &vv)
     {
       // Downcast. Throws an exception if invalid.
-      Assert(dynamic_cast<const BlockVector<Number> *>(&vv)!=NULL,
+      Assert(dynamic_cast<const BlockVector<Number> *>(&vv)!=nullptr,
              ExcVectorTypeNotCompatible());
       const BlockVector<Number> &v = dynamic_cast<const BlockVector<Number> &>(vv);
       AssertDimension(this->n_blocks(), v.n_blocks());
@@ -379,7 +379,7 @@ namespace LinearAlgebra
     BlockVector<Number>::operator -= (const VectorSpaceVector<Number> &vv)
     {
       // Downcast. Throws an exception if invalid.
-      Assert(dynamic_cast<const BlockVector<Number> *>(&vv)!=NULL,
+      Assert(dynamic_cast<const BlockVector<Number> *>(&vv)!=nullptr,
              ExcVectorTypeNotCompatible());
       const BlockVector<Number> &v = dynamic_cast<const BlockVector<Number> &>(vv);
       AssertDimension(this->n_blocks(), v.n_blocks());
@@ -407,7 +407,7 @@ namespace LinearAlgebra
                               const VectorSpaceVector<Number> &vv)
     {
       // Downcast. Throws an exception if invalid.
-      Assert(dynamic_cast<const BlockVector<Number> *>(&vv)!=NULL,
+      Assert(dynamic_cast<const BlockVector<Number> *>(&vv)!=nullptr,
              ExcVectorTypeNotCompatible());
       const BlockVector<Number> &v = dynamic_cast<const BlockVector<Number> &>(vv);
       AssertDimension(this->n_blocks(), v.n_blocks());
@@ -425,11 +425,11 @@ namespace LinearAlgebra
                               const VectorSpaceVector<Number> &ww)
     {
       // Downcast. Throws an exception if invalid.
-      Assert(dynamic_cast<const BlockVector<Number> *>(&vv)!=NULL,
+      Assert(dynamic_cast<const BlockVector<Number> *>(&vv)!=nullptr,
              ExcVectorTypeNotCompatible());
       const BlockVector<Number> &v = dynamic_cast<const BlockVector<Number> &>(vv);
       AssertDimension(this->n_blocks(), v.n_blocks());
-      Assert(dynamic_cast<const BlockVector<Number> *>(&ww)!=NULL,
+      Assert(dynamic_cast<const BlockVector<Number> *>(&ww)!=nullptr,
              ExcVectorTypeNotCompatible());
       const BlockVector<Number> &w = dynamic_cast<const BlockVector<Number> &>(ww);
       AssertDimension(this->n_blocks(), v.n_blocks());
@@ -447,7 +447,7 @@ namespace LinearAlgebra
                                const VectorSpaceVector<Number> &vv)
     {
       // Downcast. Throws an exception if invalid.
-      Assert(dynamic_cast<const BlockVector<Number> *>(&vv)!=NULL,
+      Assert(dynamic_cast<const BlockVector<Number> *>(&vv)!=nullptr,
              ExcVectorTypeNotCompatible());
       const BlockVector<Number> &v = dynamic_cast<const BlockVector<Number> &>(vv);
       AssertDimension(this->n_blocks(), v.n_blocks());
@@ -541,7 +541,7 @@ namespace LinearAlgebra
       Assert (this->n_blocks() > 0, ExcEmptyObject());
 
       // Downcast. Throws an exception if invalid.
-      Assert(dynamic_cast<const BlockVector<Number> *>(&vv)!=NULL,
+      Assert(dynamic_cast<const BlockVector<Number> *>(&vv)!=nullptr,
              ExcVectorTypeNotCompatible());
       const BlockVector<Number> &v = dynamic_cast<const BlockVector<Number> &>(vv);
       AssertDimension(this->n_blocks(), v.n_blocks());
@@ -669,13 +669,13 @@ namespace LinearAlgebra
                                       const VectorSpaceVector<Number> &ww)
     {
       // Downcast. Throws an exception if invalid.
-      Assert(dynamic_cast<const BlockVector<Number> *>(&vv)!=NULL,
+      Assert(dynamic_cast<const BlockVector<Number> *>(&vv)!=nullptr,
              ExcVectorTypeNotCompatible());
       const BlockVector<Number> &v = dynamic_cast<const BlockVector<Number> &>(vv);
       AssertDimension(this->n_blocks(), v.n_blocks());
 
       // Downcast. Throws an exception if invalid.
-      Assert(dynamic_cast<const BlockVector<Number> *>(&ww)!=NULL,
+      Assert(dynamic_cast<const BlockVector<Number> *>(&ww)!=nullptr,
              ExcVectorTypeNotCompatible());
       const BlockVector<Number> &w = dynamic_cast<const BlockVector<Number> &>(ww);
       AssertDimension(this->n_blocks(), w.n_blocks());
index e096652690769969fd0392ffe37eda9c718f0051..d23101c5b4affbcd7de21c189600bb0d9e714d6a 100644 (file)
@@ -62,9 +62,9 @@ namespace LinearAlgebra
     {
       if (new_alloc_size > allocated_size)
         {
-          Assert (((allocated_size > 0 && val != 0) ||
-                   val == 0), ExcInternalError());
-          if (val != 0)
+          Assert (((allocated_size > 0 && val != nullptr) ||
+                   val == nullptr), ExcInternalError());
+          if (val != nullptr)
             free(val);
 
           Utilities::System::posix_memalign ((void **)&val, 64, sizeof(Number)*new_alloc_size);
@@ -73,9 +73,9 @@ namespace LinearAlgebra
         }
       else if (new_alloc_size == 0)
         {
-          if (val != 0)
+          if (val != nullptr)
             free(val);
-          val = 0;
+          val = nullptr;
           allocated_size = 0;
         }
       thread_loop_partitioner.reset(new ::dealii::parallel::internal::TBBPartitioner());
@@ -94,9 +94,9 @@ namespace LinearAlgebra
       resize_val (size);
 
       // delete previous content in import data
-      if (import_data != 0)
+      if (import_data != nullptr)
         delete[] import_data;
-      import_data = 0;
+      import_data = nullptr;
 
       // set partitioner to serial version
       partitioner.reset (new Utilities::MPI::Partitioner (size));
@@ -117,7 +117,7 @@ namespace LinearAlgebra
                             const bool             omit_zeroing_entries)
     {
       clear_mpi_requests();
-      Assert (v.partitioner.get() != 0, ExcNotInitialized());
+      Assert (v.partitioner.get() != nullptr, ExcNotInitialized());
 
       // check whether the partitioners are
       // different (check only if the are allocated
@@ -134,7 +134,7 @@ namespace LinearAlgebra
       if (omit_zeroing_entries == false)
         this->operator= (Number());
 
-      if (import_data != 0)
+      if (import_data != nullptr)
         {
           delete [] import_data;
 
@@ -142,7 +142,7 @@ namespace LinearAlgebra
           // is only used as temporary storage for compress() and
           // update_ghost_values, and we might have vectors where we never
           // call these methods and hence do not need to have the storage.
-          import_data = 0;
+          import_data = nullptr;
         }
 
       vector_is_ghosted = false;
@@ -196,7 +196,7 @@ namespace LinearAlgebra
       // initialize to zero
       this->operator= (Number());
 
-      if (import_data != 0)
+      if (import_data != nullptr)
         {
           delete [] import_data;
 
@@ -204,7 +204,7 @@ namespace LinearAlgebra
           // is only used as temporary storage for compress() and
           // update_ghost_values, and we might have vectors where we never
           // call these methods and hence do not need to have the storage.
-          import_data = 0;
+          import_data = nullptr;
         }
 
       vector_is_ghosted = false;
@@ -217,8 +217,8 @@ namespace LinearAlgebra
       :
       partitioner (new Utilities::MPI::Partitioner()),
       allocated_size (0),
-      val (0),
-      import_data (0)
+      val (nullptr),
+      import_data (nullptr)
     {
       reinit(0);
     }
@@ -230,8 +230,8 @@ namespace LinearAlgebra
       :
       Subscriptor(),
       allocated_size (0),
-      val (0),
-      import_data (0),
+      val (nullptr),
+      import_data (nullptr),
       vector_is_ghosted (false)
     {
       reinit (v, true);
@@ -252,8 +252,8 @@ namespace LinearAlgebra
                             const MPI_Comm  communicator)
       :
       allocated_size (0),
-      val (0),
-      import_data (0),
+      val (nullptr),
+      import_data (nullptr),
       vector_is_ghosted (false)
     {
       reinit (local_range, ghost_indices, communicator);
@@ -266,8 +266,8 @@ namespace LinearAlgebra
                             const MPI_Comm  communicator)
       :
       allocated_size (0),
-      val (0),
-      import_data (0),
+      val (nullptr),
+      import_data (nullptr),
       vector_is_ghosted (false)
     {
       reinit (local_range, communicator);
@@ -279,8 +279,8 @@ namespace LinearAlgebra
     Vector<Number>::Vector (const size_type size)
       :
       allocated_size (0),
-      val (0),
-      import_data (0),
+      val (nullptr),
+      import_data (nullptr),
       vector_is_ghosted (false)
     {
       reinit (size, false);
@@ -293,8 +293,8 @@ namespace LinearAlgebra
     Vector (const std::shared_ptr<const Utilities::MPI::Partitioner> &partitioner)
       :
       allocated_size (0),
-      val (0),
-      import_data (0),
+      val (nullptr),
+      import_data (nullptr),
       vector_is_ghosted (false)
     {
       reinit (partitioner);
@@ -308,9 +308,9 @@ namespace LinearAlgebra
     {
       resize_val(0);
 
-      if (import_data != 0)
+      if (import_data != nullptr)
         delete[] import_data;
-      import_data = 0;
+      import_data = nullptr;
 
       clear_mpi_requests();
     }
@@ -337,7 +337,7 @@ namespace LinearAlgebra
     Vector<Number> &
     Vector<Number>::operator = (const Vector<Number2> &c)
     {
-      Assert (c.partitioner.get() != 0, ExcNotInitialized());
+      Assert (c.partitioner.get() != nullptr, ExcNotInitialized());
 
       // we update ghost values whenever one of the input or output vector
       // already held ghost values or when we import data from a vector with
@@ -352,7 +352,7 @@ namespace LinearAlgebra
       // c does not have any ghosts (constructed without ghost elements given)
       // but the current vector does: In that case, we need to exchange data
       // also when none of the two vector had updated its ghost values before.
-      if (partitioner.get() == 0)
+      if (partitioner.get() == nullptr)
         reinit (c, true);
       else if (partitioner.get() != c.partitioner.get())
         {
@@ -567,7 +567,7 @@ namespace LinearAlgebra
       compress_requests.resize (n_import_targets + n_ghost_targets);
 
       // allocate import_data in case it is not set up yet
-      if (import_data == 0)
+      if (import_data == nullptr)
         import_data = new Number[part.n_import_indices()];
 
       // initiate the receive operations
@@ -754,13 +754,13 @@ namespace LinearAlgebra
                        part.local_size()+part.n_ghost_indices());
 
       // allocate import_data in case it is not set up yet
-      if (import_data == 0 && part.n_import_indices() > 0)
+      if (import_data == nullptr && part.n_import_indices() > 0)
         import_data = new Number[part.n_import_indices()];
 
       // copy the data to be sent to the import_data field
       if (part.n_import_indices() > 0)
         {
-          Assert (import_data != 0, ExcInternalError());
+          Assert (import_data != nullptr, ExcInternalError());
           Number *write_position = import_data;
           std::vector<std::pair<unsigned int, unsigned int> >::const_iterator
           my_imports = part.import_indices().begin();
@@ -831,7 +831,7 @@ namespace LinearAlgebra
       // If no communication pattern is given, create one. Otherwise, use the
       // given one.
       std::shared_ptr<const Utilities::MPI::Partitioner> comm_pattern;
-      if (communication_pattern.get() == NULL)
+      if (communication_pattern.get() == (nullptr))
         {
           // Split the IndexSet of V in locally owned elements and ghost indices
           // then create the communication pattern
@@ -847,7 +847,7 @@ namespace LinearAlgebra
         {
           comm_pattern =
             std::dynamic_pointer_cast<const Utilities::MPI::Partitioner> (communication_pattern);
-          AssertThrow(comm_pattern != NULL,
+          AssertThrow(comm_pattern != nullptr,
                       ExcMessage("The communication pattern is not of type "
                                  "Utilities::MPI::Partitioner."));
         }
@@ -946,7 +946,7 @@ namespace LinearAlgebra
     Vector<Number>::operator += (const VectorSpaceVector<Number> &vv)
     {
       // Downcast. Throws an exception if invalid.
-      Assert(dynamic_cast<const Vector<Number> *>(&vv)!=NULL,
+      Assert(dynamic_cast<const Vector<Number> *>(&vv)!=nullptr,
              ExcVectorTypeNotCompatible());
       const Vector<Number> &v = dynamic_cast<const Vector<Number> &>(vv);
 
@@ -969,7 +969,7 @@ namespace LinearAlgebra
     Vector<Number>::operator -= (const VectorSpaceVector<Number> &vv)
     {
       // Downcast. Throws an exception if invalid.
-      Assert(dynamic_cast<const Vector<Number> *>(&vv)!=NULL,
+      Assert(dynamic_cast<const Vector<Number> *>(&vv)!=nullptr,
              ExcVectorTypeNotCompatible());
       const Vector<Number> &v = dynamic_cast<const Vector<Number> &>(vv);
 
@@ -1009,7 +1009,7 @@ namespace LinearAlgebra
                          const VectorSpaceVector<Number> &vv)
     {
       // Downcast. Throws an exception if invalid.
-      Assert(dynamic_cast<const Vector<Number> *>(&vv)!=NULL,
+      Assert(dynamic_cast<const Vector<Number> *>(&vv)!=nullptr,
              ExcVectorTypeNotCompatible());
       const Vector<Number> &v = dynamic_cast<const Vector<Number> &>(vv);
 
@@ -1034,10 +1034,10 @@ namespace LinearAlgebra
                          const VectorSpaceVector<Number> &ww)
     {
       // Downcast. Throws an exception if invalid.
-      Assert(dynamic_cast<const Vector<Number> *>(&vv)!=NULL,
+      Assert(dynamic_cast<const Vector<Number> *>(&vv)!=nullptr,
              ExcVectorTypeNotCompatible());
       const Vector<Number> &v = dynamic_cast<const Vector<Number> &>(vv);
-      Assert(dynamic_cast<const Vector<Number> *>(&ww)!=NULL,
+      Assert(dynamic_cast<const Vector<Number> *>(&ww)!=nullptr,
              ExcVectorTypeNotCompatible());
       const Vector<Number> &w = dynamic_cast<const Vector<Number> &>(ww);
 
@@ -1097,7 +1097,7 @@ namespace LinearAlgebra
                           const VectorSpaceVector<Number> &vv)
     {
       // Downcast. Throws an exception if invalid.
-      Assert(dynamic_cast<const Vector<Number> *>(&vv)!=NULL,
+      Assert(dynamic_cast<const Vector<Number> *>(&vv)!=nullptr,
              ExcVectorTypeNotCompatible());
       const Vector<Number> &v = dynamic_cast<const Vector<Number> &>(vv);
 
@@ -1175,7 +1175,7 @@ namespace LinearAlgebra
     Vector<Number>::scale (const VectorSpaceVector<Number> &vv)
     {
       // Downcast. Throws an exception if invalid.
-      Assert(dynamic_cast<const Vector<Number> *>(&vv)!=NULL,
+      Assert(dynamic_cast<const Vector<Number> *>(&vv)!=nullptr,
              ExcVectorTypeNotCompatible());
       const Vector<Number> &v = dynamic_cast<const Vector<Number> &>(vv);
 
@@ -1197,7 +1197,7 @@ namespace LinearAlgebra
                          const VectorSpaceVector<Number> &vv)
     {
       // Downcast. Throws an exception if invalid.
-      Assert(dynamic_cast<const Vector<Number> *>(&vv)!=NULL,
+      Assert(dynamic_cast<const Vector<Number> *>(&vv)!=nullptr,
              ExcVectorTypeNotCompatible());
       const Vector<Number> &v = dynamic_cast<const Vector<Number> &>(vv);
 
@@ -1296,7 +1296,7 @@ namespace LinearAlgebra
     Vector<Number>::operator * (const VectorSpaceVector<Number> &vv) const
     {
       // Downcast. Throws an exception if invalid.
-      Assert(dynamic_cast<const Vector<Number> *>(&vv)!=NULL,
+      Assert(dynamic_cast<const Vector<Number> *>(&vv)!=nullptr,
              ExcVectorTypeNotCompatible());
       const Vector<Number> &v = dynamic_cast<const Vector<Number> &>(vv);
 
@@ -1486,10 +1486,10 @@ namespace LinearAlgebra
                                  const VectorSpaceVector<Number> &ww)
     {
       // Downcast. Throws an exception if invalid.
-      Assert(dynamic_cast<const Vector<Number> *>(&vv)!=NULL,
+      Assert(dynamic_cast<const Vector<Number> *>(&vv)!=nullptr,
              ExcVectorTypeNotCompatible());
       const Vector<Number> &v = dynamic_cast<const Vector<Number> &>(vv);
-      Assert(dynamic_cast<const Vector<Number> *>(&ww)!=NULL,
+      Assert(dynamic_cast<const Vector<Number> *>(&ww)!=nullptr,
              ExcVectorTypeNotCompatible());
       const Vector<Number> &w = dynamic_cast<const Vector<Number> &>(ww);
 
@@ -1537,7 +1537,7 @@ namespace LinearAlgebra
       // for it.
       if (partitioner.use_count() > 0)
         memory += partitioner->memory_consumption()/partitioner.use_count()+1;
-      if (import_data != 0)
+      if (import_data != nullptr)
         memory += (static_cast<std::size_t>(partitioner->n_import_indices())*
                    sizeof(Number));
       return memory;
@@ -1552,7 +1552,7 @@ namespace LinearAlgebra
                            const bool         scientific,
                            const bool         across) const
     {
-      Assert (partitioner.get() !=0, ExcInternalError());
+      Assert (partitioner.get() !=nullptr, ExcInternalError());
       AssertThrow (out, ExcIO());
       std::ios::fmtflags old_flags = out.flags();
       unsigned int old_precision = out.precision (precision);
index 460723c9421f2fb9c6b61b9be4879336c08d9e2f..84ee0877546847076a5d871b4a78a0ed2b13eeb4 100644 (file)
@@ -102,7 +102,7 @@ namespace LinearAlgebra
   Vector<Number> &Vector<Number>::operator+= (const VectorSpaceVector<Number> &V)
   {
     // Check that casting will work.
-    Assert(dynamic_cast<const Vector<Number>*>(&V)!=NULL, ExcVectorTypeNotCompatible());
+    Assert(dynamic_cast<const Vector<Number>*>(&V)!=nullptr, ExcVectorTypeNotCompatible());
 
     // Downcast V. If fails, throws an exception.
     const Vector<Number> &down_V = dynamic_cast<const Vector<Number>&>(V);
@@ -121,7 +121,7 @@ namespace LinearAlgebra
   Vector<Number> &Vector<Number>::operator-= (const VectorSpaceVector<Number> &V)
   {
     // Check that casting will work.
-    Assert(dynamic_cast<const Vector<Number>*>(&V)!=NULL, ExcVectorTypeNotCompatible());
+    Assert(dynamic_cast<const Vector<Number>*>(&V)!=nullptr, ExcVectorTypeNotCompatible());
 
     // Downcast V. If fails, throws an exception.
     const Vector<Number> &down_V = dynamic_cast<const Vector<Number>&>(V);
@@ -139,7 +139,7 @@ namespace LinearAlgebra
   Number Vector<Number>::operator* (const VectorSpaceVector<Number> &V) const
   {
     // Check that casting will work.
-    Assert(dynamic_cast<const Vector<Number>*>(&V)!=NULL,
+    Assert(dynamic_cast<const Vector<Number>*>(&V)!=nullptr,
            ExcVectorTypeNotCompatible());
 
     // Downcast V. If fails, throws an exception.
@@ -182,7 +182,7 @@ namespace LinearAlgebra
   void Vector<Number>::add(const Number a, const VectorSpaceVector<Number> &V)
   {
     // Check that casting will work.
-    Assert(dynamic_cast<const Vector<Number>*>(&V)!=NULL,
+    Assert(dynamic_cast<const Vector<Number>*>(&V)!=nullptr,
            ExcVectorTypeNotCompatible());
 
     // Downcast V. If fails, throws an exception.
@@ -202,10 +202,10 @@ namespace LinearAlgebra
                            const Number b, const VectorSpaceVector<Number> &W)
   {
     // Check that casting will work.
-    Assert(dynamic_cast<const Vector<Number>*>(&V)!=NULL,
+    Assert(dynamic_cast<const Vector<Number>*>(&V)!=nullptr,
            ExcVectorTypeNotCompatible());
     // Check that casting will work.
-    Assert(dynamic_cast<const Vector<Number>*>(&W)!=NULL,
+    Assert(dynamic_cast<const Vector<Number>*>(&W)!=nullptr,
            ExcVectorTypeNotCompatible());
 
     // Downcast V. If fails, throws an exception.
@@ -234,7 +234,7 @@ namespace LinearAlgebra
     AssertIsFinite(a);
 
     // Check that casting will work.
-    Assert(dynamic_cast<const Vector<Number>*>(&V)!=NULL,
+    Assert(dynamic_cast<const Vector<Number>*>(&V)!=nullptr,
            ExcVectorTypeNotCompatible());
 
     // Downcast V. It fails, throws an exception.
@@ -250,7 +250,7 @@ namespace LinearAlgebra
   void Vector<Number>::scale(const VectorSpaceVector<Number> &scaling_factors)
   {
     // Check that casting will work.
-    Assert(dynamic_cast<const Vector<Number>*>(&scaling_factors)!=NULL,
+    Assert(dynamic_cast<const Vector<Number>*>(&scaling_factors)!=nullptr,
            ExcVectorTypeNotCompatible());
 
     // Downcast scaling_factors. If fails, throws an exception.
@@ -271,7 +271,7 @@ namespace LinearAlgebra
     AssertIsFinite(a);
 
     // Check that casting will work.
-    Assert(dynamic_cast<const Vector<Number>*>(&V)!=NULL,
+    Assert(dynamic_cast<const Vector<Number>*>(&V)!=nullptr,
            ExcVectorTypeNotCompatible());
 
     // Downcast V. If fails, throws an exception.
@@ -377,10 +377,10 @@ namespace LinearAlgebra
                                      const VectorSpaceVector<Number> &W)
   {
     // Check that casting will work.
-    Assert(dynamic_cast<const Vector<Number>*>(&V)!=NULL,
+    Assert(dynamic_cast<const Vector<Number>*>(&V)!=nullptr,
            ExcVectorTypeNotCompatible());
     // Check that casting will work.
-    Assert(dynamic_cast<const Vector<Number>*>(&W)!=NULL,
+    Assert(dynamic_cast<const Vector<Number>*>(&W)!=nullptr,
            ExcVectorTypeNotCompatible());
 
     // Downcast V. If fails, throws an exception.
index bba1b6a5cfa84e7d6455aa611f8022573d3b6a15..5db537acb0a5ce54a96059371ac8c58d1dfa133a 100644 (file)
@@ -504,7 +504,7 @@ namespace
     // type is std::true_type if Matrix provides vmult_add and Tvmult_add,
     // otherwise it is std::false_type
 
-    typedef decltype(test<T>(0, 0, 0)) type;
+    typedef decltype(test<T>(nullptr, nullptr, nullptr)) type;
   };
 }
 
index b4efc51d222dd9823a386dbd41e494a253ad1529..b3bb1309a5fca34cd89386d408ae932f2b8bd5ff 100644 (file)
@@ -53,7 +53,7 @@ namespace PETScWrappers
 #if DEAL_II_PETSC_VERSION_LT(3, 7, 0)
     const PetscErrorCode ierr = PetscOptionsSetValue (name.c_str (), value.c_str ());
 #else
-    const PetscErrorCode ierr = PetscOptionsSetValue (NULL, name.c_str (), value.c_str ());
+    const PetscErrorCode ierr = PetscOptionsSetValue ((nullptr), name.c_str (), value.c_str ());
 #endif
     AssertThrow (ierr == 0, ExcPETScError(ierr));
   }
@@ -72,7 +72,7 @@ namespace PETScWrappers
    */
   inline PetscErrorCode destroy_matrix (Mat &matrix)
   {
-    // PETSc will check whether or not matrix is NULL.
+    // PETSc will check whether or not matrix is (nullptr).
 #if DEAL_II_PETSC_VERSION_LT(3, 2, 0)
     return MatDestroy (matrix);
 #else
@@ -94,7 +94,7 @@ namespace PETScWrappers
    */
   inline PetscErrorCode destroy_krylov_solver (KSP &krylov_solver)
   {
-    // PETSc will check whether or not matrix is NULL.
+    // PETSc will check whether or not matrix is (nullptr).
 #if DEAL_II_PETSC_VERSION_LT(3, 2, 0)
     return KSPDestroy (krylov_solver);
 #else
index 8fc7ddcff2cf636245fd12219095efba8a799796..dd6016681c7e6e9914ae98333c64d687213e6111 100644 (file)
@@ -120,7 +120,7 @@ public:
    *
    * If <tt>M</tt> is zero, no matrix is stored.
    */
-  PointerMatrix (const MatrixType *M=0);
+  PointerMatrix (const MatrixType *M=nullptr);
 
   /**
    * Constructor.
@@ -449,7 +449,7 @@ inline
 PointerMatrixBase<VectorType> *
 new_pointer_matrix_base(MatrixType &matrix, const VectorType &, const char *name = "PointerMatrixAux")
 {
-  return new PointerMatrixAux<MatrixType, VectorType>(0, &matrix, name);
+  return new PointerMatrixAux<MatrixType, VectorType>(nullptr, &matrix, name);
 }
 
 /**
@@ -591,7 +591,7 @@ PointerMatrix<MatrixType, VectorType>::PointerMatrix (const MatrixType *M)
 
 template<typename MatrixType, typename VectorType>
 PointerMatrix<MatrixType, VectorType>::PointerMatrix (const char *name)
-  : m(0, name)
+  : m(nullptr, name)
 {}
 
 
@@ -606,7 +606,7 @@ template<typename MatrixType, typename VectorType>
 inline void
 PointerMatrix<MatrixType, VectorType>::clear ()
 {
-  m = 0;
+  m = nullptr;
 }
 
 
@@ -623,7 +623,7 @@ template<typename MatrixType, typename VectorType>
 inline bool
 PointerMatrix<MatrixType, VectorType>::empty () const
 {
-  if (m == 0)
+  if (m == nullptr)
     return true;
   return m->empty();
 }
@@ -633,7 +633,7 @@ inline void
 PointerMatrix<MatrixType, VectorType>::vmult (VectorType       &dst,
                                               const VectorType &src) const
 {
-  Assert (m != 0, ExcNotInitialized());
+  Assert (m != nullptr, ExcNotInitialized());
   m->vmult (dst, src);
 }
 
@@ -643,7 +643,7 @@ inline void
 PointerMatrix<MatrixType, VectorType>::Tvmult (VectorType       &dst,
                                                const VectorType &src) const
 {
-  Assert (m != 0, ExcNotInitialized());
+  Assert (m != nullptr, ExcNotInitialized());
   m->Tvmult (dst, src);
 }
 
@@ -653,7 +653,7 @@ inline void
 PointerMatrix<MatrixType, VectorType>::vmult_add (VectorType       &dst,
                                                   const VectorType &src) const
 {
-  Assert (m != 0, ExcNotInitialized());
+  Assert (m != nullptr, ExcNotInitialized());
   m->vmult_add (dst, src);
 }
 
@@ -663,7 +663,7 @@ inline void
 PointerMatrix<MatrixType, VectorType>::Tvmult_add (VectorType       &dst,
                                                    const VectorType &src) const
 {
-  Assert (m != 0, ExcNotInitialized());
+  Assert (m != nullptr, ExcNotInitialized());
   m->Tvmult_add (dst, src);
 }
 
@@ -699,7 +699,7 @@ PointerMatrixAux<MatrixType, VectorType>::PointerMatrixAux (VectorMemory<VectorT
   : mem(mem, name),
     m(M, name)
 {
-  if (mem == 0) mem = &my_memory;
+  if (mem == nullptr) mem = &my_memory;
 }
 
 
@@ -707,7 +707,7 @@ template<typename MatrixType, typename VectorType>
 inline void
 PointerMatrixAux<MatrixType, VectorType>::clear ()
 {
-  m = 0;
+  m = nullptr;
 }
 
 
@@ -744,10 +744,10 @@ inline void
 PointerMatrixAux<MatrixType, VectorType>::vmult (VectorType       &dst,
                                                  const VectorType &src) const
 {
-  if (mem == 0)
+  if (mem == nullptr)
     mem = &my_memory;
-  Assert (mem != 0, ExcNotInitialized());
-  Assert (m != 0, ExcNotInitialized());
+  Assert (mem != nullptr, ExcNotInitialized());
+  Assert (m != nullptr, ExcNotInitialized());
   m->vmult (dst, src);
 }
 
@@ -757,10 +757,10 @@ inline void
 PointerMatrixAux<MatrixType, VectorType>::Tvmult (VectorType       &dst,
                                                   const VectorType &src) const
 {
-  if (mem == 0)
+  if (mem == nullptr)
     mem = &my_memory;
-  Assert (mem != 0, ExcNotInitialized());
-  Assert (m != 0, ExcNotInitialized());
+  Assert (mem != nullptr, ExcNotInitialized());
+  Assert (m != nullptr, ExcNotInitialized());
   m->Tvmult (dst, src);
 }
 
@@ -770,10 +770,10 @@ inline void
 PointerMatrixAux<MatrixType, VectorType>::vmult_add (VectorType       &dst,
                                                      const VectorType &src) const
 {
-  if (mem == 0)
+  if (mem == nullptr)
     mem = &my_memory;
-  Assert (mem != 0, ExcNotInitialized());
-  Assert (m != 0, ExcNotInitialized());
+  Assert (mem != nullptr, ExcNotInitialized());
+  Assert (m != nullptr, ExcNotInitialized());
   VectorType *v = mem->alloc();
   v->reinit(dst);
   m->vmult (*v, src);
@@ -787,10 +787,10 @@ inline void
 PointerMatrixAux<MatrixType, VectorType>::Tvmult_add (VectorType       &dst,
                                                       const VectorType &src) const
 {
-  if (mem == 0)
+  if (mem == nullptr)
     mem = &my_memory;
-  Assert (mem != 0, ExcNotInitialized());
-  Assert (m != 0, ExcNotInitialized());
+  Assert (mem != nullptr, ExcNotInitialized());
+  Assert (m != nullptr, ExcNotInitialized());
   VectorType *v = mem->alloc();
   v->reinit(dst);
   m->Tvmult (*v, src);
@@ -825,7 +825,7 @@ template<typename number>
 inline void
 PointerMatrixVector<number>::clear ()
 {
-  m = 0;
+  m = nullptr;
 }
 
 
@@ -852,7 +852,7 @@ inline void
 PointerMatrixVector<number>::vmult (Vector<number>       &dst,
                                     const Vector<number> &src) const
 {
-  Assert (m != 0, ExcNotInitialized());
+  Assert (m != nullptr, ExcNotInitialized());
   Assert (dst.size() == 1, ExcDimensionMismatch(dst.size(), 1));
 
   dst(0) = *m * src;
@@ -864,7 +864,7 @@ inline void
 PointerMatrixVector<number>::Tvmult (Vector<number>       &dst,
                                      const Vector<number> &src) const
 {
-  Assert (m != 0, ExcNotInitialized());
+  Assert (m != nullptr, ExcNotInitialized());
   Assert(src.size() == 1, ExcDimensionMismatch(src.size(), 1));
 
   dst.equ (src(0), *m);
@@ -876,7 +876,7 @@ inline void
 PointerMatrixVector<number>::vmult_add (Vector<number>       &dst,
                                         const Vector<number> &src) const
 {
-  Assert (m != 0, ExcNotInitialized());
+  Assert (m != nullptr, ExcNotInitialized());
   Assert (dst.size() == 1, ExcDimensionMismatch(dst.size(), 1));
 
   dst(0) += *m * src;
@@ -888,7 +888,7 @@ inline void
 PointerMatrixVector<number>::Tvmult_add (Vector<number>       &dst,
                                          const Vector<number> &src) const
 {
-  Assert (m != 0, ExcNotInitialized());
+  Assert (m != nullptr, ExcNotInitialized());
   Assert(src.size() == 1, ExcDimensionMismatch(src.size(), 1));
 
   dst.add (src(0), *m);
index 0ea8991a07b195242bdba0bd2ae72eacccc0fd4f..b11311965efd21388eb3acc6d8cae4ab47dc2415 100644 (file)
@@ -1336,14 +1336,14 @@ template <typename MatrixType>
 inline void
 PreconditionRelaxation<MatrixType>::clear ()
 {
-  A = 0;
+  A = nullptr;
 }
 
 template <typename MatrixType>
 inline typename PreconditionRelaxation<MatrixType>::size_type
 PreconditionRelaxation<MatrixType>::m () const
 {
-  Assert (A!=0, ExcNotInitialized());
+  Assert (A!=nullptr, ExcNotInitialized());
   return A->m();
 }
 
@@ -1351,7 +1351,7 @@ template <typename MatrixType>
 inline typename PreconditionRelaxation<MatrixType>::size_type
 PreconditionRelaxation<MatrixType>::n () const
 {
-  Assert (A!=0, ExcNotInitialized());
+  Assert (A!=nullptr, ExcNotInitialized());
   return A->n();
 }
 
@@ -1368,7 +1368,7 @@ PreconditionJacobi<MatrixType>::vmult (VectorType &dst, const VectorType &src) c
     "PreconditionJacobi and VectorType must have the same size_type.");
 #endif // DEAL_II_WITH_CXX11
 
-  Assert (this->A!=0, ExcNotInitialized());
+  Assert (this->A!=nullptr, ExcNotInitialized());
   this->A->precondition_Jacobi (dst, src, this->relaxation);
 }
 
@@ -1385,7 +1385,7 @@ PreconditionJacobi<MatrixType>::Tvmult (VectorType &dst, const VectorType &src)
     "PreconditionJacobi and VectorType must have the same size_type.");
 #endif // DEAL_II_WITH_CXX11
 
-  Assert (this->A!=0, ExcNotInitialized());
+  Assert (this->A!=nullptr, ExcNotInitialized());
   this->A->precondition_Jacobi (dst, src, this->relaxation);
 }
 
@@ -1402,7 +1402,7 @@ PreconditionJacobi<MatrixType>::step (VectorType &dst, const VectorType &src) co
     "PreconditionJacobi and VectorType must have the same size_type.");
 #endif // DEAL_II_WITH_CXX11
 
-  Assert (this->A!=0, ExcNotInitialized());
+  Assert (this->A!=nullptr, ExcNotInitialized());
   this->A->Jacobi_step (dst, src, this->relaxation);
 }
 
@@ -1437,7 +1437,7 @@ PreconditionSOR<MatrixType>::vmult (VectorType &dst, const VectorType &src) cons
     "PreconditionSOR and VectorType must have the same size_type.");
 #endif // DEAL_II_WITH_CXX11
 
-  Assert (this->A!=0, ExcNotInitialized());
+  Assert (this->A!=nullptr, ExcNotInitialized());
   this->A->precondition_SOR (dst, src, this->relaxation);
 }
 
@@ -1454,7 +1454,7 @@ PreconditionSOR<MatrixType>::Tvmult (VectorType &dst, const VectorType &src) con
     "PreconditionSOR and VectorType must have the same size_type.");
 #endif // DEAL_II_WITH_CXX11
 
-  Assert (this->A!=0, ExcNotInitialized());
+  Assert (this->A!=nullptr, ExcNotInitialized());
   this->A->precondition_TSOR (dst, src, this->relaxation);
 }
 
@@ -1471,7 +1471,7 @@ PreconditionSOR<MatrixType>::step (VectorType &dst, const VectorType &src) const
     "PreconditionSOR and VectorType must have the same size_type.");
 #endif // DEAL_II_WITH_CXX11
 
-  Assert (this->A!=0, ExcNotInitialized());
+  Assert (this->A!=nullptr, ExcNotInitialized());
   this->A->SOR_step (dst, src, this->relaxation);
 }
 
@@ -1488,7 +1488,7 @@ PreconditionSOR<MatrixType>::Tstep (VectorType &dst, const VectorType &src) cons
     "PreconditionSOR and VectorType must have the same size_type.");
 #endif // DEAL_II_WITH_CXX11
 
-  Assert (this->A!=0, ExcNotInitialized());
+  Assert (this->A!=nullptr, ExcNotInitialized());
   this->A->TSOR_step (dst, src, this->relaxation);
 }
 
@@ -1509,7 +1509,7 @@ PreconditionSSOR<MatrixType>::initialize (const MatrixType                     &
     dynamic_cast<const SparseMatrix<typename MatrixType::value_type> *>(&*this->A);
 
   // calculate the positions first after the diagonal.
-  if (mat != 0)
+  if (mat != nullptr)
     {
       const size_type n = this->A->n();
       pos_right_of_diagonal.resize(n, static_cast<std::size_t>(-1));
@@ -1541,7 +1541,7 @@ PreconditionSSOR<MatrixType>::vmult (VectorType &dst, const VectorType &src) con
     "PreconditionSSOR and VectorType must have the same size_type.");
 #endif // DEAL_II_WITH_CXX11
 
-  Assert (this->A!=0, ExcNotInitialized());
+  Assert (this->A!=nullptr, ExcNotInitialized());
   this->A->precondition_SSOR (dst, src, this->relaxation, pos_right_of_diagonal);
 }
 
@@ -1558,7 +1558,7 @@ PreconditionSSOR<MatrixType>::Tvmult (VectorType &dst, const VectorType &src) co
     "PreconditionSSOR and VectorType must have the same size_type.");
 #endif // DEAL_II_WITH_CXX11
 
-  Assert (this->A!=0, ExcNotInitialized());
+  Assert (this->A!=nullptr, ExcNotInitialized());
   this->A->precondition_SSOR (dst, src, this->relaxation, pos_right_of_diagonal);
 }
 
@@ -1575,7 +1575,7 @@ PreconditionSSOR<MatrixType>::step (VectorType &dst, const VectorType &src) cons
     "PreconditionSSOR and VectorType must have the same size_type.");
 #endif // DEAL_II_WITH_CXX11
 
-  Assert (this->A!=0, ExcNotInitialized());
+  Assert (this->A!=nullptr, ExcNotInitialized());
   this->A->SSOR_step (dst, src, this->relaxation);
 }
 
@@ -1636,7 +1636,7 @@ PreconditionPSOR<MatrixType>::vmult (VectorType &dst, const VectorType &src) con
     "PreconditionPSOR and VectorType must have the same size_type.");
 #endif // DEAL_II_WITH_CXX11
 
-  Assert (this->A!=0, ExcNotInitialized());
+  Assert (this->A!=nullptr, ExcNotInitialized());
   dst = src;
   this->A->PSOR (dst, *permutation, *inverse_permutation, this->relaxation);
 }
@@ -1654,7 +1654,7 @@ PreconditionPSOR<MatrixType>::Tvmult (VectorType &dst, const VectorType &src) co
     "PreconditionPSOR and VectorType must have the same size_type.");
 #endif // DEAL_II_WITH_CXX11
 
-  Assert (this->A!=0, ExcNotInitialized());
+  Assert (this->A!=nullptr, ExcNotInitialized());
   dst = src;
   this->A->TPSOR (dst, *permutation, *inverse_permutation, this->relaxation);
 }
@@ -1902,7 +1902,7 @@ namespace internal
     {
       (void)matrix;
       (void)preconditioner;
-      AssertThrow(preconditioner.get() != NULL, ExcNotInitialized());
+      AssertThrow(preconditioner.get() != nullptr, ExcNotInitialized());
     }
 
     template <typename MatrixType, typename VectorType>
@@ -1912,10 +1912,10 @@ namespace internal
                               std::shared_ptr<DiagonalMatrix<VectorType> > &preconditioner,
                               VectorType                                         &diagonal_inverse)
     {
-      if (preconditioner.get() == NULL ||
+      if (preconditioner.get() ==nullptr||
           preconditioner->m() != matrix.m())
         {
-          if (preconditioner.get() == NULL)
+          if (preconditioner.get() == (nullptr))
             preconditioner.reset(new DiagonalMatrix<VectorType>());
 
           Assert(preconditioner->m() == 0,
@@ -2051,7 +2051,7 @@ PreconditionChebyshev<MatrixType,VectorType,PreconditionerType>::clear ()
 {
   is_initialized = false;
   theta = delta = 1.0;
-  matrix_ptr = 0;
+  matrix_ptr = nullptr;
   {
     VectorType empty_vector;
     data.matrix_diagonal_inverse.reinit(empty_vector);
@@ -2073,7 +2073,7 @@ PreconditionChebyshev<MatrixType,VectorType,PreconditionerType>::estimate_eigenv
 (const VectorType &src) const
 {
   Assert(is_initialized == false, ExcInternalError());
-  Assert(data.preconditioner.get() != NULL, ExcNotInitialized());
+  Assert(data.preconditioner.get() != nullptr, ExcNotInitialized());
 
   update1.reinit(src);
   update2.reinit(src, true);
@@ -2305,7 +2305,7 @@ inline
 typename PreconditionChebyshev<MatrixType,VectorType,PreconditionerType>::size_type
 PreconditionChebyshev<MatrixType,VectorType,PreconditionerType>::m () const
 {
-  Assert (matrix_ptr!=0, ExcNotInitialized());
+  Assert (matrix_ptr!=nullptr, ExcNotInitialized());
   return matrix_ptr->m();
 }
 
@@ -2316,7 +2316,7 @@ inline
 typename PreconditionChebyshev<MatrixType,VectorType,PreconditionerType>::size_type
 PreconditionChebyshev<MatrixType,VectorType,PreconditionerType>::n () const
 {
-  Assert (matrix_ptr!=0, ExcNotInitialized());
+  Assert (matrix_ptr!=nullptr, ExcNotInitialized());
   return matrix_ptr->n();
 }
 
index 76eca4f6041df65c0e95593be55be1664c91f895..8aab5b675b4ad5e99082ce5d7a5a3ae49ea7931e 100644 (file)
@@ -868,7 +868,7 @@ template<typename MatrixType, typename inverse_type>
 inline bool
 PreconditionBlock<MatrixType, inverse_type>::empty () const
 {
-  if (A == 0)
+  if (A == nullptr)
     return true;
   return A->empty();
 }
index 0796baa52866ebb6616bd5de9f1cc5f948bef84b..789e87ccc4a0faceff5c32b1decd52418a0d189c 100644 (file)
@@ -54,7 +54,7 @@ template <typename MatrixType, typename inverse_type>
 PreconditionBlock<MatrixType,inverse_type>::PreconditionBlock (bool store)
   : PreconditionBlockBase<inverse_type>(store),
     blocksize(0),
-    A(0, typeid(*this).name()),
+    A(nullptr, typeid(*this).name()),
     relaxation(1.0)
 {}
 
@@ -69,7 +69,7 @@ void PreconditionBlock<MatrixType,inverse_type>::clear ()
 {
   PreconditionBlockBase<inverse_type>::clear();
   blocksize     = 0;
-  A = 0;
+  A = nullptr;
 }
 
 
@@ -115,7 +115,7 @@ void PreconditionBlock<MatrixType,inverse_type>::initialize
 template <typename MatrixType, typename inverse_type>
 void PreconditionBlock<MatrixType,inverse_type>::invert_permuted_diagblocks()
 {
-  Assert (A!=0, ExcNotInitialized());
+  Assert (A!=nullptr, ExcNotInitialized());
   Assert (blocksize!=0, ExcNotInitialized());
 
   const MatrixType &M=*A;
@@ -226,7 +226,7 @@ void PreconditionBlock<MatrixType,inverse_type>::forward_step
  const Vector<number2> &src,
  const bool             transpose_diagonal) const
 {
-  Assert (this->A!=0, ExcNotInitialized());
+  Assert (this->A!=nullptr, ExcNotInitialized());
 
   const MatrixType &M=*this->A;
 
@@ -324,7 +324,7 @@ void PreconditionBlock<MatrixType,inverse_type>::backward_step
  const Vector<number2> &src,
  const bool             transpose_diagonal) const
 {
-  Assert (this->A!=0, ExcNotInitialized());
+  Assert (this->A!=nullptr, ExcNotInitialized());
 
   const MatrixType &M=*this->A;
 
@@ -425,7 +425,7 @@ PreconditionBlock<MatrixType,inverse_type>::block_size() const
 template <typename MatrixType, typename inverse_type>
 void PreconditionBlock<MatrixType,inverse_type>::invert_diagblocks()
 {
-  Assert (A!=0, ExcNotInitialized());
+  Assert (A!=nullptr, ExcNotInitialized());
   Assert (blocksize!=0, ExcNotInitialized());
 
   const MatrixType &M=*A;
@@ -553,7 +553,7 @@ void PreconditionBlockJacobi<MatrixType,inverse_type>
             const Vector<number2> &src,
             bool                   adding) const
 {
-  Assert(this->A!=0, ExcNotInitialized());
+  Assert(this->A!=nullptr, ExcNotInitialized());
 
   const MatrixType &M=*this->A;
 
@@ -716,7 +716,7 @@ void PreconditionBlockSOR<MatrixType,inverse_type>::forward
  const bool             transpose_diagonal,
  const bool) const
 {
-  Assert (this->A!=0, ExcNotInitialized());
+  Assert (this->A!=nullptr, ExcNotInitialized());
 
   const MatrixType &M=*this->A;
   const bool permuted = (this->permutation.size() != 0);
@@ -806,7 +806,7 @@ void PreconditionBlockSOR<MatrixType,inverse_type>::backward
  const bool              transpose_diagonal,
  const bool) const
 {
-  Assert (this->A!=0, ExcNotInitialized());
+  Assert (this->A!=nullptr, ExcNotInitialized());
 
   const MatrixType &M=*this->A;
   const bool permuted = (this->permutation.size() != 0);
index b4481ff861d68633f8bd21b5834176cb7d7c229d..0ca3ae094d8275d79861ef654be840670e4534fd 100644 (file)
@@ -202,7 +202,7 @@ template <typename MatrixType, typename VectorType>
 PreconditionSelector<MatrixType,VectorType>::~PreconditionSelector()
 {
   // release the matrix A
-  A=0;
+  A=nullptr;
 }
 
 
@@ -217,7 +217,7 @@ template <typename MatrixType, typename VectorType>
 inline typename PreconditionSelector<MatrixType,VectorType>::size_type
 PreconditionSelector<MatrixType,VectorType>::m () const
 {
-  Assert(A!=0, ExcNoMatrixGivenToUse());
+  Assert(A!=nullptr, ExcNoMatrixGivenToUse());
   return A->m();
 }
 
@@ -226,7 +226,7 @@ template <typename MatrixType, typename VectorType>
 inline typename PreconditionSelector<MatrixType,VectorType>::size_type
 PreconditionSelector<MatrixType,VectorType>::n () const
 {
-  Assert(A!=0, ExcNoMatrixGivenToUse());
+  Assert(A!=nullptr, ExcNoMatrixGivenToUse());
   return A->n();
 }
 
@@ -242,7 +242,7 @@ void PreconditionSelector<MatrixType,VectorType>::vmult (VectorType &dst,
     }
   else
     {
-      Assert(A!=0, ExcNoMatrixGivenToUse());
+      Assert(A!=nullptr, ExcNoMatrixGivenToUse());
 
       if (preconditioning=="jacobi")
         {
@@ -272,7 +272,7 @@ void PreconditionSelector<MatrixType,VectorType>::Tvmult (VectorType &dst,
     }
   else
     {
-      Assert(A!=0, ExcNoMatrixGivenToUse());
+      Assert(A!=nullptr, ExcNoMatrixGivenToUse());
 
       if (preconditioning=="jacobi")
         {
index 3d15c23daa905a5d9b0d203de98c1c412264d015..9a28632cf822df351c4ed137aaad797dcd649bdd 100644 (file)
@@ -624,7 +624,7 @@ namespace LinearAlgebra
   inline
   ReadWriteVector<Number>::ReadWriteVector ()
     :
-    val(NULL)
+    val((nullptr))
   {
     reinit(0, true);
   }
@@ -636,7 +636,7 @@ namespace LinearAlgebra
   ReadWriteVector<Number>::ReadWriteVector (const ReadWriteVector<Number> &v)
     :
     Subscriptor(),
-    val(NULL)
+    val((nullptr))
   {
     this->operator=(v);
   }
@@ -647,7 +647,7 @@ namespace LinearAlgebra
   inline
   ReadWriteVector<Number>::ReadWriteVector (const size_type size)
     :
-    val(NULL)
+    val((nullptr))
   {
     reinit (size, false);
   }
@@ -658,7 +658,7 @@ namespace LinearAlgebra
   inline
   ReadWriteVector<Number>::ReadWriteVector (const IndexSet &locally_stored_indices)
     :
-    val(NULL)
+    val((nullptr))
   {
     reinit (locally_stored_indices);
   }
index 09a0d65ebe1530dab1ca87eee11cbc02759602f3..0436e49d874cfb5ba47fe68298f1d431363c95d5 100644 (file)
@@ -52,14 +52,14 @@ namespace LinearAlgebra
   {
     if (new_alloc_size == 0)
       {
-        if (val != NULL)
+        if (val != (nullptr))
           free(val);
-        val = NULL;
+        val = (nullptr);
         thread_loop_partitioner.reset(new parallel::internal::TBBPartitioner());
       }
     else
       {
-        if (val != NULL)
+        if (val != (nullptr))
           free(val);
 
         Utilities::System::posix_memalign ((void **)&val, 64, sizeof(Number)*new_alloc_size);
@@ -206,7 +206,7 @@ namespace LinearAlgebra
     // If no communication pattern is given, create one. Otherwise, use the
     // given one.
     std::shared_ptr<const Utilities::MPI::Partitioner> comm_pattern;
-    if (communication_pattern.get() == NULL)
+    if (communication_pattern.get() == (nullptr))
       {
         comm_pattern.reset(new Utilities::MPI::Partitioner(vec.locally_owned_elements(),
                                                            get_stored_elements(),
@@ -216,7 +216,7 @@ namespace LinearAlgebra
       {
         comm_pattern =
           std::dynamic_pointer_cast<const Utilities::MPI::Partitioner> (communication_pattern);
-        AssertThrow(comm_pattern != NULL,
+        AssertThrow(comm_pattern != nullptr,
                     ExcMessage("The communication pattern is not of type "
                                "Utilities::MPI::Partitioner."));
       }
@@ -305,7 +305,7 @@ namespace LinearAlgebra
 
     // If no communication pattern is given, create one. Otherwise, use the one
     // given.
-    if (communication_pattern == NULL)
+    if (communication_pattern == (nullptr))
       {
         // The first time import is called, we create a communication pattern.
         // Check if the communication pattern already exists and if it can be
@@ -315,7 +315,7 @@ namespace LinearAlgebra
           {
             epetra_comm_pattern =
               std::dynamic_pointer_cast<const EpetraWrappers::CommunicationPattern> (comm_pattern);
-            if (epetra_comm_pattern == NULL)
+            if (epetra_comm_pattern == (nullptr))
               epetra_comm_pattern = std::make_shared<const EpetraWrappers::CommunicationPattern>(
                                       create_epetra_comm_pattern(source_elements, mpi_comm));
           }
@@ -327,7 +327,7 @@ namespace LinearAlgebra
       {
         epetra_comm_pattern = std::dynamic_pointer_cast<const EpetraWrappers::CommunicationPattern> (
                                 communication_pattern);
-        AssertThrow(epetra_comm_pattern != NULL,
+        AssertThrow(epetra_comm_pattern != nullptr,
                     ExcMessage(std::string("The communication pattern is not of type ") +
                                "LinearAlgebra::EpetraWrappers::CommunicationPattern."));
       }
index e8f1f330dd811f3a868d788d2f06a34c06b408f0..cb1aebfeb6e34381c78b8c330b003fbbc6750f2a 100644 (file)
@@ -91,7 +91,7 @@ public:
                     const typename PreconditionBlockBase<InverseNumberType>::Inversion inversion
                     = PreconditionBlockBase<InverseNumberType>::gauss_jordan,
                     const double threshold = 0.,
-                    VectorType *temp_ghost_vector = NULL);
+                    VectorType *temp_ghost_vector = (nullptr));
 
     /**
      * The mapping from indices to blocks. Each row of this pattern enumerates
index 648f8f4894993c0458dfa7cb9a3e293d6c662c52..1af48da02b945084ab0904bab3ef15e792e9861e 100644 (file)
@@ -83,8 +83,8 @@ inline
 void
 RelaxationBlock<MatrixType, InverseNumberType, VectorType>::clear ()
 {
-  A = 0;
-  additional_data = 0;
+  A = nullptr;
+  additional_data = nullptr;
   PreconditionBlockBase<InverseNumberType>::clear ();
 }
 
@@ -179,7 +179,7 @@ namespace internal
     // If the following Assertion triggers, you either set temp_ghost_vector
     // for a serial computation (don't!), or nobody implemented, instantiated, and
     // tested the parallel version for your vector type.
-    Assert(other==NULL, ExcNotImplemented());
+    Assert(other==nullptr, ExcNotImplemented());
     (void)other;
     return prev;
   }
@@ -194,7 +194,7 @@ namespace internal
     const TrilinosWrappers::MPI::Vector &prev,
     TrilinosWrappers::MPI::Vector *other)
   {
-    Assert(other!=NULL,
+    Assert(other!=nullptr,
            ExcMessage("You need to provide a ghosted vector in RelaxationBlock::AdditionalData::temp_trilinos_ghost_vector."));
     Assert(other->size()==prev.size(), ExcInternalError());
 
index 6378848ad17c6c7810be1df37be9030461b7c1aa..2745f93ffd1cf33c0957a25594ffaec49f519d0f 100644 (file)
@@ -296,15 +296,15 @@ SolverBicgstab<VectorType>::SolverBicgstab (SolverControl        &cn,
                                             const AdditionalData &data)
   :
   Solver<VectorType>(cn),
-  Vx(NULL),
-  Vr(NULL),
-  Vrbar(NULL),
-  Vp(NULL),
-  Vy(NULL),
-  Vz(NULL),
-  Vt(NULL),
-  Vv(NULL),
-  Vb(NULL),
+  Vx((nullptr)),
+  Vr((nullptr)),
+  Vrbar((nullptr)),
+  Vp((nullptr)),
+  Vy((nullptr)),
+  Vz((nullptr)),
+  Vt((nullptr)),
+  Vv((nullptr)),
+  Vb((nullptr)),
   alpha(0.),
   beta(0.),
   omega(0.),
index 5024e8e960c6452223ad30143c31ce7326087b89..9faae8f510d903f2157e5a9127296bd0e52838a6 100644 (file)
@@ -327,9 +327,9 @@ SolverCG<VectorType>::SolverCG (SolverControl        &cn,
                                 const AdditionalData     &data)
   :
   Solver<VectorType>(cn,mem),
-  Vr(NULL),
-  Vp(NULL),
-  Vz(NULL),
+  Vr((nullptr)),
+  Vp((nullptr)),
+  Vz((nullptr)),
   additional_data(data)
 {}
 
@@ -340,9 +340,9 @@ SolverCG<VectorType>::SolverCG (SolverControl        &cn,
                                 const AdditionalData &data)
   :
   Solver<VectorType>(cn),
-  Vr(NULL),
-  Vp(NULL),
-  Vz(NULL),
+  Vr((nullptr)),
+  Vp((nullptr)),
+  Vz((nullptr)),
   additional_data(data)
 {}
 
index 9ae3e8b102f5c6f6f29e897a29ee3ad25bf1a212..0bfb2d8bd9f6d52300759a4eb8479f74b7a659d5 100644 (file)
@@ -541,7 +541,7 @@ namespace internal
                 VectorMemory<VectorType> &vmem)
       :
       mem(vmem),
-      data (max_size, 0),
+      data (max_size, nullptr),
       offset(0)
     {}
 
@@ -552,7 +552,7 @@ namespace internal
     {
       for (typename std::vector<VectorType *>::iterator v = data.begin();
            v != data.end(); ++v)
-        if (*v != 0)
+        if (*v != nullptr)
           mem.free(*v);
     }
 
@@ -564,7 +564,7 @@ namespace internal
       Assert (i+offset<data.size(),
               ExcIndexRange(i, -offset, data.size()-offset));
 
-      Assert (data[i-offset] != 0, ExcNotInitialized());
+      Assert (data[i-offset] != nullptr, ExcNotInitialized());
       return *data[i-offset];
     }
 
@@ -576,7 +576,7 @@ namespace internal
     {
       Assert (i+offset<data.size(),
               ExcIndexRange(i,-offset, data.size()-offset));
-      if (data[i-offset] == 0)
+      if (data[i-offset] == nullptr)
         {
           data[i-offset] = mem.alloc();
           data[i-offset]->reinit(temp);
@@ -877,9 +877,9 @@ SolverGMRES<VectorType>::solve (const MatrixType         &A,
   // Following vectors are needed
   // when not the default residuals
   // are used as stopping criterion
-  VectorType *r=0;
-  VectorType *x_=0;
-  dealii::Vector<double> *gamma_=0;
+  VectorType *r=nullptr;
+  VectorType *x_=nullptr;
+  dealii::Vector<double> *gamma_=nullptr;
   if (!use_default_residual)
     {
       r=this->memory.alloc();
index 2ce525dcbc6bf1a3b64680ad85a8e8297d7991be..0cde0917e7d699c7f8a52770a41ec250f30b1bc3 100644 (file)
@@ -169,13 +169,13 @@ SolverMinRes<VectorType>::SolverMinRes (SolverControl        &cn,
                                         const AdditionalData &)
   :
   Solver<VectorType>(cn),
-  Vu0(NULL),
-  Vu1(NULL),
-  Vu2(NULL),
-  Vm0(NULL),
-  Vm1(NULL),
-  Vm2(NULL),
-  Vv(NULL),
+  Vu0((nullptr)),
+  Vu1((nullptr)),
+  Vu2((nullptr)),
+  Vm0((nullptr)),
+  Vm1((nullptr)),
+  Vm2((nullptr)),
+  Vv((nullptr)),
   res2(numbers::signaling_nan<double>())
 {}
 
index 324af8b4a812f1a365f67494d4f82c6bb4cd0a55..bdfe70b3f4ec59062082aa1cb7c9d61a81202f5a 100644 (file)
@@ -194,8 +194,8 @@ SolverRichardson<VectorType>::SolverRichardson(SolverControl            &cn,
                                                const AdditionalData     &data)
   :
   Solver<VectorType> (cn,mem),
-  Vr(NULL),
-  Vd(NULL),
+  Vr((nullptr)),
+  Vd((nullptr)),
   additional_data(data)
 {}
 
@@ -206,8 +206,8 @@ SolverRichardson<VectorType>::SolverRichardson(SolverControl        &cn,
                                                const AdditionalData &data)
   :
   Solver<VectorType> (cn),
-  Vr(NULL),
-  Vd(NULL),
+  Vr((nullptr)),
+  Vd((nullptr)),
   additional_data(data),
   res(numbers::signaling_nan<double>())
 {}
index 2e9e5567c3cc3ca80360dd36ecb22bec86ccff13..b22b38b063776bec1f3eeeb3dac28a315474c735 100644 (file)
@@ -148,7 +148,7 @@ public:
     AdditionalData (const double strengthen_diagonal=0,
                     const unsigned int extra_off_diagonals=0,
                     const bool use_previous_sparsity=false,
-                    const SparsityPattern *use_this_sparsity=0);
+                    const SparsityPattern *use_this_sparsity=nullptr);
 
     /**
      * <code>strengthen_diag</code> times the sum of absolute row entries is
index 956cfed739945abc2417cb30da66bd2fa69a0899..a4154c43f404a9122b4a4af5a4fad56d157a78d0 100644 (file)
@@ -32,7 +32,7 @@ SparseLUDecomposition<number>::SparseLUDecomposition()
   :
   SparseMatrix<number>(),
   strengthen_diagonal (0),
-  own_sparsity(0)
+  own_sparsity(nullptr)
 {}
 
 
@@ -55,7 +55,7 @@ void SparseLUDecomposition<number>::clear()
   if (own_sparsity)
     {
       delete own_sparsity;
-      own_sparsity=0;
+      own_sparsity=nullptr;
     }
 }
 
@@ -69,7 +69,7 @@ void SparseLUDecomposition<number>::initialize (
 {
   const SparsityPattern &matrix_sparsity=matrix.get_sparsity_pattern();
 
-  const SparsityPattern *sparsity_pattern_to_use = 0;
+  const SparsityPattern *sparsity_pattern_to_use = nullptr;
 
   if (data.use_this_sparsity)
     sparsity_pattern_to_use = data.use_this_sparsity;
index 50fa2456f9302787cf8ee73171250a1dcc79fc37..ca128cafaeebc19e1e237808f42dbb42957704ce 100644 (file)
@@ -1642,7 +1642,7 @@ template <typename number>
 inline
 typename SparseMatrix<number>::size_type SparseMatrix<number>::m () const
 {
-  Assert (cols != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
   return cols->rows;
 }
 
@@ -1651,7 +1651,7 @@ template <typename number>
 inline
 typename SparseMatrix<number>::size_type SparseMatrix<number>::n () const
 {
-  Assert (cols != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
   return cols->cols;
 }
 
@@ -1833,8 +1833,8 @@ inline
 SparseMatrix<number> &
 SparseMatrix<number>::operator *= (const number factor)
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
 
   number             *val_ptr    = &val[0];
   const number *const end_ptr    = &val[cols->n_nonzero_elements()];
@@ -1852,8 +1852,8 @@ inline
 SparseMatrix<number> &
 SparseMatrix<number>::operator /= (const number factor)
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   Assert (factor != number(), ExcDivideByZero());
 
   const number factor_inv = number(1.) / factor;
@@ -1874,7 +1874,7 @@ inline
 number SparseMatrix<number>::operator () (const size_type i,
                                           const size_type j) const
 {
-  Assert (cols != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
   Assert (cols->operator()(i,j) != SparsityPattern::invalid_entry,
           ExcInvalidIndex(i,j));
   return val[cols->operator()(i,j)];
@@ -1887,7 +1887,7 @@ inline
 number SparseMatrix<number>::el (const size_type i,
                                  const size_type j) const
 {
-  Assert (cols != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
   const size_type index = cols->operator()(i,j);
 
   if (index != SparsityPattern::invalid_entry)
@@ -1902,7 +1902,7 @@ template <typename number>
 inline
 number SparseMatrix<number>::diag_element (const size_type i) const
 {
-  Assert (cols != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
   Assert (m() == n(),  ExcNotQuadratic());
   AssertIndexRange(i, m());
 
@@ -1917,7 +1917,7 @@ template <typename number>
 inline
 number &SparseMatrix<number>::diag_element (const size_type i)
 {
-  Assert (cols != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
   Assert (m() == n(),  ExcNotQuadratic());
   AssertIndexRange(i, m());
 
@@ -2372,8 +2372,8 @@ void SparseMatrix<number>::print (StreamType &out,
                                   const bool  across,
                                   const bool  diagonal_first) const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
 
   bool hanging_diagonal = false;
   number diagonal = number();
index 23aa9084b682e7f07f2d6482010d7799f5ce60fc..316c5f75b2d76e776fe47cacfcd1d8de50420676 100644 (file)
@@ -47,8 +47,8 @@ DEAL_II_NAMESPACE_OPEN
 template <typename number>
 SparseMatrix<number>::SparseMatrix ()
   :
-  cols(0, "SparseMatrix"),
-  val(0),
+  cols(nullptr, "SparseMatrix"),
+  val(nullptr),
   max_len(0)
 {}
 
@@ -58,11 +58,11 @@ template <typename number>
 SparseMatrix<number>::SparseMatrix (const SparseMatrix &m)
   :
   Subscriptor (m),
-  cols(0, "SparseMatrix"),
-  val(0),
+  cols(nullptr, "SparseMatrix"),
+  val(nullptr),
   max_len(0)
 {
-  Assert (m.cols==0 && m.val==0 && m.max_len==0,
+  Assert (m.cols==nullptr && m.val==nullptr && m.max_len==0,
           ExcMessage("This constructor can only be called if the provided argument "
                      "is an empty matrix. This constructor can not be used to "
                      "copy-construct a non-empty matrix. Use the "
@@ -93,7 +93,7 @@ SparseMatrix<number> &
 SparseMatrix<number>::operator = (const SparseMatrix<number> &m)
 {
   (void)m;
-  Assert (m.cols==0 && m.val==0 && m.max_len==0,
+  Assert (m.cols==nullptr && m.val==nullptr && m.max_len==0,
           ExcMessage("This operator can only be called if the provided right "
                      "hand side is an empty matrix. This operator can not be "
                      "used to copy a non-empty matrix. Use the "
@@ -126,8 +126,8 @@ SparseMatrix<number>::operator = (SparseMatrix<number> &&m)
 template <typename number>
 SparseMatrix<number>::SparseMatrix (const SparsityPattern &c)
   :
-  cols(0, "SparseMatrix"),
-  val(0),
+  cols(nullptr, "SparseMatrix"),
+  val(nullptr),
   max_len(0)
 {
   reinit (c);
@@ -139,8 +139,8 @@ template <typename number>
 SparseMatrix<number>::SparseMatrix (const SparsityPattern &c,
                                     const IdentityMatrix  &id)
   :
-  cols(0, "SparseMatrix"),
-  val(0),
+  cols(nullptr, "SparseMatrix"),
+  val(nullptr),
   max_len(0)
 {
   (void)id;
@@ -157,9 +157,9 @@ SparseMatrix<number>::SparseMatrix (const SparsityPattern &c,
 template <typename number>
 SparseMatrix<number>::~SparseMatrix ()
 {
-  cols = 0;
+  cols = nullptr;
 
-  if (val != 0)
+  if (val != nullptr)
     delete[] val;
 }
 
@@ -190,7 +190,7 @@ SparseMatrix<number>::operator = (const double d)
   (void)d;
   Assert (d==0, ExcScalarAssignmentOnlyForZeroValue());
 
-  Assert (cols != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
   Assert (cols->compressed || cols->empty(), SparsityPattern::ExcNotCompressed());
 
   // do initial zeroing of elements in parallel. Try to achieve a similar
@@ -246,9 +246,9 @@ SparseMatrix<number>::reinit (const SparsityPattern &sparsity)
 
   if (cols->empty())
     {
-      if (val != 0)
+      if (val != nullptr)
         delete[] val;
-      val = 0;
+      val = nullptr;
       max_len = 0;
       return;
     }
@@ -256,7 +256,7 @@ SparseMatrix<number>::reinit (const SparsityPattern &sparsity)
   const std::size_t N = cols->n_nonzero_elements();
   if (N > max_len || max_len == 0)
     {
-      if (val != 0)
+      if (val != nullptr)
         delete[] val;
       val = new number[N];
       max_len = N;
@@ -271,9 +271,9 @@ template <typename number>
 void
 SparseMatrix<number>::clear ()
 {
-  cols = 0;
+  cols = nullptr;
   if (val) delete[] val;
-  val = 0;
+  val = nullptr;
   max_len = 0;
 }
 
@@ -283,7 +283,7 @@ template <typename number>
 bool
 SparseMatrix<number>::empty () const
 {
-  if (cols == 0)
+  if (cols == nullptr)
     return true;
   else
     return cols->empty();
@@ -295,7 +295,7 @@ template <typename number>
 typename SparseMatrix<number>::size_type
 SparseMatrix<number>::get_row_length (const size_type row) const
 {
-  Assert (cols != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
   return cols->row_length(row);
 }
 
@@ -305,7 +305,7 @@ template <typename number>
 std::size_t
 SparseMatrix<number>::n_nonzero_elements () const
 {
-  Assert (cols != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
   return cols->n_nonzero_elements ();
 }
 
@@ -315,7 +315,7 @@ template <typename number>
 std::size_t
 SparseMatrix<number>::n_actually_nonzero_elements (const double threshold) const
 {
-  Assert (cols != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
   Assert (threshold >= 0, ExcMessage ("Negative threshold!"));
   size_type nnz = 0;
   const std::size_t nnz_alloc = n_nonzero_elements();
@@ -331,7 +331,7 @@ template <typename number>
 void
 SparseMatrix<number>::symmetrize ()
 {
-  Assert (cols != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
   Assert (cols->rows == cols->cols, ExcNotQuadratic());
 
   const size_type n_rows = m();
@@ -371,8 +371,8 @@ template <typename somenumber>
 SparseMatrix<number> &
 SparseMatrix<number>::copy_from (const SparseMatrix<somenumber> &matrix)
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   Assert (cols == matrix.cols, ExcDifferentSparsityPatterns());
 
   std::copy (&matrix.val[0], &matrix.val[cols->n_nonzero_elements()],
@@ -453,8 +453,8 @@ void
 SparseMatrix<number>::add (const number factor,
                            const SparseMatrix<somenumber> &matrix)
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   Assert (cols == matrix.cols, ExcDifferentSparsityPatterns());
 
   number             *val_ptr    = &val[0];
@@ -528,7 +528,7 @@ SparseMatrix<number>::add (const size_type  row,
                            const bool       elide_zero_values,
                            const bool       col_indices_are_sorted)
 {
-  Assert (cols != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
 
   // if we have sufficiently many columns
   // and sorted indices it is faster to
@@ -677,7 +677,7 @@ SparseMatrix<number>::set (const size_type  row,
                            const number2   *values,
                            const bool       elide_zero_values)
 {
-  Assert (cols != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
   AssertIndexRange(row, m());
 
   // First, search all the indices to find
@@ -757,8 +757,8 @@ void
 SparseMatrix<number>::vmult (OutVector &dst,
                              const InVector &src) const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   Assert(m() == dst.size(), ExcDimensionMismatch(m(),dst.size()));
   Assert(n() == src.size(), ExcDimensionMismatch(n(),src.size()));
 
@@ -785,8 +785,8 @@ void
 SparseMatrix<number>::Tvmult (OutVector &dst,
                               const InVector &src) const
 {
-  Assert (val != 0, ExcNotInitialized());
-  Assert (cols != 0, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
   Assert(n() == dst.size(), ExcDimensionMismatch(n(),dst.size()));
   Assert(m() == src.size(), ExcDimensionMismatch(m(),src.size()));
 
@@ -812,8 +812,8 @@ void
 SparseMatrix<number>::vmult_add (OutVector &dst,
                                  const InVector &src) const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   Assert(m() == dst.size(), ExcDimensionMismatch(m(),dst.size()));
   Assert(n() == src.size(), ExcDimensionMismatch(n(),src.size()));
 
@@ -840,8 +840,8 @@ void
 SparseMatrix<number>::Tvmult_add (OutVector &dst,
                                   const InVector &src) const
 {
-  Assert (val != 0, ExcNotInitialized());
-  Assert (cols != 0, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
   Assert(n() == dst.size(), ExcDimensionMismatch(n(),dst.size()));
   Assert(m() == src.size(), ExcDimensionMismatch(m(),src.size()));
 
@@ -899,8 +899,8 @@ template <typename somenumber>
 somenumber
 SparseMatrix<number>::matrix_norm_square (const Vector<somenumber> &v) const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   Assert(m() == v.size(), ExcDimensionMismatch(m(),v.size()));
   Assert(n() == v.size(), ExcDimensionMismatch(n(),v.size()));
 
@@ -962,8 +962,8 @@ somenumber
 SparseMatrix<number>::matrix_scalar_product (const Vector<somenumber> &u,
                                              const Vector<somenumber> &v) const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   Assert(m() == u.size(), ExcDimensionMismatch(m(),u.size()));
   Assert(n() == v.size(), ExcDimensionMismatch(n(),v.size()));
 
@@ -991,9 +991,9 @@ SparseMatrix<number>::mmult (SparseMatrix<numberC>       &C,
 {
   const bool use_vector = V.size() == n() ? true : false;
   Assert (n() == B.m(), ExcDimensionMismatch(n(), B.m()));
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (B.cols != 0, ExcNotInitialized());
-  Assert (C.cols != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (B.cols != nullptr, ExcNotInitialized());
+  Assert (C.cols != nullptr, ExcNotInitialized());
 
   const SparsityPattern &sp_A = *cols;
   const SparsityPattern &sp_B = *B.cols;
@@ -1118,9 +1118,9 @@ SparseMatrix<number>::Tmmult (SparseMatrix<numberC>       &C,
 {
   const bool use_vector = V.size() == m() ? true : false;
   Assert (m() == B.m(), ExcDimensionMismatch(m(), B.m()));
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (B.cols != 0, ExcNotInitialized());
-  Assert (C.cols != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (B.cols != nullptr, ExcNotInitialized());
+  Assert (C.cols != nullptr, ExcNotInitialized());
 
   const SparsityPattern &sp_A = *cols;
   const SparsityPattern &sp_B = *B.cols;
@@ -1241,8 +1241,8 @@ template <typename number>
 typename SparseMatrix<number>::real_type
 SparseMatrix<number>::l1_norm () const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
 
   Vector<real_type> column_sums(n());
   const size_type n_rows = m();
@@ -1259,8 +1259,8 @@ template <typename number>
 typename SparseMatrix<number>::real_type
 SparseMatrix<number>::linfty_norm () const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
 
   const number *val_ptr = &val[cols->rowstart[0]];
 
@@ -1346,8 +1346,8 @@ SparseMatrix<number>::residual (Vector<somenumber>       &dst,
                                 const Vector<somenumber> &u,
                                 const Vector<somenumber> &b) const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   Assert(m() == dst.size(), ExcDimensionMismatch(m(),dst.size()));
   Assert(m() == b.size(), ExcDimensionMismatch(m(),b.size()));
   Assert(n() == u.size(), ExcDimensionMismatch(n(),u.size()));
@@ -1406,8 +1406,8 @@ SparseMatrix<number>::precondition_Jacobi (Vector<somenumber>       &dst,
                                            const Vector<somenumber> &src,
                                            const number              om) const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   AssertDimension (m(), n());
   AssertDimension (dst.size(), n());
   AssertDimension (src.size(), n());
@@ -1452,8 +1452,8 @@ SparseMatrix<number>::precondition_SSOR (Vector<somenumber>              &dst,
   // you may want to take a look at the CVS
   // archives to see the original version
   // which is much clearer...
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   AssertDimension (m(), n());
   AssertDimension (dst.size(), n());
   AssertDimension (src.size(), n());
@@ -1576,8 +1576,8 @@ SparseMatrix<number>::precondition_SOR (Vector<somenumber> &dst,
                                         const Vector<somenumber> &src,
                                         const number om) const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
 
   dst = src;
   SOR(dst,om);
@@ -1591,8 +1591,8 @@ SparseMatrix<number>::precondition_TSOR (Vector<somenumber> &dst,
                                          const Vector<somenumber> &src,
                                          const number om) const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
 
   dst = src;
   TSOR(dst,om);
@@ -1605,8 +1605,8 @@ void
 SparseMatrix<number>::SOR (Vector<somenumber> &dst,
                            const number om) const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   AssertDimension (m(), n());
   AssertDimension (dst.size(), n());
 
@@ -1633,8 +1633,8 @@ void
 SparseMatrix<number>::TSOR (Vector<somenumber> &dst,
                             const number om) const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   AssertDimension (m(), n());
   AssertDimension (dst.size(), n());
 
@@ -1666,8 +1666,8 @@ SparseMatrix<number>::PSOR (Vector<somenumber> &dst,
                             const std::vector<size_type> &inverse_permutation,
                             const number om) const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   AssertDimension (m(), n());
 
   Assert (m() == dst.size(), ExcDimensionMismatch(m(),dst.size()));
@@ -1705,8 +1705,8 @@ SparseMatrix<number>::TPSOR (Vector<somenumber> &dst,
                              const std::vector<size_type> &inverse_permutation,
                              const number om) const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   AssertDimension (m(), n());
 
   Assert (m() == dst.size(), ExcDimensionMismatch(m(),dst.size()));
@@ -1742,8 +1742,8 @@ SparseMatrix<number>::Jacobi_step (Vector<somenumber> &v,
                                    const Vector<somenumber> &b,
                                    const number        om) const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   AssertDimension (m(), n());
 
   Assert (m() == v.size(), ExcDimensionMismatch(m(),v.size()));
@@ -1773,8 +1773,8 @@ SparseMatrix<number>::SOR_step (Vector<somenumber> &v,
                                 const Vector<somenumber> &b,
                                 const number        om) const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   AssertDimension (m(), n());
   Assert (m() == v.size(), ExcDimensionMismatch(m(),v.size()));
   Assert (m() == b.size(), ExcDimensionMismatch(m(),b.size()));
@@ -1801,8 +1801,8 @@ SparseMatrix<number>::TSOR_step (Vector<somenumber> &v,
                                  const Vector<somenumber> &b,
                                  const number        om) const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   AssertDimension (m(), n());
   Assert (m() == v.size(), ExcDimensionMismatch(m(),v.size()));
   Assert (m() == b.size(), ExcDimensionMismatch(m(),b.size()));
@@ -1844,8 +1844,8 @@ SparseMatrix<number>::SSOR (Vector<somenumber> &dst,
 //TODO: Is this called anywhere? If so, multiplication with om(2-om)D is missing
   Assert(false, ExcNotImplemented());
 
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
   AssertDimension (m(), n());
   Assert (m() == dst.size(), ExcDimensionMismatch(m(),dst.size()));
 
@@ -1893,7 +1893,7 @@ template <typename number>
 const SparsityPattern &
 SparseMatrix<number>::get_sparsity_pattern () const
 {
-  Assert (cols != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
   return *cols;
 }
 
@@ -1907,8 +1907,8 @@ void SparseMatrix<number>::print_formatted (std::ostream &out,
                                             const char *zero_string,
                                             const double denominator) const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
 
   unsigned int width = width_;
 
@@ -1951,8 +1951,8 @@ template <typename number>
 void SparseMatrix<number>::print_pattern (std::ostream &out,
                                           const double threshold) const
 {
-  Assert (cols != 0, ExcNotInitialized());
-  Assert (val != 0, ExcNotInitialized());
+  Assert (cols != nullptr, ExcNotInitialized());
+  Assert (val != nullptr, ExcNotInitialized());
 
   for (size_type i=0; i<m(); ++i)
     {
index 7a133edf98ad165840b5cc0175da3978cc04d648..66276cd39892338047d43c36f01c4528f1533902 100644 (file)
@@ -1100,9 +1100,9 @@ SparseMatrixEZ<number>::locate (const size_type row,
       if (entry->column == col)
         return entry;
       if (entry->column == Entry::invalid)
-        return 0;
+        return nullptr;
     }
-  return 0;
+  return nullptr;
 }
 
 
@@ -1231,7 +1231,7 @@ void SparseMatrixEZ<number>::set (const size_type i,
   if (elide_zero_values && value == 0.)
     {
       Entry *entry = locate(i,j);
-      if (entry != 0)
+      if (entry != nullptr)
         entry->value = 0.;
     }
   else
index 0b4319b2c7857599dc1ef9455415b1b0f7c8a50b..73f813b2fb153e68bac1d87b2f254665dd966798 100644 (file)
@@ -282,7 +282,7 @@ protected:
   template<typename number2>
   void apply_preconditioner (Vector<number2>         &dst,
                              const Vector<number2>   &src,
-                             const std::vector<bool> *const dof_mask = 0) const;
+                             const std::vector<bool> *const dof_mask = nullptr) const;
 
   /**
    * Determine an estimate for the memory consumption (in bytes) of this
index 254b6934e2d073aee14f6fa946a8a18db28a84a4..31da7a5cc083f1dde9550f03082c155a092b0d96 100644 (file)
@@ -53,7 +53,7 @@ SparseVanka<number>::SparseVanka(const SparseMatrix<number> &M,
   conserve_mem (conserve_mem),
   selected (&selected_dofs),
   n_threads (n_threads),
-  inverses (M.m(), 0),
+  inverses (M.m(), nullptr),
   _m (M.m()),
   _n (M.n())
 {
@@ -72,8 +72,8 @@ SparseVanka<number>::~SparseVanka()
   for (i=inverses.begin(); i!=inverses.end(); ++i)
     {
       FullMatrix<float> *p = *i;
-      *i = 0;
-      if (p != 0) delete p;
+      *i = nullptr;
+      if (p != nullptr) delete p;
     }
 }
 
@@ -102,8 +102,8 @@ template <typename number>
 void
 SparseVanka<number>::compute_inverses ()
 {
-  Assert(matrix != 0, ExcNotInitialized());
-  Assert(selected != 0, ExcNotInitialized());
+  Assert(matrix != nullptr, ExcNotInitialized());
+  Assert(selected != nullptr, ExcNotInitialized());
 
 #ifndef DEAL_II_WITH_THREADS
   compute_inverses (0, matrix->m());
@@ -191,8 +191,8 @@ void
 SparseVanka<number>::compute_inverse (const size_type         row,
                                       std::vector<size_type> &local_indices)
 {
-  Assert(matrix != 0, ExcNotInitialized());
-  Assert(selected != 0, ExcNotInitialized());
+  Assert(matrix != nullptr, ExcNotInitialized());
+  Assert(selected != nullptr, ExcNotInitialized());
 
   // first define an alias to the sparsity
   // pattern of the matrix, since this
@@ -226,8 +226,8 @@ void
 SparseVanka<number>::vmult (Vector<number2>       &dst,
                             const Vector<number2> &src) const
 {
-  Assert(matrix != 0, ExcNotInitialized());
-  Assert(selected != 0, ExcNotInitialized());
+  Assert(matrix != nullptr, ExcNotInitialized());
+  Assert(selected != nullptr, ExcNotInitialized());
 
   // first set output vector to zero
   dst = 0;
@@ -261,7 +261,7 @@ SparseVanka<number>::apply_preconditioner (Vector<number2>         &dst,
   // blocks. this variable is used to
   // optimize access to vectors a
   // little bit.
-  const bool range_is_restricted = (dof_mask != 0);
+  const bool range_is_restricted = (dof_mask != nullptr);
 
   // space to be used for local
   // systems. allocate as much memory
@@ -389,7 +389,7 @@ SparseVanka<number>::apply_preconditioner (Vector<number2>         &dst,
         // inverses, then unalias the
         // local matrix
         if (conserve_mem == true)
-          inverses[row] = 0;
+          inverses[row] = nullptr;
       }
 }
 
index 2db0dd3009abfc24a8a098c43fdcd023a189c53b..f8d9b29aeb24d61d2753024779e44e08ce554c24 100644 (file)
@@ -1397,7 +1397,7 @@ inline
 std::size_t
 SparsityPattern::n_nonzero_elements () const
 {
-  Assert ((rowstart!=0) && (colnums!=0), ExcEmptyObject());
+  Assert ((rowstart!=nullptr) && (colnums!=nullptr), ExcEmptyObject());
   Assert (compressed, ExcNotCompressed());
   return rowstart[rows]-rowstart[0];
 }
@@ -1430,11 +1430,11 @@ SparsityPattern::load (Archive &ar, const unsigned int)
 
   ar &max_dim &rows &cols &max_vec_len &max_row_length &compressed &store_diagonal_first_in_row;
 
-  if (rowstart != 0)
+  if (rowstart != nullptr)
     delete[] rowstart;
   rowstart = new std::size_t[max_dim + 1];
 
-  if (colnums != 0)
+  if (colnums != nullptr)
     delete[] colnums;
   colnums = new size_type[max_vec_len];
 
index d6b70df82a6ff40fd454a46fb2ec641268eb5302..f3ff0283a2ab6a22fbda15d8e7c2c302749156db 100644 (file)
@@ -1574,7 +1574,7 @@ namespace TrilinosWrappers
     void initialize (const ::dealii::SparseMatrix<number> &deal_ii_sparse_matrix,
                      const AdditionalData                 &additional_data = AdditionalData(),
                      const double                          drop_tolerance = 1e-13,
-                     const ::dealii::SparsityPattern      *use_this_sparsity = 0);
+                     const ::dealii::SparsityPattern      *use_this_sparsity = nullptr);
 
     /**
      * This function can be used for a faster recalculation of the
@@ -1823,7 +1823,7 @@ namespace TrilinosWrappers
     void initialize (const ::dealii::SparseMatrix<number> &deal_ii_sparse_matrix,
                      const AdditionalData                 &additional_data = AdditionalData(),
                      const double                          drop_tolerance = 1e-13,
-                     const ::dealii::SparsityPattern      *use_this_sparsity = 0);
+                     const ::dealii::SparsityPattern      *use_this_sparsity = nullptr);
 
     /**
      * Destroys the preconditioner, leaving an object like just after having
index 51e9162848a6f31ba530aaf7d8a9a0ecfb2802bb..15c53e6f601752c4b87ac332356187369e80e024 100644 (file)
@@ -640,7 +640,7 @@ namespace TrilinosWrappers
     void reinit (const ::dealii::SparseMatrix<number> &dealii_sparse_matrix,
                  const double                          drop_tolerance=1e-13,
                  const bool                            copy_values=true,
-                 const ::dealii::SparsityPattern      *use_this_sparsity=0);
+                 const ::dealii::SparsityPattern      *use_this_sparsity=nullptr);
 
     /**
      * This reinit function takes as input a Trilinos Epetra_CrsMatrix and
@@ -799,7 +799,7 @@ namespace TrilinosWrappers
                  const ::dealii::SparseMatrix<number> &dealii_sparse_matrix,
                  const double                          drop_tolerance=1e-13,
                  const bool                            copy_values=true,
-                 const ::dealii::SparsityPattern      *use_this_sparsity=0) DEAL_II_DEPRECATED;
+                 const ::dealii::SparsityPattern      *use_this_sparsity=nullptr) DEAL_II_DEPRECATED;
 
     /**
      * This function is similar to the other initialization function with
@@ -822,7 +822,7 @@ namespace TrilinosWrappers
                  const ::dealii::SparseMatrix<number>  &dealii_sparse_matrix,
                  const double                           drop_tolerance=1e-13,
                  const bool                             copy_values=true,
-                 const ::dealii::SparsityPattern      *use_this_sparsity=0) DEAL_II_DEPRECATED;
+                 const ::dealii::SparsityPattern      *use_this_sparsity=nullptr) DEAL_II_DEPRECATED;
 //@}
     /**
      * @name Constructors and initialization using an IndexSet description
@@ -960,7 +960,7 @@ namespace TrilinosWrappers
                  const MPI_Comm                       &communicator = MPI_COMM_WORLD,
                  const double                          drop_tolerance=1e-13,
                  const bool                            copy_values=true,
-                 const ::dealii::SparsityPattern      *use_this_sparsity=0);
+                 const ::dealii::SparsityPattern      *use_this_sparsity=nullptr);
 
     /**
      * This function is similar to the other initialization function with
@@ -982,7 +982,7 @@ namespace TrilinosWrappers
                  const MPI_Comm                        &communicator = MPI_COMM_WORLD,
                  const double                           drop_tolerance=1e-13,
                  const bool                             copy_values=true,
-                 const ::dealii::SparsityPattern      *use_this_sparsity=0);
+                 const ::dealii::SparsityPattern      *use_this_sparsity=nullptr);
 //@}
     /**
      * @name Information on the matrix
@@ -3040,7 +3040,7 @@ namespace TrilinosWrappers
     // If the matrix structure has not been fixed (i.e., we did not have a
     // sparsity pattern), it does not know about the number of columns so we
     // must always take this from the additional column space map
-    Assert(column_space_map.get() != 0, ExcInternalError());
+    Assert(column_space_map.get() != nullptr, ExcInternalError());
 #ifndef DEAL_II_WITH_64BIT_INDICES
     return column_space_map->NumGlobalElements();
 #else
index 5230b2e7439eb52cd329f64cead73967f2cbd7bc..f37f9b477f8af15a4c9c40addb732c2afafefee8 100644 (file)
@@ -1454,7 +1454,7 @@ namespace TrilinosWrappers
     int ierr;
     if ( graph->RowMap().LID(static_cast<TrilinosWrappers::types::int_type>(row)) != -1)
       ierr = graph->InsertGlobalIndices (row, n_cols, col_index_ptr);
-    else if (nonlocal_graph.get() != 0)
+    else if (nonlocal_graph.get() != nullptr)
       {
         // this is the case when we have explicitly set the off-processor rows
         // and want to create a separate matrix object for them (to retain
index c60cec7aed37149aac3bb8200d91f0fed0098795..fa99de015a256e16c7f842a5b733076d0278e3fb 100644 (file)
@@ -684,7 +684,7 @@ namespace TrilinosWrappers
     void Vector::reinit (const Epetra_Map             &parallel_partitioner,
                          const dealii::Vector<number> &v)
     {
-      if (vector.get() == 0 || vector->Map().SameAs(parallel_partitioner) == false)
+      if (vector.get() == nullptr || vector->Map().SameAs(parallel_partitioner) == false)
         reinit(parallel_partitioner);
 
       const int size = parallel_partitioner.NumMyElements();
index d0472a32e04be464d0e359b2e6157daaa810f9cc..082c69a93f98ed70c1a07bd14c913c9b0a53b84a 100644 (file)
@@ -832,7 +832,7 @@ namespace TrilinosWrappers
      *
      * This function is deprecated.
      */
-    void print (const char *format = 0) const DEAL_II_DEPRECATED;
+    void print (const char *format = nullptr) const DEAL_II_DEPRECATED;
 
     /**
      * Print to a stream. @p precision denotes the desired precision with
@@ -1203,14 +1203,14 @@ namespace TrilinosWrappers
   VectorBase::reinit (const VectorBase &v,
                       const bool        omit_zeroing_entries)
   {
-    Assert (vector.get() != 0,
+    Assert (vector.get() != nullptr,
             ExcMessage("Vector has not been constructed properly."));
 
     if (omit_zeroing_entries == false ||
         vector_partitioner().SameAs(v.vector_partitioner())==false)
       vector.reset (new Epetra_FEVector(*v.vector));
 
-    if (v.nonlocal_vector.get() != 0)
+    if (v.nonlocal_vector.get() != nullptr)
       nonlocal_vector.reset(new Epetra_MultiVector(v.nonlocal_vector->Map(), 1));
 
     owned_elements = v.owned_elements;
@@ -1227,7 +1227,7 @@ namespace TrilinosWrappers
     int ierr = vector->PutScalar(s);
     AssertThrow (ierr == 0, ExcTrilinosError(ierr));
 
-    if (nonlocal_vector.get() != 0)
+    if (nonlocal_vector.get() != nullptr)
       {
         ierr = nonlocal_vector->PutScalar(0.);
         AssertThrow (ierr == 0, ExcTrilinosError(ierr));
@@ -1373,7 +1373,7 @@ namespace TrilinosWrappers
         const TrilinosWrappers::types::int_type local_row = vector->Map().LID(static_cast<TrilinosWrappers::types::int_type>(row));
         if (local_row != -1)
           (*vector)[0][local_row] += values[i];
-        else if (nonlocal_vector.get() == 0)
+        else if (nonlocal_vector.get() == nullptr)
           {
             const int ierr = vector->SumIntoGlobalValues (1,
                                                           (const TrilinosWrappers::types::int_type *)(&row),
index 6798ecc4600bb29f8bf981fc81a8c47a683c7255..d5bf2b678c76c70a1e2f36a8d463b79d6ae798a6 100644 (file)
@@ -864,7 +864,7 @@ public:
    *
    * This function is deprecated.
    */
-  void print (const char *format = 0) const DEAL_II_DEPRECATED;
+  void print (const char *format = nullptr) const DEAL_II_DEPRECATED;
 
   /**
    * Print to a stream. @p precision denotes the desired precision with which
@@ -1073,7 +1073,7 @@ Vector<Number>::Vector ()
   :
   vec_size(0),
   max_vec_size(0),
-  val(0)
+  val(nullptr)
 {
   reinit(0);
 }
@@ -1086,7 +1086,7 @@ Vector<Number>::Vector (const InputIterator first, const InputIterator last)
   :
   vec_size (0),
   max_vec_size (0),
-  val (0)
+  val (nullptr)
 {
   // allocate memory. do not initialize it, as we will copy over to it in a
   // second
@@ -1102,7 +1102,7 @@ Vector<Number>::Vector (const size_type n)
   :
   vec_size(0),
   max_vec_size(0),
-  val(0)
+  val(nullptr)
 {
   reinit (n, false);
 }
@@ -1116,7 +1116,7 @@ Vector<Number>::~Vector ()
   if (val)
     {
       deallocate();
-      val=0;
+      val=nullptr;
     }
 }
 
index 08ec9c3a410396152349379b976fd2868470f656..674404dcbf34d4d23f78b2f004cf09ce536bb7fd 100644 (file)
@@ -48,7 +48,7 @@ Vector<Number>::Vector (const Vector<Number> &v)
   Subscriptor(),
   vec_size(v.size()),
   max_vec_size(v.size()),
-  val(0)
+  val(nullptr)
 {
   if (vec_size != 0)
     {
@@ -85,7 +85,7 @@ Vector<Number>::Vector (const Vector<OtherNumber> &v)
   Subscriptor(),
   vec_size(v.size()),
   max_vec_size(v.size()),
-  val(0)
+  val(nullptr)
 {
   if (vec_size != 0)
     {
@@ -104,7 +104,7 @@ Vector<Number>::Vector (const PETScWrappers::Vector &v)
   Subscriptor(),
   vec_size(v.size()),
   max_vec_size(v.size()),
-  val(0)
+  val(nullptr)
 {
   if (vec_size != 0)
     {
@@ -133,7 +133,7 @@ Vector<Number>::Vector (const PETScWrappers::MPI::Vector &v)
   Subscriptor(),
   vec_size(0),
   max_vec_size(0),
-  val(0)
+  val(nullptr)
 {
   if (v.size() != 0)
     {
@@ -156,7 +156,7 @@ Vector<Number>::Vector (const TrilinosWrappers::MPI::Vector &v)
   Subscriptor(),
   vec_size(v.size()),
   max_vec_size(v.size()),
-  val(0)
+  val(nullptr)
 {
   if (vec_size != 0)
     {
@@ -189,7 +189,7 @@ Vector<Number>::Vector (const TrilinosWrappers::Vector &v)
   Subscriptor(),
   vec_size(v.size()),
   max_vec_size(v.size()),
-  val(0)
+  val(nullptr)
 {
   if (vec_size != 0)
     {
@@ -280,7 +280,7 @@ void Vector<Number>::reinit (const size_type n,
   if (n==0)
     {
       if (val) deallocate();
-      val = 0;
+      val = nullptr;
       max_vec_size = vec_size = 0;
       thread_loop_partitioner.reset(new parallel::internal::TBBPartitioner());
       return;
@@ -319,7 +319,7 @@ void Vector<Number>::reinit (const Vector<Number2> &v,
   if (v.vec_size==0)
     {
       if (val) deallocate();
-      val = 0;
+      val = nullptr;
       max_vec_size = vec_size = 0;
       return;
     };
@@ -1123,7 +1123,7 @@ void
 Vector<Number>::allocate()
 {
   // make sure that we don't create a memory leak
-  Assert (val == 0, ExcInternalError());
+  Assert (val == nullptr, ExcInternalError());
 
   // then allocate memory with the proper alignment requirements of 64 bytes
   Utilities::System::posix_memalign ((void **)&val, 64, sizeof(Number)*max_vec_size);
@@ -1136,7 +1136,7 @@ void
 Vector<Number>::deallocate()
 {
   free(val);
-  val = 0;
+  val = nullptr;
 }
 
 DEAL_II_NAMESPACE_CLOSE
index 8158043b284418764f2ff3808bdab197cd8217ae..f899c237d932d4857accd0cf470de1d2056263be 100644 (file)
@@ -368,7 +368,7 @@ template <typename VectorType>
 inline
 VectorMemory<VectorType>::Pointer::Pointer(VectorMemory<VectorType> &mem)
   :
-  pool(&mem, typeid(*this).name()), v(0)
+  pool(&mem, typeid(*this).name()), v(nullptr)
 {
   v = pool->alloc();
 }
index 85d433a132a784cfc747ecd2c4ee7eb1fcaed910..03a2a043de5e3c3ffe4be9415a83c0aae1c41de4 100644 (file)
@@ -32,7 +32,7 @@ template <typename VectorType>
 inline
 GrowingVectorMemory<VectorType>::Pool::Pool()
   :
-  data(0)
+  data(nullptr)
 {}
 
 
@@ -42,7 +42,7 @@ inline
 GrowingVectorMemory<VectorType>::Pool::~Pool()
 {
   // Nothing to do if memory was unused.
-  if (data == 0) return;
+  if (data == nullptr) return;
 
   // First, delete all remaining
   // vectors. Actually, there should
@@ -63,7 +63,7 @@ inline
 void
 GrowingVectorMemory<VectorType>::Pool::initialize(const size_type size)
 {
-  if (data == 0)
+  if (data == nullptr)
     {
       data = new std::vector<entry_type>(size);
 
@@ -170,7 +170,7 @@ GrowingVectorMemory<VectorType>::release_unused_memory ()
 
   std::vector<entry_type> new_data;
 
-  if (pool.data != 0)
+  if (pool.data != nullptr)
     {
       const typename std::vector<entry_type>::const_iterator
       end = pool.data->end();
index 08370b0db84bf8af8467d851d139022e9eb8d2c0..d603841a98881469b87e2b1bb8b3cb53c202f6cd 100644 (file)
@@ -54,7 +54,7 @@ namespace internal
     void print (const T    &t,
                 const char *format)
     {
-      if (format != 0)
+      if (format != nullptr)
         std::printf (format, t);
       else
         std::printf (" %5.2f", double(t));
@@ -66,7 +66,7 @@ namespace internal
     void print (const std::complex<T> &t,
                 const char            *format)
     {
-      if (format != 0)
+      if (format != nullptr)
         std::printf (format, t.real(), t.imag());
       else
         std::printf (" %5.2f+%5.2fi",
@@ -170,7 +170,7 @@ namespace internal
       if (vec_size >= 4*internal::Vector::minimum_parallel_grain_size &&
           MultithreadInfo::n_threads() > 1)
         {
-          Assert(partitioner.get() != NULL,
+          Assert(partitioner.get() != nullptr,
                  ExcInternalError("Unexpected initialization of Vector that does "
                                   "not set the TBB partitioner to a usable state."));
           std::shared_ptr<tbb::affinity_partitioner> tbb_partitioner =
@@ -1264,7 +1264,7 @@ namespace internal
       if (vec_size >= 4*internal::Vector::minimum_parallel_grain_size &&
           MultithreadInfo::n_threads() > 1)
         {
-          Assert(partitioner.get() != NULL,
+          Assert(partitioner.get() != nullptr,
                  ExcInternalError("Unexpected initialization of Vector that does "
                                   "not set the TBB partitioner to a usable state."));
           std::shared_ptr<tbb::affinity_partitioner> tbb_partitioner =
index 485e130fc36640cf0c56746239bc556f5d1b1b54..4095238c7835a815d8bc389c0440d780a29776f5 100644 (file)
@@ -262,7 +262,7 @@ VectorView<Number>::~VectorView()
   // memory it doesn't own
   this->vec_size = 0;
   this->max_vec_size = 0;
-  this->val = 0;
+  this->val = nullptr;
 }
 
 
index 0ce8303d50767509e142f9da7dbca7ed3f588a37..5ee5d962c1a7007ecec919a713061e8fe67f1ecf 100644 (file)
@@ -432,7 +432,7 @@ namespace internal
       AssertIndexRange (row, row_starts.size()-1);
       const unsigned int index = row_starts[row][0];
       AssertIndexRange(index, dof_indices.size()+1);
-      return dof_indices.empty() ? 0 : &dof_indices[0] + index;
+      return dof_indices.empty() ? nullptr : &dof_indices[0] + index;
     }
 
 
@@ -444,7 +444,7 @@ namespace internal
       AssertIndexRange (row, row_starts.size()-1);
       const unsigned int index = row_starts[row+1][0];
       AssertIndexRange(index, dof_indices.size()+1);
-      return dof_indices.empty() ? 0 : &dof_indices[0] + index;
+      return dof_indices.empty() ? nullptr : &dof_indices[0] + index;
     }
 
 
@@ -466,7 +466,7 @@ namespace internal
       AssertIndexRange (row, row_starts.size()-1);
       const unsigned int index = row_starts[row][1];
       AssertIndexRange (index, constraint_indicator.size()+1);
-      return constraint_indicator.empty() ? 0 : &constraint_indicator[0] + index;
+      return constraint_indicator.empty() ? nullptr : &constraint_indicator[0] + index;
     }
 
 
@@ -478,7 +478,7 @@ namespace internal
       AssertIndexRange (row, row_starts.size()-1);
       const unsigned int index = row_starts[row+1][1];
       AssertIndexRange (index, constraint_indicator.size()+1);
-      return constraint_indicator.empty() ? 0 : &constraint_indicator[0] + index;
+      return constraint_indicator.empty() ? nullptr : &constraint_indicator[0] + index;
     }
 
 
@@ -509,7 +509,7 @@ namespace internal
           AssertDimension (row_starts.size(), row_starts_plain_indices.size());
           const unsigned int index = row_starts_plain_indices[row];
           AssertIndexRange(index, plain_dof_indices.size()+1);
-          return plain_dof_indices.empty() ? 0 : &plain_dof_indices[0] + index;
+          return plain_dof_indices.empty() ? nullptr : &plain_dof_indices[0] + index;
         }
     }
 
index b1abd0d1c02c921e065e083bf9f7c2ef8b6bfe0b..7c49f391a9ec6b395b59dd721db663b2d4c92a14 100644 (file)
@@ -182,7 +182,7 @@ namespace internal
                                ConstraintValues<double> &constraint_values,
                                bool                            &cell_at_boundary)
     {
-      Assert (vector_partitioner.get() !=0, ExcInternalError());
+      Assert (vector_partitioner.get() !=nullptr, ExcInternalError());
       const unsigned int n_mpi_procs = vector_partitioner->n_mpi_processes();
       const types::global_dof_index first_owned = vector_partitioner->local_range().first;
       const types::global_dof_index last_owned  = vector_partitioner->local_range().second;
@@ -203,7 +203,7 @@ namespace internal
             constraints.get_constraint_entries(current_dof);
 
           // dof is constrained
-          if (entries_ptr != 0)
+          if (entries_ptr != nullptr)
             {
               // in case we want to access plain indices, we need to know
               // about the location of constrained indices as well (all the
index b31663bdda9556d59fcc0ddcadc081173a53f7d5..78a21d23b0c76407fefcf65f7892d6768674900b 100644 (file)
@@ -2151,14 +2151,14 @@ FEEvaluationBase<dim,n_components_,Number>
   data               (&data_in.get_shape_info
                       (fe_no_in, quad_no_in, active_fe_index,
                        active_quad_index)),
-  cartesian_data     (0),
-  jacobian           (0),
-  J_value            (0),
+  cartesian_data     (nullptr),
+  jacobian           (nullptr),
+  J_value            (nullptr),
   quadrature_weights (mapping_info->mapping_data_gen[quad_no].
                       quadrature_weights[active_quad_index].begin()),
-  quadrature_points  (0),
-  jacobian_grad      (0),
-  jacobian_grad_upper(0),
+  quadrature_points  (nullptr),
+  jacobian_grad      (nullptr),
+  jacobian_grad_upper(nullptr),
   cell               (numbers::invalid_unsigned_int),
   cell_type          (internal::MatrixFreeFunctions::undefined),
   cell_data_number   (numbers::invalid_unsigned_int),
@@ -2209,18 +2209,18 @@ FEEvaluationBase<dim,n_components_,Number>
   n_fe_components    (n_components_),
   active_fe_index    (numbers::invalid_unsigned_int),
   active_quad_index  (numbers::invalid_unsigned_int),
-  matrix_info        (0),
-  dof_info           (0),
-  mapping_info       (0),
+  matrix_info        (nullptr),
+  dof_info           (nullptr),
+  mapping_info       (nullptr),
   // select the correct base element from the given FE component
   data               (new internal::MatrixFreeFunctions::ShapeInfo<Number>(quadrature, fe, fe.component_to_base_index(first_selected_component).first)),
-  cartesian_data     (0),
-  jacobian           (0),
-  J_value            (0),
-  quadrature_weights (0),
-  quadrature_points  (0),
-  jacobian_grad      (0),
-  jacobian_grad_upper(0),
+  cartesian_data     (nullptr),
+  jacobian           (nullptr),
+  J_value            (nullptr),
+  quadrature_weights (nullptr),
+  quadrature_points  (nullptr),
+  jacobian_grad      (nullptr),
+  jacobian_grad_upper(nullptr),
   cell               (0),
   cell_type          (internal::MatrixFreeFunctions::general),
   cell_data_number   (numbers::invalid_unsigned_int),
@@ -2238,8 +2238,8 @@ FEEvaluationBase<dim,n_components_,Number>
     fe.component_to_base_index(first_selected_component).first;
   set_data_pointers();
 
-  Assert(other == 0 || other->mapped_geometry.get() != 0, ExcInternalError());
-  if (other != 0 &&
+  Assert(other == nullptr || other->mapped_geometry.get() != nullptr, ExcInternalError());
+  if (other != nullptr &&
       other->mapped_geometry->get_quadrature() == quadrature)
     mapped_geometry = other->mapped_geometry;
   else
@@ -2264,7 +2264,7 @@ inline
 FEEvaluationBase<dim,n_components_,Number>
 ::FEEvaluationBase (const FEEvaluationBase<dim,n_components_,Number> &other)
   :
-  scratch_data_array (other.matrix_info == 0 ?
+  scratch_data_array (other.matrix_info == nullptr ?
                       new AlignedVector<VectorizedArray<Number> >() :
                       other.matrix_info->acquire_scratch_data()),
   quad_no            (other.quad_no),
@@ -2274,20 +2274,20 @@ FEEvaluationBase<dim,n_components_,Number>
   matrix_info        (other.matrix_info),
   dof_info           (other.dof_info),
   mapping_info       (other.mapping_info),
-  data               (other.matrix_info == 0 ?
+  data               (other.matrix_info == nullptr ?
                       new internal::MatrixFreeFunctions::ShapeInfo<Number>(*other.data) :
                       other.data),
-  cartesian_data     (0),
-  jacobian           (0),
-  J_value            (0),
-  quadrature_weights (mapping_info != 0 ?
+  cartesian_data     (nullptr),
+  jacobian           (nullptr),
+  J_value            (nullptr),
+  quadrature_weights (mapping_info != nullptr ?
                       mapping_info->mapping_data_gen[quad_no].
                       quadrature_weights[active_quad_index].begin()
                       :
-                      0),
-  quadrature_points  (0),
-  jacobian_grad      (0),
-  jacobian_grad_upper(0),
+                      nullptr),
+  quadrature_points  (nullptr),
+  jacobian_grad      (nullptr),
+  jacobian_grad_upper(nullptr),
   cell               (numbers::invalid_unsigned_int),
   cell_type          (internal::MatrixFreeFunctions::general),
   cell_data_number   (numbers::invalid_unsigned_int),
@@ -2302,7 +2302,7 @@ FEEvaluationBase<dim,n_components_,Number>
   set_data_pointers();
 
   // Create deep copy of mapped geometry for use in parallel...
-  if (other.mapped_geometry.get() != 0)
+  if (other.mapped_geometry.get() != nullptr)
     {
       mapped_geometry.reset
       (new internal::MatrixFreeFunctions::
@@ -2331,7 +2331,7 @@ FEEvaluationBase<dim,n_components_,Number>
   AssertDimension(first_selected_component, other.first_selected_component);
 
   // release old memory
-  if (matrix_info == 0)
+  if (matrix_info == nullptr)
     {
       delete data;
       delete scratch_data_array;
@@ -2344,7 +2344,7 @@ FEEvaluationBase<dim,n_components_,Number>
   matrix_info = other.matrix_info;
   dof_info = other.dof_info;
   mapping_info = other.mapping_info;
-  if (other.matrix_info == 0)
+  if (other.matrix_info == nullptr)
     {
       data = new internal::MatrixFreeFunctions::ShapeInfo<Number>(*other.data);
       scratch_data_array = new AlignedVector<VectorizedArray<Number> >();
@@ -2356,23 +2356,23 @@ FEEvaluationBase<dim,n_components_,Number>
     }
   set_data_pointers();
 
-  cartesian_data = 0;
-  jacobian = 0;
-  J_value = 0;
-  quadrature_weights = mapping_info != 0 ?
+  cartesian_data = nullptr;
+  jacobian = nullptr;
+  J_value = nullptr;
+  quadrature_weights = mapping_info != nullptr ?
                        mapping_info->mapping_data_gen[quad_no].
                        quadrature_weights[active_quad_index].begin()
                        :
-                       0;
-  quadrature_points = 0;
-  jacobian_grad = 0;
-  jacobian_grad_upper = 0;
+                       nullptr;
+  quadrature_points = nullptr;
+  jacobian_grad = nullptr;
+  jacobian_grad_upper = nullptr;
   cell = numbers::invalid_unsigned_int;
   cell_type = internal::MatrixFreeFunctions::general;
   cell_data_number = numbers::invalid_unsigned_int;
 
   // Create deep copy of mapped geometry for use in parallel...
-  if (other.mapped_geometry.get() != 0)
+  if (other.mapped_geometry.get() != nullptr)
     {
       mapped_geometry.reset
       (new internal::MatrixFreeFunctions::
@@ -2394,7 +2394,7 @@ template <int dim, int n_components_, typename Number>
 inline
 FEEvaluationBase<dim,n_components_,Number>::~FEEvaluationBase ()
 {
-  if (matrix_info != 0)
+  if (matrix_info != nullptr)
     {
       try
         {
@@ -2418,7 +2418,7 @@ void
 FEEvaluationBase<dim,n_components_,Number>
 ::set_data_pointers()
 {
-  Assert(scratch_data_array != NULL, ExcInternalError());
+  Assert(scratch_data_array != nullptr, ExcInternalError());
 
   const unsigned int tensor_dofs_per_cell =
     Utilities::fixed_power<dim>(this->data->fe_degree+1);
@@ -2457,13 +2457,13 @@ inline
 void
 FEEvaluationBase<dim,n_components_,Number>::reinit (const unsigned int cell_in)
 {
-  Assert (mapped_geometry == 0,
+  Assert (mapped_geometry == nullptr,
           ExcMessage("FEEvaluation was initialized without a matrix-free object."
                      " Integer indexing is not possible"));
-  if (mapped_geometry != 0)
+  if (mapped_geometry != nullptr)
     return;
-  Assert (dof_info != 0, ExcNotInitialized());
-  Assert (mapping_info != 0, ExcNotInitialized());
+  Assert (dof_info != nullptr, ExcNotInitialized());
+  Assert (mapping_info != nullptr, ExcNotInitialized());
   AssertIndexRange (cell_in, dof_info->row_starts.size()-1);
   AssertDimension (((dof_info->cell_active_fe_index.size() > 0) ?
                     dof_info->cell_active_fe_index[cell_in] : 0),
@@ -2539,12 +2539,12 @@ void
 FEEvaluationBase<dim,n_components_,Number>
 ::reinit (const TriaIterator<DoFCellAccessor<DoFHandlerType,level_dof_access> > &cell)
 {
-  Assert(matrix_info == 0,
+  Assert(matrix_info == nullptr,
          ExcMessage("Cannot use initialization from cell iterator if "
                     "initialized from MatrixFree object. Use variant for "
                     "on the fly computation with arguments as for FEValues "
                     "instead"));
-  Assert(mapped_geometry.get() != 0, ExcNotInitialized());
+  Assert(mapped_geometry.get() != nullptr, ExcNotInitialized());
   mapped_geometry->reinit(static_cast<typename Triangulation<dim>::cell_iterator>(cell));
   local_dof_indices.resize(cell->get_fe().dofs_per_cell);
   if (level_dof_access)
@@ -2600,7 +2600,7 @@ inline
 const internal::MatrixFreeFunctions::ShapeInfo<Number> &
 FEEvaluationBase<dim,n_components_,Number>::get_shape_info() const
 {
-  Assert(data != 0, ExcInternalError());
+  Assert(data != nullptr, ExcInternalError());
   return *data;
 }
 
@@ -2613,11 +2613,11 @@ FEEvaluationBase<dim,n_components_,Number>
 ::fill_JxW_values(AlignedVector<VectorizedArray<Number> > &JxW_values) const
 {
   AssertDimension(JxW_values.size(), data->n_q_points);
-  Assert (this->J_value != 0, ExcNotInitialized());
+  Assert (this->J_value != nullptr, ExcNotInitialized());
   if (this->cell_type == internal::MatrixFreeFunctions::cartesian ||
       this->cell_type == internal::MatrixFreeFunctions::affine)
     {
-      Assert (this->mapping_info != 0, ExcNotImplemented());
+      Assert (this->mapping_info != nullptr, ExcNotImplemented());
       VectorizedArray<Number> J = this->J_value[0];
       for (unsigned int q=0; q<this->data->n_q_points; ++q)
         JxW_values[q] = J * this->quadrature_weights[q];
@@ -2634,11 +2634,11 @@ inline
 VectorizedArray<Number>
 FEEvaluationBase<dim,n_components_,Number>::JxW(const unsigned int q_point) const
 {
-  Assert (this->J_value != 0, ExcNotInitialized());
+  Assert (this->J_value != nullptr, ExcNotInitialized());
   if (this->cell_type == internal::MatrixFreeFunctions::cartesian ||
       this->cell_type == internal::MatrixFreeFunctions::affine)
     {
-      Assert (this->mapping_info != 0, ExcInternalError());
+      Assert (this->mapping_info != nullptr, ExcInternalError());
       return this->J_value[0] * this->quadrature_weights[q_point];
     }
   else
@@ -3019,7 +3019,7 @@ FEEvaluationBase<dim,n_components_,Number>
 
   // Case 1: No MatrixFree object given, simple case because we do not need to
   // process constraints and need not care about vectorization
-  if (matrix_info == 0)
+  if (matrix_info == nullptr)
     {
       Assert (!local_dof_indices.empty(), ExcNotInitialized());
 
@@ -3037,7 +3037,7 @@ FEEvaluationBase<dim,n_components_,Number>
       return;
     }
 
-  Assert (dof_info != 0, ExcNotInitialized());
+  Assert (dof_info != nullptr, ExcNotInitialized());
   Assert (matrix_info->indices_initialized() == true,
           ExcNotInitialized());
   Assert (cell != numbers::invalid_unsigned_int, ExcNotInitialized());
@@ -3448,7 +3448,7 @@ FEEvaluationBase<dim,n_components_,Number>
 ::read_dof_values_plain (const VectorType *src[])
 {
   // Case without MatrixFree initialization object
-  if (matrix_info == 0)
+  if (matrix_info == nullptr)
     {
       internal::VectorReader<Number> reader;
       read_write_operation (reader, src);
@@ -3457,7 +3457,7 @@ FEEvaluationBase<dim,n_components_,Number>
 
   // this is different from the other three operations because we do not use
   // constraints here, so this is a separate function.
-  Assert (dof_info != 0, ExcNotInitialized());
+  Assert (dof_info != nullptr, ExcNotInitialized());
   Assert (matrix_info->indices_initialized() == true,
           ExcNotInitialized());
   Assert (cell != numbers::invalid_unsigned_int, ExcNotInitialized());
@@ -5114,7 +5114,7 @@ FEEvaluation<dim,fe_degree,n_q_points_1d,n_components_,Number>
   :
   BaseClass (mapping, fe, quadrature, update_flags,
              first_selected_component,
-             static_cast<FEEvaluationBase<dim,1,Number>*>(0)),
+             static_cast<FEEvaluationBase<dim,1,Number>*>(nullptr)),
   dofs_per_cell (this->data->dofs_per_cell),
   n_q_points (this->data->n_q_points)
 {
@@ -5134,7 +5134,7 @@ FEEvaluation<dim,fe_degree,n_q_points_1d,n_components_,Number>
   :
   BaseClass (StaticMappingQ1<dim>::mapping, fe, quadrature, update_flags,
              first_selected_component,
-             static_cast<FEEvaluationBase<dim,1,Number>*>(0)),
+             static_cast<FEEvaluationBase<dim,1,Number>*>(nullptr)),
   dofs_per_cell (this->data->dofs_per_cell),
   n_q_points (this->data->n_q_points)
 {
@@ -5335,7 +5335,7 @@ FEEvaluation<dim,fe_degree,n_q_points_1d,n_components_,Number>
 {
   Assert (this->mapping_info->quadrature_points_initialized == true,
           ExcNotInitialized());
-  Assert (this->quadrature_points != 0, ExcNotInitialized());
+  Assert (this->quadrature_points != nullptr, ExcNotInitialized());
   AssertIndexRange (q, n_q_points);
 
   // Cartesian mesh: not all quadrature points are stored, only the
@@ -5380,7 +5380,7 @@ FEEvaluation<dim,fe_degree,n_q_points_1d,n_components_,Number>
 {
   Assert (this->dof_values_initialized == true,
           internal::ExcAccessToUninitializedField());
-  Assert(this->matrix_info != 0 ||
+  Assert(this->matrix_info != nullptr ||
          this->mapped_geometry->is_initialized(), ExcNotInitialized());
 
   // Run time selection of algorithm matching the element type. Since some
@@ -5470,7 +5470,7 @@ FEEvaluation<dim,fe_degree,n_q_points_1d,n_components_,Number>
   if (integrate_gradients == true)
     Assert (this->gradients_quad_submitted == true,
             internal::ExcAccessToUninitializedField());
-  Assert(this->matrix_info != 0 ||
+  Assert(this->matrix_info != nullptr ||
          this->mapped_geometry->is_initialized(), ExcNotInitialized());
 
   // Run time selection of algorithm matching the element type. Since some
index 6e32bb1c460b0a45b6dfeca9f8b6b1c4e5a64efb..f68c9f72fb8163a9e3888bda50cd7006a08e5451 100644 (file)
@@ -290,7 +290,7 @@ namespace internal
               const unsigned int fe_index = active_fe_index.size() > 0 ?
                                             active_fe_index[cell] : 0;
               const unsigned int n_q_points = current_data.n_q_points[fe_index];
-              if (fe_values[fe_index].get() == 0)
+              if (fe_values[fe_index].get() == nullptr)
                 fe_values[fe_index].reset
                 (new dealii::FEValues<dim> (mapping, dummy_fe,
                                             current_data.quadrature[fe_index],
index 2f502a2411142f00446930fa77d6f3a1d56e0677..65b46baa1207c8bee9fd7514f601e39c2839d3f3 100644 (file)
@@ -1164,7 +1164,7 @@ const Number *
 MatrixFree<dim,Number>::constraint_pool_begin (const unsigned int row) const
 {
   AssertIndexRange (row, constraint_pool_row_index.size()-1);
-  return constraint_pool_data.empty() ? 0 :
+  return constraint_pool_data.empty() ? nullptr :
          &constraint_pool_data[0] + constraint_pool_row_index[row];
 }
 
@@ -1176,7 +1176,7 @@ const Number *
 MatrixFree<dim,Number>::constraint_pool_end (const unsigned int row) const
 {
   AssertIndexRange (row, constraint_pool_row_index.size()-1);
-  return constraint_pool_data.empty() ? 0 :
+  return constraint_pool_data.empty() ? nullptr :
          &constraint_pool_data[0] + constraint_pool_row_index[row+1];
 }
 
@@ -1303,7 +1303,7 @@ MatrixFree<dim,Number>::get_cell_iterator(const unsigned int macro_cell_number,
     AssertIndexRange (vector_number, irreg_filled);
 #endif
 
-  const DoFHandler<dim> *dofh = 0;
+  const DoFHandler<dim> *dofh = nullptr;
   if (dof_handlers.active_dof_handler == DoFHandlers::usual)
     {
       AssertDimension (dof_handlers.dof_handler.size(),
@@ -2100,7 +2100,7 @@ namespace internal
                 const internal::MatrixFreeFunctions::TaskInfo &task_info_in,
                 const bool is_blocked_in)
         :
-        dummy (NULL),
+        dummy ((nullptr)),
         worker (worker_in),
         partition (partition_in),
         task_info (task_info_in),
@@ -2114,7 +2114,7 @@ namespace internal
         worker(cell_range);
         if (is_blocked==true)
           dummy->spawn (*dummy);
-        return NULL;
+        return (nullptr);
       }
 
       tbb::empty_task *dummy;
@@ -2137,7 +2137,7 @@ namespace internal
                      const internal::MatrixFreeFunctions::TaskInfo &task_info_in,
                      const bool    is_blocked_in = false)
         :
-        dummy (NULL),
+        dummy ((nullptr)),
         function (function_in),
         partition (partition_in),
         task_info (task_info_in),
@@ -2201,7 +2201,7 @@ namespace internal
         root->destroy(*root);
         if (is_blocked==true)
           dummy->spawn (*dummy);
-        return NULL;
+        return (nullptr);
       }
 
       tbb::empty_task *dummy;
@@ -2265,7 +2265,7 @@ namespace internal
                      const internal::MatrixFreeFunctions::TaskInfo &task_info_in,
                      const bool    is_blocked_in)
         :
-        dummy (NULL),
+        dummy ((nullptr)),
         worker (worker_in),
         partition (partition_in),
         task_info (task_info_in),
@@ -2279,7 +2279,7 @@ namespace internal
                      CellWork<Worker> (worker,task_info));
         if (is_blocked==true)
           dummy->spawn (*dummy);
-        return NULL;
+        return (nullptr);
       }
 
       tbb::empty_task *dummy;
@@ -2306,7 +2306,7 @@ namespace internal
     tbb::task *execute ()
     {
       internal::update_ghost_values_finish(src);
-      return 0;
+      return nullptr;
     }
 
   private:
@@ -2327,7 +2327,7 @@ namespace internal
     tbb::task *execute ()
     {
       internal::compress_start(dst);
-      return 0;
+      return nullptr;
     }
 
   private:
index f14f38cb9023477140ef0cb2412fb7de7471ca1c..74d00de99512dcb1e52ea9a65152fceb7373838b 100644 (file)
@@ -121,7 +121,7 @@ internal_reinit(const Mapping<dim>                          &mapping,
           const parallel::Triangulation<dim> *dist_tria =
             dynamic_cast<const parallel::Triangulation<dim>*>
             (&(dof_handler[0]->get_triangulation()));
-          size_info.communicator = dist_tria != 0 ?
+          size_info.communicator = dist_tria != nullptr ?
                                    dist_tria->get_communicator() :
                                    MPI_COMM_SELF;
           size_info.my_pid  =
@@ -255,7 +255,7 @@ internal_reinit(const Mapping<dim>                            &mapping,
           const parallel::Triangulation<dim> *dist_tria =
             dynamic_cast<const parallel::Triangulation<dim>*>
             (&(dof_handler[0]->get_triangulation()));
-          size_info.communicator = dist_tria != 0 ?
+          size_info.communicator = dist_tria != nullptr ?
                                    dist_tria->get_communicator() :
                                    MPI_COMM_SELF;
           size_info.my_pid  =
@@ -358,14 +358,14 @@ MatrixFree<dim, Number>::is_supported(const FiniteElement<dim, spacedim> &fe)
     return false;
 
   // then check of the base element is supported
-  if (dynamic_cast<const FE_Poly<TensorProductPolynomials<dim>,dim,spacedim>*>(fe_ptr)!=0)
+  if (dynamic_cast<const FE_Poly<TensorProductPolynomials<dim>,dim,spacedim>*>(fe_ptr)!=nullptr)
     return true;
   if (dynamic_cast<const FE_Poly<TensorProductPolynomials<dim,
-      Polynomials::PiecewisePolynomial<double> >,dim,spacedim>*>(fe_ptr)!=0)
+      Polynomials::PiecewisePolynomial<double> >,dim,spacedim>*>(fe_ptr)!=nullptr)
     return true;
-  if (dynamic_cast<const FE_DGP<dim, spacedim>*>(fe_ptr)!=0)
+  if (dynamic_cast<const FE_DGP<dim, spacedim>*>(fe_ptr)!=nullptr)
     return true;
-  if (dynamic_cast<const FE_Q_DG0<dim, spacedim>*>(fe_ptr)!=0)
+  if (dynamic_cast<const FE_Q_DG0<dim, spacedim>*>(fe_ptr)!=nullptr)
     return true;
 
   // if the base element is not in the above list it is not supported
@@ -430,7 +430,7 @@ initialize_dof_handlers (const std::vector<const DoFHandler<dim>*> &dof_handler,
       // For serial Triangulations always take all cells
       const unsigned int subdomain_id
         = (dynamic_cast<const parallel::Triangulation<dim> *>
-           (&dof_handler[0]->get_triangulation())!=0)
+           (&dof_handler[0]->get_triangulation())!=nullptr)
           ? my_pid : numbers::invalid_subdomain_id;
       for ( ; cell != end_cell; ++cell)
         internal::resolve_cell (cell, cell_level_index, subdomain_id);
@@ -488,7 +488,7 @@ initialize_dof_handlers (const std::vector<const hp::DoFHandler<dim>*> &dof_hand
   // For serial Triangulations always take all cells
   const unsigned int subdomain_id
     = (dynamic_cast<const parallel::Triangulation<dim> *>
-       (&dof_handler[0]->get_triangulation())!=0)
+       (&dof_handler[0]->get_triangulation())!=nullptr)
       ? my_pid : numbers::invalid_subdomain_id;
   for ( ; cell != end_cell; ++cell)
     internal::resolve_cell (cell, cell_level_index,
@@ -761,7 +761,7 @@ void MatrixFree<dim,Number>::initialize_indices
   constraint_pool_row_index.resize(1, 0);
   for (unsigned int i=0; i<constraints.size(); ++i)
     {
-      Assert(constraints[i] != 0, ExcInternalError());
+      Assert(constraints[i] != nullptr, ExcInternalError());
       constraint_pool_data.insert(constraint_pool_data.end(),
                                   constraints[i]->begin(),
                                   constraints[i]->end());
index c3842933c4839c1902e5f84113270ca5720b6ad1..22ac681c594f65bfea8c6bd252fc5773cd74bc9b 100644 (file)
@@ -882,11 +882,7 @@ namespace MatrixFreeOperators
     :
     Subscriptor(),
     have_interface_matrices(false)
-  {
-    // boost-1.62.0 doesn't allow initializing a shared_ptr
-    // with NULL. Make sure the default constructor does that.
-    Assert(data.get() == NULL, ExcInternalError());
-  }
+  {}
 
 
 
@@ -894,7 +890,7 @@ namespace MatrixFreeOperators
   typename Base<dim,VectorType>::size_type
   Base<dim,VectorType>::m () const
   {
-    Assert(data.get() != NULL,
+    Assert(data.get() != nullptr,
            ExcNotInitialized());
     typename Base<dim, VectorType>::size_type total_size = 0;
     for (unsigned int i=0; i<selected_rows.size(); ++i)
@@ -908,7 +904,7 @@ namespace MatrixFreeOperators
   typename Base<dim,VectorType>::size_type
   Base<dim,VectorType>::n () const
   {
-    Assert(data.get() != NULL,
+    Assert(data.get() != nullptr,
            ExcNotInitialized());
     typename Base<dim, VectorType>::size_type total_size = 0;
     for (unsigned int i=0; i<selected_columns.size(); ++i)
@@ -935,7 +931,7 @@ namespace MatrixFreeOperators
   {
     (void) col;
     Assert (row == col, ExcNotImplemented());
-    Assert (inverse_diagonal_entries.get() != NULL &&
+    Assert (inverse_diagonal_entries.get() !=nullptr&&
             inverse_diagonal_entries->m() > 0, ExcNotInitialized());
     return 1.0/(*inverse_diagonal_entries)(row,row);
   }
@@ -946,7 +942,7 @@ namespace MatrixFreeOperators
   void
   Base<dim,VectorType>::initialize_dof_vector (VectorType &vec) const
   {
-    Assert(data.get() != NULL,
+    Assert(data.get() != nullptr,
            ExcNotInitialized());
     AssertDimension(n_blocks(vec), selected_rows.size());
     for (unsigned int i = 0; i < n_blocks(vec); ++i)
@@ -1348,7 +1344,7 @@ namespace MatrixFreeOperators
   std::size_t
   Base<dim,VectorType>::memory_consumption () const
   {
-    return inverse_diagonal_entries.get() != NULL ? inverse_diagonal_entries->memory_consumption() : sizeof(*this);
+    return inverse_diagonal_entries.get() !=nullptr? inverse_diagonal_entries->memory_consumption() : sizeof(*this);
   }
 
 
@@ -1366,7 +1362,7 @@ namespace MatrixFreeOperators
   const std::shared_ptr<DiagonalMatrix<VectorType> > &
   Base<dim,VectorType>::get_matrix_diagonal_inverse() const
   {
-    Assert(inverse_diagonal_entries.get() != NULL &&
+    Assert(inverse_diagonal_entries.get() !=nullptr&&
            inverse_diagonal_entries->m() > 0, ExcNotInitialized());
     return inverse_diagonal_entries;
   }
@@ -1403,7 +1399,7 @@ namespace MatrixFreeOperators
   MGInterfaceOperator<OperatorType>::MGInterfaceOperator ()
     :
     Subscriptor(),
-    mf_base_operator(NULL)
+    mf_base_operator((nullptr))
   {
   }
 
@@ -1413,7 +1409,7 @@ namespace MatrixFreeOperators
   void
   MGInterfaceOperator<OperatorType>::clear ()
   {
-    mf_base_operator = NULL;
+    mf_base_operator = (nullptr);
   }
 
 
@@ -1439,7 +1435,7 @@ namespace MatrixFreeOperators
                    "operator");
 #endif
 
-    Assert(mf_base_operator != NULL,
+    Assert(mf_base_operator != nullptr,
            ExcNotInitialized());
 
     mf_base_operator->vmult_interface_down(dst, src);
@@ -1459,7 +1455,7 @@ namespace MatrixFreeOperators
                    "operator");
 #endif
 
-    Assert(mf_base_operator != NULL,
+    Assert(mf_base_operator != nullptr,
            ExcNotInitialized());
 
     mf_base_operator->vmult_interface_up(dst, src);
@@ -1484,7 +1480,7 @@ namespace MatrixFreeOperators
   compute_diagonal()
   {
     typedef typename Base<dim,VectorType>::value_type Number;
-    Assert((Base<dim, VectorType>::data.get() != NULL), ExcNotInitialized());
+    Assert((Base<dim, VectorType>::data.get() != nullptr), ExcNotInitialized());
 
     this->inverse_diagonal_entries.
     reset(new DiagonalMatrix<VectorType>());
@@ -1593,7 +1589,7 @@ namespace MatrixFreeOperators
   compute_diagonal()
   {
     typedef typename Base<dim,VectorType>::value_type Number;
-    Assert((Base<dim, VectorType>::data.get() != NULL), ExcNotInitialized());
+    Assert((Base<dim, VectorType>::data.get() != nullptr), ExcNotInitialized());
 
     unsigned int dummy = 0;
     this->inverse_diagonal_entries.
index ea4a249c33ee40973526a4ee6a0d9a0863746146..d29e75dd503cac3bd0fa00ca584de88f4bb47f75 100644 (file)
@@ -95,18 +95,18 @@ namespace internal
         const FE_Q_DG0<dim> *fe_q_dg0 = dynamic_cast<const FE_Q_DG0<dim>*>(fe);
 
         element_type = tensor_general;
-        if (fe_poly != 0)
+        if (fe_poly != nullptr)
           scalar_lexicographic = fe_poly->get_poly_space_numbering_inverse();
-        else if (fe_poly_piece != 0)
+        else if (fe_poly_piece != nullptr)
           scalar_lexicographic = fe_poly_piece->get_poly_space_numbering_inverse();
-        else if (fe_dgp != 0)
+        else if (fe_dgp != nullptr)
           {
             scalar_lexicographic.resize(fe_dgp->dofs_per_cell);
             for (unsigned int i=0; i<fe_dgp->dofs_per_cell; ++i)
               scalar_lexicographic[i] = i;
             element_type = truncated_tensor;
           }
-        else if (fe_q_dg0 != 0)
+        else if (fe_q_dg0 != nullptr)
           {
             scalar_lexicographic = fe_q_dg0->get_poly_space_numbering_inverse();
             element_type = tensor_symmetric_plus_dg0;
index c9dcd39f989039a8a3c24b21505e9fcdf7f59615..bfaf7994a690ea69dac3941c269286cdcffb2abd 100644 (file)
@@ -623,7 +623,7 @@ namespace MeshWorker
      const std::vector<types::global_dof_index> &dof1,
      const std::vector<types::global_dof_index> &dof2)
     {
-      if (constraints == 0)
+      if (constraints == nullptr)
         {
           for (unsigned int j=0; j<local.n_rows(); ++j)
             for (unsigned int k=0; k<local.n_cols(); ++k)
index 13021b8aafdd480d076510f4288e3d6840e26f5d..d17372380e947a00893614f025ca1cae13736d44 100644 (file)
@@ -291,7 +291,7 @@ namespace MeshWorker
   DoFInfo<dim,spacedim,number>::get_indices(const DHCellIterator &c)
   {
     indices.resize(c->get_fe().dofs_per_cell);
-    if (block_info == 0 || block_info->local().size() == 0)
+    if (block_info == nullptr || block_info->local().size() == 0)
       c->get_active_or_mg_dof_indices(indices);
     else
       {
index 2ef065480bb5155689fe9b18777fb8f0707c8275..5bbb513d2bc91f311c69ede9dce0e33a0e5be7cc 100644 (file)
@@ -113,7 +113,7 @@ namespace MeshWorker
                     const Mapping<dim,spacedim> &mapping,
                     const Quadrature<FEVALUES::integral_dimension> &quadrature,
                     const UpdateFlags flags,
-                    const BlockInfo *local_block_info = 0);
+                    const BlockInfo *local_block_info = nullptr);
 
     /**
      * Initialize the data vector and cache the selector.
@@ -302,7 +302,7 @@ namespace MeshWorker
      */
     void initialize(const FiniteElement<dim, spacedim> &el,
                     const Mapping<dim, spacedim> &mapping,
-                    const BlockInfo *block_info = 0);
+                    const BlockInfo *block_info = nullptr);
 
     /**
      * Initialize the IntegrationInfo objects contained.
@@ -316,7 +316,7 @@ namespace MeshWorker
                     const Mapping<dim, spacedim>       &mapping,
                     const AnyData                      &data,
                     const VectorType                   &dummy,
-                    const BlockInfo                    *block_info = 0);
+                    const BlockInfo                    *block_info = nullptr);
     /**
      * Initialize the IntegrationInfo objects contained.
      *
@@ -329,7 +329,7 @@ namespace MeshWorker
                     const Mapping<dim, spacedim>       &mapping,
                     const AnyData                      &data,
                     const MGLevelObject<VectorType>    &dummy,
-                    const BlockInfo                    *block_info = 0);
+                    const BlockInfo                    *block_info = nullptr);
     /**
      * @name FEValues setup
      */
@@ -582,14 +582,14 @@ namespace MeshWorker
         const FEFaceValues<dim,sdim> *pf = dynamic_cast<const FEFaceValues<dim,sdim>*>(&p);
         const FESubfaceValues<dim,sdim> *ps = dynamic_cast<const FESubfaceValues<dim,sdim>*>(&p);
 
-        if (pc != 0)
+        if (pc != nullptr)
           fevalv[i] = std::shared_ptr<FEValuesBase<dim,sdim> > (
                         new FEValues<dim,sdim> (pc->get_mapping(), pc->get_fe(),
                                                 pc->get_quadrature(), pc->get_update_flags()));
-        else if (pf != 0)
+        else if (pf != nullptr)
           fevalv[i] = std::shared_ptr<FEValuesBase<dim,sdim> > (
                         new FEFaceValues<dim,sdim> (pf->get_mapping(), pf->get_fe(), pf->get_quadrature(), pf->get_update_flags()));
-        else if (ps != 0)
+        else if (ps != nullptr)
           fevalv[i] = std::shared_ptr<FEValuesBase<dim,sdim> > (
                         new FESubfaceValues<dim,sdim> (ps->get_mapping(), ps->get_fe(), ps->get_quadrature(), ps->get_update_flags()));
         else
@@ -610,7 +610,7 @@ namespace MeshWorker
     const BlockInfo *block_info)
   {
     fe_pointer = &el;
-    if (block_info == 0 || block_info->local().size() == 0)
+    if (block_info == nullptr || block_info->local().size() == 0)
       {
         fevalv.resize(1);
         fevalv[0] = std::shared_ptr<FEValuesBase<dim,sdim> > (
@@ -633,7 +633,7 @@ namespace MeshWorker
   inline const FiniteElement<dim, spacedim> &
   IntegrationInfo<dim,spacedim>::finite_element() const
   {
-    Assert (fe_pointer !=0, ExcNotInitialized());
+    Assert (fe_pointer !=nullptr, ExcNotInitialized());
     return *fe_pointer;
   }
 
@@ -683,7 +683,7 @@ namespace MeshWorker
           }
       }
 
-    const bool split_fevalues = info.block_info != 0;
+    const bool split_fevalues = info.block_info != nullptr;
     if (!global_data->empty())
       fill_local_data(info, split_fevalues);
   }
index 1421f113c51813e0a401efd1e034ee8be0c61ce1..d062db5dd81a6bcbcacb9a898824b0e1e5762227 100644 (file)
@@ -200,9 +200,9 @@ namespace MeshWorker
     dof_info.cell.reinit(cell);
     dof_info.cell_valid = true;
 
-    const bool integrate_cell          = (cell_worker != 0);
-    const bool integrate_boundary      = (boundary_worker != 0);
-    const bool integrate_interior_face = (face_worker != 0);
+    const bool integrate_cell          = (cell_worker != nullptr);
+    const bool integrate_boundary      = (boundary_worker != nullptr);
+    const bool integrate_interior_face = (face_worker != nullptr);
 
     if (integrate_cell)
       info.cell.reinit(dof_info.cell);
index fd947fdc5a9e7ae430e89f6fae5919faad4ca7c7..06fae5fe745bdf8a4d4cc7ae702755567e9894d1 100644 (file)
@@ -139,7 +139,7 @@ namespace MeshWorker
     inline void
     GnuplotPatch::write(const T &d) const
     {
-      if (os == 0)
+      if (os == nullptr)
         deallog << d;
       else
         (*os) << d;
@@ -149,7 +149,7 @@ namespace MeshWorker
     inline void
     GnuplotPatch::write_endl() const
     {
-      if (os == 0)
+      if (os == nullptr)
         deallog << std::endl;
       else
         (*os) << std::endl;
@@ -159,7 +159,7 @@ namespace MeshWorker
     inline
     GnuplotPatch::GnuplotPatch()
       :
-      os(0)
+      os(nullptr)
     {}
 
 
index 5282f4ee639d81abc8bc77254f224aa0e8ca7ff4..4e09dc91be3fa1d318d2e79fc697cb789e890ba5 100644 (file)
@@ -524,7 +524,7 @@ namespace MeshWorker
                                                                  info.indices:
                                                                  info.indices_by_block[i];
 
-              if (constraints !=0)
+              if (constraints !=nullptr)
                 constraints->distribute_local_to_global(info.vector(k).block(i), ldi, *v);
               else
                 v->add(ldi, info.vector(k).block(i));
@@ -622,7 +622,7 @@ namespace MeshWorker
       AssertDimension(M.m(), i1.size());
       AssertDimension(M.n(), i2.size());
 
-      if (constraints == 0)
+      if (constraints == nullptr)
         {
           for (unsigned int j=0; j<i1.size(); ++j)
             for (unsigned int k=0; k<i2.size(); ++k)
@@ -805,7 +805,7 @@ namespace MeshWorker
       AssertDimension(M.m(), i1.size());
       AssertDimension(M.n(), i2.size());
 
-      if (mg_constrained_dofs == 0)
+      if (mg_constrained_dofs == nullptr)
         {
           for (unsigned int j=0; j<i1.size(); ++j)
             for (unsigned int k=0; k<i2.size(); ++k)
@@ -858,7 +858,7 @@ namespace MeshWorker
       AssertDimension(M.n(), i1.size());
       AssertDimension(M.m(), i2.size());
 
-      if (mg_constrained_dofs == 0)
+      if (mg_constrained_dofs == nullptr)
         {
           for (unsigned int j=0; j<i1.size(); ++j)
             for (unsigned int k=0; k<i2.size(); ++k)
@@ -887,7 +887,7 @@ namespace MeshWorker
       AssertDimension(M.m(), i1.size());
       AssertDimension(M.n(), i2.size());
 
-      if (mg_constrained_dofs == 0)
+      if (mg_constrained_dofs == nullptr)
         {
           for (unsigned int j=0; j<i1.size(); ++j)
             for (unsigned int k=0; k<i2.size(); ++k)
@@ -915,7 +915,7 @@ namespace MeshWorker
     {
       AssertDimension(M.m(), i1.size());
       AssertDimension(M.n(), i2.size());
-      Assert(mg_constrained_dofs != 0, ExcInternalError());
+      Assert(mg_constrained_dofs != nullptr, ExcInternalError());
 
       for (unsigned int j=0; j<i1.size(); ++j)
         for (unsigned int k=0; k<i2.size(); ++k)
@@ -956,7 +956,7 @@ namespace MeshWorker
     {
       AssertDimension(M.n(), i1.size());
       AssertDimension(M.m(), i2.size());
-      Assert(mg_constrained_dofs != 0, ExcInternalError());
+      Assert(mg_constrained_dofs != nullptr, ExcInternalError());
 
       for (unsigned int j=0; j<i1.size(); ++j)
         for (unsigned int k=0; k<i2.size(); ++k)
@@ -987,7 +987,7 @@ namespace MeshWorker
         {
           assemble((*matrix)[level], info.matrix(0,false).matrix,
                    info.indices, info.indices, level);
-          if (mg_constrained_dofs != 0)
+          if (mg_constrained_dofs != nullptr)
             {
               assemble_in((*interface_in)[level], info.matrix(0,false).matrix,
                           info.indices, info.indices, level);
@@ -1004,7 +1004,7 @@ namespace MeshWorker
             assemble((*matrix)[level], info.matrix(k,false).matrix,
                      info.indices_by_block[row], info.indices_by_block[column], level);
 
-            if (mg_constrained_dofs != 0)
+            if (mg_constrained_dofs != nullptr)
               {
                 assemble_in((*interface_in)[level], info.matrix(k,false).matrix,
                             info.indices_by_block[row], info.indices_by_block[column], level);
@@ -1130,7 +1130,7 @@ namespace MeshWorker
       AnyData residuals = ResidualSimple<VectorType>::residuals;
       VectorType *v = residuals.entry<VectorType *>(index);
 
-      if (ResidualSimple<VectorType>::constraints == 0)
+      if (ResidualSimple<VectorType>::constraints == nullptr)
         {
           for (unsigned int i=0; i<indices.size(); ++i)
             (*v)(indices[i]) += vector(i);
@@ -1160,7 +1160,7 @@ namespace MeshWorker
       AnyData residuals = ResidualSimple<VectorType>::residuals;
       VectorType *v = residuals.entry<VectorType *>(index);
 
-      if (ResidualSimple<VectorType>::constraints == 0)
+      if (ResidualSimple<VectorType>::constraints == nullptr)
         {
           for (unsigned int j=0; j<i1.size(); ++j)
             for (unsigned int k=0; k<i2.size(); ++k)
index 7ebc96cd6e510b60af18f0d6ce76a6193398b766..6fa2bdf3839ba43a24c0a0f7bcb056046171551e 100644 (file)
@@ -174,8 +174,8 @@ MGSmootherBlock<MatrixType, RelaxationType, number>::clear ()
                max_level=matrices.max_level();
   for (; i<=max_level; ++i)
     {
-      smoothers[i] = 0;
-      matrices[i] = 0;
+      smoothers[i] = nullptr;
+      matrices[i] = nullptr;
     }
 }
 
index 2d8c6e2605ffdd02c29c89da31e73bb9cd6d134b..14680ac30de77094890d5f6aa3ba816347b14543 100644 (file)
@@ -245,7 +245,7 @@ public:
   /**
    * Constructor, taking the coarse grid matrix.
    */
-  MGCoarseGridHouseholder (const FullMatrix<number> *A = 0);
+  MGCoarseGridHouseholder (const FullMatrix<number> *A = nullptr);
 
   /**
    * Initialize for a new matrix.
@@ -308,13 +308,13 @@ private:
 /* ------------------ Functions for MGCoarseGridApplySmoother -----------*/
 template<class VectorType>
 MGCoarseGridApplySmoother<VectorType>::MGCoarseGridApplySmoother ()
-  : coarse_smooth(NULL)
+  : coarse_smooth((nullptr))
 {
 }
 
 template<class VectorType>
 MGCoarseGridApplySmoother<VectorType>::MGCoarseGridApplySmoother (const MGSmootherBase<VectorType> &coarse_smooth)
-  : coarse_smooth(NULL)
+  : coarse_smooth((nullptr))
 {
   initialize(coarse_smooth);
 }
@@ -397,13 +397,13 @@ void
 MGCoarseGridLACIteration<SolverType, VectorType>
 ::clear()
 {
-  solver = 0;
+  solver = nullptr;
   if (matrix)
     delete matrix;
-  matrix = 0;
+  matrix = nullptr;
   if (precondition)
     delete precondition;
-  precondition = 0;
+  precondition = nullptr;
 }
 
 
@@ -414,9 +414,9 @@ MGCoarseGridLACIteration<SolverType, VectorType>
               VectorType         &dst,
               const VectorType   &src) const
 {
-  Assert(solver!=0, ExcNotInitialized());
-  Assert(matrix!=0, ExcNotInitialized());
-  Assert(precondition!=0, ExcNotInitialized());
+  Assert(solver!=nullptr, ExcNotInitialized());
+  Assert(matrix!=nullptr, ExcNotInitialized());
+  Assert(precondition!=nullptr, ExcNotInitialized());
   solver->solve(*matrix, dst, src, *precondition);
 }
 
@@ -510,9 +510,9 @@ MGCoarseGridIterativeSolver<VectorType, SolverType, MatrixType, PreconditionerTy
               VectorType         &dst,
               const VectorType   &src) const
 {
-  Assert(solver!=0, ExcNotInitialized());
-  Assert(matrix!=0, ExcNotInitialized());
-  Assert(preconditioner!=0, ExcNotInitialized());
+  Assert(solver!=nullptr, ExcNotInitialized());
+  Assert(matrix!=nullptr, ExcNotInitialized());
+  Assert(preconditioner!=nullptr, ExcNotInitialized());
   solver->solve(*matrix, dst, src, *preconditioner);
 }
 
@@ -524,7 +524,7 @@ template<typename number, class VectorType>
 MGCoarseGridHouseholder<number, VectorType>::MGCoarseGridHouseholder
 (const FullMatrix<number> *A)
 {
-  if (A != 0) householder.initialize(*A);
+  if (A != nullptr) householder.initialize(*A);
 }
 
 
index 64c0d954d63ce803cc07a8ce8b0b146f86ab815d..b64a1bd86cc38c5bd8db27fec7b33e6008cce4a8 100644 (file)
@@ -692,7 +692,7 @@ MGSmootherRelaxation<MatrixType, RelaxationType, VectorType>::clear ()
   unsigned int i=matrices.min_level(),
                max_level=matrices.max_level();
   for (; i<=max_level; ++i)
-    matrices[i]=0;
+    matrices[i]=nullptr;
 }
 
 
@@ -859,7 +859,7 @@ MGSmootherPrecondition<MatrixType, PreconditionerType, VectorType>::clear ()
   unsigned int i=matrices.min_level(),
                max_level=matrices.max_level();
   for (; i<=max_level; ++i)
-    matrices[i]=0;
+    matrices[i]=nullptr;
 }
 
 
index 8b525c4e90bb5aa144f296e7b46f81bd2a893964..68d7b87cedf457f036b98f8069e8940b19cdaa05 100644 (file)
@@ -119,7 +119,7 @@ namespace
       {
         if (v[level].size() != mg_dof.locally_owned_mg_dofs(level).size() ||
             v[level].local_size() != mg_dof.locally_owned_mg_dofs(level).n_elements())
-          v[level].reinit(mg_dof.locally_owned_mg_dofs(level), tria != 0 ?
+          v[level].reinit(mg_dof.locally_owned_mg_dofs(level), tria != nullptr ?
                           tria->get_communicator() : MPI_COMM_SELF);
         else
           v[level] = 0.;
@@ -142,7 +142,7 @@ namespace
     const dealii::parallel::distributed::Triangulation<dim,spacedim> *tria =
       (dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>
        (&mg_dof.get_triangulation()));
-    AssertThrow(tria!=NULL, ExcMessage("multigrid with Trilinos vectors only works with distributed Triangulation!"));
+    AssertThrow(tria!=nullptr, ExcMessage("multigrid with Trilinos vectors only works with distributed Triangulation!"));
 
 #ifdef DEAL_II_WITH_P4EST
     for (unsigned int level=v.min_level();
index acadee775078b6f0f846a8925c24d5aac95ccc24..b54420debf69a7471cb225872c9db6347c57d9ca 100644 (file)
@@ -74,7 +74,7 @@ MGTransferSelect<number>::copy_from_mg (
   dst = 0;
   do_copy_from_mg (mg_dof_handler,
                    dst.block(target_component[selected_component]), src);
-  if (constraints != 0)
+  if (constraints != nullptr)
     constraints->condense(dst);
 }
 
@@ -90,7 +90,7 @@ MGTransferSelect<number>::copy_from_mg (
 {
   dst = 0;
   do_copy_from_mg (mg_dof_handler, dst, src);
-  if (constraints != 0)
+  if (constraints != nullptr)
     {
       //If we were given constraints
       //apply them to the dst that goes
index 2d30d4381301102f3a7111a0f209202c1433e20f..e79f7e0b20a0c41b84bac5d0a2d709e00204c25a 100644 (file)
@@ -468,8 +468,8 @@ Multigrid<VectorType>::Multigrid (const DoFHandler<dim>              &mg_dof_han
   transfer(&transfer, typeid(*this).name()),
   pre_smooth(&pre_smooth, typeid(*this).name()),
   post_smooth(&post_smooth, typeid(*this).name()),
-  edge_down(0, typeid(*this).name()),
-  edge_up(0, typeid(*this).name()),
+  edge_down(nullptr, typeid(*this).name()),
+  edge_up(nullptr, typeid(*this).name()),
   debug(0)
 {
   const unsigned int dof_handler_max_level
@@ -500,10 +500,10 @@ Multigrid<VectorType>::Multigrid (const MGMatrixBase<VectorType>        &matrix,
   transfer(&transfer, typeid(*this).name()),
   pre_smooth(&pre_smooth, typeid(*this).name()),
   post_smooth(&post_smooth, typeid(*this).name()),
-  edge_out(0, typeid(*this).name()),
-  edge_in(0, typeid(*this).name()),
-  edge_down(0, typeid(*this).name()),
-  edge_up(0, typeid(*this).name()),
+  edge_out(nullptr, typeid(*this).name()),
+  edge_in(nullptr, typeid(*this).name()),
+  edge_down(nullptr, typeid(*this).name()),
+  edge_up(nullptr, typeid(*this).name()),
   debug(0)
 {
   if (max_level == numbers::invalid_unsigned_int)
@@ -597,7 +597,7 @@ PreconditionMG<dim, VectorType, TRANSFER>::get_mpi_communicator() const
   // so it should be a safe bet to use it to query MPI communicator:
   const Triangulation<dim> &tria = dof_handler->get_triangulation();
   const parallel::distributed::Triangulation<dim> *ptria = dynamic_cast<const parallel::distributed::Triangulation<dim> *>(&tria);
-  Assert (ptria != NULL, ExcInternalError());
+  Assert (ptria != nullptr, ExcInternalError());
   return ptria->get_communicator ();
 }
 
index d5a96366684ebb79d80f208c3d85f1846128f5d8..833ab779cd2d9ef6ab5c1c0b465dd110b1b1accf 100644 (file)
@@ -135,7 +135,7 @@ Multigrid<VectorType>::level_v_step (const unsigned int level)
   if (debug>1)
     deallog << "Residual on      level " << level << std::endl;
   matrix->vmult(level, t[level], solution[level]);
-  if (edge_out != 0)
+  if (edge_out != nullptr)
     {
       edge_out->vmult_add(level, t[level], solution[level]);
       if (debug>2)
@@ -149,7 +149,7 @@ Multigrid<VectorType>::level_v_step (const unsigned int level)
 
   // Get the defect on the next coarser level as part of the (DG) edge matrix
   // and then the main part by the restriction of the transfer
-  if (edge_down != 0)
+  if (edge_down != nullptr)
     {
       edge_down->vmult(level, t[level-1], solution[level]);
       defect[level-1] -= t[level-1];
@@ -166,12 +166,12 @@ Multigrid<VectorType>::level_v_step (const unsigned int level)
   solution[level] += t[level];
 
   // get in contribution from edge matrices to the defect
-  if (edge_in != 0)
+  if (edge_in != nullptr)
     {
       edge_in->Tvmult(level, t[level], solution[level]);
       defect[level] -= t[level];
     }
-  if (edge_up != 0)
+  if (edge_up != nullptr)
     {
       edge_up->Tvmult(level, t[level], solution[level-1]);
       defect[level] -= t[level];
@@ -251,7 +251,7 @@ Multigrid<VectorType>::level_step(const unsigned int level,
   if (debug>1)
     deallog << cychar << "-cycle residual level  " << level << std::endl;
   matrix->vmult(level, t[level], solution[level]);
-  if (edge_out != 0)
+  if (edge_out != nullptr)
     edge_out->vmult_add(level, t[level], solution[level]);
   t[level].sadd(-1.0, 1.0, defect2[level]);
 
@@ -261,7 +261,7 @@ Multigrid<VectorType>::level_step(const unsigned int level,
 
   // Get the defect on the next coarser level as part of the (DG) edge matrix
   // and then the main part by the restriction of the transfer
-  if (edge_down != 0)
+  if (edge_down != nullptr)
     edge_down->vmult(level, defect2[level-1], solution[level]);
   else
     defect2[level-1] = 0;
@@ -293,13 +293,13 @@ Multigrid<VectorType>::level_step(const unsigned int level,
   solution[level] += t[level];
 
   // get in contribution from edge matrices to the defect
-  if (edge_in != 0)
+  if (edge_in != nullptr)
     {
       edge_in->Tvmult(level, t[level], solution[level]);
       defect2[level] -= t[level];
     }
 
-  if (edge_up != 0)
+  if (edge_up != nullptr)
     {
       edge_up->Tvmult(level, t[level], solution[level-1]);
       defect2[level] -= t[level];
index 230874d9ef1d2a99d8fc3c99f82269468f1d8976..a9b76e85160db70bc857505e02e105aade2af1d5 100644 (file)
@@ -740,7 +740,7 @@ namespace DataPostprocessorInputs
            ExcMessage ("You are trying to access the cell associated with a "
                        "DataPostprocessorInputs::Scalar object for which no cell has "
                        "been set."));
-    Assert(boost::any_cast<typename DoFHandlerType::cell_iterator>(&cell) != 0,
+    Assert(boost::any_cast<typename DoFHandlerType::cell_iterator>(&cell) != nullptr,
            ExcMessage ("You are trying to access the cell associated with a "
                        "DataPostprocessorInputs::Scalar with a DoFHandler type that "
                        "is different from the type with which it has been set. For "
index 8d45a1fa16e84f7b7082b140cb55069eec0a42f4..79bf6bb85d12c96eed00c2fbca8c2689a54bfcb3 100644 (file)
@@ -47,12 +47,12 @@ namespace Algorithms
   DoFOutputOperator<VectorType, dim, spacedim>::operator<<(
     const AnyData &data)
   {
-    Assert ((dof!=0), ExcNotInitialized());
+    Assert ((dof!=nullptr), ExcNotInitialized());
     out.attach_dof_handler (*dof);
     for (unsigned int i=0; i<data.size(); ++i)
       {
         const VectorType *p = data.try_read_ptr<VectorType>(i);
-        if (p!=0)
+        if (p!=nullptr)
           {
             out.add_data_vector (*p, data.name(i));
           }
index 83258cd4c320977f07709578aee4d59e656d02c3..ba06b911da1f2c804ba9727a223e9612d8ae6b39 100644 (file)
@@ -334,7 +334,7 @@ public:
    const InputVector                          &solution,
    Vector<float>                              &error,
    const ComponentMask                        &component_mask = ComponentMask(),
-   const Function<spacedim>                   *coefficients   = 0,
+   const Function<spacedim>                   *coefficients   = nullptr,
    const unsigned int                          n_threads      = numbers::invalid_unsigned_int,
    const types::subdomain_id                   subdomain_id   = numbers::invalid_subdomain_id,
    const types::material_id                    material_id    = numbers::invalid_material_id,
@@ -352,7 +352,7 @@ public:
    const InputVector                          &solution,
    Vector<float>                              &error,
    const ComponentMask                        &component_mask = ComponentMask(),
-   const Function<spacedim>                   *coefficients   = 0,
+   const Function<spacedim>                   *coefficients   = nullptr,
    const unsigned int                          n_threads      = numbers::invalid_unsigned_int,
    const types::subdomain_id                   subdomain_id   = numbers::invalid_subdomain_id,
    const types::material_id                    material_id    = numbers::invalid_material_id,
@@ -437,7 +437,7 @@ public:
    const InputVector                          &solution,
    Vector<float>                              &error,
    const ComponentMask                        &component_mask = ComponentMask(),
-   const Function<spacedim>                   *coefficients   = 0,
+   const Function<spacedim>                   *coefficients   = nullptr,
    const unsigned int                          n_threads      = numbers::invalid_unsigned_int,
    const types::subdomain_id                   subdomain_id   = numbers::invalid_subdomain_id,
    const types::material_id                    material_id    = numbers::invalid_material_id,
@@ -476,7 +476,7 @@ public:
    const std::vector<const InputVector *>     &solutions,
    std::vector<Vector<float>*>                &errors,
    const ComponentMask                        &component_mask = ComponentMask(),
-   const Function<spacedim>                   *coefficients   = 0,
+   const Function<spacedim>                   *coefficients   = nullptr,
    const unsigned int                          n_threads      = numbers::invalid_unsigned_int,
    const types::subdomain_id                   subdomain_id   = numbers::invalid_subdomain_id,
    const types::material_id                    material_id    = numbers::invalid_material_id,
@@ -580,7 +580,7 @@ public:
    const InputVector                          &solution,
    Vector<float>                              &error,
    const ComponentMask                        &component_mask = ComponentMask(),
-   const Function<spacedim>                   *coefficients   = 0,
+   const Function<spacedim>                   *coefficient    = nullptr,
    const unsigned int                          n_threads      = numbers::invalid_unsigned_int,
    const types::subdomain_id                   subdomain_id   = numbers::invalid_subdomain_id,
    const types::material_id                    material_id    = numbers::invalid_material_id);
@@ -597,7 +597,7 @@ public:
    const InputVector                          &solution,
    Vector<float>                              &error,
    const ComponentMask                        &component_mask = ComponentMask(),
-   const Function<spacedim>                   *coefficients   = 0,
+   const Function<spacedim>                   *coefficients   = nullptr,
    const unsigned int                          n_threads      = numbers::invalid_unsigned_int,
    const types::subdomain_id                   subdomain_id   = numbers::invalid_subdomain_id,
    const types::material_id                    material_id    = numbers::invalid_material_id);
index 2634d2210f9f4495b1e3f8bd40a5cc7ebc90e6a1..780b9c2544f85fa07c2bf2758368666268a2061e 100644 (file)
@@ -377,7 +377,7 @@ namespace internal
 
       // if a coefficient was given: use that to scale the jump in the
       // gradient
-      if (parallel_data.coefficients != 0)
+      if (parallel_data.coefficients != nullptr)
         {
           // scalar coefficient
           if (parallel_data.coefficients->n_components == 1)
@@ -1080,7 +1080,7 @@ estimate (const Mapping<dim, spacedim>               &mapping,
 #ifdef DEAL_II_WITH_P4EST
   if (dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>
       (&dof_handler.get_triangulation())
-      != 0)
+      != nullptr)
     Assert ((subdomain_id_ == numbers::invalid_subdomain_id)
             ||
             (subdomain_id_ ==
@@ -1093,7 +1093,7 @@ estimate (const Mapping<dim, spacedim>               &mapping,
   const types::subdomain_id subdomain_id
     = ((dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>
         (&dof_handler.get_triangulation())
-        != 0)
+        != nullptr)
        ?
        dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>&>
        (dof_handler.get_triangulation()).locally_owned_subdomain()
@@ -1125,7 +1125,7 @@ estimate (const Mapping<dim, spacedim>               &mapping,
   Assert (component_mask.n_selected_components(n_components) > 0,
           ExcInvalidComponentMask());
 
-  Assert ((coefficients == 0) ||
+  Assert ((coefficients == nullptr) ||
           (coefficients->n_components == n_components) ||
           (coefficients->n_components == 1),
           ExcInvalidCoefficient());
@@ -1150,7 +1150,7 @@ estimate (const Mapping<dim, spacedim>               &mapping,
   parallel_data (dof_handler.get_fe(),
                  face_quadratures,
                  mapping_collection,
-                 (!neumann_bc.empty() || (coefficients != 0)),
+                 (!neumann_bc.empty() || (coefficients != nullptr)),
                  solutions.size(),
                  subdomain_id,
                  material_id,
index 8a6d27978932ec2ee0aea9570af5766c6dd380a3..1d85dcbe3c7b4a041d3b4f2108387c32232569f8 100644 (file)
@@ -237,11 +237,11 @@ namespace MatrixCreator
       const FiniteElement<dim,spacedim> &fe  = fe_values.get_fe();
       const unsigned int n_components  = fe.n_components();
 
-      Assert(data.rhs_function == 0 ||
+      Assert(data.rhs_function == nullptr ||
              data.rhs_function->n_components==1 ||
              data.rhs_function->n_components==n_components,
              ::dealii::MatrixCreator::ExcComponentMismatch());
-      Assert(data.coefficient == 0 ||
+      Assert(data.coefficient == nullptr ||
              data.coefficient->n_components==1 ||
              data.coefficient->n_components==n_components,
              ::dealii::MatrixCreator::ExcComponentMismatch());
@@ -252,7 +252,7 @@ namespace MatrixCreator
       copy_data.dof_indices.resize (dofs_per_cell);
       cell->get_dof_indices (copy_data.dof_indices);
 
-      const bool use_rhs_function = data.rhs_function != 0;
+      const bool use_rhs_function = data.rhs_function != nullptr;
       if (use_rhs_function)
         {
           if (data.rhs_function->n_components==1)
@@ -270,7 +270,7 @@ namespace MatrixCreator
             }
         }
 
-      const bool use_coefficient = data.coefficient != 0;
+      const bool use_coefficient = data.coefficient != nullptr;
       if (use_coefficient)
         {
           if (data.coefficient->n_components==1)
@@ -420,11 +420,11 @@ namespace MatrixCreator
       const FiniteElement<dim,spacedim>    &fe  = fe_values.get_fe();
       const unsigned int n_components  = fe.n_components();
 
-      Assert(data.rhs_function == 0 ||
+      Assert(data.rhs_function == nullptr ||
              data.rhs_function->n_components==1 ||
              data.rhs_function->n_components==n_components,
              ::dealii::MatrixCreator::ExcComponentMismatch());
-      Assert(data.coefficient == 0 ||
+      Assert(data.coefficient == nullptr ||
              data.coefficient->n_components==1 ||
              data.coefficient->n_components==n_components,
              ::dealii::MatrixCreator::ExcComponentMismatch());
@@ -435,7 +435,7 @@ namespace MatrixCreator
       cell->get_dof_indices (copy_data.dof_indices);
 
 
-      const bool use_rhs_function = data.rhs_function != 0;
+      const bool use_rhs_function = data.rhs_function != nullptr;
       if (use_rhs_function)
         {
           if (data.rhs_function->n_components==1)
@@ -453,7 +453,7 @@ namespace MatrixCreator
             }
         }
 
-      const bool use_coefficient = data.coefficient != 0;
+      const bool use_coefficient = data.coefficient != nullptr;
       if (use_coefficient)
         {
           if (data.coefficient->n_components==1)
@@ -600,12 +600,12 @@ namespace MatrixCreator
               ExcInternalError());
       Assert (data.cell_matrix.n() == dofs_per_cell,
               ExcInternalError());
-      Assert ((right_hand_side == 0)
+      Assert ((right_hand_side == nullptr)
               ||
               (data.cell_rhs.size() == dofs_per_cell),
               ExcInternalError());
 
-      if (right_hand_side != 0)
+      if (right_hand_side != nullptr)
         data.constraints->distribute_local_to_global(data.cell_matrix,
                                                      data.cell_rhs,
                                                      data.dof_indices,
@@ -685,8 +685,8 @@ namespace MatrixCreator
     MatrixCreator::internal::AssemblerData::Scratch<dim, spacedim,number>
     assembler_data (fe_collection,
                     update_values | update_JxW_values |
-                    (coefficient != 0 ? update_quadrature_points : UpdateFlags(0)),
-                    coefficient, /*rhs_function=*/0,
+                    (coefficient != nullptr ? update_quadrature_points : UpdateFlags(0)),
+                    coefficient, /*rhs_function=*/nullptr,
                     q_collection, mapping_collection);
 
     MatrixCreator::internal::AssemblerData::CopyData<number> copy_data;
@@ -701,7 +701,7 @@ namespace MatrixCreator
                      &MatrixCreator::internal::mass_assembler<dim, spacedim, typename DoFHandler<dim,spacedim>::active_cell_iterator,number>,
                      std::bind (&MatrixCreator::internal::
                                 copy_local_to_global<number,SparseMatrix<number>, Vector<number> >,
-                                std::placeholders::_1, &matrix, (Vector<number> *)0),
+                                std::placeholders::_1, &matrix, (Vector<number> *)nullptr),
                      assembler_data,
                      copy_data);
   }
@@ -796,8 +796,8 @@ namespace MatrixCreator
     MatrixCreator::internal::AssemblerData::Scratch<dim, spacedim,number>
     assembler_data (dof.get_fe(),
                     update_values | update_JxW_values |
-                    (coefficient != 0 ? update_quadrature_points : UpdateFlags(0)),
-                    coefficient, /*rhs_function=*/0,
+                    (coefficient != nullptr ? update_quadrature_points : UpdateFlags(0)),
+                    coefficient, /*rhs_function=*/nullptr,
                     q, mapping);
     MatrixCreator::internal::AssemblerData::CopyData<number> copy_data;
     copy_data.cell_matrix.reinit (assembler_data.fe_collection.max_dofs_per_cell(),
@@ -811,7 +811,7 @@ namespace MatrixCreator
                      &MatrixCreator::internal::mass_assembler<dim, spacedim, typename hp::DoFHandler<dim,spacedim>::active_cell_iterator,number>,
                      std::bind (&MatrixCreator::internal::
                                 copy_local_to_global<number,SparseMatrix<number>, Vector<number> >,
-                                std::placeholders::_1, &matrix, (Vector<number> *)0),
+                                std::placeholders::_1, &matrix, (Vector<number> *)nullptr),
                      assembler_data,
                      copy_data);
   }
@@ -926,7 +926,7 @@ namespace MatrixCreator
       std::vector<number>          coefficient_values (fe_values.n_quadrature_points, 1.);
       std::vector<Vector<number> > coefficient_vector_values (fe_values.n_quadrature_points,
                                                               Vector<number>(n_components));
-      const bool coefficient_is_vector = (coefficient != 0 && coefficient->n_components != 1)
+      const bool coefficient_is_vector = (coefficient != nullptr && coefficient->n_components != 1)
                                          ? true : false;
 
       std::vector<number>          rhs_values_scalar (fe_values.n_quadrature_points);
@@ -973,7 +973,7 @@ namespace MatrixCreator
                     // If a scalar function is given, update the
                     // values, if not, use the default one set in the
                     // constructor above
-                    if (coefficient != 0)
+                    if (coefficient != nullptr)
                       coefficient->value_list (fe_values.get_quadrature_points(),
                                                coefficient_values);
                     // Copy scalar values into vector
@@ -1046,7 +1046,7 @@ namespace MatrixCreator
                 boundary_functions.find(cell->face(face)->boundary_id())
                 ->second->value_list (fe_values.get_quadrature_points(), rhs_values_scalar);
 
-                if (coefficient != 0)
+                if (coefficient != nullptr)
                   coefficient->value_list (fe_values.get_quadrature_points(),
                                            coefficient_values);
                 for (unsigned int point=0; point<fe_values.n_quadrature_points; ++point)
@@ -1220,7 +1220,7 @@ namespace MatrixCreator
     Assert (boundary_functions.size() != 0, ExcInternalError());
     Assert (dof_to_boundary_mapping.size() == dof.n_dofs(),
             ExcInternalError());
-    Assert (coefficient ==0 ||
+    Assert (coefficient ==nullptr ||
             coefficient->n_components==1 ||
             coefficient->n_components==n_components, ExcComponentMismatch());
 
@@ -1338,7 +1338,7 @@ namespace MatrixCreator
                 ->second->vector_value_list (fe_values.get_quadrature_points(),
                                              rhs_values_system);
 
-                if (coefficient != 0)
+                if (coefficient != nullptr)
                   {
                     if (coefficient->n_components==1)
                       {
@@ -1424,7 +1424,7 @@ namespace MatrixCreator
                 boundary_functions.find(cell->face(face)->boundary_id())
                 ->second->value_list (fe_values.get_quadrature_points(), rhs_values_scalar);
 
-                if (coefficient != 0)
+                if (coefficient != nullptr)
                   {
                     coefficient_values.resize (fe_values.n_quadrature_points);
                     coefficient->value_list (fe_values.get_quadrature_points(),
@@ -1637,7 +1637,7 @@ namespace MatrixCreator
     Assert (boundary_functions.size() != 0, ExcInternalError());
     Assert (dof_to_boundary_mapping.size() == dof.n_dofs(),
             ExcInternalError());
-    Assert (coefficient ==0 ||
+    Assert (coefficient ==nullptr ||
             coefficient->n_components==1 ||
             coefficient->n_components==n_components, ExcComponentMismatch());
 
@@ -1712,8 +1712,8 @@ namespace MatrixCreator
     MatrixCreator::internal::AssemblerData::Scratch<dim, spacedim,double>
     assembler_data (fe_collection,
                     update_gradients  | update_JxW_values |
-                    (coefficient != 0 ? update_quadrature_points : UpdateFlags(0)),
-                    coefficient, /*rhs_function=*/0,
+                    (coefficient != nullptr ? update_quadrature_points : UpdateFlags(0)),
+                    coefficient, /*rhs_function=*/nullptr,
                     q_collection, mapping_collection);
     MatrixCreator::internal::AssemblerData::CopyData<double> copy_data;
     copy_data.cell_matrix.reinit (assembler_data.fe_collection.max_dofs_per_cell(),
@@ -1729,7 +1729,7 @@ namespace MatrixCreator
                                 copy_local_to_global<double,SparseMatrix<double>, Vector<double> >,
                                 std::placeholders::_1,
                                 &matrix,
-                                (Vector<double> *)NULL),
+                                (Vector<double> *)(nullptr)),
                      assembler_data,
                      copy_data);
   }
@@ -1825,8 +1825,8 @@ namespace MatrixCreator
     MatrixCreator::internal::AssemblerData::Scratch<dim, spacedim,double>
     assembler_data (dof.get_fe(),
                     update_gradients  | update_JxW_values |
-                    (coefficient != 0 ? update_quadrature_points : UpdateFlags(0)),
-                    coefficient, /*rhs_function=*/0,
+                    (coefficient != nullptr ? update_quadrature_points : UpdateFlags(0)),
+                    coefficient, /*rhs_function=*/nullptr,
                     q, mapping);
     MatrixCreator::internal::AssemblerData::CopyData<double> copy_data;
     copy_data.cell_matrix.reinit (assembler_data.fe_collection.max_dofs_per_cell(),
@@ -1842,7 +1842,7 @@ namespace MatrixCreator
                                 copy_local_to_global<double,SparseMatrix<double>, Vector<double> >,
                                 std::placeholders::_1,
                                 &matrix,
-                                (Vector<double> *)0),
+                                (Vector<double> *)nullptr),
                      assembler_data,
                      copy_data);
   }
index d0e0c19160976a77af15f2e0a6a23db897dd2f06..e89b4280ff6056ca3c07f67ad5e116260f769ac0 100644 (file)
@@ -241,7 +241,7 @@ namespace MatrixCreator
                            const DoFHandler<dim,spacedim>    &dof,
                            const Quadrature<dim>    &q,
                            SparseMatrix<number>     &matrix,
-                           const Function<spacedim,number> *const a = 0,
+                           const Function<spacedim,number> *const a = nullptr,
                            const ConstraintMatrix   &constraints = ConstraintMatrix());
 
   /**
@@ -252,7 +252,7 @@ namespace MatrixCreator
   void create_mass_matrix (const DoFHandler<dim,spacedim>    &dof,
                            const Quadrature<dim>    &q,
                            SparseMatrix<number>     &matrix,
-                           const Function<spacedim,number> *const a = 0,
+                           const Function<spacedim,number> *const a = nullptr,
                            const ConstraintMatrix   &constraints = ConstraintMatrix());
 
   /**
@@ -278,7 +278,7 @@ namespace MatrixCreator
                            SparseMatrix<number>     &matrix,
                            const Function<spacedim,number> &rhs,
                            Vector<number>           &rhs_vector,
-                           const Function<spacedim,number> *const a = 0,
+                           const Function<spacedim,number> *const a = nullptr,
                            const ConstraintMatrix   &constraints = ConstraintMatrix());
 
   /**
@@ -302,7 +302,7 @@ namespace MatrixCreator
                            const hp::DoFHandler<dim,spacedim>    &dof,
                            const hp::QCollection<dim>    &q,
                            SparseMatrix<number>     &matrix,
-                           const Function<spacedim,number> *const a = 0,
+                           const Function<spacedim,number> *const a = nullptr,
                            const ConstraintMatrix   &constraints = ConstraintMatrix());
 
   /**
@@ -325,7 +325,7 @@ namespace MatrixCreator
                            SparseMatrix<number>     &matrix,
                            const Function<spacedim,number> &rhs,
                            Vector<number>           &rhs_vector,
-                           const Function<spacedim,number> *const a = 0,
+                           const Function<spacedim,number> *const a = nullptr,
                            const ConstraintMatrix   &constraints = ConstraintMatrix());
 
   /**
@@ -437,7 +437,7 @@ namespace MatrixCreator
                               const DoFHandler<dim,spacedim> &dof,
                               const Quadrature<dim>    &q,
                               SparseMatrix<double>     &matrix,
-                              const Function<spacedim> *const a = 0,
+                              const Function<spacedim> *const a = nullptr,
                               const ConstraintMatrix   &constraints = ConstraintMatrix());
 
   /**
@@ -448,7 +448,7 @@ namespace MatrixCreator
   void create_laplace_matrix (const DoFHandler<dim,spacedim> &dof,
                               const Quadrature<dim>    &q,
                               SparseMatrix<double>     &matrix,
-                              const Function<spacedim> *const a = 0,
+                              const Function<spacedim> *const a = nullptr,
                               const ConstraintMatrix   &constraints = ConstraintMatrix());
 
   /**
@@ -473,7 +473,7 @@ namespace MatrixCreator
                               SparseMatrix<double>     &matrix,
                               const Function<spacedim> &rhs,
                               Vector<double>           &rhs_vector,
-                              const Function<spacedim> *const a = 0,
+                              const Function<spacedim> *const a = nullptr,
                               const ConstraintMatrix   &constraints = ConstraintMatrix());
 
   /**
@@ -486,7 +486,7 @@ namespace MatrixCreator
                               SparseMatrix<double>     &matrix,
                               const Function<spacedim> &rhs,
                               Vector<double>           &rhs_vector,
-                              const Function<spacedim> *const a = 0,
+                              const Function<spacedim> *const a = nullptr,
                               const ConstraintMatrix   &constraints = ConstraintMatrix());
 
   /**
@@ -498,7 +498,7 @@ namespace MatrixCreator
                               const hp::DoFHandler<dim,spacedim> &dof,
                               const hp::QCollection<dim>    &q,
                               SparseMatrix<double>     &matrix,
-                              const Function<spacedim> *const a = 0,
+                              const Function<spacedim> *const a = nullptr,
                               const ConstraintMatrix   &constraints = ConstraintMatrix());
 
   /**
@@ -509,7 +509,7 @@ namespace MatrixCreator
   void create_laplace_matrix (const hp::DoFHandler<dim,spacedim> &dof,
                               const hp::QCollection<dim>    &q,
                               SparseMatrix<double>     &matrix,
-                              const Function<spacedim> *const a = 0,
+                              const Function<spacedim> *const a = nullptr,
                               const ConstraintMatrix   &constraints = ConstraintMatrix());
 
   /**
@@ -523,7 +523,7 @@ namespace MatrixCreator
                               SparseMatrix<double>     &matrix,
                               const Function<spacedim>      &rhs,
                               Vector<double>           &rhs_vector,
-                              const Function<spacedim> *const a = 0,
+                              const Function<spacedim> *const a = nullptr,
                               const ConstraintMatrix   &constraints = ConstraintMatrix());
 
   /**
@@ -536,7 +536,7 @@ namespace MatrixCreator
                               SparseMatrix<double>     &matrix,
                               const Function<spacedim>      &rhs,
                               Vector<double>           &rhs_vector,
-                              const Function<spacedim> *const a = 0,
+                              const Function<spacedim> *const a = nullptr,
                               const ConstraintMatrix   &constraints = ConstraintMatrix());
 
   /**
index 0b7c7529d3d1f072c99eeb051ef8a90e2086b37e..3ed4f297ac4aa0b94ae25e6474a4d7f78ecd062b 100644 (file)
@@ -473,16 +473,16 @@ private:
    */
   struct Pointerstruct
   {
-    Pointerstruct() : indices_ptr(0), dof_values_ptr(0), active_fe_index(0) {};
+    Pointerstruct() : indices_ptr(nullptr), dof_values_ptr(nullptr), active_fe_index(0) {};
     Pointerstruct(std::vector<types::global_dof_index> *indices_ptr_in,
                   const unsigned int active_fe_index_in = 0)
       :
       indices_ptr(indices_ptr_in),
-      dof_values_ptr (0),
+      dof_values_ptr (nullptr),
       active_fe_index(active_fe_index_in) {};
     Pointerstruct(std::vector<Vector<typename VectorType::value_type> > *dof_values_ptr_in,
                   const unsigned int active_fe_index_in = 0) :
-      indices_ptr (0),
+      indices_ptr (nullptr),
       dof_values_ptr(dof_values_ptr_in),
       active_fe_index(active_fe_index_in) {};
     std::size_t memory_consumption () const;
index 80f90256bbf2544ead888f8ec31d51169aa2b5ea..b4c06996025af5d89d6f649105fc4f3ab89dd43f 100644 (file)
@@ -2241,7 +2241,7 @@ namespace VectorTools
                              OutVector                       &difference,
                              const Quadrature<dim>           &q,
                              const NormType                  &norm,
-                             const Function<spacedim,double> *weight   = 0,
+                             const Function<spacedim,double> *weight   = nullptr,
                              const double                     exponent = 2.);
 
   /**
@@ -2255,7 +2255,7 @@ namespace VectorTools
                              OutVector                       &difference,
                              const Quadrature<dim>           &q,
                              const NormType                  &norm,
-                             const Function<spacedim,double> *weight   = 0,
+                             const Function<spacedim,double> *weight   = nullptr,
                              const double                     exponent = 2.);
 
   /**
@@ -2269,7 +2269,7 @@ namespace VectorTools
                              OutVector                                 &difference,
                              const hp::QCollection<dim>                &q,
                              const NormType                            &norm,
-                             const Function<spacedim,double>           *weight   = 0,
+                             const Function<spacedim,double>           *weight   = nullptr,
                              const double                               exponent = 2.);
 
   /**
@@ -2283,7 +2283,7 @@ namespace VectorTools
                              OutVector                          &difference,
                              const hp::QCollection<dim>         &q,
                              const NormType                     &norm,
-                             const Function<spacedim,double>    *weight   = 0,
+                             const Function<spacedim,double>    *weight   = nullptr,
                              const double                        exponent = 2.);
 
   /**
index e1d99f804ff2a2c3e09a59aa67d69c1260b8898b..dea18e79b149fe2967b6f1efa084801c200abd55 100644 (file)
@@ -863,7 +863,7 @@ namespace VectorTools
       // interpolate the boundary values and then condense the matrix and vector
       if (constraints_are_compatible)
         {
-          const Function<spacedim,number> *dummy = 0;
+          const Function<spacedim,number> *dummy = nullptr;
           MatrixCreator::create_mass_matrix (mapping, dof, quadrature,
                                              mass_matrix, function, tmp,
                                              dummy, constraints);
@@ -1130,7 +1130,7 @@ namespace VectorTools
                                          project_to_boundary_first);
       else
         {
-          Assert((dynamic_cast<const parallel::Triangulation<dim>* > (&(dof.get_triangulation()))==0),
+          Assert((dynamic_cast<const parallel::Triangulation<dim>* > (&(dof.get_triangulation()))==nullptr),
                  ExcNotImplemented());
           do_project (mapping, dof, constraints, quadrature,
                       function, vec_result,
@@ -1406,15 +1406,15 @@ namespace VectorTools
         const DoFHandler<dim> *const dof_ptr = dynamic_cast<const DoFHandler<dim>*> (&dof);
         const Function<dim, typename VectorType::value_type> *const function_ptr
           = dynamic_cast<const Function<dim, typename VectorType::value_type>*> (&function);
-        Assert (mapping_ptr!=0, ExcInternalError());
-        Assert (dof_ptr!=0, ExcInternalError());
+        Assert (mapping_ptr!=nullptr, ExcInternalError());
+        Assert (dof_ptr!=nullptr, ExcInternalError());
         project<VectorType, dim>
         (*mapping_ptr, *dof_ptr, constraints, quadrature, *function_ptr, vec_result,
          enforce_zero_boundary, q_boundary, project_to_boundary_first);
       }
     else
       {
-        Assert((dynamic_cast<const parallel::Triangulation<dim,spacedim>* > (&(dof.get_triangulation()))==0),
+        Assert((dynamic_cast<const parallel::Triangulation<dim,spacedim>* > (&(dof.get_triangulation()))==nullptr),
                ExcNotImplemented());
         do_project (mapping, dof, constraints, quadrature,
                     function, vec_result,
@@ -1452,7 +1452,7 @@ namespace VectorTools
                 const hp::QCollection<dim-1>               &q_boundary,
                 const bool                                  project_to_boundary_first)
   {
-    Assert((dynamic_cast<const parallel::Triangulation<dim,spacedim>* > (&(dof.get_triangulation()))==0),
+    Assert((dynamic_cast<const parallel::Triangulation<dim,spacedim>* > (&(dof.get_triangulation()))==nullptr),
            ExcNotImplemented());
 
     do_project (mapping, dof, constraints, quadrature,
@@ -2894,7 +2894,7 @@ namespace VectorTools
       MatrixCreator::create_boundary_mass_matrix (mapping, dof, q,
                                                   mass_matrix, boundary_functions,
                                                   rhs, dof_to_boundary_mapping,
-                                                  (const Function<spacedim,number> *) 0,
+                                                  (const Function<spacedim,number> *) nullptr,
                                                   component_mapping);
 
       // For certain weird elements,
@@ -3569,7 +3569,7 @@ namespace VectorTools
       reference_quadrature_points = fe_values.get_quadrature ().get_points ();
       std::pair<unsigned int, unsigned int> base_indices (0, 0);
 
-      if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) != 0)
+      if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) != nullptr)
         {
           unsigned int fe_index = 0;
           unsigned int fe_index_old = 0;
@@ -3636,7 +3636,7 @@ namespace VectorTools
           // Compute the degrees of
           // freedom.
           for (unsigned int i = 0; i < fe.dofs_per_face; ++i)
-            if (((dynamic_cast<const FESystem<dim>*> (&fe) != 0)
+            if (((dynamic_cast<const FESystem<dim>*> (&fe) != nullptr)
                  && (fe.system_to_base_index (fe.face_to_cell_index (i, face)).first
                      == base_indices)
                  && (fe.base_element (base_indices.first).face_to_cell_index (line * fe.degree, face)
@@ -3644,7 +3644,7 @@ namespace VectorTools
                  && (fe.system_to_base_index (fe.face_to_cell_index (i, face)).second
                      <= fe.base_element (base_indices.first).face_to_cell_index
                      ((line + 1) * fe.degree - 1, face)))
-                || ((dynamic_cast<const FE_Nedelec<dim>*> (&fe) != 0) && (line * fe.degree <= i)
+                || ((dynamic_cast<const FE_Nedelec<dim>*> (&fe) != nullptr) && (line * fe.degree <= i)
                     && (i < (line + 1) * fe.degree)))
               {
                 const double tangential_solution_component
@@ -3715,7 +3715,7 @@ namespace VectorTools
       const unsigned int degree = fe.degree - 1;
       std::pair<unsigned int, unsigned int> base_indices (0, 0);
 
-      if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) != 0)
+      if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) != nullptr)
         {
           unsigned int fe_index = 0;
           unsigned int fe_index_old = 0;
@@ -3797,10 +3797,10 @@ namespace VectorTools
               // Compute the degrees
               // of freedom.
               for (unsigned int i = 0; i < fe.dofs_per_face; ++i)
-                if (((dynamic_cast<const FESystem<dim>*> (&fe) != 0)
+                if (((dynamic_cast<const FESystem<dim>*> (&fe) != nullptr)
                      && (fe.system_to_base_index (fe.face_to_cell_index (i, face)).first
                          == base_indices))
-                    || (dynamic_cast<const FE_Nedelec<dim>*> (&fe) != 0))
+                    || (dynamic_cast<const FE_Nedelec<dim>*> (&fe) != nullptr))
                   {
                     dof_values[i]
                     += fe_values.JxW (q_point)
@@ -3869,13 +3869,13 @@ namespace VectorTools
                 tmp[d] = values[q_point] (first_vector_component + d);
 
               for (unsigned int i = 0; i < fe.dofs_per_face; ++i)
-                if (((dynamic_cast<const FESystem<dim>*> (&fe) != 0)
+                if (((dynamic_cast<const FESystem<dim>*> (&fe) != nullptr)
                      && (fe.system_to_base_index (fe.face_to_cell_index (i, face)).first == base_indices)
                      && (fe.base_element (base_indices.first).face_to_cell_index (2 * fe.degree, face)
                          <= fe.system_to_base_index (fe.face_to_cell_index (i, face)).second)
                      && (fe.system_to_base_index (fe.face_to_cell_index (i, face)).second
                          <= fe.base_element (base_indices.first).face_to_cell_index (4 * fe.degree - 1, face)))
-                    || ((dynamic_cast<const FE_Nedelec<dim>*> (&fe) != 0) && (2 * fe.degree <= i)
+                    || ((dynamic_cast<const FE_Nedelec<dim>*> (&fe) != nullptr) && (2 * fe.degree <= i)
                         && (i < 4 * fe.degree)))
                   tmp -= dof_values[i] * fe_values[vec].value (fe.face_to_cell_index (i, face), q_point);
 
@@ -3914,7 +3914,7 @@ namespace VectorTools
               unsigned int index = 0;
 
               for (unsigned int i = 0; i < fe.dofs_per_face; ++i)
-                if (((dynamic_cast<const FESystem<dim>*> (&fe) != 0)
+                if (((dynamic_cast<const FESystem<dim>*> (&fe) != nullptr)
                      && (fe.system_to_base_index (fe.face_to_cell_index (i, face)).first
                          == base_indices)
                      && (fe.base_element (base_indices.first).face_to_cell_index
@@ -3923,7 +3923,7 @@ namespace VectorTools
                      && (fe.system_to_base_index (fe.face_to_cell_index (i, face)).second
                          < fe.base_element (base_indices.first).face_to_cell_index
                          ((degree + GeometryInfo<dim>::lines_per_face) * fe.degree, face)))
-                    || ((dynamic_cast<const FE_Nedelec<dim>*> (&fe) != 0)
+                    || ((dynamic_cast<const FE_Nedelec<dim>*> (&fe) != nullptr)
                         && (GeometryInfo<dim>::lines_per_face * fe.degree <= i)
                         && (i < (degree + GeometryInfo<dim>::lines_per_face) * fe.degree)))
                   {
@@ -3953,7 +3953,7 @@ namespace VectorTools
             unsigned int index = 0;
 
             for (unsigned int i = 0; i < fe.dofs_per_face; ++i)
-              if (((dynamic_cast<const FESystem<dim>*> (&fe) != 0)
+              if (((dynamic_cast<const FESystem<dim>*> (&fe) != nullptr)
                    && (fe.system_to_base_index (fe.face_to_cell_index (i, face)).first
                        == base_indices)
                    && (fe.base_element (base_indices.first).face_to_cell_index
@@ -3962,7 +3962,7 @@ namespace VectorTools
                    && (fe.system_to_base_index (fe.face_to_cell_index (i, face)).second
                        < fe.base_element (base_indices.first).face_to_cell_index
                        ((degree + GeometryInfo<dim>::lines_per_face) * fe.degree, face)))
-                  || ((dynamic_cast<const FE_Nedelec<dim>*> (&fe) != 0)
+                  || ((dynamic_cast<const FE_Nedelec<dim>*> (&fe) != nullptr)
                       && (GeometryInfo<dim>::lines_per_face * fe.degree <= i)
                       && (i < (degree + GeometryInfo<dim>::lines_per_face) * fe.degree)))
                 {
@@ -3983,14 +3983,14 @@ namespace VectorTools
                 tmp[d] = values[q_point] (first_vector_component + d);
 
               for (unsigned int i = 0; i < fe.dofs_per_face; ++i)
-                if (((dynamic_cast<const FESystem<dim>*> (&fe) != 0)
+                if (((dynamic_cast<const FESystem<dim>*> (&fe) != nullptr)
                      && (fe.system_to_base_index (fe.face_to_cell_index (i, face)).first
                          == base_indices)
                      && (fe.system_to_base_index (fe.face_to_cell_index (i, face)).second
                          <= fe.base_element (base_indices.first).face_to_cell_index (2 * fe.degree - 1, face))
                      && (fe.system_to_base_index (fe.face_to_cell_index (i, face)).second
                          >= fe.base_element (base_indices.first).face_to_cell_index (0, face)))
-                    || ((dynamic_cast<const FE_Nedelec<dim>*> (&fe) != 0) && (i < 2 * fe.degree)))
+                    || ((dynamic_cast<const FE_Nedelec<dim>*> (&fe) != nullptr) && (i < 2 * fe.degree)))
                   tmp -= dof_values[i] * fe_values[vec].value (fe.face_to_cell_index (i, face), q_point);
 
               const double JxW
@@ -4019,13 +4019,13 @@ namespace VectorTools
               unsigned int index = 0;
 
               for (unsigned int i = 0; i < fe.dofs_per_face; ++i)
-                if (((dynamic_cast<const FESystem<dim>*> (&fe) != 0)
+                if (((dynamic_cast<const FESystem<dim>*> (&fe) != nullptr)
                      && (fe.system_to_base_index (fe.face_to_cell_index (i, face)).first
                          == base_indices)
                      && (fe.base_element (base_indices.first).face_to_cell_index
                          ((degree + GeometryInfo<dim>::lines_per_face) * fe.degree, face)
                          <= fe.system_to_base_index (fe.face_to_cell_index (i, face)).second))
-                    || ((dynamic_cast<const FE_Nedelec<dim>*> (&fe) != 0)
+                    || ((dynamic_cast<const FE_Nedelec<dim>*> (&fe) != nullptr)
                         && ((degree + GeometryInfo<dim>::lines_per_face) * fe.degree <= i)))
                   {
                     const Tensor<1, dim> shape_value
@@ -4047,13 +4047,13 @@ namespace VectorTools
           unsigned int index = 0;
 
           for (unsigned int i = 0; i < fe.dofs_per_face; ++i)
-            if (((dynamic_cast<const FESystem<dim>*> (&fe) != 0)
+            if (((dynamic_cast<const FESystem<dim>*> (&fe) != nullptr)
                  && (fe.system_to_base_index (fe.face_to_cell_index (i, face)).first
                      == base_indices)
                  && (fe.base_element (base_indices.first).face_to_cell_index
                      ((degree + GeometryInfo<dim>::lines_per_face) * fe.degree, face)
                      <= fe.system_to_base_index (fe.face_to_cell_index (i, face)).second))
-                || ((dynamic_cast<const FE_Nedelec<dim>*> (&fe) != 0)
+                || ((dynamic_cast<const FE_Nedelec<dim>*> (&fe) != nullptr)
                     && ((degree + GeometryInfo<dim>::lines_per_face) * fe.degree <= i)))
               {
                 dof_values[i] = solution (index);
@@ -4131,7 +4131,7 @@ namespace VectorTools
                   // FE_Nothing object
                   // there is no work to
                   // do
-                  if (dynamic_cast<const FE_Nothing<dim>*> (&cell->get_fe ()) != 0)
+                  if (dynamic_cast<const FE_Nothing<dim>*> (&cell->get_fe ()) != nullptr)
                     return;
 
                   // This is only
@@ -4140,10 +4140,10 @@ namespace VectorTools
                   // element. If the FE
                   // is a FESystem, we
                   // cannot check this.
-                  if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == 0)
+                  if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == nullptr)
                     {
                       typedef FiniteElement<dim> FEL;
-                      AssertThrow (dynamic_cast<const FE_Nedelec<dim>*> (&cell->get_fe ()) != 0,
+                      AssertThrow (dynamic_cast<const FE_Nedelec<dim>*> (&cell->get_fe ()) != nullptr,
 
                                    typename FEL::ExcInterpolationNotImplemented ());
                     }
@@ -4215,7 +4215,7 @@ namespace VectorTools
                   // FE_Nothing object
                   // there is no work to
                   // do
-                  if (dynamic_cast<const FE_Nothing<dim>*> (&cell->get_fe ()) != 0)
+                  if (dynamic_cast<const FE_Nothing<dim>*> (&cell->get_fe ()) != nullptr)
                     return;
 
                   // This is only
@@ -4224,11 +4224,11 @@ namespace VectorTools
                   // element. If the FE is
                   // a FESystem we cannot
                   // check this.
-                  if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == 0)
+                  if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == nullptr)
                     {
                       typedef FiniteElement<dim> FEL;
 
-                      AssertThrow (dynamic_cast<const FE_Nedelec<dim>*> (&cell->get_fe ()) != 0,
+                      AssertThrow (dynamic_cast<const FE_Nedelec<dim>*> (&cell->get_fe ()) != nullptr,
                                    typename FEL::ExcInterpolationNotImplemented ());
                     }
 
@@ -4334,16 +4334,16 @@ namespace VectorTools
               if (cell->face (face)->boundary_id () == boundary_component)
                 {
                   // if the FE is a FE_Nothing object there is no work to do
-                  if (dynamic_cast<const FE_Nothing<dim>*> (&cell->get_fe ()) != 0)
+                  if (dynamic_cast<const FE_Nothing<dim>*> (&cell->get_fe ()) != nullptr)
                     return;
 
                   // This is only implemented, if the FE is a Nedelec
                   // element. If the FE is a FESystem we cannot check this.
-                  if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == 0)
+                  if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == nullptr)
                     {
                       typedef FiniteElement<dim> FEL;
 
-                      AssertThrow (dynamic_cast<const FE_Nedelec<dim>*> (&cell->get_fe ()) != 0,
+                      AssertThrow (dynamic_cast<const FE_Nedelec<dim>*> (&cell->get_fe ()) != nullptr,
                                    typename FEL::ExcInterpolationNotImplemented ());
                     }
 
@@ -4411,16 +4411,16 @@ namespace VectorTools
               if (cell->face (face)->boundary_id () == boundary_component)
                 {
                   // if the FE is a FE_Nothing object there is no work to do
-                  if (dynamic_cast<const FE_Nothing<dim>*> (&cell->get_fe ()) != 0)
+                  if (dynamic_cast<const FE_Nothing<dim>*> (&cell->get_fe ()) != nullptr)
                     return;
 
                   // This is only implemented, if the FE is a Nedelec
                   // element. If the FE is a FESystem we cannot check this.
-                  if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == 0)
+                  if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == nullptr)
                     {
                       typedef FiniteElement<dim> FEL;
 
-                      AssertThrow (dynamic_cast<const FE_Nedelec<dim>*> (&cell->get_fe ()) != 0,
+                      AssertThrow (dynamic_cast<const FE_Nedelec<dim>*> (&cell->get_fe ()) != nullptr,
                                    typename FEL::ExcInterpolationNotImplemented ());
                     }
 
@@ -4530,7 +4530,7 @@ namespace VectorTools
       // If not using FESystem then must be using FE_Nedelec,
       // which has one base element and one copy of it (with 3 components).
       std::pair<unsigned int, unsigned int> base_indices (0, 0);
-      if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) != 0)
+      if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) != nullptr)
         {
           unsigned int fe_index = 0;
           unsigned int fe_index_old = 0;
@@ -4595,11 +4595,11 @@ namespace VectorTools
           const unsigned int cell_idx = fe.face_to_cell_index (face_idx, face);
 
           // Check this cell_idx belongs to the correct base_element, component and line:
-          if (((dynamic_cast<const FESystem<dim>*> (&fe) != 0)
+          if (((dynamic_cast<const FESystem<dim>*> (&fe) != nullptr)
                && (fe.system_to_base_index (cell_idx).first == base_indices)
                && (lower_bound <= fe.system_to_base_index (cell_idx).second)
                && (fe.system_to_base_index (cell_idx).second <= upper_bound))
-              || ((dynamic_cast<const FE_Nedelec<dim>*> (&fe) != 0)
+              || ((dynamic_cast<const FE_Nedelec<dim>*> (&fe) != nullptr)
                   && (line * (degree + 1) <= face_idx)
                   && (face_idx <= (line + 1) * (degree + 1) - 1)))
             {
@@ -4767,7 +4767,7 @@ namespace VectorTools
       // If not using FESystem then must be using FE_Nedelec,
       // which has one base element and one copy of it (with 3 components).
       std::pair<unsigned int, unsigned int> base_indices (0, 0);
-      if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) != 0)
+      if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) != nullptr)
         {
           unsigned int fe_index = 0;
           unsigned int fe_index_old = 0;
@@ -4815,9 +4815,9 @@ namespace VectorTools
           for (unsigned int face_idx = 0; face_idx < fe.dofs_per_face; ++face_idx)
             {
               const unsigned int cell_idx = fe.face_to_cell_index (face_idx, face);
-              if (((dynamic_cast<const FESystem<dim>*> (&fe) != 0)
+              if (((dynamic_cast<const FESystem<dim>*> (&fe) != nullptr)
                    && (fe.system_to_base_index (cell_idx).first == base_indices))
-                  || (dynamic_cast<const FE_Nedelec<dim>*> (&fe) != 0))
+                  || (dynamic_cast<const FE_Nedelec<dim>*> (&fe) != nullptr))
                 {
                   associated_edge_dof_to_face_dof[associated_edge_dof_index] = face_idx;
                   ++associated_edge_dof_index;
@@ -4930,11 +4930,11 @@ namespace VectorTools
                   const unsigned int face_idx = line*fe.dofs_per_line + line_idx;
                   const unsigned int cell_idx = fe.face_to_cell_index(face_idx, face);
                   // Check this cell_idx belongs to the correct base_element, component and line:
-                  if (((dynamic_cast<const FESystem<dim>*> (&fe) != 0)
+                  if (((dynamic_cast<const FESystem<dim>*> (&fe) != nullptr)
                        && (fe.system_to_base_index (cell_idx).first == base_indices)
                        && (lower_bound <= fe.system_to_base_index (cell_idx).second)
                        && (fe.system_to_base_index (cell_idx).second <= upper_bound))
-                      || ((dynamic_cast<const FE_Nedelec<dim>*> (&fe) != 0)
+                      || ((dynamic_cast<const FE_Nedelec<dim>*> (&fe) != nullptr)
                           && (line * (degree + 1) <= face_idx)
                           && (face_idx <= (line + 1) * (degree + 1) - 1)))
                     {
@@ -4969,9 +4969,9 @@ namespace VectorTools
                face_idx < fe.dofs_per_face; ++face_idx)
             {
               const unsigned int cell_idx = fe.face_to_cell_index (face_idx, face);
-              if (((dynamic_cast<const FESystem<dim>*> (&fe) != 0)
+              if (((dynamic_cast<const FESystem<dim>*> (&fe) != nullptr)
                    && (fe.system_to_base_index (cell_idx).first == base_indices))
-                  || ((dynamic_cast<const FE_Nedelec<dim>*> (&fe) != 0)))
+                  || ((dynamic_cast<const FE_Nedelec<dim>*> (&fe) != nullptr)))
                 {
                   associated_face_dof_to_face_dof[associated_face_dof_index] = face_idx;
                   ++associated_face_dof_index;
@@ -5160,17 +5160,17 @@ namespace VectorTools
                       if (cell->face (face)->boundary_id () == boundary_component)
                         {
                           // If the FE is an FE_Nothing object there is no work to do
-                          if (dynamic_cast<const FE_Nothing<dim>*> (&cell->get_fe ()) != 0)
+                          if (dynamic_cast<const FE_Nothing<dim>*> (&cell->get_fe ()) != nullptr)
                             {
                               return;
                             }
 
                           // This is only implemented for FE_Nedelec elements.
                           // If the FE is a FESystem we cannot check this.
-                          if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == 0)
+                          if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == nullptr)
                             {
                               typedef FiniteElement<dim> FEL;
-                              AssertThrow (dynamic_cast<const FE_Nedelec<dim>*> (&cell->get_fe ()) != 0,
+                              AssertThrow (dynamic_cast<const FE_Nedelec<dim>*> (&cell->get_fe ()) != nullptr,
                                            typename FEL::ExcInterpolationNotImplemented ());
 
                             }
@@ -5257,18 +5257,18 @@ namespace VectorTools
                       if (cell->face (face)->boundary_id () == boundary_component)
                         {
                           // If the FE is an FE_Nothing object there is no work to do
-                          if (dynamic_cast<const FE_Nothing<dim>*> (&cell->get_fe ()) != 0)
+                          if (dynamic_cast<const FE_Nothing<dim>*> (&cell->get_fe ()) != nullptr)
                             {
                               return;
                             }
 
                           // This is only implemented for FE_Nedelec elements.
                           // If the FE is a FESystem we cannot check this.
-                          if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == 0)
+                          if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == nullptr)
                             {
                               typedef FiniteElement<dim> FEL;
 
-                              AssertThrow (dynamic_cast<const FE_Nedelec<dim>*> (&cell->get_fe ()) != 0,
+                              AssertThrow (dynamic_cast<const FE_Nedelec<dim>*> (&cell->get_fe ()) != nullptr,
                                            typename FEL::ExcInterpolationNotImplemented ());
                             }
 
@@ -5620,7 +5620,7 @@ namespace VectorTools
                   // FE_Nothing object
                   // there is no work to
                   // do
-                  if (dynamic_cast<const FE_Nothing<dim>*> (&cell->get_fe ()) != 0)
+                  if (dynamic_cast<const FE_Nothing<dim>*> (&cell->get_fe ()) != nullptr)
                     return;
 
                   // This is only
@@ -5629,11 +5629,11 @@ namespace VectorTools
                   // element. If the FE is
                   // a FESystem we cannot
                   // check this.
-                  if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == 0)
+                  if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == nullptr)
                     {
                       typedef FiniteElement<dim> FEL;
 
-                      AssertThrow (dynamic_cast<const FE_RaviartThomas<dim>*> (&cell->get_fe ()) != 0,
+                      AssertThrow (dynamic_cast<const FE_RaviartThomas<dim>*> (&cell->get_fe ()) != nullptr,
                                    typename FEL::ExcInterpolationNotImplemented ());
                     }
 
@@ -5693,11 +5693,11 @@ namespace VectorTools
                   // element. If the FE is
                   // a FESystem we cannot
                   // check this.
-                  if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == 0)
+                  if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == nullptr)
                     {
                       typedef FiniteElement<dim> FEL;
 
-                      AssertThrow (dynamic_cast<const FE_RaviartThomas<dim>*> (&cell->get_fe ()) != 0,
+                      AssertThrow (dynamic_cast<const FE_RaviartThomas<dim>*> (&cell->get_fe ()) != nullptr,
                                    typename FEL::ExcInterpolationNotImplemented ());
                     }
 
@@ -5784,11 +5784,11 @@ namespace VectorTools
                   // element. If the FE is
                   // a FESystem we cannot
                   // check this.
-                  if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == 0)
+                  if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == nullptr)
                     {
                       typedef FiniteElement<dim> FEL;
 
-                      AssertThrow (dynamic_cast<const FE_RaviartThomas<dim>*> (&cell->get_fe ()) != 0,
+                      AssertThrow (dynamic_cast<const FE_RaviartThomas<dim>*> (&cell->get_fe ()) != nullptr,
                                    typename FEL::ExcInterpolationNotImplemented ());
                     }
 
@@ -5831,11 +5831,11 @@ namespace VectorTools
                   // element. If the FE is
                   // a FESystem we cannot
                   // check this.
-                  if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == 0)
+                  if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) == nullptr)
                     {
                       typedef FiniteElement<dim> FEL;
 
-                      AssertThrow (dynamic_cast<const FE_RaviartThomas<dim>*> (&cell->get_fe ()) != 0,
+                      AssertThrow (dynamic_cast<const FE_RaviartThomas<dim>*> (&cell->get_fe ()) != nullptr,
                                    typename FEL::ExcInterpolationNotImplemented ());
                     }
 
@@ -6650,7 +6650,7 @@ namespace VectorTools
             const std::vector<std::pair<types::global_dof_index, double> > *constrained
               = no_normal_flux_constraints.get_constraint_entries((*it)[constrained_index]);
             // find components to which this index is constrained to
-            Assert(constrained != 0, ExcInternalError());
+            Assert(constrained != nullptr, ExcInternalError());
             Assert(constrained->size() < dim, ExcInternalError());
             for (unsigned int c=0; c<constrained->size(); ++c)
               {
@@ -6801,7 +6801,7 @@ namespace VectorTools
       const dealii::FEValues<dim, spacedim> &fe_values  = data.x_fe_values.get_present_fe_values ();
       const unsigned int n_q_points = fe_values.n_quadrature_points;
 
-      if (weight!=0)
+      if (weight!=nullptr)
         {
           if (weight->n_components>1)
             weight->vector_value_list (fe_values.get_quadrature_points(),
@@ -7067,7 +7067,7 @@ namespace VectorTools
 
       const unsigned int        n_components = dof.get_fe().n_components();
 
-      if (weight!=0)
+      if (weight!=nullptr)
         {
           Assert ((weight->n_components==1) || (weight->n_components==n_components),
                   ExcDimensionMismatch(weight->n_components, n_components));
index aa6acad5dcef6538b0f49cf7c57ffbe2b8e96666..456962a9d01ca8af61b3cccf5224642cc2ae8283 100644 (file)
@@ -74,13 +74,13 @@ ExceptionBase::ExceptionBase ()
   function(""),
   cond(""),
   exc(""),
-  stacktrace (NULL),
+  stacktrace (nullptr),
   n_stacktrace_frames (0),
   what_str("")
 {
 #ifdef DEAL_II_HAVE_GLIBC_STACKTRACE
   for (unsigned int i=0; i<sizeof(raw_stacktrace)/sizeof(raw_stacktrace[0]); ++i)
-    raw_stacktrace[i] = NULL;
+    raw_stacktrace[i] = nullptr;
 #endif
 }
 
@@ -93,13 +93,13 @@ ExceptionBase::ExceptionBase (const ExceptionBase &exc)
   function(exc.function),
   cond(exc.cond),
   exc(exc.exc),
-  stacktrace (NULL), // don't copy stacktrace to avoid double de-allocation problem
+  stacktrace (nullptr), // don't copy stacktrace to avoid double de-allocation problem
   n_stacktrace_frames (0),
   what_str("") // don't copy the error message, it gets generated dynamically by what()
 {
 #ifdef DEAL_II_HAVE_GLIBC_STACKTRACE
   for (unsigned int i=0; i<sizeof(raw_stacktrace)/sizeof(raw_stacktrace[0]); ++i)
-    raw_stacktrace[i] = NULL;
+    raw_stacktrace[i] = nullptr;
 #endif
 }
 
@@ -108,7 +108,7 @@ ExceptionBase::ExceptionBase (const ExceptionBase &exc)
 ExceptionBase::~ExceptionBase () noexcept
 {
   free (stacktrace); // free(NULL) is allowed
-  stacktrace = NULL;
+  stacktrace = nullptr;
 }
 
 
@@ -186,7 +186,7 @@ void ExceptionBase::print_exc_data (std::ostream &out) const
   // between numerous "..."-enclosed strings that the preprocessor
   // collates into a single string, making it awkward to read. Consequently,
   // elide this text if the message was generated via an ExcMessage object
-  if (std::strstr(cond, "dealii::ExcMessage") != NULL)
+  if (std::strstr(cond, "dealii::ExcMessage") != nullptr)
     out << "The name and call sequence of the exception was:" << std::endl
         << "    " << exc  << std::endl;
 
@@ -250,7 +250,7 @@ void ExceptionBase::print_stack_trace (std::ostream &out) const
       // for unknown reasons :-) if we can, demangle the function name
 #ifdef DEAL_II_HAVE_LIBSTDCXX_DEMANGLER
       int         status;
-      char *p = abi::__cxa_demangle(functionname.c_str(), 0, 0, &status);
+      char *p = abi::__cxa_demangle(functionname.c_str(), nullptr, nullptr, &status);
 
       if ((status == 0) && (functionname != "main"))
         {
index 6c12007b1fdace0956752c187cb9cc78f55a3e4c..6f53c6cc7aa1b57c3ad2803b58dc4f95f3fff5e6 100644 (file)
@@ -213,7 +213,7 @@ namespace internal
     static Threads::Mutex rand_mutex;
     Threads::Mutex::ScopedLock lock(rand_mutex);
     static boost::random::uniform_real_distribution<> uniform_distribution(0,1);
-    static boost::random::mt19937 rng(static_cast<unsigned long>(std::time(0)));
+    static boost::random::mt19937 rng(static_cast<unsigned long>(std::time(nullptr)));
     return uniform_distribution(rng);
   }
 
index 7e74c4964f2bac23f9635461212fe80f5fe7e79d..8c348ad8f80ca4dcc9dec4e54eedf6bf0e51e425 100644 (file)
@@ -586,7 +586,7 @@ IndexSet::make_trilinos_map (const MPI_Comm &communicator,
                           ?
                           reinterpret_cast<TrilinosWrappers::types::int_type *>(&indices[0])
                           :
-                          0),
+                          nullptr),
                          0,
 #ifdef DEAL_II_WITH_MPI
                          Epetra_MpiComm(communicator)
index 87f8c7559f8413ba7238a2b8756e7173449a96c7..13df1dd755412893fe5698bb4d5928fd4def5ccc 100644 (file)
@@ -28,7 +28,7 @@ JobIdentifier dealjobid;
 
 JobIdentifier::JobIdentifier()
 {
-  time_t t = std::time(0);
+  time_t t = std::time(nullptr);
   id = std::string("JobId ");
 
 #if defined(DEAL_II_HAVE_UNISTD_H) && defined(DEAL_II_HAVE_GETHOSTNAME)
index 77543746b3cd11a8728c111429c1a0122ea5ff24..e96f48ce0905c1efcacff896f0aefde8b2026908 100644 (file)
@@ -48,7 +48,7 @@ LogStream deallog;
 LogStream::LogStream()
   :
   std_out(&std::cerr),
-  file(0),
+  file(nullptr),
   std_depth(0),
   file_depth(10000),
   print_utime(false),
@@ -58,7 +58,7 @@ LogStream::LogStream()
   float_threshold(0.),
   offset(0),
   print_thread_id(false),
-  old_cerr(0),
+  old_cerr(nullptr),
   at_newline(true)
 {
   get_prefixes().push("DEAL:");
@@ -235,21 +235,21 @@ LogStream::attach(std::ostream &o,
 void LogStream::detach ()
 {
   Threads::Mutex::ScopedLock lock(log_lock);
-  file = 0;
+  file = nullptr;
 }
 
 
 void LogStream::log_cerr ()
 {
   Threads::Mutex::ScopedLock lock(log_lock);
-  if (old_cerr == 0)
+  if (old_cerr == nullptr)
     {
       old_cerr = std::cerr.rdbuf(file->rdbuf());
     }
   else
     {
       std::cerr.rdbuf(old_cerr);
-      old_cerr = 0;
+      old_cerr = nullptr;
     }
 }
 
@@ -274,7 +274,7 @@ LogStream::get_file_stream()
 bool
 LogStream::has_file() const
 {
-  return (file != 0);
+  return (file != nullptr);
 }
 
 
index 0c2a6d7597a386506aafa3d9d6d473c29fb5243c..2291631db9ca05d5e736851d1601ef1adca6b590 100644 (file)
@@ -351,8 +351,8 @@ namespace Utilities
 
 #ifdef DEAL_II_WITH_P4EST
       //Initialize p4est and libsc components
-      sc_init(MPI_COMM_WORLD, 0, 0, NULL, SC_LP_SILENT);
-      p4est_init (0, SC_LP_SILENT);
+      sc_init(MPI_COMM_WORLD, 0, 0, nullptr, SC_LP_SILENT);
+      p4est_init (nullptr, SC_LP_SILENT);
 #endif
 
       constructor_has_already_run = true;
index 6e5d146c0f72fb51d7ba05eaad1c18806988267c..60026df181231e68c3bd41ad0ca38b68008d4986 100644 (file)
@@ -112,7 +112,7 @@ void MultithreadInfo::set_thread_limit(const unsigned int max_threads)
   // then also see if something was given in the environment
   {
     const char *penv = getenv ("DEAL_II_NUM_THREADS");
-    if (penv!=NULL)
+    if (penv!=nullptr)
       {
         unsigned int max_threads_env = numbers::invalid_unsigned_int;
         try
index e1c6bfd40e217f1829cf130df8000fac9e8a5ff5..a197206a23d1156ce3362a043545655b396ed9dd 100644 (file)
@@ -79,44 +79,44 @@ namespace Patterns
     PatternBase *p;
 
     p = Integer::create(description);
-    if (p != 0)
+    if (p != nullptr)
       return p;
 
     p = Double::create(description);
-    if (p !=0 )
+    if (p !=nullptr )
       return p;
 
     p = Selection::create(description);
-    if (p !=0 )
+    if (p !=nullptr )
       return p;
 
     p = List::create(description);
-    if (p !=0 )
+    if (p !=nullptr )
       return p;
 
     p = MultipleSelection::create(description);
-    if (p !=0 )
+    if (p !=nullptr )
       return p;
 
     p = Bool::create(description);
-    if (p!=0 )
+    if (p!=nullptr )
       return p;
 
     p = Anything::create(description);
-    if (p !=0 )
+    if (p !=nullptr )
       return p;
 
     p = FileName::create(description);
-    if (p !=0 )
+    if (p !=nullptr )
       return p;
 
     p = DirectoryName::create(description);
-    if (p!=0 )
+    if (p!=nullptr )
       return p;
 
     Assert(false, ExcNotImplemented());
 
-    return 0;
+    return nullptr;
   }
 
 
@@ -128,13 +128,13 @@ namespace Patterns
   std::size_t
   PatternBase::memory_consumption () const
   {
-    if (dynamic_cast<const Integer *>(this) != 0)
+    if (dynamic_cast<const Integer *>(this) != nullptr)
       return sizeof(Integer);
-    else if (dynamic_cast<const Double *>(this) != 0)
+    else if (dynamic_cast<const Double *>(this) != nullptr)
       return sizeof(Double);
-    else if (dynamic_cast<const Bool *>(this) != 0)
+    else if (dynamic_cast<const Bool *>(this) != nullptr)
       return sizeof(Bool);
-    else if (dynamic_cast<const Anything *>(this) != 0)
+    else if (dynamic_cast<const Anything *>(this) != nullptr)
       return sizeof(Anything);
     else
       return sizeof(*this) + 32;
@@ -276,7 +276,7 @@ namespace Patterns
           return new Integer();
       }
     else
-      return 0;
+      return nullptr;
   }
 
 
@@ -416,9 +416,9 @@ namespace Patterns
   {
     const std::string description_init_str = description_init;
     if (description.compare(0, description_init_str.size(), description_init_str) != 0)
-      return NULL;
+      return nullptr;
     if (*description.rbegin() != ']')
-      return NULL;
+      return nullptr;
 
     std::string temp = description.substr(description_init_str.size());
     if (temp == "]")
@@ -437,7 +437,7 @@ namespace Patterns
       {
         // parse lower bound and give up if not a double
         if (!(is >> lower_bound))
-          return NULL;
+          return nullptr;
       }
 
     // ignore failure here and assume we got MAX_DOUBLE as upper bound:
@@ -558,7 +558,7 @@ namespace Patterns
         return new Selection(sequence);
       }
     else
-      return 0;
+      return nullptr;
   }
 
 
@@ -590,7 +590,7 @@ namespace Patterns
   List::~List ()
   {
     delete pattern;
-    pattern = 0;
+    pattern = nullptr;
   }
 
 
@@ -733,7 +733,7 @@ namespace Patterns
         return new List(*base_pattern, min_elements, max_elements, separator);
       }
     else
-      return 0;
+      return nullptr;
   }
 
 
@@ -770,10 +770,10 @@ namespace Patterns
   Map::~Map ()
   {
     delete key_pattern;
-    key_pattern = 0;
+    key_pattern = nullptr;
 
     delete value_pattern;
-    value_pattern = 0;
+    value_pattern = nullptr;
   }
 
 
@@ -955,7 +955,7 @@ namespace Patterns
                        separator);
       }
     else
-      return 0;
+      return nullptr;
   }
 
 
@@ -1103,7 +1103,7 @@ namespace Patterns
         return new MultipleSelection(sequence);
       }
     else
-      return 0;
+      return nullptr;
   }
 
 
@@ -1159,7 +1159,7 @@ namespace Patterns
     if (description.compare(0, std::strlen(description_init), description_init) == 0)
       return new Bool();
     else
-      return 0;
+      return nullptr;
   }
 
 
@@ -1220,7 +1220,7 @@ namespace Patterns
     if (description.compare(0, std::strlen(description_init), description_init) == 0)
       return new Anything();
     else
-      return 0;
+      return nullptr;
   }
 
 
@@ -1304,7 +1304,7 @@ namespace Patterns
         return new FileName(type);
       }
     else
-      return 0;
+      return nullptr;
   }
 
 
@@ -1364,7 +1364,7 @@ namespace Patterns
     if (description.compare(0, std::strlen(description_init), description_init) == 0)
       return new DirectoryName();
     else
-      return 0;
+      return nullptr;
   }
 
 }   // end namespace Patterns
index ed006f1a5e60a508f4c13a55395676314b5663ee..5ad67128303787f6f0a2094a953a7dfc5bdca4cb 100644 (file)
@@ -135,7 +135,7 @@ PathSearch::find (const std::string &filename,
           deallog << "PathSearch[" << cls << "] trying "
                   << real_name << std::endl;
         FILE *fp = fopen(real_name.c_str(), open_mode);
-        if (fp != 0)
+        if (fp != nullptr)
           {
             if (debug > 0)
               deallog << "PathSearch[" << cls << "] opened "
@@ -154,7 +154,7 @@ PathSearch::find (const std::string &filename,
             deallog << "PathSearch[" << cls << "] trying "
                     << real_name << std::endl;
           FILE *fp = fopen(real_name.c_str(), open_mode);
-          if (fp != 0)
+          if (fp != nullptr)
             {
               if (debug > 0)
                 deallog << "PathSearch[" << cls << "] opened "
index 2ec390e1db63a8ecc3c935b282d64b1ba06c65f4..91285c50aab24da71cf8bbec859082e7ae2a7bc9 100644 (file)
@@ -371,7 +371,7 @@ namespace Polynomials
     // well if necessary. copy the polynomial to
     // do this
     std::shared_ptr<Polynomial<number> > q_data;
-    const Polynomial<number> *q = 0;
+    const Polynomial<number> *q = nullptr;
     if (p.in_lagrange_product_form == true)
       {
         q_data.reset (new Polynomial<number>(p));
@@ -415,7 +415,7 @@ namespace Polynomials
     // well if necessary. copy the polynomial to
     // do this
     std::shared_ptr<Polynomial<number> > q_data;
-    const Polynomial<number> *q = 0;
+    const Polynomial<number> *q = nullptr;
     if (p.in_lagrange_product_form == true)
       {
         q_data.reset (new Polynomial<number>(p));
@@ -451,7 +451,7 @@ namespace Polynomials
     // well if necessary. copy the polynomial to
     // do this
     std::shared_ptr<Polynomial<number> > q_data;
-    const Polynomial<number> *q = 0;
+    const Polynomial<number> *q = nullptr;
     if (p.in_lagrange_product_form == true)
       {
         q_data.reset (new Polynomial<number>(p));
@@ -598,7 +598,7 @@ namespace Polynomials
       return Monomial<number>(0, 0.);
 
     std::shared_ptr<Polynomial<number> > q_data;
-    const Polynomial<number> *q = 0;
+    const Polynomial<number> *q = nullptr;
     if (in_lagrange_product_form == true)
       {
         q_data.reset (new Polynomial<number>(*this));
@@ -624,7 +624,7 @@ namespace Polynomials
     // no simple form possible for Lagrange
     // polynomial on product form
     std::shared_ptr<Polynomial<number> > q_data;
-    const Polynomial<number> *q = 0;
+    const Polynomial<number> *q = nullptr;
     if (in_lagrange_product_form == true)
       {
         q_data.reset (new Polynomial<number>(*this));
@@ -753,7 +753,7 @@ namespace Polynomials
     unsigned int n_functions=n+1;
     Assert(support_point<n_functions,
            ExcIndexRange(support_point, 0, n_functions));
-    double const *x=0;
+    double const *x=nullptr;
 
     switch (n)
       {
@@ -794,7 +794,7 @@ namespace Polynomials
         Assert(false, ExcInternalError())
       }
 
-    Assert(x!=0, ExcInternalError());
+    Assert(x!=nullptr, ExcInternalError());
     for (unsigned int i=0; i<n_functions; ++i)
       a[i]=x[support_point*n_functions+i];
   }
@@ -1005,7 +1005,7 @@ namespace Polynomials
     // already exist?
     if (  (recursive_coefficients.size() < k+1) ||
           ((recursive_coefficients.size() >= k+1) &&
-           (recursive_coefficients[k].get() == 0)) )
+           (recursive_coefficients[k].get() == nullptr)) )
       // no, then generate the
       // respective coefficients
       {
index e0ed16198e3bf0664cde0eef4f80f65713dcdbd8..e249163e80252547284b2f3685e2753cfc8c8d8c 100644 (file)
@@ -47,7 +47,7 @@ static const char *unknown_subscriber = "unknown subscriber";
 Subscriptor::Subscriptor ()
   :
   counter (0),
-  object_info (0)
+  object_info (nullptr)
 {
   // this has to go somewhere to avoid an extra warning.
   (void)unknown_subscriber;
@@ -58,7 +58,7 @@ Subscriptor::Subscriptor ()
 Subscriptor::Subscriptor (const Subscriptor &)
   :
   counter (0),
-  object_info (0)
+  object_info (nullptr)
 {}
 
 
@@ -165,7 +165,7 @@ void
 Subscriptor::subscribe(const char *id) const
 {
 #ifdef DEBUG
-  if (object_info == 0)
+  if (object_info == nullptr)
     object_info = &typeid(*this);
   Threads::Mutex::ScopedLock lock (subscription_lock);
   ++counter;
@@ -192,7 +192,7 @@ void
 Subscriptor::unsubscribe(const char *id) const
 {
 #ifdef DEBUG
-  const char *name = (id != 0) ? id : unknown_subscriber;
+  const char *name = (id != nullptr) ? id : unknown_subscriber;
   AssertNothrow (counter>0, ExcNoSubscriber(object_info->name(), name));
   // This is for the case that we do
   // not abort after the exception
index c2c0aad9ac7574e70dc3ff9defe2b0f60b9f87f4..f60db61786b6769535a4e3cff02f7e237ad26e4a 100644 (file)
@@ -167,7 +167,7 @@ namespace Threads
                                           const char *,
                                           void *)
   {
-    pthread_barrier_init (&barrier, 0, count);
+    pthread_barrier_init (&barrier, nullptr, count);
   }
 
 #else
index eab168a149f8e5abd14ded540a708cdc59e4cee2..6f877448d645d7e288ac002f8bc9d8e5d6a85904 100644 (file)
@@ -141,7 +141,7 @@ void Timer::start ()
 //TODO: Break this out into a function like the functions in
 //namespace windows above
   struct timeval wall_timer;
-  gettimeofday(&wall_timer, NULL);
+  gettimeofday(&wall_timer, nullptr);
   start_wall_time = wall_timer.tv_sec + 1.e-6 * wall_timer.tv_usec;
 
   rusage usage;
@@ -184,7 +184,7 @@ double Timer::stop ()
       cumulative_time += dtime_children - start_time_children;
 
       struct timeval wall_timer;
-      gettimeofday(&wall_timer, NULL);
+      gettimeofday(&wall_timer, nullptr);
       last_lap_time = wall_timer.tv_sec + 1.e-6 * wall_timer.tv_usec
                       - start_wall_time;
 #elif defined(DEAL_II_MSVC)
@@ -263,7 +263,7 @@ double Timer::wall_time () const
     {
 #if defined(DEAL_II_HAVE_SYS_TIME_H) && defined(DEAL_II_HAVE_SYS_RESOURCE_H)
       struct timeval wall_timer;
-      gettimeofday(&wall_timer, NULL);
+      gettimeofday(&wall_timer, nullptr);
       return (wall_timer.tv_sec
               + 1.e-6 * wall_timer.tv_usec
               - start_wall_time
index df61f53b8e8a57b9219f0570d1dfe4028c601907..301ec99aba32b272fdbda5aafe5dfa39efa5b56b 100644 (file)
@@ -659,7 +659,7 @@ namespace Utilities
 
     std::string get_time ()
     {
-      std::time_t  time1= std::time (0);
+      std::time_t  time1= std::time (nullptr);
       std::tm     *time = std::localtime(&time1);
 
       std::ostringstream o;
@@ -674,7 +674,7 @@ namespace Utilities
 
     std::string get_date ()
     {
-      std::time_t  time1= std::time (0);
+      std::time_t  time1= std::time (nullptr);
       std::tm     *time = std::localtime(&time1);
 
       std::ostringstream o;
@@ -693,7 +693,7 @@ namespace Utilities
       const int ierr = ::posix_memalign (memptr, alignment, size);
 
       AssertThrow (ierr == 0, ExcOutOfMemory());
-      AssertThrow (*memptr != 0, ExcOutOfMemory());
+      AssertThrow (*memptr != nullptr, ExcOutOfMemory());
 #else
       // Windows does not appear to have posix_memalign. just use the
       // regular malloc in that case
@@ -758,7 +758,7 @@ namespace Utilities
       // return a duplicate of it
       const Epetra_MpiComm
       *mpi_comm = dynamic_cast<const Epetra_MpiComm *>(&communicator);
-      if (mpi_comm != 0)
+      if (mpi_comm != nullptr)
         return new Epetra_MpiComm(Utilities::MPI::
                                   duplicate_communicator(mpi_comm->GetMpiComm()));
 #endif
@@ -768,7 +768,7 @@ namespace Utilities
       // not an MPI communicator, return a
       // copy of the same object again
       Assert (dynamic_cast<const Epetra_SerialComm *>(&communicator)
-              != 0,
+              != nullptr,
               ExcInternalError());
       return new Epetra_SerialComm(dynamic_cast<const Epetra_SerialComm &>(communicator));
     }
@@ -782,7 +782,7 @@ namespace Utilities
 #ifdef DEAL_II_WITH_MPI
       Epetra_MpiComm
       *mpi_comm = dynamic_cast<Epetra_MpiComm *>(&communicator);
-      if (mpi_comm != 0)
+      if (mpi_comm != nullptr)
         {
           MPI_Comm comm = mpi_comm->GetMpiComm();
           *mpi_comm = Epetra_MpiComm(MPI_COMM_SELF);
index 94518a90954532d3e276460bfd25ec4d7247b836..a0cef5fe5dcf98913b87ad44817d6d818dbd5501 100644 (file)
@@ -442,7 +442,7 @@ namespace internal
                                void *user_data)
     {
       p4est_iterate (parallel_forest, parallel_ghost, user_data,
-                     NULL,
+                     nullptr,
                      find_ghosts_face<2,spacedim>,
                      find_ghosts_corner<2,spacedim>);
     }
@@ -644,7 +644,7 @@ namespace internal
                                void *user_data)
     {
       p8est_iterate (parallel_forest, parallel_ghost, user_data,
-                     NULL,
+                     nullptr,
                      find_ghosts_face<3,spacedim>,
                      find_ghosts_edge<3,spacedim>,
                      find_ghosts_corner<3,spacedim>);
index 190c0204f2a8e267164fc2f11089e52ab6fa5f0f..bef870a3a03aee3f3955566276040141fc2d45c6 100644 (file)
@@ -272,7 +272,7 @@ namespace parallel
     Triangulation<dim, spacedim>::
     copy_triangulation (const dealii::Triangulation<dim, spacedim> &other_tria)
     {
-      Assert ((dynamic_cast<const dealii::parallel::distributed::Triangulation<dim,spacedim> *>(&other_tria) == NULL),
+      Assert ((dynamic_cast<const dealii::parallel::distributed::Triangulation<dim,spacedim> *>(&other_tria) == nullptr),
               ExcMessage("Cannot use this function on parallel::distributed::Triangulation."));
 
       dealii::parallel::Triangulation<dim,spacedim>::copy_triangulation (other_tria);
index 99b9628a0f24c4453cf79a335f1b7c82ed620c9b..d5a1acbbaf61ad124609147fddbaf21e7b5f4353 100644 (file)
@@ -50,7 +50,7 @@ namespace parallel
       offset (numbers::invalid_unsigned_int)
     {
       Assert (dynamic_cast<const parallel::distributed::Triangulation<dim>*>
-              (&dof_handler->get_triangulation()) != 0,
+              (&dof_handler->get_triangulation()) != nullptr,
               ExcMessage("parallel::distributed::SolutionTransfer requires a parallel::distributed::Triangulation object."));
     }
 
@@ -84,7 +84,7 @@ namespace parallel
         = (dynamic_cast<parallel::distributed::Triangulation<dim,DoFHandlerType::space_dimension>*>
            (const_cast<dealii::Triangulation<dim,DoFHandlerType::space_dimension>*>
             (&dof_handler->get_triangulation())));
-      Assert (tria != 0, ExcInternalError());
+      Assert (tria != nullptr, ExcInternalError());
 
       offset
         = tria->register_data_attach(size,
@@ -165,7 +165,7 @@ namespace parallel
         = (dynamic_cast<parallel::distributed::Triangulation<dim,DoFHandlerType::space_dimension>*>
            (const_cast<dealii::Triangulation<dim,DoFHandlerType::space_dimension>*>
             (&dof_handler->get_triangulation())));
-      Assert (tria != 0, ExcInternalError());
+      Assert (tria != nullptr, ExcInternalError());
 
       tria->notify_ready_to_unpack(offset,
                                    std::bind(&SolutionTransfer<dim, VectorType,
index ebb8cab5cb50ea6458605352c5c35a9538470773..b361173562ba785272aa0def18e50e3fa0a84c86 100644 (file)
@@ -1292,14 +1292,14 @@ namespace parallel
        false),
       settings(settings_),
       triangulation_has_content (false),
-      connectivity (0),
-      parallel_forest (0),
+      connectivity (nullptr),
+      parallel_forest (nullptr),
       refinement_in_progress (false),
       attached_data_size(0),
       n_attached_datas(0),
       n_attached_deserialize(0)
     {
-      parallel_ghost = 0;
+      parallel_ghost = nullptr;
     }
 
 
@@ -1311,8 +1311,8 @@ namespace parallel
 
       Assert (triangulation_has_content == false,
               ExcInternalError());
-      Assert (connectivity == 0,    ExcInternalError());
-      Assert (parallel_forest == 0, ExcInternalError());
+      Assert (connectivity == nullptr,    ExcInternalError());
+      Assert (parallel_forest == nullptr, ExcInternalError());
       Assert (refinement_in_progress == false, ExcInternalError());
     }
 
@@ -1677,22 +1677,22 @@ namespace parallel
     {
       triangulation_has_content = false;
 
-      if (parallel_ghost != 0)
+      if (parallel_ghost != nullptr)
         {
           dealii::internal::p4est::functions<dim>::ghost_destroy (parallel_ghost);
-          parallel_ghost = 0;
+          parallel_ghost = nullptr;
         }
 
-      if (parallel_forest != 0)
+      if (parallel_forest != nullptr)
         {
           dealii::internal::p4est::functions<dim>::destroy (parallel_forest);
-          parallel_forest = 0;
+          parallel_forest = nullptr;
         }
 
-      if (connectivity != 0)
+      if (connectivity != nullptr)
         {
           dealii::internal::p4est::functions<dim>::connectivity_destroy (connectivity);
-          connectivity = 0;
+          connectivity = nullptr;
         }
 
       coarse_cell_to_p4est_tree_permutation.resize (0);
@@ -1753,10 +1753,10 @@ namespace parallel
     void
     Triangulation<dim,spacedim>::write_mesh_vtk (const char *file_basename) const
     {
-      Assert (parallel_forest != 0,
+      Assert (parallel_forest != nullptr,
               ExcMessage ("Can't produce output when no forest is created yet."));
       dealii::internal::p4est::functions<dim>::
-      vtk_write_file (parallel_forest, 0, file_basename);
+      vtk_write_file (parallel_forest, nullptr, file_basename);
     }
 
 
@@ -1803,7 +1803,7 @@ namespace parallel
 
       // and release the data
       void *userptr = parallel_forest->user_pointer;
-      dealii::internal::p4est::functions<dim>::reset_data (parallel_forest, 0, NULL, NULL);
+      dealii::internal::p4est::functions<dim>::reset_data (parallel_forest, 0, nullptr, nullptr);
       parallel_forest->user_pointer = userptr;
     }
 
@@ -1818,15 +1818,15 @@ namespace parallel
       Assert(this->n_levels()==1, ExcMessage("Triangulation may only contain coarse cells when calling load()."));
 
 
-      if (parallel_ghost != 0)
+      if (parallel_ghost != nullptr)
         {
           dealii::internal::p4est::functions<dim>::ghost_destroy (parallel_ghost);
-          parallel_ghost = 0;
+          parallel_ghost = nullptr;
         }
       dealii::internal::p4est::functions<dim>::destroy (parallel_forest);
-      parallel_forest = 0;
+      parallel_forest = nullptr;
       dealii::internal::p4est::functions<dim>::connectivity_destroy (connectivity);
-      connectivity = 0;
+      connectivity = nullptr;
 
       unsigned int version, numcpus, attached_size, attached_count, n_coarse_cells;
       {
@@ -1897,7 +1897,7 @@ namespace parallel
     unsigned int
     Triangulation<dim,spacedim>::get_checksum () const
     {
-      Assert (parallel_forest != 0,
+      Assert (parallel_forest != nullptr,
               ExcMessage ("Can't produce a check sum when no forest is created yet."));
       return dealii::internal::p4est::functions<dim>::checksum (parallel_forest);
     }
@@ -2059,7 +2059,7 @@ namespace parallel
                       /* minimum level of upfront refinement */ 0,
                       /* use uniform upfront refinement */ 1,
                       /* user_data_size = */ 0,
-                      /* user_data_constructor = */ NULL,
+                      /* user_data_constructor = */ nullptr,
                       /* user_pointer */ this);
     }
 
@@ -2130,7 +2130,7 @@ namespace parallel
                       /* minimum level of upfront refinement */ 0,
                       /* use uniform upfront refinement */ 1,
                       /* user_data_size = */ 0,
-                      /* user_data_constructor = */ NULL,
+                      /* user_data_constructor = */ nullptr,
                       /* user_pointer */ this);
     }
 
@@ -2282,7 +2282,7 @@ namespace parallel
                       /* minimum level of upfront refinement */ 0,
                       /* use uniform upfront refinement */ 1,
                       /* user_data_size = */ 0,
-                      /* user_data_constructor = */ NULL,
+                      /* user_data_constructor = */ nullptr,
                       /* user_pointer */ this);
     }
 
@@ -2576,10 +2576,10 @@ namespace parallel
 
 
       // query p4est for the ghost cells
-      if (parallel_ghost != 0)
+      if (parallel_ghost != nullptr)
         {
           dealii::internal::p4est::functions<dim>::ghost_destroy (parallel_ghost);
-          parallel_ghost = 0;
+          parallel_ghost = nullptr;
         }
       parallel_ghost = dealii::internal::p4est::functions<dim>::ghost_new (parallel_forest,
                        (dim == 2
@@ -2897,19 +2897,19 @@ namespace parallel
               ExcInternalError());
       parallel_forest->user_pointer = &refine_and_coarsen_list;
 
-      if (parallel_ghost != 0)
+      if (parallel_ghost != nullptr)
         {
           dealii::internal::p4est::functions<dim>::ghost_destroy (parallel_ghost);
-          parallel_ghost = 0;
+          parallel_ghost = nullptr;
         }
       dealii::internal::p4est::functions<dim>::
       refine (parallel_forest, /* refine_recursive */ false,
               &RefineAndCoarsenList<dim,spacedim>::refine_callback,
-              /*init_callback=*/NULL);
+              /*init_callback=*/nullptr);
       dealii::internal::p4est::functions<dim>::
       coarsen (parallel_forest, /* coarsen_recursive */ false,
                &RefineAndCoarsenList<dim,spacedim>::coarsen_callback,
-               /*init_callback=*/NULL);
+               /*init_callback=*/nullptr);
 
       // make sure all cells in the lists have been consumed
       Assert (refine_and_coarsen_list.pointers_are_at_end(),
@@ -2929,7 +2929,7 @@ namespace parallel
                 :
                 typename dealii::internal::p4est::types<dim>::
                 balance_type(P8EST_CONNECT_FULL)),
-               /*init_callback=*/NULL);
+               /*init_callback=*/nullptr);
 
       // before repartitioning the mesh let others attach mesh related info
       // (such as SolutionTransfer data) to the p4est
@@ -2943,7 +2943,7 @@ namespace parallel
             dealii::internal::p4est::functions<dim>::
             partition (parallel_forest,
                        /* prepare coarsening */ 1,
-                       /* weight_callback */ NULL);
+                       /* weight_callback */ nullptr);
           else
             {
               // get cell weights for a weighted repartitioning.
@@ -3070,7 +3070,7 @@ namespace parallel
           dealii::internal::p4est::functions<dim>::
           partition (parallel_forest,
                      /* prepare coarsening */ 1,
-                     /* weight_callback */ NULL);
+                     /* weight_callback */ nullptr);
         }
       else
         {
@@ -3357,7 +3357,7 @@ namespace parallel
 
           // and release the data
           void *userptr = parallel_forest->user_pointer;
-          dealii::internal::p4est::functions<dim>::reset_data (parallel_forest, 0, NULL, NULL);
+          dealii::internal::p4est::functions<dim>::reset_data (parallel_forest, 0, nullptr, nullptr);
           parallel_forest->user_pointer = userptr;
         }
     }
@@ -3645,7 +3645,7 @@ namespace parallel
                       /* minimum level of upfront refinement */ 0,
                       /* use uniform upfront refinement */ 1,
                       /* user_data_size = */ 0,
-                      /* user_data_constructor = */ NULL,
+                      /* user_data_constructor = */ nullptr,
                       /* user_pointer */ this);
 
 
@@ -3782,7 +3782,7 @@ namespace parallel
       void *userptr = parallel_forest->user_pointer;
       dealii::internal::p4est::functions<dim>::reset_data (parallel_forest,
                                                            attached_data_size+sizeof(CellStatus),
-                                                           NULL, NULL);
+                                                           nullptr, nullptr);
       parallel_forest->user_pointer = userptr;
 
 
index 6cbbe599684a7135587a5eaf598f375e693fa09e..369208cc598193bee45fccc1c0b93ab4e53f1b07 100644 (file)
@@ -48,7 +48,7 @@ DoFCellAccessor<DoFHandlerType,lda>::update_cell_dof_indices_cache () const
   Assert (static_cast<unsigned int>(this->present_level) < this->dof_handler->levels.size(),
           ExcMessage ("DoFHandler not initialized"));
 
-  Assert (this->dof_handler != 0, typename BaseClass::ExcInvalidObject());
+  Assert (this->dof_handler != nullptr, typename BaseClass::ExcInvalidObject());
 
   internal::DoFCellAccessor::Implementation::
   update_cell_dof_indices_cache (*this);
@@ -63,7 +63,7 @@ DoFCellAccessor<DoFHandlerType,lda>::set_dof_indices (const std::vector<types::g
   Assert (static_cast<unsigned int>(this->present_level) < this->dof_handler->levels.size(),
           ExcMessage ("DoFHandler not initialized"));
 
-  Assert (this->dof_handler != 0, typename BaseClass::ExcInvalidObject());
+  Assert (this->dof_handler != nullptr, typename BaseClass::ExcInvalidObject());
 
   internal::DoFCellAccessor::Implementation::
   set_dof_indices (*this, local_dof_indices);
index e1d339e1ad63995f873f48b449b4668d06ba6a91..6015c62374e4235630f76fd1d85627c4efecb743 100644 (file)
@@ -53,7 +53,7 @@ get_interpolated_dof_values (const InputVector &values,
     {
       if ((dynamic_cast<DoFHandler<DoFHandlerType::dimension,DoFHandlerType::space_dimension>*>
            (this->dof_handler)
-           != 0)
+           != nullptr)
           ||
           // for hp-DoFHandlers, we need to require that on
           // active cells, you either don't specify an fe_index,
@@ -89,7 +89,7 @@ get_interpolated_dof_values (const InputVector &values,
       // fe_index is given
       Assert ((dynamic_cast<DoFHandler<DoFHandlerType::dimension,DoFHandlerType::space_dimension>*>
                (this->dof_handler)
-               != 0)
+               != nullptr)
               ||
               (fe_index != DoFHandlerType::default_fe_index),
               ExcMessage ("You cannot call this function on non-active cells "
@@ -102,7 +102,7 @@ get_interpolated_dof_values (const InputVector &values,
       const FiniteElement<dim,spacedim> &fe            = this->get_dof_handler().get_fe()[fe_index];
       const unsigned int                 dofs_per_cell = fe.dofs_per_cell;
 
-      Assert (this->dof_handler != 0,
+      Assert (this->dof_handler != nullptr,
               typename BaseClass::ExcInvalidObject());
       Assert (interpolated_values.size() == dofs_per_cell,
               typename BaseClass::ExcVectorDoesNotMatch());
index 9a5109af3aafc04ab7866dba4190d6cb581a22ae..33e885e5c56674fa20bd331edf1ed14d65a14d1b 100644 (file)
@@ -50,7 +50,7 @@ set_dof_values_by_interpolation (const Vector<number> &local_values,
     {
       if ((dynamic_cast<DoFHandler<DoFHandlerType::dimension,DoFHandlerType::space_dimension>*>
            (this->dof_handler)
-           != 0)
+           != nullptr)
           ||
           // for hp-DoFHandlers, we need to require that on
           // active cells, you either don't specify an fe_index,
@@ -86,7 +86,7 @@ set_dof_values_by_interpolation (const Vector<number> &local_values,
     {
       Assert ((dynamic_cast<DoFHandler<DoFHandlerType::dimension,DoFHandlerType::space_dimension>*>
                (this->dof_handler)
-               != 0)
+               != nullptr)
               ||
               (fe_index != DoFHandlerType::default_fe_index),
               ExcMessage ("You cannot call this function on non-active cells "
@@ -99,7 +99,7 @@ set_dof_values_by_interpolation (const Vector<number> &local_values,
       const FiniteElement<dim,spacedim> &fe            = this->get_dof_handler().get_fe()[fe_index];
       const unsigned int                 dofs_per_cell = fe.dofs_per_cell;
 
-      Assert (this->dof_handler != 0,
+      Assert (this->dof_handler != nullptr,
               typename BaseClass::ExcInvalidObject());
       Assert (local_values.size() == dofs_per_cell,
               typename BaseClass::ExcVectorDoesNotMatch());
index 2031a70fec1ebd1ec34466fe5d2a9ed2ba30d9d7..ae731e3ce2ba0add4d45c948f7684fb2a0688943 100644 (file)
@@ -654,20 +654,20 @@ template<int dim, int spacedim>
 DoFHandler<dim,spacedim>::DoFHandler (const Triangulation<dim,spacedim> &tria)
   :
   tria(&tria, typeid(*this).name()),
-  selected_fe(0, typeid(*this).name()),
-  faces(NULL),
-  mg_faces (NULL)
+  selected_fe(nullptr, typeid(*this).name()),
+  faces(nullptr),
+  mg_faces (nullptr)
 {
   // decide whether we need a
   // sequential or a parallel
   // distributed policy
   if (dynamic_cast<const parallel::shared::Triangulation< dim, spacedim>*>
       (&tria)
-      != 0)
+      != nullptr)
     policy.reset (new internal::DoFHandler::Policy::ParallelShared<dim,spacedim>());
   else if (dynamic_cast<const parallel::distributed::Triangulation< dim, spacedim >*>
            (&tria)
-           == 0)
+           == nullptr)
     policy.reset (new internal::DoFHandler::Policy::Sequential<dim,spacedim>());
   else
     policy.reset (new internal::DoFHandler::Policy::ParallelDistributed<dim,spacedim>());
@@ -677,10 +677,10 @@ DoFHandler<dim,spacedim>::DoFHandler (const Triangulation<dim,spacedim> &tria)
 template<int dim, int spacedim>
 DoFHandler<dim,spacedim>::DoFHandler ()
   :
-  tria(0, typeid(*this).name()),
-  selected_fe(0, typeid(*this).name()),
-  faces(NULL),
-  mg_faces (NULL)
+  tria(nullptr, typeid(*this).name()),
+  selected_fe(nullptr, typeid(*this).name()),
+  faces(nullptr),
+  mg_faces (nullptr)
 {}
 
 
@@ -699,7 +699,7 @@ DoFHandler<dim,spacedim>::initialize(
   const FiniteElement<dim,spacedim> &fe)
 {
   tria = &t;
-  faces = 0;
+  faces = nullptr;
   number_cache.n_global_dofs = 0;
 
   // decide whether we need a
@@ -707,11 +707,11 @@ DoFHandler<dim,spacedim>::initialize(
   // distributed policy
   if (dynamic_cast<const parallel::shared::Triangulation< dim, spacedim>*>
       (&t)
-      != 0)
+      != nullptr)
     policy.reset (new internal::DoFHandler::Policy::ParallelShared<dim,spacedim>());
   else if (dynamic_cast<const parallel::distributed::Triangulation< dim, spacedim >*>
            (&t)
-           == 0)
+           == nullptr)
     policy.reset (new internal::DoFHandler::Policy::Sequential<dim,spacedim>());
   else
     policy.reset (new internal::DoFHandler::Policy::ParallelDistributed<dim,spacedim>());
@@ -1064,7 +1064,7 @@ DoFHandler<dim,spacedim>::memory_consumption () const
   for (unsigned int level = 0; level < mg_levels.size (); ++level)
     mem += mg_levels[level]->memory_consumption ();
 
-  if (mg_faces != 0)
+  if (mg_faces != nullptr)
     mem += MemoryConsumption::memory_consumption (*mg_faces);
 
   for (unsigned int i = 0; i < mg_vertex_dofs.size (); ++i)
@@ -1106,7 +1106,7 @@ void DoFHandler<dim,spacedim>::distribute_dofs (const FiniteElement<dim,spacedim
   // only if this is a sequential
   // triangulation. it doesn't work
   // correctly yet if it is parallel
-  if (dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&*tria) == 0)
+  if (dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&*tria) == nullptr)
     block_info_object.initialize(*this, false, true);
 }
 
@@ -1140,7 +1140,7 @@ void DoFHandler<dim, spacedim>::distribute_mg_dofs (const FiniteElement<dim, spa
   // only if this is a sequential
   // triangulation. it doesn't work
   // correctly yet if it is parallel
-  if (dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&*tria) == 0)
+  if (dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&*tria) == nullptr)
     block_info_object.initialize (*this, true, false);
 }
 
@@ -1158,7 +1158,7 @@ void DoFHandler<dim, spacedim>::clear_mg_space ()
 
   mg_levels.clear ();
   delete mg_faces;
-  mg_faces = NULL;
+  mg_faces = nullptr;
 
   std::vector<MGVertexDoFs> tmp;
 
@@ -1180,7 +1180,7 @@ template<int dim, int spacedim>
 void DoFHandler<dim,spacedim>::clear ()
 {
   // release lock to old fe
-  selected_fe = 0;
+  selected_fe = nullptr;
 
   // release memory
   clear_space ();
@@ -1482,7 +1482,7 @@ void DoFHandler<dim,spacedim>::clear_space ()
   levels.resize (0);
 
   delete faces;
-  faces = 0;
+  faces = nullptr;
 
   std::vector<types::global_dof_index> tmp;
   std::swap (vertex_dofs, tmp);
@@ -1514,7 +1514,7 @@ void DoFHandler<dim, spacedim>::set_dof_index (const unsigned int obj_level, con
 
 
 template<int dim, int spacedim>
-DoFHandler<dim, spacedim>::MGVertexDoFs::MGVertexDoFs (): coarsest_level (numbers::invalid_unsigned_int), finest_level (0), indices (0), indices_offset (0)
+DoFHandler<dim, spacedim>::MGVertexDoFs::MGVertexDoFs (): coarsest_level (numbers::invalid_unsigned_int), finest_level (0), indices (nullptr), indices_offset (nullptr)
 {
 }
 
@@ -1529,16 +1529,16 @@ DoFHandler<dim, spacedim>::MGVertexDoFs::~MGVertexDoFs ()
 template<int dim, int spacedim>
 void DoFHandler<dim, spacedim>::MGVertexDoFs::init (const unsigned int cl, const unsigned int fl, const unsigned int dofs_per_vertex)
 {
-  if (indices != 0)
+  if (indices != nullptr)
     {
       delete[] indices;
-      indices = 0;
+      indices = nullptr;
     }
 
-  if (indices_offset != 0)
+  if (indices_offset != nullptr)
     {
       delete[] indices_offset;
-      indices_offset = 0;
+      indices_offset = nullptr;
     }
 
   coarsest_level = cl;
@@ -1551,13 +1551,13 @@ void DoFHandler<dim, spacedim>::MGVertexDoFs::init (const unsigned int cl, const
   const unsigned int n_indices = n_levels * dofs_per_vertex;
 
   indices = new types::global_dof_index[n_indices];
-  Assert (indices != 0, ExcNoMemory ());
+  Assert (indices != nullptr, ExcNoMemory ());
 
   for (unsigned int i = 0; i < n_indices; ++i)
     indices[i] = DoFHandler<dim, spacedim>::invalid_dof_index;
 
   indices_offset = new types::global_dof_index[n_levels];
-  Assert (indices != 0, ExcNoMemory ());
+  Assert (indices != nullptr, ExcNoMemory ());
 
   for (unsigned int i = 0; i < n_levels; ++i)
     indices_offset[i] = i * dofs_per_vertex;
index c9ad02a385bbd1560c524040f3a03d1124e5f8ba..2070b4e5bb64e01ae60af6ea4371c26594b22e06 100644 (file)
@@ -1050,7 +1050,7 @@ namespace internal
         // and then turn artificial cells on at the end of this function.
         const parallel::shared::Triangulation<dim, spacedim> *tr =
           (dynamic_cast<const parallel::shared::Triangulation<dim, spacedim>*> (&dof_handler.get_triangulation()));
-        Assert(tr != 0, ExcInternalError());
+        Assert(tr != nullptr, ExcInternalError());
         typename parallel::shared::Triangulation<dim,spacedim>::active_cell_iterator
         cell = dof_handler.get_triangulation().begin_active(),
         endc = dof_handler.get_triangulation().end();
@@ -1116,7 +1116,7 @@ namespace internal
         // case artificial cells are present.
         const parallel::shared::Triangulation<dim, spacedim> *tr =
           (dynamic_cast<const parallel::shared::Triangulation<dim, spacedim>*> (&dof_handler.get_triangulation()));
-        Assert(tr != 0, ExcInternalError());
+        Assert(tr != nullptr, ExcInternalError());
         typename parallel::shared::Triangulation<dim,spacedim>::active_cell_iterator
         cell = dof_handler.get_triangulation().begin_active(),
         endc = dof_handler.get_triangulation().end();
@@ -1872,7 +1872,7 @@ namespace internal
           const parallel::distributed::Triangulation< dim, spacedim > *tr
             = (dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>
                (&dof_handler.get_triangulation()));
-          Assert (tr != 0, ExcInternalError());
+          Assert (tr != nullptr, ExcInternalError());
 
           // now collect cells and their
           // dof_indices for the
@@ -2096,7 +2096,7 @@ namespace internal
           = (dynamic_cast<parallel::distributed::Triangulation<dim,spacedim>*>
              (const_cast<dealii::Triangulation< dim, spacedim >*>
               (&dof_handler.get_triangulation())));
-        Assert (tr != 0, ExcInternalError());
+        Assert (tr != nullptr, ExcInternalError());
 
         const unsigned int
         n_cpus = Utilities::MPI::n_mpi_processes (tr->get_communicator());
@@ -2319,7 +2319,7 @@ namespace internal
           = (dynamic_cast<parallel::distributed::Triangulation<dim,spacedim>*>
              (const_cast<dealii::Triangulation< dim, spacedim >*>
               (&dof_handler.get_triangulation())));
-        Assert (tr != 0, ExcInternalError());
+        Assert (tr != nullptr, ExcInternalError());
 
         AssertThrow(
           (tr->settings &  parallel::distributed::Triangulation< dim, spacedim >::construct_multigrid_hierarchy),
@@ -2699,7 +2699,7 @@ namespace internal
             = (dynamic_cast<parallel::distributed::Triangulation<dim,spacedim>*>
                (const_cast<dealii::Triangulation< dim, spacedim >*>
                 (&dof_handler.get_triangulation())));
-          Assert (tr != 0, ExcInternalError());
+          Assert (tr != nullptr, ExcInternalError());
 
           std::vector<bool> user_flags;
           tr->save_user_flags(user_flags);
index 19314c16c14bcf35d18350d67f17be3ffb1fa8ab..4d7c9b9d01d2e5186554fa847b5795fb25d3e703 100644 (file)
@@ -559,7 +559,7 @@ namespace DoFTools
   {
     Assert ((dynamic_cast<const parallel::distributed::Triangulation<DoFHandlerType::dimension,DoFHandlerType::space_dimension>*>
              (&dof_handler.get_triangulation())
-             == 0),
+             == nullptr),
             ExcMessage ("This function can not be used with distributed triangulations."
                         "See the documentation for more information."));
 
@@ -1172,7 +1172,7 @@ namespace DoFTools
     // ask is for its locally owned subdomain
     Assert ((dynamic_cast<const parallel::distributed::
              Triangulation<DoFHandlerType::dimension,DoFHandlerType::space_dimension> *>
-             (&dof_handler.get_triangulation()) == 0),
+             (&dof_handler.get_triangulation()) == nullptr),
             ExcMessage ("For parallel::distributed::Triangulation objects and "
                         "associated DoF handler objects, asking for any information "
                         "related to a subdomain other than the locally owned one does "
@@ -1189,7 +1189,7 @@ namespace DoFTools
     // is non-empty (n_dofs()>0).
     const unsigned int n_subdomains
       = (dynamic_cast<const parallel::Triangulation<DoFHandlerType::dimension,DoFHandlerType::space_dimension> *>
-         (&dof_handler.get_triangulation()) == 0
+         (&dof_handler.get_triangulation()) == nullptr
          ?
          (1+*std::max_element (subdomain_association.begin (),
                                subdomain_association.end ()))
@@ -1249,7 +1249,7 @@ namespace DoFTools
     // ask is for its locally owned subdomain
     Assert ((dynamic_cast<const parallel::distributed::
              Triangulation<DoFHandlerType::dimension,DoFHandlerType::space_dimension> *>
-             (&dof_handler.get_triangulation()) == 0),
+             (&dof_handler.get_triangulation()) == nullptr),
             ExcMessage ("For parallel::distributed::Triangulation objects and "
                         "associated DoF handler objects, asking for any information "
                         "related to a subdomain other than the locally owned one does "
@@ -1313,7 +1313,7 @@ namespace DoFTools
     // ask is for its locally owned subdomain
     Assert ((dynamic_cast<const parallel::distributed::
              Triangulation<DoFHandlerType::dimension,DoFHandlerType::space_dimension> *>
-             (&dof_handler.get_triangulation()) == 0),
+             (&dof_handler.get_triangulation()) == nullptr),
             ExcMessage ("For parallel::distributed::Triangulation objects and "
                         "associated DoF handler objects, asking for any subdomain other "
                         "than the locally owned one does not make sense."));
@@ -1965,7 +1965,7 @@ namespace DoFTools
     Assert ((dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>
              (&dof_handler.get_triangulation())
              ==
-             0),
+             nullptr),
             ExcMessage ("This function can not be used with distributed triangulations."
                         "See the documentation for more information."));
 
@@ -1989,7 +1989,7 @@ namespace DoFTools
     Assert ((dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>
              (&dof_handler.get_triangulation())
              ==
-             0),
+             nullptr),
             ExcMessage ("This function can not be used with distributed triangulations."
                         "See the documentation for more information."));
 
index 2960525c8cca7bb6abb3940767e683790d6b3cc5..17268152667ee7c522e747d83bc1e54887032356 100644 (file)
@@ -1040,7 +1040,7 @@ namespace DoFTools
       get_fe_collection (const dealii::DoFHandler<dim,spacedim> &)
       {
         Assert(false, ExcInternalError());
-        return NULL;
+        return nullptr;
       }
     }
 
index 0ed9628156f2fbd8f3422a0947f99979009c8022..38012593ced00c06ced204f3e98016b20f44d9b0 100644 (file)
@@ -310,8 +310,8 @@ namespace DoFTools
         // there are only 2 boundary indicators in 1d, so it is no
         // performance problem to call the other function
         std::map<types::boundary_id, const Function<DoFHandlerType::space_dimension,double>*> boundary_ids;
-        boundary_ids[0] = 0;
-        boundary_ids[1] = 0;
+        boundary_ids[0] = nullptr;
+        boundary_ids[1] = nullptr;
         make_boundary_sparsity_pattern<DoFHandlerType, SparsityPatternType>
         (dof,
          boundary_ids,
index dd04142a5a3233fbfad8337c73b842a05e7a3e47..68cbe82bff94a5728f1f24c4ca01a71399253425 100644 (file)
@@ -181,7 +181,7 @@ get_subface_interpolation_matrix (const FiniteElement<dim,spacedim> &x_source_fe
           Assert (std::fabs(sum-1) < eps, ExcInternalError());
         }
     }
-  else if (dynamic_cast<const FE_Nothing<dim> *>(&x_source_fe) != 0)
+  else if (dynamic_cast<const FE_Nothing<dim> *>(&x_source_fe) != nullptr)
     {
       // nothing to do here, the FE_Nothing has no degrees of freedom anyway
     }
@@ -208,13 +208,13 @@ FE_Bernstein<dim,spacedim>::hp_vertex_dof_identities (const FiniteElement<dim,sp
   // or if the other one is an FE_Nothing. in the first case, there should be
   // exactly one single DoF of each FE at a vertex, and they should have
   // identical value
-  if (dynamic_cast<const FE_Bernstein<dim,spacedim>*>(&fe_other) != 0)
+  if (dynamic_cast<const FE_Bernstein<dim,spacedim>*>(&fe_other) != nullptr)
     {
       return
         std::vector<std::pair<unsigned int, unsigned int> >
         (1, std::make_pair (0U, 0U));
     }
-  else if (dynamic_cast<const FE_Nothing<dim>*>(&fe_other) != 0)
+  else if (dynamic_cast<const FE_Nothing<dim>*>(&fe_other) != nullptr)
     {
       // the FE_Nothing has no degrees of freedom, so there are no
       // equivalencies to be recorded
index f7ac1517f051af8aa59590b50e2639e3c74a669b..657e93511a110b549d8690bfba507776327a5033 100644 (file)
@@ -107,7 +107,7 @@ get_face_interpolation_matrix (const FiniteElement<dim,spacedim> &x_source_fe,
   typedef FE_DGP<dim,spacedim> FEDGP;
   AssertThrow ((x_source_fe.get_name().find ("FE_DGP<") == 0)
                ||
-               (dynamic_cast<const FEDGP *>(&x_source_fe) != 0),
+               (dynamic_cast<const FEDGP *>(&x_source_fe) != nullptr),
                typename FE::
                ExcInterpolationNotImplemented());
 
@@ -137,7 +137,7 @@ get_subface_interpolation_matrix (const FiniteElement<dim,spacedim> &x_source_fe
   typedef FE_DGP<dim,spacedim> FEDGP;
   AssertThrow ((x_source_fe.get_name().find ("FE_DGP<") == 0)
                ||
-               (dynamic_cast<const FEDGP *>(&x_source_fe) != 0),
+               (dynamic_cast<const FEDGP *>(&x_source_fe) != nullptr),
                typename FE::
                ExcInterpolationNotImplemented());
 
@@ -166,7 +166,7 @@ FE_DGP<dim,spacedim>::
 hp_vertex_dof_identities (const FiniteElement<dim,spacedim> &fe_other) const
 {
   // there are no such constraints for DGP elements at all
-  if (dynamic_cast<const FE_DGP<dim,spacedim>*>(&fe_other) != 0)
+  if (dynamic_cast<const FE_DGP<dim,spacedim>*>(&fe_other) != nullptr)
     return
       std::vector<std::pair<unsigned int, unsigned int> > ();
   else
@@ -184,7 +184,7 @@ FE_DGP<dim,spacedim>::
 hp_line_dof_identities (const FiniteElement<dim,spacedim> &fe_other) const
 {
   // there are no such constraints for DGP elements at all
-  if (dynamic_cast<const FE_DGP<dim,spacedim>*>(&fe_other) != 0)
+  if (dynamic_cast<const FE_DGP<dim,spacedim>*>(&fe_other) != nullptr)
     return
       std::vector<std::pair<unsigned int, unsigned int> > ();
   else
@@ -202,7 +202,7 @@ FE_DGP<dim,spacedim>::
 hp_quad_dof_identities (const FiniteElement<dim,spacedim>        &fe_other) const
 {
   // there are no such constraints for DGP elements at all
-  if (dynamic_cast<const FE_DGP<dim,spacedim>*>(&fe_other) != 0)
+  if (dynamic_cast<const FE_DGP<dim,spacedim>*>(&fe_other) != nullptr)
     return
       std::vector<std::pair<unsigned int, unsigned int> > ();
   else
@@ -220,7 +220,7 @@ FE_DGP<dim,spacedim>::compare_for_face_domination (const FiniteElement<dim,space
 {
   // check whether both are discontinuous elements, see the description of
   // FiniteElementDomination::Domination
-  if (dynamic_cast<const FE_DGP<dim,spacedim>*>(&fe_other) != 0)
+  if (dynamic_cast<const FE_DGP<dim,spacedim>*>(&fe_other) != nullptr)
     return FiniteElementDomination::no_requirements;
 
   Assert (false, ExcNotImplemented());
index ecf3b95ea6ef552d29e849606eef70b4b42f4eb7..2cbdf9d49d3541989d275b4d58a68590bd958717 100644 (file)
@@ -260,7 +260,7 @@ get_face_interpolation_matrix (const FiniteElement<dim> &x_source_fe,
   (void)interpolation_matrix;
   AssertThrow ((x_source_fe.get_name().find ("FE_DGPMonomial<") == 0)
                ||
-               (dynamic_cast<const FE_DGPMonomial<dim>*>(&x_source_fe) != 0),
+               (dynamic_cast<const FE_DGPMonomial<dim>*>(&x_source_fe) != nullptr),
                typename FiniteElement<dim>::
                ExcInterpolationNotImplemented());
 
@@ -290,7 +290,7 @@ get_subface_interpolation_matrix (const FiniteElement<dim> &x_source_fe,
   (void)interpolation_matrix;
   AssertThrow ((x_source_fe.get_name().find ("FE_DGPMonomial<") == 0)
                ||
-               (dynamic_cast<const FE_DGPMonomial<dim>*>(&x_source_fe) != 0),
+               (dynamic_cast<const FE_DGPMonomial<dim>*>(&x_source_fe) != nullptr),
                typename FiniteElement<dim>::
                ExcInterpolationNotImplemented());
 
@@ -320,7 +320,7 @@ hp_vertex_dof_identities (const FiniteElement<dim> &fe_other) const
 {
   // there are no such constraints for DGPMonomial
   // elements at all
-  if (dynamic_cast<const FE_DGPMonomial<dim>*>(&fe_other) != 0)
+  if (dynamic_cast<const FE_DGPMonomial<dim>*>(&fe_other) != nullptr)
     return
       std::vector<std::pair<unsigned int, unsigned int> > ();
   else
@@ -339,7 +339,7 @@ hp_line_dof_identities (const FiniteElement<dim> &fe_other) const
 {
   // there are no such constraints for DGPMonomial
   // elements at all
-  if (dynamic_cast<const FE_DGPMonomial<dim>*>(&fe_other) != 0)
+  if (dynamic_cast<const FE_DGPMonomial<dim>*>(&fe_other) != nullptr)
     return
       std::vector<std::pair<unsigned int, unsigned int> > ();
   else
@@ -358,7 +358,7 @@ hp_quad_dof_identities (const FiniteElement<dim>        &fe_other) const
 {
   // there are no such constraints for DGPMonomial
   // elements at all
-  if (dynamic_cast<const FE_DGPMonomial<dim>*>(&fe_other) != 0)
+  if (dynamic_cast<const FE_DGPMonomial<dim>*>(&fe_other) != nullptr)
     return
       std::vector<std::pair<unsigned int, unsigned int> > ();
   else
@@ -379,7 +379,7 @@ compare_for_face_domination (const FiniteElement<dim> &fe_other) const
   // elements, see
   // the description of
   // FiniteElementDomination::Domination
-  if (dynamic_cast<const FE_DGPMonomial<dim>*>(&fe_other) != 0)
+  if (dynamic_cast<const FE_DGPMonomial<dim>*>(&fe_other) != nullptr)
     return FiniteElementDomination::no_requirements;
 
   Assert (false, ExcNotImplemented());
index 9bb2c12e2b42eea26b4649d9a4efc4e6c883c274..6caa4839cd2ba396084f31624125f457641cf8bf 100644 (file)
@@ -432,7 +432,7 @@ get_face_interpolation_matrix (const FiniteElement<dim,spacedim> &x_source_fe,
   typedef              FiniteElement<dim,spacedim> FEE;
   AssertThrow ((x_source_fe.get_name().find ("FE_DGPNonparametric<") == 0)
                ||
-               (dynamic_cast<const FE_DGPNonparametric<dim,spacedim>*>(&x_source_fe) != 0),
+               (dynamic_cast<const FE_DGPNonparametric<dim,spacedim>*>(&x_source_fe) != nullptr),
                typename FEE::
                ExcInterpolationNotImplemented());
 
@@ -463,7 +463,7 @@ get_subface_interpolation_matrix (const FiniteElement<dim,spacedim> &x_source_fe
   typedef              FiniteElement<dim,spacedim> FEE;
   AssertThrow ((x_source_fe.get_name().find ("FE_DGPNonparametric<") == 0)
                ||
-               (dynamic_cast<const FE_DGPNonparametric<dim,spacedim>*>(&x_source_fe) != 0),
+               (dynamic_cast<const FE_DGPNonparametric<dim,spacedim>*>(&x_source_fe) != nullptr),
                typename FEE::
                ExcInterpolationNotImplemented());
 
@@ -493,7 +493,7 @@ hp_vertex_dof_identities (const FiniteElement<dim,spacedim> &fe_other) const
 {
   // there are no such constraints for DGPNonparametric
   // elements at all
-  if (dynamic_cast<const FE_DGPNonparametric<dim,spacedim>*>(&fe_other) != 0)
+  if (dynamic_cast<const FE_DGPNonparametric<dim,spacedim>*>(&fe_other) != nullptr)
     return
       std::vector<std::pair<unsigned int, unsigned int> > ();
   else
@@ -512,7 +512,7 @@ hp_line_dof_identities (const FiniteElement<dim,spacedim> &fe_other) const
 {
   // there are no such constraints for DGPNonparametric
   // elements at all
-  if (dynamic_cast<const FE_DGPNonparametric<dim,spacedim>*>(&fe_other) != 0)
+  if (dynamic_cast<const FE_DGPNonparametric<dim,spacedim>*>(&fe_other) != nullptr)
     return
       std::vector<std::pair<unsigned int, unsigned int> > ();
   else
@@ -531,7 +531,7 @@ hp_quad_dof_identities (const FiniteElement<dim,spacedim>        &fe_other) cons
 {
   // there are no such constraints for DGPNonparametric
   // elements at all
-  if (dynamic_cast<const FE_DGPNonparametric<dim,spacedim>*>(&fe_other) != 0)
+  if (dynamic_cast<const FE_DGPNonparametric<dim,spacedim>*>(&fe_other) != nullptr)
     return
       std::vector<std::pair<unsigned int, unsigned int> > ();
   else
@@ -551,7 +551,7 @@ compare_for_face_domination (const FiniteElement<dim,spacedim> &fe_other) const
   // check whether both are discontinuous
   // elements, see the description of
   // FiniteElementDomination::Domination
-  if (dynamic_cast<const FE_DGPNonparametric<dim,spacedim>*>(&fe_other) != 0)
+  if (dynamic_cast<const FE_DGPNonparametric<dim,spacedim>*>(&fe_other) != nullptr)
     return FiniteElementDomination::no_requirements;
 
   Assert (false, ExcNotImplemented());
index bc9159982d4ec14d05eb400e0d5c30316ae7f896..495cc48a92629d5bf8d58cc1236b3afcc526d9cf 100644 (file)
@@ -239,7 +239,7 @@ get_interpolation_matrix (const FiniteElement<dim, spacedim> &x_source_fe,
   // source FE is also a
   // DGQ element
   typedef FiniteElement<dim, spacedim> FE;
-  AssertThrow ((dynamic_cast<const FE_DGQ<dim, spacedim>*>(&x_source_fe) != 0),
+  AssertThrow ((dynamic_cast<const FE_DGQ<dim, spacedim>*>(&x_source_fe) != nullptr),
                typename FE::ExcInterpolationNotImplemented() );
 
   // ok, source is a Q element, so
@@ -326,7 +326,7 @@ get_face_interpolation_matrix (const FiniteElement<dim, spacedim> &x_source_fe,
   // much we need to do here.
   (void)interpolation_matrix;
   typedef FiniteElement<dim,spacedim> FE;
-  AssertThrow ((dynamic_cast<const FE_DGQ<dim, spacedim>*>(&x_source_fe) != 0),
+  AssertThrow ((dynamic_cast<const FE_DGQ<dim, spacedim>*>(&x_source_fe) != nullptr),
                typename FE::ExcInterpolationNotImplemented());
 
   Assert (interpolation_matrix.m() == 0,
@@ -354,7 +354,7 @@ get_subface_interpolation_matrix (const FiniteElement<dim, spacedim> &x_source_f
   // much we need to do here.
   (void)interpolation_matrix;
   typedef FiniteElement<dim, spacedim> FE;
-  AssertThrow ((dynamic_cast<const FE_DGQ<dim, spacedim>*>(&x_source_fe) != 0),
+  AssertThrow ((dynamic_cast<const FE_DGQ<dim, spacedim>*>(&x_source_fe) != nullptr),
                typename FE::ExcInterpolationNotImplemented());
 
   Assert (interpolation_matrix.m() == 0,
index 1fa511a26c2b49fe86b479113e32351c84b990f4..2fea36bcab2c58c1857b945e4770ab7ff1270fe4 100644 (file)
@@ -104,7 +104,7 @@ namespace
   {
     // start from fe=1 as 0th is always non-enriched FE.
     for (unsigned int fe=1; fe < fes.size(); fe++)
-      if (dynamic_cast<const FE_Nothing<dim>*>(fes[fe]) == 0)
+      if (dynamic_cast<const FE_Nothing<dim>*>(fes[fe]) == nullptr)
         // this is not FE_Nothing => there will be enrichment
         return true;
 
@@ -118,7 +118,7 @@ FE_Enriched<dim,spacedim>::FE_Enriched (const FiniteElement<dim,spacedim> &fe_ba
   :
   FE_Enriched<dim,spacedim>(fe_base,
                             FE_Nothing<dim,spacedim>(fe_base.n_components(),true),
-                            NULL)
+                            nullptr)
 {
 }
 
@@ -285,7 +285,7 @@ FE_Enriched<dim,spacedim>::setup_data (std::unique_ptr<typename FiniteElement<di
                                        const UpdateFlags      flags,
                                        const Quadrature<dim_1> &quadrature) const
 {
-  Assert ((dynamic_cast<typename FESystem<dim,spacedim>::InternalData *> (fes_data.get()) != NULL),
+  Assert ((dynamic_cast<typename FESystem<dim,spacedim>::InternalData *> (fes_data.get()) != nullptr),
           ExcInternalError());
   typename FESystem<dim,spacedim>::InternalData *data_fesystem =
     static_cast<typename FESystem<dim,spacedim>::InternalData *> (fes_data.get());
@@ -461,7 +461,7 @@ FE_Enriched<dim,spacedim>::fill_fe_values (const typename Triangulation< dim, sp
                                            internal::FEValues::FiniteElementRelatedData< dim, spacedim > &output_data
                                           ) const
 {
-  Assert (dynamic_cast<const InternalData *> (&fe_internal) != NULL,
+  Assert (dynamic_cast<const InternalData *> (&fe_internal) != nullptr,
           ExcInternalError());
   const InternalData &fe_data = static_cast<const InternalData &> (fe_internal);
 
@@ -497,7 +497,7 @@ FE_Enriched<dim,spacedim>::fill_fe_face_values
  internal::FEValues::FiniteElementRelatedData< dim, spacedim > &output_data
 ) const
 {
-  Assert (dynamic_cast<const InternalData *> (&fe_internal) != NULL,
+  Assert (dynamic_cast<const InternalData *> (&fe_internal) != nullptr,
           ExcInternalError());
   const InternalData &fe_data = static_cast<const InternalData &> (fe_internal);
 
@@ -534,7 +534,7 @@ FE_Enriched<dim,spacedim>::fill_fe_subface_values
  internal::FEValues::FiniteElementRelatedData< dim, spacedim > &output_data
 ) const
 {
-  Assert (dynamic_cast<const InternalData *> (&fe_internal) != NULL,
+  Assert (dynamic_cast<const InternalData *> (&fe_internal) != nullptr,
           ExcInternalError());
   const InternalData &fe_data = static_cast<const InternalData &> (fe_internal);
 
@@ -656,7 +656,7 @@ FE_Enriched<dim,spacedim>::multiply_by_enrichment
                                    fe_data.enrichment[base_no].size()));
       for (unsigned int m=0; m < base_no_mult_local_enriched_dofs[base_no].size(); m++)
         {
-          Assert (enrichments[base_no-1][m](cell) !=NULL,
+          Assert (enrichments[base_no-1][m](cell) !=nullptr,
                   ExcMessage("The pointer to the enrichment function is NULL"));
 
           Assert (enrichments[base_no-1][m](cell)->n_components == 1,
index b77a6ff8425931710a913a86aca8ccd2031050e2..8dde09d0c4311aacc503a91d79540db447119b32 100644 (file)
@@ -217,7 +217,7 @@ get_subface_interpolation_matrix (const FiniteElement<dim,spacedim> &x_source_fe
           Assert (std::fabs(sum-1) < eps, ExcInternalError());
         }
     }
-  else if (dynamic_cast<const FE_Nothing<dim> *>(&x_source_fe) != 0)
+  else if (dynamic_cast<const FE_Nothing<dim> *>(&x_source_fe) != nullptr)
     {
       // nothing to do here, the FE_Nothing has no degrees of freedom anyway
     }
@@ -727,7 +727,7 @@ get_subface_interpolation_matrix (const FiniteElement<dim,spacedim> &x_source_fe
             }
         }
     }
-  else if (dynamic_cast<const FE_Nothing<dim> *>(&x_source_fe) != 0)
+  else if (dynamic_cast<const FE_Nothing<dim> *>(&x_source_fe) != nullptr)
     {
       // nothing to do here, the FE_Nothing has no degrees of freedom anyway
     }
index e4aedd7233ebf685a6821b237af68436717b8892..27eed349893ad000b96f78aa252d1578008471c5 100644 (file)
@@ -2387,7 +2387,7 @@ const
       return identities;
     }
 
-  else if (dynamic_cast<const FE_Nothing<dim>*> (&fe_other) != 0)
+  else if (dynamic_cast<const FE_Nothing<dim>*> (&fe_other) != nullptr)
     {
       // the FE_Nothing has no
       // degrees of freedom, so there
@@ -2436,7 +2436,7 @@ const
       return identities;
     }
 
-  else if (dynamic_cast<const FE_Nothing<dim>*> (&fe_other) != 0)
+  else if (dynamic_cast<const FE_Nothing<dim>*> (&fe_other) != nullptr)
     {
       // the FE_Nothing has no
       // degrees of freedom, so there
@@ -2472,7 +2472,7 @@ const
   typedef FiniteElement<dim> FEL;
 
   AssertThrow ((source.get_name ().find ("FE_Nedelec<") == 0) ||
-               (dynamic_cast<const FEN *> (&source) != 0),
+               (dynamic_cast<const FEN *> (&source) != nullptr),
                typename FEL::ExcInterpolationNotImplemented());
   Assert (interpolation_matrix.m () == source.dofs_per_face,
           ExcDimensionMismatch (interpolation_matrix.m (),
@@ -2580,7 +2580,7 @@ FE_Nedelec<dim>::get_subface_interpolation_matrix(
   typedef FiniteElement<dim> FEL;
 
   AssertThrow ((source.get_name ().find ("FE_Nedelec<") == 0) ||
-               (dynamic_cast<const FEN *> (&source) != 0),
+               (dynamic_cast<const FEN *> (&source) != nullptr),
                typename FEL::ExcInterpolationNotImplemented ());
   Assert (interpolation_matrix.m () == source.dofs_per_face,
           ExcDimensionMismatch (interpolation_matrix.m (),
index 9a4fb881658f5de7974cb43eb7c7f5cc22c748d6..70953546071106a514e1e7ed5c45fd1049a28f47 100644 (file)
@@ -179,7 +179,7 @@ compare_for_face_domination (const FiniteElement<dim,spacedim> &fe) const
       return FiniteElementDomination::no_requirements;
     }
   // if it does and the other is FE_Nothing, either can dominate
-  else if (dynamic_cast<const FE_Nothing<dim>*>(&fe) != 0)
+  else if (dynamic_cast<const FE_Nothing<dim>*>(&fe) != nullptr)
     {
       return FiniteElementDomination::either_element_can_dominate;
     }
index 54dbb5b82d306c84f6dc508eb130efb8ed937bb6..296b2fe8e8c3d21083dcc54427620043d3043648 100644 (file)
@@ -44,7 +44,7 @@ fill_fe_values (const Triangulation<1,2>::cell_iterator &,
   // data for this class. fails with
   // an exception if that is not
   // possible
-  Assert (dynamic_cast<const InternalData *> (&fe_internal) != 0, ExcInternalError());
+  Assert (dynamic_cast<const InternalData *> (&fe_internal) != nullptr, ExcInternalError());
   const InternalData &fe_data = static_cast<const InternalData &> (fe_internal);
 
   // transform gradients and higher derivatives. there is nothing to do
@@ -103,7 +103,7 @@ fill_fe_values (const Triangulation<2,3>::cell_iterator &,
 
   // assert that the following dynamics
   // cast is really well-defined.
-  Assert (dynamic_cast<const InternalData *> (&fe_internal) != 0, ExcInternalError());
+  Assert (dynamic_cast<const InternalData *> (&fe_internal) != nullptr, ExcInternalError());
   const InternalData &fe_data = static_cast<const InternalData &> (fe_internal);
 
   // transform gradients and higher derivatives. there is nothing to do
@@ -163,7 +163,7 @@ fill_fe_values (const Triangulation<1,2>::cell_iterator &,
   // an exception if that is not
   // possible
 
-  Assert (dynamic_cast<const InternalData *> (&fe_internal) != 0, ExcInternalError());
+  Assert (dynamic_cast<const InternalData *> (&fe_internal) != nullptr, ExcInternalError());
   const InternalData &fe_data = static_cast<const InternalData &> (fe_internal);
 
   // transform gradients and higher derivatives. there is nothing to do
@@ -218,7 +218,7 @@ fill_fe_values (const Triangulation<2,3>::cell_iterator &,
                 const FiniteElement<2,3>::InternalDataBase                &fe_internal,
                 dealii::internal::FEValues::FiniteElementRelatedData<2,3> &output_data) const
 {
-  Assert (dynamic_cast<const InternalData *> (&fe_internal) != 0, ExcInternalError());
+  Assert (dynamic_cast<const InternalData *> (&fe_internal) != nullptr, ExcInternalError());
   const InternalData &fe_data = static_cast<const InternalData &> (fe_internal);
 
   // transform gradients and higher derivatives. there is nothing to do
index 7e3378a06a0dc359d82fcce57030d1ef5d45e319..4ff9e3295e07f6a7c610496ef23f02bdf7a68d25 100644 (file)
@@ -316,7 +316,7 @@ fill_fe_values
   // data for this class. fails with
   // an exception if that is not
   // possible
-  Assert (dynamic_cast<const InternalData *> (&fe_internal) != 0,
+  Assert (dynamic_cast<const InternalData *> (&fe_internal) != nullptr,
           ExcInternalError());
   const InternalData &fe_data = static_cast<const InternalData &> (fe_internal);
 
@@ -790,7 +790,7 @@ fill_fe_face_values
   // data for this class. fails with
   // an exception if that is not
   // possible
-  Assert (dynamic_cast<const InternalData *> (&fe_internal) != 0,
+  Assert (dynamic_cast<const InternalData *> (&fe_internal) != nullptr,
           ExcInternalError());
   const InternalData &fe_data = static_cast<const InternalData &> (fe_internal);
 
@@ -1265,7 +1265,7 @@ fill_fe_subface_values
   // data for this class. fails with
   // an exception if that is not
   // possible
-  Assert (dynamic_cast<const InternalData *> (&fe_internal) != 0,
+  Assert (dynamic_cast<const InternalData *> (&fe_internal) != nullptr,
           ExcInternalError());
   const InternalData &fe_data = static_cast<const InternalData &> (fe_internal);
 
index 097a6e5c232aadbee21fbb04572ccb9fea822383..260052b2860d2a4cfa0a80e6ca7072306d32bf65 100644 (file)
@@ -657,7 +657,7 @@ get_subface_interpolation_matrix (const FiniteElement<dim,spacedim> &x_source_fe
           Assert (std::fabs(sum-1) < eps, ExcInternalError());
         }
     }
-  else if (dynamic_cast<const FE_Nothing<dim> *>(&x_source_fe) != 0)
+  else if (dynamic_cast<const FE_Nothing<dim> *>(&x_source_fe) != nullptr)
     {
       // nothing to do here, the FE_Nothing has no degrees of freedom anyway
     }
@@ -687,13 +687,13 @@ hp_vertex_dof_identities (const FiniteElement<dim,spacedim> &fe_other) const
   // if the other one is an FE_Nothing. in the first case, there should be
   // exactly one single DoF of each FE at a vertex, and they should have
   // identical value
-  if (dynamic_cast<const FE_Q_Base<PolynomialType,dim,spacedim>*>(&fe_other) != 0)
+  if (dynamic_cast<const FE_Q_Base<PolynomialType,dim,spacedim>*>(&fe_other) != nullptr)
     {
       return
         std::vector<std::pair<unsigned int, unsigned int> >
         (1, std::make_pair (0U, 0U));
     }
-  else if (dynamic_cast<const FE_Nothing<dim>*>(&fe_other) != 0)
+  else if (dynamic_cast<const FE_Nothing<dim>*>(&fe_other) != nullptr)
     {
       // the FE_Nothing has no degrees of freedom, so there are no
       // equivalencies to be recorded
@@ -756,7 +756,7 @@ hp_line_dof_identities (const FiniteElement<dim,spacedim> &fe_other) const
 
       return identities;
     }
-  else if (dynamic_cast<const FE_Nothing<dim>*>(&fe_other) != 0)
+  else if (dynamic_cast<const FE_Nothing<dim>*>(&fe_other) != nullptr)
     {
       // the FE_Nothing has no degrees of freedom, so there are no
       // equivalencies to be recorded
@@ -823,7 +823,7 @@ hp_quad_dof_identities (const FiniteElement<dim,spacedim>        &fe_other) cons
 
       return identities;
     }
-  else if (dynamic_cast<const FE_Nothing<dim>*>(&fe_other) != 0)
+  else if (dynamic_cast<const FE_Nothing<dim>*>(&fe_other) != nullptr)
     {
       // the FE_Nothing has no degrees of freedom, so there are no
       // equivalencies to be recorded
@@ -878,9 +878,9 @@ compare_for_face_domination (const FiniteElement<dim,spacedim> &fe_other) const
           return FiniteElementDomination::no_requirements;
         }
     }
-  else if ((dynamic_cast<const FE_DGQ<dim,spacedim>*>(&fe_other) != 0)
+  else if ((dynamic_cast<const FE_DGQ<dim,spacedim>*>(&fe_other) != nullptr)
            ||
-           (dynamic_cast<const FE_DGP<dim,spacedim>*>(&fe_other) != 0))
+           (dynamic_cast<const FE_DGP<dim,spacedim>*>(&fe_other) != nullptr))
     {
       // there are no requirements between continuous and
       // discontinuous elements
index eccf22f2ff48dcba949f270cb66de983665b3a2d..117244270fd9ba187d894470bd56ad8ad10ec713 100644 (file)
@@ -77,7 +77,7 @@ namespace FE_Q_Bubbles_Helper
           Assert(false, ExcInternalError());
         }
 
-      Assert(q_fine.get() != NULL, ExcInternalError());
+      Assert(q_fine.get() != nullptr, ExcInternalError());
       const unsigned int nq = q_fine->size();
 
       // loop over all possible refinement cases
@@ -370,7 +370,7 @@ get_interpolation_matrix (const FiniteElement<dim,spacedim> &x_source_fe,
 
   AssertThrow ((x_source_fe.get_name().find ("FE_Q_Bubbles<") == 0)
                ||
-               (dynamic_cast<const FEQBUBBLES *>(&x_source_fe) != 0)
+               (dynamic_cast<const FEQBUBBLES *>(&x_source_fe) != nullptr)
                ,
                typename FEL::
                ExcInterpolationNotImplemented());
index 28669436128757e584e14a11327ff138d1a510c2..f8c61fe8ef799f8f81dec747b465b291ac486fe9 100644 (file)
@@ -288,7 +288,7 @@ get_interpolation_matrix (const FiniteElement<dim,spacedim> &x_source_fe,
 
   AssertThrow ((x_source_fe.get_name().find ("FE_Q_DG0<") == 0)
                ||
-               (dynamic_cast<const FEQDG0 *>(&x_source_fe) != 0),
+               (dynamic_cast<const FEQDG0 *>(&x_source_fe) != nullptr),
                typename FEL::
                ExcInterpolationNotImplemented());
 
index 0e4e9b90887d330a6c12fc811c95f3b55423ec6b..905a0cea263ff46f23d0d484bf28943945f423f9 100644 (file)
@@ -217,13 +217,13 @@ hp_vertex_dof_identities (const FiniteElement<dim> &fe_other) const
   // single DoF of each FE at a
   // vertex, and they should have
   // identical value
-  if (dynamic_cast<const FE_Q_Hierarchical<dim>*>(&fe_other) != 0)
+  if (dynamic_cast<const FE_Q_Hierarchical<dim>*>(&fe_other) != nullptr)
     {
       return
         std::vector<std::pair<unsigned int, unsigned int> >
         (1, std::make_pair (0U, 0U));
     }
-  else if (dynamic_cast<const FE_Nothing<dim>*>(&fe_other) != 0)
+  else if (dynamic_cast<const FE_Nothing<dim>*>(&fe_other) != nullptr)
     {
       // the FE_Nothing has no
       // degrees of freedom, so there
@@ -247,7 +247,7 @@ hp_line_dof_identities (const FiniteElement<dim> &fe_other) const
   // these identities if both FEs are
   // FE_Q_Hierarchicals or if the other
   // one is an FE_Nothing.
-  if (dynamic_cast<const FE_Q_Hierarchical<dim>*>(&fe_other) != 0)
+  if (dynamic_cast<const FE_Q_Hierarchical<dim>*>(&fe_other) != nullptr)
     {
       const unsigned int &this_dpl  = this->dofs_per_line;
       const unsigned int &other_dpl = fe_other.dofs_per_line;
@@ -262,7 +262,7 @@ hp_line_dof_identities (const FiniteElement<dim> &fe_other) const
 
       return res;
     }
-  else if (dynamic_cast<const FE_Nothing<dim>*>(&fe_other) != 0)
+  else if (dynamic_cast<const FE_Nothing<dim>*>(&fe_other) != nullptr)
     {
       // the FE_Nothing has no
       // degrees of freedom, so there
@@ -286,7 +286,7 @@ hp_quad_dof_identities (const FiniteElement<dim> &fe_other) const
   // these identities if both FEs are
   // FE_Q_Hierarchicals or if the other
   // one is an FE_Nothing.
-  if (dynamic_cast<const FE_Q_Hierarchical<dim>*>(&fe_other) != 0)
+  if (dynamic_cast<const FE_Q_Hierarchical<dim>*>(&fe_other) != nullptr)
     {
       const unsigned int &this_dpq  = this->dofs_per_quad;
       const unsigned int &other_dpq = fe_other.dofs_per_quad;
@@ -301,7 +301,7 @@ hp_quad_dof_identities (const FiniteElement<dim> &fe_other) const
 
       return res;
     }
-  else if (dynamic_cast<const FE_Nothing<dim>*>(&fe_other) != 0)
+  else if (dynamic_cast<const FE_Nothing<dim>*>(&fe_other) != nullptr)
     {
       // the FE_Nothing has no
       // degrees of freedom, so there
@@ -824,7 +824,7 @@ get_face_interpolation_matrix (const FiniteElement<dim> &x_source_fe,
   typedef FiniteElement<dim> FEL;
   AssertThrow ((x_source_fe.get_name().find ("FE_Q_Hierarchical<") == 0)
                ||
-               (dynamic_cast<const FEQHierarchical *>(&x_source_fe) != 0),
+               (dynamic_cast<const FEQHierarchical *>(&x_source_fe) != nullptr),
                typename FEL::
                ExcInterpolationNotImplemented());
 
@@ -912,7 +912,7 @@ get_subface_interpolation_matrix (const FiniteElement<dim> &x_source_fe,
   typedef FiniteElement<dim> FEL;
   AssertThrow ((x_source_fe.get_name().find ("FE_Q_Hierarchical<") == 0)
                ||
-               (dynamic_cast<const FEQHierarchical *>(&x_source_fe) != 0),
+               (dynamic_cast<const FEQHierarchical *>(&x_source_fe) != nullptr),
                typename FEL::
                ExcInterpolationNotImplemented());
 
index b5d7f269e8645aac57b30f64b482ac5bc5536a34..fea085808eed22a1d35a04ddcce4353b02c16a50 100644 (file)
@@ -349,7 +349,7 @@ FE_RaviartThomasNodal<dim>::hp_vertex_dof_identities (
   // FE_RaviartThomasNodals. in that case, no
   // dofs are assigned on the vertex, so we
   // shouldn't be getting here at all.
-  if (dynamic_cast<const FE_RaviartThomasNodal<dim>*>(&fe_other)!=0)
+  if (dynamic_cast<const FE_RaviartThomasNodal<dim>*>(&fe_other)!=nullptr)
     return std::vector<std::pair<unsigned int, unsigned int> > ();
   else
     {
@@ -512,7 +512,7 @@ FE_RaviartThomasNodal<dim>::get_face_interpolation_matrix (
   // RaviartThomasNodal element
   AssertThrow ((x_source_fe.get_name().find ("FE_RaviartThomasNodal<") == 0)
                ||
-               (dynamic_cast<const FE_RaviartThomasNodal<dim>*>(&x_source_fe) != 0),
+               (dynamic_cast<const FE_RaviartThomasNodal<dim>*>(&x_source_fe) != nullptr),
                typename FiniteElement<dim>::
                ExcInterpolationNotImplemented());
 
@@ -619,7 +619,7 @@ FE_RaviartThomasNodal<dim>::get_subface_interpolation_matrix (
   // RaviartThomasNodal element
   AssertThrow ((x_source_fe.get_name().find ("FE_RaviartThomasNodal<") == 0)
                ||
-               (dynamic_cast<const FE_RaviartThomasNodal<dim>*>(&x_source_fe) != 0),
+               (dynamic_cast<const FE_RaviartThomasNodal<dim>*>(&x_source_fe) != nullptr),
                typename FiniteElement<dim>::
                ExcInterpolationNotImplemented());
 
index 2731f918991b9e2fd6ecdb34f3bcde1a2effffc4..adcc12048abf84ba0275a88081b06ffd7028fe60 100644 (file)
@@ -62,7 +62,7 @@ FESystem<dim,spacedim>::InternalData::~InternalData()
     if (base_fe_datas[i])
       {
         delete base_fe_datas[i];
-        base_fe_datas[i] = 0;
+        base_fe_datas[i] = nullptr;
       }
 }
 
@@ -596,7 +596,7 @@ FESystem<dim,spacedim>::get_interpolation_matrix (
   typedef FiniteElement<dim,spacedim> FEL;
   AssertThrow ((x_source_fe.get_name().find ("FESystem<") == 0)
                ||
-               (dynamic_cast<const FESystem<dim,spacedim>*>(&x_source_fe) != 0),
+               (dynamic_cast<const FESystem<dim,spacedim>*>(&x_source_fe) != nullptr),
                typename FEL::
                ExcInterpolationNotImplemented());
 
@@ -1108,7 +1108,7 @@ compute_fill (const Mapping<dim,spacedim>                      &mapping,
   // data for this class. fails with
   // an exception if that is not
   // possible
-  Assert (dynamic_cast<const InternalData *> (&fe_internal) != 0, ExcInternalError());
+  Assert (dynamic_cast<const InternalData *> (&fe_internal) != nullptr, ExcInternalError());
   const InternalData &fe_data = static_cast<const InternalData &> (fe_internal);
 
   // Either dim_1==dim
@@ -1141,8 +1141,8 @@ compute_fill (const Mapping<dim,spacedim>                      &mapping,
 
         // fill_fe_face_values needs argument Quadrature<dim-1> for both cases
         // dim_1==dim-1 and dim_1=dim. Hence the following workaround
-        const Quadrature<dim>   *cell_quadrature = 0;
-        const Quadrature<dim-1> *face_quadrature = 0;
+        const Quadrature<dim>   *cell_quadrature = nullptr;
+        const Quadrature<dim-1> *face_quadrature = nullptr;
         const unsigned int n_q_points = quadrature.size();
 
         // static cast to the common base class of quadrature being either
@@ -1152,7 +1152,7 @@ compute_fill (const Mapping<dim,spacedim>                      &mapping,
         if (face_no==invalid_face_number)
           {
             Assert(dim_1==dim, ExcDimensionMismatch(dim_1,dim));
-            Assert (dynamic_cast<const Quadrature<dim> *>(quadrature_base_pointer) != 0,
+            Assert (dynamic_cast<const Quadrature<dim> *>(quadrature_base_pointer) != nullptr,
                     ExcInternalError());
 
             cell_quadrature
@@ -1161,7 +1161,7 @@ compute_fill (const Mapping<dim,spacedim>                      &mapping,
         else
           {
             Assert(dim_1==dim-1, ExcDimensionMismatch(dim_1,dim-1));
-            Assert (dynamic_cast<const Quadrature<dim-1> *>(quadrature_base_pointer) != 0,
+            Assert (dynamic_cast<const Quadrature<dim-1> *>(quadrature_base_pointer) != nullptr,
                     ExcInternalError());
 
             face_quadrature
@@ -1681,7 +1681,7 @@ get_face_interpolation_matrix (const FiniteElement<dim,spacedim> &x_source_fe,
   typedef FiniteElement<dim,spacedim> FEL;
   AssertThrow ((x_source_fe.get_name().find ("FE_System<") == 0)
                ||
-               (dynamic_cast<const FESystem<dim,spacedim>*>(&x_source_fe) != 0),
+               (dynamic_cast<const FESystem<dim,spacedim>*>(&x_source_fe) != nullptr),
                typename FEL::
                ExcInterpolationNotImplemented());
 
@@ -1792,7 +1792,7 @@ get_subface_interpolation_matrix (const FiniteElement<dim,spacedim> &x_source_fe
   typedef FiniteElement<dim,spacedim> FEL;
   AssertThrow ((x_source_fe.get_name().find ("FE_System<") == 0)
                ||
-               (dynamic_cast<const FESystem<dim,spacedim>*>(&x_source_fe) != 0),
+               (dynamic_cast<const FESystem<dim,spacedim>*>(&x_source_fe) != nullptr),
                typename FEL::
                ExcInterpolationNotImplemented());
 
index c9344e3fd37aea30ba6480ddef1edea587a785d7..5915432825ae0de3e22c67a891ddba0cf50066b1 100644 (file)
@@ -938,7 +938,7 @@ namespace FETools
   FEFactory<FE>::get (const Quadrature<1> &) const
   {
     Assert(false, ExcNotImplemented());
-    return 0;
+    return nullptr;
   }
 
   // Specializations for FE_Q.
@@ -2421,7 +2421,7 @@ namespace FETools
                 // everything went ok. so
                 // generate the composed
                 // element
-                FiniteElement<dim,spacedim> *system_element = 0;
+                FiniteElement<dim,spacedim> *system_element = nullptr;
 
                 // uses new FESystem constructor
                 // which is independent of
@@ -2560,7 +2560,7 @@ namespace FETools
         // make some compilers happy that
         // do not realize that we can't get
         // here after throwing
-        return 0;
+        return nullptr;
       }
 
 
@@ -2668,7 +2668,7 @@ namespace FETools
         AssertThrow(false, ExcInvalidFEName(parameter_name
                                             + std::string(" at ")
                                             + errline));
-        return 0;
+        return nullptr;
       }
   }
 
index 0456936f35e8f954a5efe1e7aee9f094d9140431..5c8d76ba01959a1ff2612191ea62b745cd3b3aea 100644 (file)
@@ -724,7 +724,7 @@ namespace FETools
         = (dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>
            (&dof2.get_tria()));
 
-      Assert (tr != 0, ExcInternalError());
+      Assert (tr != nullptr, ExcInternalError());
 
       typename DoFHandler<dim,spacedim>::cell_iterator
       cell=dof2.begin(0),
@@ -915,7 +915,7 @@ namespace FETools
         = (dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>
            (&dof2.get_tria()));
 
-      Assert (tr != 0, ExcInternalError());
+      Assert (tr != nullptr, ExcInternalError());
 
       // collect in a set all trees this
       // process has to compute cells on
@@ -1292,7 +1292,7 @@ namespace FETools
         = (dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>
            (&dof2.get_tria()));
 
-      Assert (tr != 0,
+      Assert (tr != nullptr,
               ExcMessage ("Extrapolate in parallel only works for parallel distributed triangulations!"));
 
       communicator = tr->get_communicator ();
@@ -1411,7 +1411,7 @@ namespace FETools
       {
         const parallel::distributed::Triangulation<dim,spacedim> *parallel_tria =
           dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&dh.get_tria());
-        Assert (parallel_tria !=0, ExcNotImplemented());
+        Assert (parallel_tria !=nullptr, ExcNotImplemented());
 
         const IndexSet locally_owned_dofs = dh.locally_owned_dofs();
         vector.reinit(locally_owned_dofs, parallel_tria->get_communicator());
@@ -1425,7 +1425,7 @@ namespace FETools
       {
         const parallel::distributed::Triangulation<dim,spacedim> *parallel_tria =
           dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&dh.get_tria());
-        Assert (parallel_tria !=0, ExcNotImplemented());
+        Assert (parallel_tria !=nullptr, ExcNotImplemented());
 
         const IndexSet locally_owned_dofs = dh.locally_owned_dofs();
         vector.reinit(locally_owned_dofs, parallel_tria->get_communicator());
@@ -1438,7 +1438,7 @@ namespace FETools
       {
         const parallel::distributed::Triangulation<dim,spacedim> *parallel_tria =
           dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&dh.get_tria());
-        Assert (parallel_tria !=0, ExcNotImplemented());
+        Assert (parallel_tria !=nullptr, ExcNotImplemented());
 
         const IndexSet locally_owned_dofs = dh.locally_owned_dofs();
         vector.reinit(locally_owned_dofs, parallel_tria->get_communicator());
@@ -1460,7 +1460,7 @@ namespace FETools
       {
         const parallel::distributed::Triangulation<dim,spacedim> *parallel_tria =
           dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&dh.get_tria());
-        Assert(parallel_tria !=0, ExcNotImplemented());
+        Assert(parallel_tria !=nullptr, ExcNotImplemented());
         const IndexSet  locally_owned_dofs = dh.locally_owned_dofs();
         IndexSet  locally_relevant_dofs;
         DoFTools::extract_locally_relevant_dofs (dh, locally_relevant_dofs);
@@ -1476,7 +1476,7 @@ namespace FETools
       {
         const parallel::distributed::Triangulation<dim,spacedim> *parallel_tria =
           dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&dh.get_tria());
-        Assert (parallel_tria !=0, ExcNotImplemented());
+        Assert (parallel_tria !=nullptr, ExcNotImplemented());
         const IndexSet  locally_owned_dofs = dh.locally_owned_dofs();
         IndexSet  locally_relevant_dofs;
         DoFTools::extract_locally_relevant_dofs (dh, locally_relevant_dofs);
@@ -1491,7 +1491,7 @@ namespace FETools
       {
         const parallel::distributed::Triangulation<dim,spacedim> *parallel_tria =
           dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&dh.get_tria());
-        Assert (parallel_tria !=0, ExcNotImplemented());
+        Assert (parallel_tria !=nullptr, ExcNotImplemented());
         const IndexSet  locally_owned_dofs = dh.locally_owned_dofs();
         IndexSet  locally_relevant_dofs;
         DoFTools::extract_locally_relevant_dofs (dh, locally_relevant_dofs);
@@ -1585,7 +1585,7 @@ namespace FETools
 
     OutVector u3;
     internal::reinit_distributed(dof2, u3);
-    if (dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&dof2.get_tria()) != 0)
+    if (dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&dof2.get_tria()) != nullptr)
       {
         interpolate(dof1, u1, dof2, constraints, u3);
 
index 7f5f1fd6dc82402e294e0eebaef1046405e85a36..8ea418fa520885774fc8fa404ebc98fdbfcd3500 100644 (file)
@@ -172,7 +172,7 @@ namespace FETools
           // matrix for this particular
           // pair of elements is already
           // there
-          if (interpolation_matrices[&cell1->get_fe()][&cell2->get_fe()].get() == 0)
+          if (interpolation_matrices[&cell1->get_fe()][&cell2->get_fe()].get() == nullptr)
             {
               std::shared_ptr<FullMatrix<double> >
               interpolation_matrix (new FullMatrix<double> (dofs_per_cell2,
@@ -305,7 +305,7 @@ namespace FETools
 
           // make sure back_interpolation
           // matrix is available
-          if (interpolation_matrices[&cell->get_fe()] == 0)
+          if (interpolation_matrices[&cell->get_fe()] == nullptr)
             {
               interpolation_matrices[&cell->get_fe()] =
                 std::shared_ptr<FullMatrix<double> >
index 070e83afc6e1a3c20b9bf0e977ac890b9108c989..16cbb037761b6cfa58cd14c71b8dde57fecd5bd2 100644 (file)
@@ -217,7 +217,7 @@ get_subface_interpolation_matrix (const FiniteElement<dim,spacedim> &x_source_fe
     {
       fe_q.get_subface_interpolation_matrix (source_fe->fe_q, subface, interpolation_matrix);
     }
-  else if (dynamic_cast<const FE_Nothing<dim> *>(&x_source_fe) != 0)
+  else if (dynamic_cast<const FE_Nothing<dim> *>(&x_source_fe) != nullptr)
     {
       // nothing to do here, the FE_Nothing has no degrees of freedom anyway
     }
index 6255057241b3f3cc778bc44539b969754b7e5145..af64a397cbab62a7e04261d32c9d2fe140828372 100644 (file)
@@ -138,7 +138,7 @@ namespace FEValuesViews
   template <int dim, int spacedim>
   Scalar<dim,spacedim>::Scalar ()
     :
-    fe_values (NULL),
+    fe_values (nullptr),
     component (numbers::invalid_unsigned_int)
   {}
 
@@ -232,7 +232,7 @@ namespace FEValuesViews
   template <int dim, int spacedim>
   Vector<dim,spacedim>::Vector ()
     :
-    fe_values (NULL),
+    fe_values (nullptr),
     first_vector_component (numbers::invalid_unsigned_int)
   {}
 
@@ -331,7 +331,7 @@ namespace FEValuesViews
   template <int dim, int spacedim>
   SymmetricTensor<2, dim, spacedim>::SymmetricTensor()
     :
-    fe_values(NULL),
+    fe_values(nullptr),
     first_tensor_component(numbers::invalid_unsigned_int)
   {}
 
@@ -430,7 +430,7 @@ namespace FEValuesViews
   template <int dim, int spacedim>
   Tensor<2, dim, spacedim>::Tensor()
     :
-    fe_values(NULL),
+    fe_values(nullptr),
     first_tensor_component(numbers::invalid_unsigned_int)
   {}
 
@@ -1271,7 +1271,7 @@ namespace FEValuesViews
   {
     Assert (fe_values->update_flags & update_values,
             (typename FEValuesBase<dim,spacedim>::ExcAccessToUninitializedField("update_values")));
-    Assert (fe_values->present_cell.get() != 0,
+    Assert (fe_values->present_cell.get() != nullptr,
             ExcMessage ("FEValues object is not reinit'ed to any cell"));
     AssertDimension (fe_function.size(),
                      fe_values->present_cell->n_dofs_for_dof_handler());
@@ -1294,7 +1294,7 @@ namespace FEValuesViews
   {
     Assert (fe_values->update_flags & update_gradients,
             (typename FEValuesBase<dim,spacedim>::ExcAccessToUninitializedField("update_gradients")));
-    Assert (fe_values->present_cell.get() != 0,
+    Assert (fe_values->present_cell.get() != nullptr,
             ExcMessage ("FEValues object is not reinit'ed to any cell"));
     AssertDimension (fe_function.size(),
                      fe_values->present_cell->n_dofs_for_dof_handler());
@@ -1317,7 +1317,7 @@ namespace FEValuesViews
   {
     Assert (fe_values->update_flags & update_hessians,
             (typename FEValuesBase<dim,spacedim>::ExcAccessToUninitializedField("update_hessians")));
-    Assert (fe_values->present_cell.get() != 0,
+    Assert (fe_values->present_cell.get() != nullptr,
             ExcMessage ("FEValues object is not reinit'ed to any cell"));
     AssertDimension (fe_function.size(),
                      fe_values->present_cell->n_dofs_for_dof_handler());
@@ -1340,7 +1340,7 @@ namespace FEValuesViews
   {
     Assert (fe_values->update_flags & update_hessians,
             (typename FEValuesBase<dim,spacedim>::ExcAccessToUninitializedField("update_hessians")));
-    Assert (fe_values->present_cell.get() != 0,
+    Assert (fe_values->present_cell.get() != nullptr,
             ExcMessage ("FEValues object is not reinit'ed to any cell"));
     AssertDimension (fe_function.size(),
                      fe_values->present_cell->n_dofs_for_dof_handler());
@@ -1363,7 +1363,7 @@ namespace FEValuesViews
   {
     Assert (fe_values->update_flags & update_3rd_derivatives,
             (typename FEValuesBase<dim,spacedim>::ExcAccessToUninitializedField("update_3rd_derivatives")));
-    Assert (fe_values->present_cell.get() != 0,
+    Assert (fe_values->present_cell.get() != nullptr,
             ExcMessage ("FEValues object is not reinit'ed to any cell"));
     AssertDimension (fe_function.size(),
                      fe_values->present_cell->n_dofs_for_dof_handler());
@@ -1386,7 +1386,7 @@ namespace FEValuesViews
   {
     Assert (fe_values->update_flags & update_values,
             (typename FEValuesBase<dim,spacedim>::ExcAccessToUninitializedField("update_values")));
-    Assert (fe_values->present_cell.get() != 0,
+    Assert (fe_values->present_cell.get() != nullptr,
             ExcMessage ("FEValues object is not reinit'ed to any cell"));
     AssertDimension (fe_function.size(),
                      fe_values->present_cell->n_dofs_for_dof_handler());
@@ -1410,7 +1410,7 @@ namespace FEValuesViews
   {
     Assert (fe_values->update_flags & update_gradients,
             (typename FEValuesBase<dim,spacedim>::ExcAccessToUninitializedField("update_gradients")));
-    Assert (fe_values->present_cell.get() != 0,
+    Assert (fe_values->present_cell.get() != nullptr,
             ExcMessage ("FEValues object is not reinit'ed to any cell"));
     AssertDimension (fe_function.size(),
                      fe_values->present_cell->n_dofs_for_dof_handler());
@@ -1433,7 +1433,7 @@ namespace FEValuesViews
   {
     Assert (fe_values->update_flags & update_gradients,
             (typename FEValuesBase<dim,spacedim>::ExcAccessToUninitializedField("update_gradients")));
-    Assert (fe_values->present_cell.get() != 0,
+    Assert (fe_values->present_cell.get() != nullptr,
             ExcMessage ("FEValues object is not reinit'ed to any cell"));
     AssertDimension (fe_function.size(),
                      fe_values->present_cell->n_dofs_for_dof_handler());
@@ -1457,7 +1457,7 @@ namespace FEValuesViews
   {
     Assert (fe_values->update_flags & update_gradients,
             (typename FEValuesBase<dim,spacedim>::ExcAccessToUninitializedField("update_gradients")));
-    Assert (fe_values->present_cell.get() != 0,
+    Assert (fe_values->present_cell.get() != nullptr,
             ExcMessage ("FEValues object is not reinit'ed to any cell"));
     AssertDimension (fe_function.size(),
                      fe_values->present_cell->n_dofs_for_dof_handler());
@@ -1479,7 +1479,7 @@ namespace FEValuesViews
   {
     Assert (fe_values->update_flags & update_gradients,
             (typename FEValuesBase<dim,spacedim>::ExcAccessToUninitializedField("update_gradients")));
-    Assert (fe_values->present_cell.get () != 0,
+    Assert (fe_values->present_cell.get () != nullptr,
             ExcMessage ("FEValues object is not reinited to any cell"));
     AssertDimension (fe_function.size (),
                      fe_values->present_cell->n_dofs_for_dof_handler ());
@@ -1501,7 +1501,7 @@ namespace FEValuesViews
   {
     Assert (fe_values->update_flags & update_hessians,
             (typename FEValuesBase<dim,spacedim>::ExcAccessToUninitializedField("update_hessians")));
-    Assert (fe_values->present_cell.get() != 0,
+    Assert (fe_values->present_cell.get() != nullptr,
             ExcMessage ("FEValues object is not reinit'ed to any cell"));
     AssertDimension (fe_function.size(),
                      fe_values->present_cell->n_dofs_for_dof_handler());
@@ -1526,7 +1526,7 @@ namespace FEValuesViews
             (typename FEValuesBase<dim,spacedim>::ExcAccessToUninitializedField("update_hessians")));
     Assert (laplacians.size() == fe_values->n_quadrature_points,
             ExcDimensionMismatch(laplacians.size(), fe_values->n_quadrature_points));
-    Assert (fe_values->present_cell.get() != 0,
+    Assert (fe_values->present_cell.get() != nullptr,
             ExcMessage ("FEValues object is not reinit'ed to any cell"));
     Assert (fe_function.size() == fe_values->present_cell->n_dofs_for_dof_handler(),
             ExcDimensionMismatch(fe_function.size(),
@@ -1549,7 +1549,7 @@ namespace FEValuesViews
   {
     Assert (fe_values->update_flags & update_3rd_derivatives,
             (typename FEValuesBase<dim,spacedim>::ExcAccessToUninitializedField("update_3rd_derivatives")));
-    Assert (fe_values->present_cell.get() != 0,
+    Assert (fe_values->present_cell.get() != nullptr,
             ExcMessage ("FEValues object is not reinit'ed to any cell"));
     AssertDimension (fe_function.size(),
                      fe_values->present_cell->n_dofs_for_dof_handler());
@@ -1572,7 +1572,7 @@ namespace FEValuesViews
   {
     Assert(fe_values->update_flags & update_values,
            (typename FEValuesBase<dim,spacedim>::ExcAccessToUninitializedField("update_values")));
-    Assert(fe_values->present_cell.get() != 0,
+    Assert(fe_values->present_cell.get() != nullptr,
            ExcMessage("FEValues object is not reinit'ed to any cell"));
     AssertDimension(fe_function.size(),
                     fe_values->present_cell->n_dofs_for_dof_handler());
@@ -1595,7 +1595,7 @@ namespace FEValuesViews
   {
     Assert(fe_values->update_flags & update_gradients,
            (typename FEValuesBase<dim,spacedim>::ExcAccessToUninitializedField("update_gradients")));
-    Assert(fe_values->present_cell.get() != 0,
+    Assert(fe_values->present_cell.get() != nullptr,
            ExcMessage("FEValues object is not reinit'ed to any cell"));
     AssertDimension(fe_function.size(),
                     fe_values->present_cell->n_dofs_for_dof_handler());
@@ -1617,7 +1617,7 @@ namespace FEValuesViews
   {
     Assert(fe_values->update_flags & update_values,
            (typename FEValuesBase<dim,spacedim>::ExcAccessToUninitializedField("update_values")));
-    Assert(fe_values->present_cell.get() != 0,
+    Assert(fe_values->present_cell.get() != nullptr,
            ExcMessage("FEValues object is not reinit'ed to any cell"));
     AssertDimension(fe_function.size(),
                     fe_values->present_cell->n_dofs_for_dof_handler());
@@ -1640,7 +1640,7 @@ namespace FEValuesViews
   {
     Assert(fe_values->update_flags & update_gradients,
            (typename FEValuesBase<dim,spacedim>::ExcAccessToUninitializedField("update_gradients")));
-    Assert(fe_values->present_cell.get() != 0,
+    Assert(fe_values->present_cell.get() != nullptr,
            ExcMessage("FEValues object is not reinit'ed to any cell"));
     AssertDimension(fe_function.size(),
                     fe_values->present_cell->n_dofs_for_dof_handler());
@@ -2694,7 +2694,7 @@ void FEValuesBase<dim,spacedim>::get_function_values (
   Assert (this->update_flags & update_values,
           ExcAccessToUninitializedField("update_values"));
   AssertDimension (fe->n_components(), 1);
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   AssertDimension (fe_function.size(),
                    present_cell->n_dofs_for_dof_handler());
@@ -2748,7 +2748,7 @@ void FEValuesBase<dim,spacedim>::get_function_values (
   std::vector<Vector<typename InputVector::value_type> > &values) const
 {
   typedef typename InputVector::value_type Number;
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
 
   Assert (this->update_flags & update_values,
@@ -2855,7 +2855,7 @@ FEValuesBase<dim,spacedim>::get_function_gradients (
   Assert (this->update_flags & update_gradients,
           ExcAccessToUninitializedField("update_gradients"));
   AssertDimension (fe->n_components(), 1);
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   AssertDimension (fe_function.size(), present_cell->n_dofs_for_dof_handler());
 
@@ -2911,7 +2911,7 @@ FEValuesBase<dim,spacedim>::get_function_gradients (
   typedef typename InputVector::value_type Number;
   Assert (this->update_flags & update_gradients,
           ExcAccessToUninitializedField("update_gradients"));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   AssertDimension (fe_function.size(), present_cell->n_dofs_for_dof_handler());
 
@@ -2977,7 +2977,7 @@ get_function_hessians (const InputVector                &fe_function,
   AssertDimension (fe->n_components(), 1);
   Assert (this->update_flags & update_hessians,
           ExcAccessToUninitializedField("update_hessians"));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   AssertDimension (fe_function.size(), present_cell->n_dofs_for_dof_handler());
 
@@ -3034,7 +3034,7 @@ get_function_hessians (const InputVector                         &fe_function,
   typedef typename InputVector::value_type Number;
   Assert (this->update_flags & update_hessians,
           ExcAccessToUninitializedField("update_hessians"));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   AssertDimension (fe_function.size(), present_cell->n_dofs_for_dof_handler());
 
@@ -3096,7 +3096,7 @@ void FEValuesBase<dim,spacedim>::get_function_laplacians (
   Assert (this->update_flags & update_hessians,
           ExcAccessToUninitializedField("update_hessians"));
   AssertDimension (fe->n_components(), 1);
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   AssertDimension (fe_function.size(), present_cell->n_dofs_for_dof_handler());
 
@@ -3148,7 +3148,7 @@ void FEValuesBase<dim,spacedim>::get_function_laplacians (
   std::vector<Vector<typename InputVector::value_type> > &laplacians) const
 {
   typedef typename InputVector::value_type Number;
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   Assert (this->update_flags & update_hessians,
           ExcAccessToUninitializedField("update_hessians"));
@@ -3250,7 +3250,7 @@ get_function_third_derivatives (const InputVector                &fe_function,
   AssertDimension (fe->n_components(), 1);
   Assert (this->update_flags & update_3rd_derivatives,
           ExcAccessToUninitializedField("update_3rd_derivatives"));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   AssertDimension (fe_function.size(), present_cell->n_dofs_for_dof_handler());
 
@@ -3307,7 +3307,7 @@ get_function_third_derivatives (const InputVector                         &fe_fu
   typedef typename InputVector::value_type Number;
   Assert (this->update_flags & update_3rd_derivatives,
           ExcAccessToUninitializedField("update_3rd_derivatives"));
-  Assert (present_cell.get() != 0,
+  Assert (present_cell.get() != nullptr,
           ExcMessage ("FEValues object is not reinit'ed to any cell"));
   AssertDimension (fe_function.size(), present_cell->n_dofs_for_dof_handler());
 
@@ -3454,7 +3454,7 @@ FEValuesBase< dim, spacedim >::invalidate_present_cell ()
 {
   // if there is no present cell, then we shouldn't be
   // connected via a signal to a triangulation
-  Assert (present_cell.get() != 0, ExcInternalError());
+  Assert (present_cell.get() != nullptr, ExcInternalError());
 
   // so delete the present cell and
   // disconnect from the signal we have with
@@ -3470,7 +3470,7 @@ void
 FEValuesBase< dim, spacedim >::
 maybe_invalidate_previous_present_cell (const typename Triangulation<dim,spacedim>::cell_iterator &cell)
 {
-  if (present_cell.get() != 0)
+  if (present_cell.get() != nullptr)
     {
       if (&cell->get_triangulation() !=
           &present_cell->operator typename Triangulation<dim,spacedim>::cell_iterator()
@@ -3537,7 +3537,7 @@ FEValuesBase<dim,spacedim>::check_cell_similarity
     }
 
   // case that there has not been any cell before
-  if (this->present_cell.get() == 0)
+  if (this->present_cell.get() == nullptr)
     cell_similarity = CellSimilarity::none;
   else
     // in MappingQ, data can have been modified during the last call. Then, we
index 0951bd7bbd549eaff080f9dc80a3733c2a62013f..09f7ade5c3ff5cece2a01f62f39b399f98e89909 100644 (file)
@@ -344,7 +344,7 @@ fill_fe_values (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
 {
   // convert data object to internal data for this class. fails with
   // an exception if that is not possible
-  Assert (dynamic_cast<const InternalData *> (&internal_data) != 0, ExcInternalError());
+  Assert (dynamic_cast<const InternalData *> (&internal_data) != nullptr, ExcInternalError());
   const InternalData &data = static_cast<const InternalData &> (internal_data);
 
   std::vector<Tensor<1,dim> > dummy;
@@ -440,7 +440,7 @@ fill_fe_face_values (const typename Triangulation<dim,spacedim>::cell_iterator &
   // data for this class. fails with
   // an exception if that is not
   // possible
-  Assert (dynamic_cast<const InternalData *> (&internal_data) != 0,
+  Assert (dynamic_cast<const InternalData *> (&internal_data) != nullptr,
           ExcInternalError());
   const InternalData &data = static_cast<const InternalData &> (internal_data);
 
@@ -528,7 +528,7 @@ fill_fe_subface_values (const typename Triangulation<dim,spacedim>::cell_iterato
 {
   // convert data object to internal data for this class. fails with
   // an exception if that is not possible
-  Assert (dynamic_cast<const InternalData *> (&internal_data) != 0, ExcInternalError());
+  Assert (dynamic_cast<const InternalData *> (&internal_data) != nullptr, ExcInternalError());
   const InternalData &data = static_cast<const InternalData &> (internal_data);
 
   compute_fill (cell, face_no, subface_no, CellSimilarity::none,
@@ -622,7 +622,7 @@ transform (const ArrayView<const Tensor<1,dim> >                  &input,
            const ArrayView<Tensor<1,spacedim> >                   &output) const
 {
   AssertDimension (input.size(), output.size());
-  Assert (dynamic_cast<const InternalData *>(&mapping_data) != 0,
+  Assert (dynamic_cast<const InternalData *>(&mapping_data) != nullptr,
           ExcInternalError());
   const InternalData &data = static_cast<const InternalData &> (mapping_data);
 
@@ -677,7 +677,7 @@ transform (const ArrayView<const DerivativeForm<1, dim,spacedim> > &input,
            const ArrayView<Tensor<2,spacedim> >                    &output) const
 {
   AssertDimension (input.size(), output.size());
-  Assert (dynamic_cast<const InternalData *>(&mapping_data) != 0,
+  Assert (dynamic_cast<const InternalData *>(&mapping_data) != nullptr,
           ExcInternalError());
   const InternalData &data = static_cast<const InternalData &>(mapping_data);
 
@@ -779,7 +779,7 @@ transform (const ArrayView<const Tensor<2, dim> >                 &input,
 {
 
   AssertDimension (input.size(), output.size());
-  Assert (dynamic_cast<const InternalData *>(&mapping_data) != 0,
+  Assert (dynamic_cast<const InternalData *>(&mapping_data) != nullptr,
           ExcInternalError());
   const InternalData &data = static_cast<const InternalData &>(mapping_data);
 
@@ -880,7 +880,7 @@ transform (const ArrayView<const  DerivativeForm<2, dim, spacedim> > &input,
 {
 
   AssertDimension (input.size(), output.size());
-  Assert (dynamic_cast<const InternalData *>(&mapping_data) != 0,
+  Assert (dynamic_cast<const InternalData *>(&mapping_data) != nullptr,
           ExcInternalError());
   const InternalData &data = static_cast<const InternalData &>(mapping_data);
 
@@ -918,7 +918,7 @@ transform (const ArrayView<const  Tensor<3,dim> >                 &input,
 {
 
   AssertDimension (input.size(), output.size());
-  Assert (dynamic_cast<const InternalData *>(&mapping_data) != 0,
+  Assert (dynamic_cast<const InternalData *>(&mapping_data) != nullptr,
           ExcInternalError());
   const InternalData &data = static_cast<const InternalData &>(mapping_data);
 
index 6c9ab388759f5bd1ed8b46119cddd66d3e760ceb..88432c17b7e02b1ebbbc3034e626934143ac8d47 100644 (file)
@@ -1305,7 +1305,7 @@ fill_fe_values (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
 {
   // convert data object to internal data for this class. fails with an
   // exception if that is not possible
-  Assert (dynamic_cast<const InternalData *> (&internal_data) != 0, ExcInternalError());
+  Assert (dynamic_cast<const InternalData *> (&internal_data) != nullptr, ExcInternalError());
   const InternalData &data = static_cast<const InternalData &> (internal_data);
 
   const unsigned int n_q_points=quadrature.size();
@@ -1485,7 +1485,7 @@ fill_fe_face_values (const typename Triangulation<dim,spacedim>::cell_iterator &
 {
   // convert data object to internal data for this class. fails with an
   // exception if that is not possible
-  Assert (dynamic_cast<const InternalData *> (&internal_data) != 0,
+  Assert (dynamic_cast<const InternalData *> (&internal_data) != nullptr,
           ExcInternalError());
   const InternalData &data = static_cast<const InternalData &> (internal_data);
 
@@ -1519,7 +1519,7 @@ fill_fe_subface_values (const typename Triangulation<dim,spacedim>::cell_iterato
 {
   // convert data object to internal data for this class. fails with an
   // exception if that is not possible
-  Assert (dynamic_cast<const InternalData *> (&internal_data) != 0,
+  Assert (dynamic_cast<const InternalData *> (&internal_data) != nullptr,
           ExcInternalError());
   const InternalData &data = static_cast<const InternalData &> (internal_data);
 
@@ -1552,7 +1552,7 @@ namespace
                    const ArrayView<Tensor<rank,spacedim> >                 &output)
   {
     AssertDimension (input.size(), output.size());
-    Assert ((dynamic_cast<const typename MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::InternalData *>(&mapping_data) != 0),
+    Assert ((dynamic_cast<const typename MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::InternalData *>(&mapping_data) != nullptr),
             ExcInternalError());
     const typename MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::InternalData
     &data = static_cast<const typename MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::InternalData &>(mapping_data);
@@ -1616,7 +1616,7 @@ namespace
   {
 
     AssertDimension (input.size(), output.size());
-    Assert ((dynamic_cast<const typename MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::InternalData *>(&mapping_data) != 0),
+    Assert ((dynamic_cast<const typename MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::InternalData *>(&mapping_data) != nullptr),
             ExcInternalError());
     const typename MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::InternalData
     &data = static_cast<const typename MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::InternalData &>(mapping_data);
@@ -1699,7 +1699,7 @@ transform (const ArrayView<const DerivativeForm<2, dim, spacedim> >  &input,
            const ArrayView<Tensor<3,spacedim> >                      &output) const
 {
   AssertDimension (input.size(), output.size());
-  Assert (dynamic_cast<const InternalData *>(&mapping_data) != 0,
+  Assert (dynamic_cast<const InternalData *>(&mapping_data) != nullptr,
           ExcInternalError());
   const InternalData &data = static_cast<const InternalData &>(mapping_data);
 
@@ -1978,7 +1978,7 @@ MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::update_internal_dofs
 (const typename Triangulation<dim,spacedim>::cell_iterator  &cell,
  const typename MappingFEField<dim, spacedim,VectorType,DoFHandlerType>::InternalData &data) const
 {
-  Assert(euler_dof_handler != 0, ExcMessage("euler_dof_handler is empty"));
+  Assert(euler_dof_handler != nullptr, ExcMessage("euler_dof_handler is empty"));
 
   typename DoFHandlerType::cell_iterator dof_cell(*cell, euler_dof_handler);
   Assert (dof_cell->active() == true, ExcInactiveCell());
index 436562070d88c533774365776a3a1fc58128caa7..39d0b99c49cf044f498bcf2dcceab43df3b3fd5a 100644 (file)
@@ -511,7 +511,7 @@ fill_fe_values (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
                 internal::FEValues::MappingRelatedData<dim,spacedim>      &output_data) const
 {
   // ensure that the following static_cast is really correct:
-  Assert (dynamic_cast<const InternalData *>(&internal_data) != 0,
+  Assert (dynamic_cast<const InternalData *>(&internal_data) != nullptr,
           ExcInternalError());
   const InternalData &data = static_cast<const InternalData &>(internal_data);
 
@@ -850,7 +850,7 @@ fill_fe_face_values (const typename Triangulation<dim,spacedim>::cell_iterator &
                      internal::FEValues::MappingRelatedData<dim,spacedim>      &output_data) const
 {
   // ensure that the following cast is really correct:
-  Assert ((dynamic_cast<const InternalData *>(&internal_data) != 0),
+  Assert ((dynamic_cast<const InternalData *>(&internal_data) != nullptr),
           ExcInternalError());
   const InternalData &data
     = static_cast<const InternalData &>(internal_data);
@@ -880,7 +880,7 @@ fill_fe_subface_values (const typename Triangulation<dim,spacedim>::cell_iterato
                         internal::FEValues::MappingRelatedData<dim,spacedim>      &output_data) const
 {
   // ensure that the following cast is really correct:
-  Assert ((dynamic_cast<const InternalData *>(&internal_data) != 0),
+  Assert ((dynamic_cast<const InternalData *>(&internal_data) != nullptr),
           ExcInternalError());
   const InternalData &data
     = static_cast<const InternalData &>(internal_data);
@@ -910,7 +910,7 @@ namespace
                    const ArrayView<Tensor<rank,spacedim> >                &output)
   {
     AssertDimension (input.size(), output.size());
-    Assert ((dynamic_cast<const typename MappingManifold<dim,spacedim>::InternalData *>(&mapping_data) != 0),
+    Assert ((dynamic_cast<const typename MappingManifold<dim,spacedim>::InternalData *>(&mapping_data) != nullptr),
             ExcInternalError());
     const typename MappingManifold<dim,spacedim>::InternalData
     &data = static_cast<const typename MappingManifold<dim,spacedim>::InternalData &>(mapping_data);
@@ -973,7 +973,7 @@ namespace
                       const ArrayView<Tensor<rank,spacedim> >                 &output)
   {
     AssertDimension (input.size(), output.size());
-    Assert ((dynamic_cast<const typename MappingManifold<dim,spacedim>::InternalData *>(&mapping_data) != 0),
+    Assert ((dynamic_cast<const typename MappingManifold<dim,spacedim>::InternalData *>(&mapping_data) != nullptr),
             ExcInternalError());
     const typename MappingManifold<dim,spacedim>::InternalData
     &data = static_cast<const typename MappingManifold<dim,spacedim>::InternalData &>(mapping_data);
@@ -1054,7 +1054,7 @@ namespace
                      const ArrayView<Tensor<3,spacedim> >                   &output)
   {
     AssertDimension (input.size(), output.size());
-    Assert ((dynamic_cast<const typename MappingManifold<dim,spacedim>::InternalData *>(&mapping_data) != 0),
+    Assert ((dynamic_cast<const typename MappingManifold<dim,spacedim>::InternalData *>(&mapping_data) != nullptr),
             ExcInternalError());
     const typename MappingManifold<dim,spacedim>::InternalData
     &data = static_cast<const typename MappingManifold<dim,spacedim>::InternalData &>(mapping_data);
@@ -1196,7 +1196,7 @@ namespace
                                const ArrayView<Tensor<rank+1, spacedim> >                   &output)
   {
     AssertDimension (input.size(), output.size());
-    Assert ((dynamic_cast<const typename MappingManifold<dim,spacedim>::InternalData *>(&mapping_data) != 0),
+    Assert ((dynamic_cast<const typename MappingManifold<dim,spacedim>::InternalData *>(&mapping_data) != nullptr),
             ExcInternalError());
     const typename MappingManifold<dim,spacedim>::InternalData
     &data = static_cast<const typename MappingManifold<dim,spacedim>::InternalData &>(mapping_data);
@@ -1283,7 +1283,7 @@ transform (const ArrayView<const  DerivativeForm<2, dim, spacedim> > &input,
 {
 
   AssertDimension (input.size(), output.size());
-  Assert (dynamic_cast<const InternalData *>(&mapping_data) != 0,
+  Assert (dynamic_cast<const InternalData *>(&mapping_data) != nullptr,
           ExcInternalError());
   const InternalData &data = static_cast<const InternalData &>(mapping_data);
 
index a567704aad0112b471849badbe39d8276e631e01..a3d0b17dead1bdfcf22bd17509f210cecb32c613 100644 (file)
@@ -216,7 +216,7 @@ fill_fe_values (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
 {
   // convert data object to internal data for this class. fails with an
   // exception if that is not possible
-  Assert (dynamic_cast<const InternalData *> (&internal_data) != 0, ExcInternalError());
+  Assert (dynamic_cast<const InternalData *> (&internal_data) != nullptr, ExcInternalError());
   const InternalData &data = static_cast<const InternalData &> (internal_data);
 
   // check whether this cell needs the full mapping or can be treated by a
@@ -271,7 +271,7 @@ fill_fe_face_values (const typename Triangulation<dim,spacedim>::cell_iterator &
 {
   // convert data object to internal data for this class. fails with an
   // exception if that is not possible
-  Assert (dynamic_cast<const InternalData *> (&internal_data) != 0,
+  Assert (dynamic_cast<const InternalData *> (&internal_data) != nullptr,
           ExcInternalError());
   const InternalData &data = static_cast<const InternalData &> (internal_data);
 
@@ -313,7 +313,7 @@ fill_fe_subface_values (const typename Triangulation<dim,spacedim>::cell_iterato
 {
   // convert data object to internal data for this class. fails with an
   // exception if that is not possible
-  Assert (dynamic_cast<const InternalData *> (&internal_data) != 0,
+  Assert (dynamic_cast<const InternalData *> (&internal_data) != nullptr,
           ExcInternalError());
   const InternalData &data = static_cast<const InternalData &> (internal_data);
 
@@ -356,7 +356,7 @@ transform (const ArrayView<const Tensor<1,dim> >                  &input,
 {
   AssertDimension (input.size(), output.size());
   Assert ((dynamic_cast<const typename MappingQ<dim,spacedim>::InternalData *> (&mapping_data)
-           != 0),
+           != nullptr),
           ExcInternalError());
   const InternalData *data = dynamic_cast<const InternalData *>(&mapping_data);
 
@@ -380,7 +380,7 @@ transform (const ArrayView<const DerivativeForm<1, dim ,spacedim> >  &input,
 {
   AssertDimension (input.size(), output.size());
   Assert ((dynamic_cast<const typename MappingQ<dim,spacedim>::InternalData *> (&mapping_data)
-           != 0),
+           != nullptr),
           ExcInternalError());
   const InternalData *data = dynamic_cast<const InternalData *>(&mapping_data);
 
@@ -404,7 +404,7 @@ transform (const ArrayView<const Tensor<2, dim> >                 &input,
 {
   AssertDimension (input.size(), output.size());
   Assert ((dynamic_cast<const typename MappingQ<dim,spacedim>::InternalData *> (&mapping_data)
-           != 0),
+           != nullptr),
           ExcInternalError());
   const InternalData *data = dynamic_cast<const InternalData *>(&mapping_data);
 
@@ -428,7 +428,7 @@ transform (const ArrayView<const DerivativeForm<2, dim ,spacedim> >  &input,
 {
   AssertDimension (input.size(), output.size());
   Assert ((dynamic_cast<const typename MappingQ<dim,spacedim>::InternalData *> (&mapping_data)
-           != 0),
+           != nullptr),
           ExcInternalError());
   const InternalData *data = dynamic_cast<const InternalData *>(&mapping_data);
 
@@ -451,7 +451,7 @@ transform (const ArrayView<const Tensor<3, dim> >                 &input,
 {
   AssertDimension (input.size(), output.size());
   Assert ((dynamic_cast<const typename MappingQ<dim,spacedim>::InternalData *> (&mapping_data)
-           != 0),
+           != nullptr),
           ExcInternalError());
   const InternalData *data = dynamic_cast<const InternalData *>(&mapping_data);
 
index 0b55214b5c50eeb01f07b264d2d5d89e53dad892..2eb5cf2f6da4e877d64c6ce0ebb2142afdeebec2 100644 (file)
@@ -1253,7 +1253,7 @@ MappingQGeneric<dim,spacedim>::MappingQGeneric (const unsigned int p)
   :
   polynomial_degree(p),
   line_support_points(this->polynomial_degree+1),
-  fe_q(dim == 3 ? new FE_Q<dim>(this->polynomial_degree) : 0),
+  fe_q(dim == 3 ? new FE_Q<dim>(this->polynomial_degree) : nullptr),
   support_point_weights_perimeter_to_interior (compute_support_point_weights_perimeter_to_interior(this->polynomial_degree, dim)),
   support_point_weights_cell (compute_support_point_weights_cell<dim>(this->polynomial_degree))
 {
@@ -1268,7 +1268,7 @@ MappingQGeneric<dim,spacedim>::MappingQGeneric (const MappingQGeneric<dim,spaced
   :
   polynomial_degree(mapping.polynomial_degree),
   line_support_points(mapping.line_support_points),
-  fe_q(dim == 3 ? new FE_Q<dim>(*mapping.fe_q) : 0),
+  fe_q(dim == 3 ? new FE_Q<dim>(*mapping.fe_q) : nullptr),
   support_point_weights_perimeter_to_interior (mapping.support_point_weights_perimeter_to_interior),
   support_point_weights_cell (mapping.support_point_weights_cell)
 {}
@@ -2618,7 +2618,7 @@ fill_fe_values (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
                 internal::FEValues::MappingRelatedData<dim,spacedim>      &output_data) const
 {
   // ensure that the following static_cast is really correct:
-  Assert (dynamic_cast<const InternalData *>(&internal_data) != 0,
+  Assert (dynamic_cast<const InternalData *>(&internal_data) != nullptr,
           ExcInternalError());
   const InternalData &data = static_cast<const InternalData &>(internal_data);
 
@@ -3026,7 +3026,7 @@ fill_fe_face_values (const typename Triangulation<dim,spacedim>::cell_iterator &
                      internal::FEValues::MappingRelatedData<dim,spacedim>      &output_data) const
 {
   // ensure that the following cast is really correct:
-  Assert ((dynamic_cast<const InternalData *>(&internal_data) != 0),
+  Assert ((dynamic_cast<const InternalData *>(&internal_data) != nullptr),
           ExcInternalError());
   const InternalData &data
     = static_cast<const InternalData &>(internal_data);
@@ -3071,7 +3071,7 @@ fill_fe_subface_values (const typename Triangulation<dim,spacedim>::cell_iterato
                         internal::FEValues::MappingRelatedData<dim,spacedim>      &output_data) const
 {
   // ensure that the following cast is really correct:
-  Assert ((dynamic_cast<const InternalData *>(&internal_data) != 0),
+  Assert ((dynamic_cast<const InternalData *>(&internal_data) != nullptr),
           ExcInternalError());
   const InternalData &data
     = static_cast<const InternalData &>(internal_data);
@@ -3116,7 +3116,7 @@ namespace
                    const ArrayView<Tensor<rank,spacedim> >                &output)
   {
     AssertDimension (input.size(), output.size());
-    Assert ((dynamic_cast<const typename MappingQGeneric<dim,spacedim>::InternalData *>(&mapping_data) != 0),
+    Assert ((dynamic_cast<const typename MappingQGeneric<dim,spacedim>::InternalData *>(&mapping_data) != nullptr),
             ExcInternalError());
     const typename MappingQGeneric<dim,spacedim>::InternalData
     &data = static_cast<const typename MappingQGeneric<dim,spacedim>::InternalData &>(mapping_data);
@@ -3179,7 +3179,7 @@ namespace
                       const ArrayView<Tensor<rank,spacedim> >                 &output)
   {
     AssertDimension (input.size(), output.size());
-    Assert ((dynamic_cast<const typename MappingQGeneric<dim,spacedim>::InternalData *>(&mapping_data) != 0),
+    Assert ((dynamic_cast<const typename MappingQGeneric<dim,spacedim>::InternalData *>(&mapping_data) != nullptr),
             ExcInternalError());
     const typename MappingQGeneric<dim,spacedim>::InternalData
     &data = static_cast<const typename MappingQGeneric<dim,spacedim>::InternalData &>(mapping_data);
@@ -3260,7 +3260,7 @@ namespace
                      const ArrayView<Tensor<3,spacedim> >                   &output)
   {
     AssertDimension (input.size(), output.size());
-    Assert ((dynamic_cast<const typename MappingQGeneric<dim,spacedim>::InternalData *>(&mapping_data) != 0),
+    Assert ((dynamic_cast<const typename MappingQGeneric<dim,spacedim>::InternalData *>(&mapping_data) != nullptr),
             ExcInternalError());
     const typename MappingQGeneric<dim,spacedim>::InternalData
     &data = static_cast<const typename MappingQGeneric<dim,spacedim>::InternalData &>(mapping_data);
@@ -3402,7 +3402,7 @@ namespace
                                const ArrayView<Tensor<rank+1, spacedim> >                   &output)
   {
     AssertDimension (input.size(), output.size());
-    Assert ((dynamic_cast<const typename MappingQGeneric<dim,spacedim>::InternalData *>(&mapping_data) != 0),
+    Assert ((dynamic_cast<const typename MappingQGeneric<dim,spacedim>::InternalData *>(&mapping_data) != nullptr),
             ExcInternalError());
     const typename MappingQGeneric<dim,spacedim>::InternalData
     &data = static_cast<const typename MappingQGeneric<dim,spacedim>::InternalData &>(mapping_data);
@@ -3489,7 +3489,7 @@ transform (const ArrayView<const  DerivativeForm<2, dim, spacedim> > &input,
 {
 
   AssertDimension (input.size(), output.size());
-  Assert (dynamic_cast<const InternalData *>(&mapping_data) != 0,
+  Assert (dynamic_cast<const InternalData *>(&mapping_data) != nullptr,
           ExcInternalError());
   const InternalData &data = static_cast<const InternalData &>(mapping_data);
 
@@ -3695,7 +3695,7 @@ add_quad_support_points(const Triangulation<3,3>::cell_iterator &cell,
       // the triangulation if no manifold is assigned).
       const Boundary<3,3> *boundary =
         dynamic_cast<const Boundary<3,3> *>(&face->get_manifold());
-      if (boundary != NULL &&
+      if (boundary != nullptr &&
           std::string(typeid(*boundary).name()).find("StraightBoundary") ==
           std::string::npos)
         {
index 7edb5fb1c06e2029b03d9edc758859c991a0ff4e..7989aa5e9792fa1140a0697683afde72f8595d2e 100644 (file)
@@ -3934,9 +3934,9 @@ namespace GridGenerator
     Assert (GridTools::have_same_coarse_mesh (triangulation_1, triangulation_2),
             ExcMessage ("The two input triangulations are not derived from "
                         "the same coarse mesh as required."));
-    Assert ((dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&triangulation_1) == 0)
+    Assert ((dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&triangulation_1) == nullptr)
             &&
-            (dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&triangulation_2) == 0),
+            (dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&triangulation_2) == nullptr),
             ExcMessage ("The source triangulations for this function must both "
                         "be available entirely locally, and not be distributed "
                         "triangulations."));
@@ -4380,7 +4380,7 @@ namespace GridGenerator
       dynamic_cast<const parallel::distributed::Triangulation<dim, spacedim1> *>(&in_tria);
 
     (void)pt;
-    Assert (pt == NULL,
+    Assert (pt == nullptr,
             ExcMessage("Cannot use this function on parallel::distributed::Triangulation."));
 
     std::vector<Point<spacedim2> > v;
@@ -4470,7 +4470,7 @@ namespace GridGenerator
   {
     Assert ((dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>
              (&volume_mesh.get_triangulation())
-             == 0),
+             == nullptr),
             ExcNotImplemented());
 
 // This function works using the following assumption:
index 09cfe62289eae70e8f0f6ba15b703d64cee9837e..fca781871ef4a3aa3f27aeebccd29798f27077d5 100644 (file)
@@ -82,7 +82,7 @@ namespace
 
 template <int dim, int spacedim>
 GridIn<dim, spacedim>::GridIn () :
-  tria(0, typeid(*this).name()), default_format(ucd)
+  tria(nullptr, typeid(*this).name()), default_format(ucd)
 {}
 
 
@@ -384,7 +384,7 @@ void GridIn<dim, spacedim>::read_vtk(std::istream &in)
 template<int dim, int spacedim>
 void GridIn<dim, spacedim>::read_unv(std::istream &in)
 {
-  Assert(tria != 0, ExcNoTriangulationSelected());
+  Assert(tria != nullptr, ExcNoTriangulationSelected());
   Assert((dim == 2)||(dim == 3), ExcNotImplemented());
 
   AssertThrow(in, ExcIO());
@@ -621,7 +621,7 @@ template <int dim, int spacedim>
 void GridIn<dim, spacedim>::read_ucd (std::istream                            &in,
                                       const bool apply_all_indicators_to_manifolds)
 {
-  Assert (tria != 0, ExcNoTriangulationSelected());
+  Assert (tria != nullptr, ExcNoTriangulationSelected());
   AssertThrow (in, ExcIO());
 
   // skip comments at start of file
@@ -855,7 +855,7 @@ template <int dim, int spacedim>
 void GridIn<dim, spacedim>::read_abaqus (std::istream                            &in,
                                          const bool apply_all_indicators_to_manifolds)
 {
-  Assert (tria != 0, ExcNoTriangulationSelected());
+  Assert (tria != nullptr, ExcNoTriangulationSelected());
   Assert (dim==2 || dim==3, ExcNotImplemented());
   AssertThrow (in, ExcIO());
 
@@ -899,7 +899,7 @@ void GridIn<dim, spacedim>::read_abaqus (std::istream
 template <int dim, int spacedim>
 void GridIn<dim, spacedim>::read_dbmesh (std::istream &in)
 {
-  Assert (tria != 0, ExcNoTriangulationSelected());
+  Assert (tria != nullptr, ExcNoTriangulationSelected());
   Assert (dim==2, ExcNotImplemented());
 
   AssertThrow (in, ExcIO());
@@ -1073,7 +1073,7 @@ void GridIn<dim, spacedim>::read_xda (std::istream &)
 template <>
 void GridIn<2>::read_xda (std::istream &in)
 {
-  Assert (tria != 0, ExcNoTriangulationSelected());
+  Assert (tria != nullptr, ExcNoTriangulationSelected());
   AssertThrow (in, ExcIO());
 
   std::string line;
@@ -1144,7 +1144,7 @@ void GridIn<2>::read_xda (std::istream &in)
 template <>
 void GridIn<3>::read_xda (std::istream &in)
 {
-  Assert (tria != 0, ExcNoTriangulationSelected());
+  Assert (tria != nullptr, ExcNoTriangulationSelected());
   AssertThrow (in, ExcIO());
 
   static const unsigned int xda_to_dealII_map[] = {0,1,5,4,3,2,6,7};
@@ -1223,7 +1223,7 @@ void GridIn<3>::read_xda (std::istream &in)
 template <int dim, int spacedim>
 void GridIn<dim, spacedim>::read_msh (std::istream &in)
 {
-  Assert (tria != 0, ExcNoTriangulationSelected());
+  Assert (tria != nullptr, ExcNoTriangulationSelected());
   AssertThrow (in, ExcIO());
 
   unsigned int n_vertices;
@@ -2304,7 +2304,7 @@ void GridIn<2>::read_tecplot (std::istream &in)
 {
   const unsigned int dim=2;
   const unsigned int spacedim=2;
-  Assert (tria != 0, ExcNoTriangulationSelected());
+  Assert (tria != nullptr, ExcNoTriangulationSelected());
   AssertThrow (in, ExcIO());
 
   // skip comments at start of file
index e533a2145a10021463a0ba161335495361ea6db4..40b9707ac70c88ab24d9ec5f404d29da1007cd33 100644 (file)
@@ -1110,7 +1110,7 @@ void GridOut::write_ucd (const Triangulation<dim,spacedim> &tria,
       // block this to have local
       // variables destroyed after
       // use
-      std::time_t  time1= std::time (0);
+      std::time_t  time1= std::time (nullptr);
       std::tm     *time = std::localtime(&time1);
       out << "# This file was generated by the deal.II library." << '\n'
           << "# Date =  "
@@ -2301,7 +2301,7 @@ void GridOut::write_mathgl (const Triangulation<dim, spacedim> &tria,
   if (true)
     {
       // block this to have local variables destroyed after use
-      const std::time_t  time1 = std::time (0);
+      const std::time_t  time1 = std::time (nullptr);
       const std::tm     *time  = std::localtime (&time1);
 
       out << "\n#"
@@ -3166,9 +3166,9 @@ namespace internal
       // quadrature formula which will be
       // used to probe boundary points at
       // curved faces
-      Quadrature<dim> *q_projector=0;
+      Quadrature<dim> *q_projector=nullptr;
       std::vector<Point<dim-1> > boundary_points;
-      if (mapping!=0)
+      if (mapping!=nullptr)
         {
           boundary_points.resize(n_points);
           boundary_points[0][0]=0;
@@ -3187,7 +3187,7 @@ namespace internal
           if (gnuplot_flags.write_cell_numbers)
             out << "# cell " << cell << '\n';
 
-          if (mapping==0 ||
+          if (mapping==nullptr ||
               (!cell->at_boundary() && !gnuplot_flags.curved_inner_cells))
             {
               // write out the four sides
@@ -3259,7 +3259,7 @@ namespace internal
             }
         }
 
-      if (q_projector != 0)
+      if (q_projector != nullptr)
         delete q_projector;
 
       // make sure everything now gets to
@@ -3295,9 +3295,9 @@ namespace internal
       // quadrature formula which will be
       // used to probe boundary points at
       // curved faces
-      Quadrature<dim> *q_projector=0;
+      Quadrature<dim> *q_projector=nullptr;
       std::vector<Point<1> > boundary_points;
-      if (mapping!=0)
+      if (mapping!=nullptr)
         {
           boundary_points.resize(n_points);
           boundary_points[0][0]=0;
@@ -3319,7 +3319,7 @@ namespace internal
           if (gnuplot_flags.write_cell_numbers)
             out << "# cell " << cell << '\n';
 
-          if (mapping==0 || n_points==2 ||
+          if (mapping==nullptr || n_points==2 ||
               (!cell->has_boundary_lines() && !gnuplot_flags.curved_inner_cells))
             {
               // front face
@@ -3470,7 +3470,7 @@ namespace internal
             }
         }
 
-      if (q_projector != 0)
+      if (q_projector != nullptr)
         delete q_projector;
 
 
@@ -3622,7 +3622,7 @@ namespace internal
                 // treat all other
                 // lines
                 if (!line->has_children() &&
-                    (mapping==0 || !line->at_boundary()))
+                    (mapping==nullptr || !line->at_boundary()))
                   // one would expect
                   // make_pair(line->vertex(0),
                   //           line->vertex(1))
@@ -3656,7 +3656,7 @@ namespace internal
           // to the list consisting of
           // pieces of the boundary
           // lines
-          if (mapping!=0)
+          if (mapping!=nullptr)
             {
               // to do so, first
               // generate a sequence of
@@ -3723,7 +3723,7 @@ namespace internal
         {
           // curved boundary output
           // presently not supported
-          Assert (mapping == 0, ExcNotImplemented());
+          Assert (mapping == nullptr, ExcNotImplemented());
 
           typename dealii::Triangulation<dim, spacedim>::active_cell_iterator
           cell=tria.begin_active(),
@@ -3839,7 +3839,7 @@ namespace internal
           // block this to have local
           // variables destroyed after
           // use
-          std::time_t  time1= std::time (0);
+          std::time_t  time1= std::time (nullptr);
           std::tm     *time = std::localtime(&time1);
           out << "%!PS-Adobe-2.0 EPSF-1.2" << '\n'
               << "%%Title: deal.II Output" << '\n'
index a24ff402e0327e2da23588cc13768ec4fbda0604..62785b5506e677926e8ca95c5c2203dc6b8b1b62 100644 (file)
@@ -123,7 +123,7 @@ namespace GridTools
   {
     // get the degree of the mapping if possible. if not, just assume 1
     const unsigned int mapping_degree
-      = (dynamic_cast<const MappingQ<dim,spacedim>*>(&mapping) != 0 ?
+      = (dynamic_cast<const MappingQ<dim,spacedim>*>(&mapping) != nullptr ?
          dynamic_cast<const MappingQ<dim,spacedim>*>(&mapping)->get_degree() :
          1);
 
@@ -2124,7 +2124,7 @@ next_cell:
   {
     Assert ((dynamic_cast<parallel::distributed::Triangulation<dim,spacedim>*>
              (&triangulation)
-             == 0),
+             == nullptr),
             ExcMessage ("Objects of type parallel::distributed::Triangulation "
                         "are already partitioned implicitly and can not be "
                         "partitioned again explicitly."));
@@ -2164,7 +2164,7 @@ next_cell:
   {
     Assert ((dynamic_cast<parallel::distributed::Triangulation<dim,spacedim>*>
              (&triangulation)
-             == 0),
+             == nullptr),
             ExcMessage ("Objects of type parallel::distributed::Triangulation "
                         "are already partitioned implicitly and can not be "
                         "partitioned again explicitly."));
@@ -2238,7 +2238,7 @@ next_cell:
   {
     Assert ((dynamic_cast<parallel::distributed::Triangulation<dim,spacedim>*>
              (&triangulation)
-             == 0),
+             == nullptr),
             ExcMessage ("Objects of type parallel::distributed::Triangulation "
                         "are already partitioned implicitly and can not be "
                         "partitioned again explicitly."));
@@ -2810,7 +2810,7 @@ next_cell:
               Iterator::AccessorType::space_dimension>
               *manifold = (respect_manifold ?
                            &object->get_boundary() :
-                           0);
+                           nullptr);
 
         const unsigned int structdim = Iterator::AccessorType::structure_dimension;
         const unsigned int spacedim  = Iterator::AccessorType::space_dimension;
index bd86dfd62b98e8a70dcf63c09f84a0e74a2dd40d..bcbb590d48d18b8d86f3593600c168c1143ae157 100644 (file)
@@ -32,8 +32,8 @@ DEAL_II_NAMESPACE_OPEN
 template <class MeshType>
 InterGridMap<MeshType>::InterGridMap ()
   :
-  source_grid(0, typeid(*this).name()),
-  destination_grid(0, typeid(*this).name())
+  source_grid(nullptr, typeid(*this).name()),
+  destination_grid(nullptr, typeid(*this).name())
 {}
 
 
@@ -173,8 +173,8 @@ template <class MeshType>
 void InterGridMap<MeshType>::clear ()
 {
   mapping.clear ();
-  source_grid      = 0;
-  destination_grid = 0;
+  source_grid      = nullptr;
+  destination_grid = nullptr;
 }
 
 
index 57acfd68900661693889cba55a07d3dc2d2a8563..b95593149a92db181c1657f96411d61cb89a4b0f 100644 (file)
@@ -425,11 +425,11 @@ FunctionManifold<dim,spacedim,chartdim>::~FunctionManifold()
   if (owns_pointers == true)
     {
       const Function<chartdim> *pf = push_forward_function;
-      push_forward_function = 0;
+      push_forward_function = nullptr;
       delete pf;
 
       const Function<spacedim> *pb = pull_back_function;
-      pull_back_function = 0;
+      pull_back_function = nullptr;
       delete pb;
     }
 }
index ab252e8a104defd49bb075d53977b02f8148265a..b1d2b525b14155cdb26800b3fd8a9b560f10b0a2 100644 (file)
@@ -6291,10 +6291,10 @@ namespace internal
                     case RefinementCase<dim>::cut_x:
                     {
                       const typename Triangulation<dim,spacedim>::raw_line_iterator
-                      *lines = NULL;
-                      const unsigned int *line_indices     = NULL;
-                      const bool         *line_orientation = NULL;
-                      const int          *quad_indices     = NULL;
+                      *lines = nullptr;
+                      const unsigned int *line_indices     = nullptr;
+                      const bool         *line_orientation = nullptr;
+                      const int          *quad_indices     = nullptr;
 
                       //////////////////////////////
                       //
@@ -6494,10 +6494,10 @@ namespace internal
                     case RefinementCase<dim>::cut_y:
                     {
                       const typename Triangulation<dim,spacedim>::raw_line_iterator
-                      *lines = NULL;
-                      const unsigned int *line_indices     = NULL;
-                      const bool         *line_orientation = NULL;
-                      const int          *quad_indices     = NULL;
+                      *lines = nullptr;
+                      const unsigned int *line_indices     = nullptr;
+                      const bool         *line_orientation = nullptr;
+                      const int          *quad_indices     = nullptr;
 
                       //////////////////////////////
                       //
@@ -6701,10 +6701,10 @@ namespace internal
                     case RefinementCase<dim>::cut_z:
                     {
                       const typename Triangulation<dim,spacedim>::raw_line_iterator
-                      *lines = NULL;
-                      const unsigned int *line_indices     = NULL;
-                      const bool         *line_orientation = NULL;
-                      const int          *quad_indices     = NULL;
+                      *lines = nullptr;
+                      const unsigned int *line_indices     = nullptr;
+                      const bool         *line_orientation = nullptr;
+                      const int          *quad_indices     = nullptr;
 
                       //////////////////////////////
                       //
@@ -6910,10 +6910,10 @@ namespace internal
                     case RefinementCase<dim>::cut_xy:
                     {
                       const typename Triangulation<dim,spacedim>::raw_line_iterator
-                      *lines = NULL;
-                      const unsigned int *line_indices     = NULL;
-                      const bool         *line_orientation = NULL;
-                      const int          *quad_indices     = NULL;
+                      *lines = nullptr;
+                      const unsigned int *line_indices     = nullptr;
+                      const bool         *line_orientation = nullptr;
+                      const int          *quad_indices     = nullptr;
 
                       //////////////////////////////
                       //
@@ -7259,10 +7259,10 @@ namespace internal
                     case RefinementCase<dim>::cut_xz:
                     {
                       const typename Triangulation<dim,spacedim>::raw_line_iterator
-                      *lines = NULL;
-                      const unsigned int *line_indices     = NULL;
-                      const bool         *line_orientation = NULL;
-                      const int          *quad_indices     = NULL;
+                      *lines = nullptr;
+                      const unsigned int *line_indices     = nullptr;
+                      const bool         *line_orientation = nullptr;
+                      const int          *quad_indices     = nullptr;
 
                       //////////////////////////////
                       //
@@ -7618,10 +7618,10 @@ namespace internal
                     case RefinementCase<dim>::cut_yz:
                     {
                       const typename Triangulation<dim,spacedim>::raw_line_iterator
-                      *lines = NULL;
-                      const unsigned int *line_indices     = NULL;
-                      const bool         *line_orientation = NULL;
-                      const int          *quad_indices     = NULL;
+                      *lines = nullptr;
+                      const unsigned int *line_indices     = nullptr;
+                      const bool         *line_orientation = nullptr;
+                      const int          *quad_indices     = nullptr;
 
                       //////////////////////////////
                       //
@@ -7964,11 +7964,11 @@ namespace internal
                     case RefinementCase<dim>::cut_xyz:
                     {
                       const typename Triangulation<dim,spacedim>::raw_line_iterator
-                      *lines = NULL;
-                      const unsigned int *vertex_indices   = NULL;
-                      const unsigned int *line_indices     = NULL;
-                      const bool         *line_orientation = NULL;
-                      const int          *quad_indices     = NULL;
+                      *lines = nullptr;
+                      const unsigned int *vertex_indices   = nullptr;
+                      const unsigned int *line_indices     = nullptr;
+                      const bool         *line_orientation = nullptr;
+                      const int          *quad_indices     = nullptr;
 
                       //////////////////////////////
                       //
@@ -9048,7 +9048,7 @@ Triangulation<dim, spacedim>::~Triangulation ()
     if (levels[i])
       {
         delete levels[i];
-        levels[i] = 0;
+        levels[i] = nullptr;
       }
   levels.clear ();
 
@@ -9058,14 +9058,14 @@ Triangulation<dim, spacedim>::~Triangulation ()
   // this object makes sense
   Assert ((dim == 1)
           ||
-          (vertex_to_boundary_id_map_1d == 0),
+          (vertex_to_boundary_id_map_1d == nullptr),
           ExcInternalError());
 
   // the vertex_to_manifold_id_map_1d field should be also unused
   // except in 1d. check this as well
   Assert ((dim == 1)
           ||
-          (vertex_to_manifold_id_map_1d == 0),
+          (vertex_to_manifold_id_map_1d == nullptr),
           ExcInternalError());
 }
 
@@ -9219,7 +9219,7 @@ Triangulation<dim, spacedim>::get_boundary (const types::manifold_id m_number) c
 {
   const Boundary<dim, spacedim> *man =
     dynamic_cast<const Boundary<dim, spacedim> *>(&get_manifold(m_number));
-  Assert(man != NULL,
+  Assert(man != nullptr,
          ExcMessage("You tried to get a Boundary, but I only have a Manifold."));
 
   return *man;
@@ -9311,11 +9311,11 @@ copy_triangulation (const Triangulation<dim, spacedim> &other_tria)
 {
   Assert ((vertices.size() == 0) &&
           (levels.size () == 0) &&
-          (faces == NULL),
+          (faces == nullptr),
           ExcTriangulationNotEmpty(vertices.size(), levels.size()));
   Assert ((other_tria.levels.size() != 0) &&
           (other_tria.vertices.size() != 0) &&
-          (dim == 1 || other_tria.faces != NULL),
+          (dim == 1 || other_tria.faces != nullptr),
           ExcMessage("When calling Triangulation::copy_triangulation(), "
                      "the target triangulation must be empty but the source "
                      "triangulation (the argument to this function) must contain "
@@ -9399,7 +9399,7 @@ create_triangulation (const std::vector<Point<spacedim> >    &v,
 {
   Assert ((vertices.size() == 0) &&
           (levels.size () == 0) &&
-          (faces == NULL),
+          (faces == nullptr),
           ExcTriangulationNotEmpty(vertices.size(), levels.size()));
   // check that no forbidden arrays
   // are used
@@ -10433,7 +10433,7 @@ namespace
   void *get_user_pointer (const TriaIterator<InvalidAccessor<structdim,dim,spacedim> > &)
   {
     Assert (false, ExcInternalError());
-    return 0;
+    return nullptr;
   }
 
 
@@ -10524,7 +10524,7 @@ void Triangulation<dim, spacedim>::load_user_pointers (const std::vector<void *>
 template <int dim, int spacedim>
 void Triangulation<dim, spacedim>::save_user_pointers_line (std::vector<void *> &v) const
 {
-  v.resize (n_lines(), 0);
+  v.resize (n_lines(), nullptr);
   std::vector<void *>::iterator  i = v.begin();
   line_iterator line = begin_line(),
                 endl = end_line();
@@ -10551,7 +10551,7 @@ void Triangulation<dim, spacedim>::load_user_pointers_line (const std::vector<vo
 template <int dim, int spacedim>
 void Triangulation<dim, spacedim>::save_user_pointers_quad (std::vector<void *> &v) const
 {
-  v.resize (n_quads(), 0);
+  v.resize (n_quads(), nullptr);
 
   if (dim >= 2)
     {
@@ -10584,7 +10584,7 @@ void Triangulation<dim, spacedim>::load_user_pointers_quad (const std::vector<vo
 template <int dim, int spacedim>
 void Triangulation<dim, spacedim>::save_user_pointers_hex (std::vector<void *> &v) const
 {
-  v.resize (n_hexs(), 0);
+  v.resize (n_hexs(), nullptr);
 
   if (dim >= 3)
     {
index c583bb5f06c27ea7dba171fb23db77a3ca16ded0..5daf316f909ed4d4a8c29b188c955fc8e22b3f1a 100644 (file)
@@ -163,14 +163,14 @@ Boundary<dim,spacedim>::
 get_line_support_points (const unsigned int n_intermediate_points) const
 {
   if (points.size() <= n_intermediate_points ||
-      points[n_intermediate_points].get() == 0)
+      points[n_intermediate_points].get() == nullptr)
     {
       Threads::Mutex::ScopedLock lock(mutex);
       if (points.size() <= n_intermediate_points)
         points.resize(n_intermediate_points+1);
 
       // another thread might have created points in the meantime
-      if (points[n_intermediate_points].get() == 0)
+      if (points[n_intermediate_points].get() == nullptr)
         {
           std::shared_ptr<QGaussLobatto<1> >
           quadrature (new QGaussLobatto<1>(n_intermediate_points+2));
index 0f1815a2eb10a68ec709ed0afe33ca6b0db06e82..7bdb99eb373d38c01f2a5341f17384d58ee42105 100644 (file)
@@ -86,7 +86,7 @@ namespace internal
       // see if we need to fill this
       // entry, or whether it already
       // exists
-      if (identities.get() == 0)
+      if (identities.get() == nullptr)
         {
           switch (structdim)
             {
@@ -543,7 +543,7 @@ namespace internal
 
           typedef DoFHandler<dim,spacedim> BaseClass;
 
-          Assert (dof_handler.finite_elements != 0,
+          Assert (dof_handler.finite_elements != nullptr,
                   typename BaseClass::ExcNoFESelected());
           Assert (dof_handler.finite_elements->size() > 0,
                   typename BaseClass::ExcNoFESelected());
@@ -672,7 +672,7 @@ namespace internal
 
           typedef DoFHandler<dim,spacedim> BaseClass;
 
-          Assert (dof_handler.finite_elements != 0,
+          Assert (dof_handler.finite_elements != nullptr,
                   typename BaseClass::ExcNoFESelected());
           Assert (dof_handler.finite_elements->size() > 0,
                   typename BaseClass::ExcNoFESelected());
@@ -1049,7 +1049,7 @@ namespace internal
 
           typedef DoFHandler<dim,spacedim> BaseClass;
 
-          Assert (dof_handler.finite_elements != 0,
+          Assert (dof_handler.finite_elements != nullptr,
                   typename BaseClass::ExcNoFESelected());
           Assert (dof_handler.finite_elements->size() > 0,
                   typename BaseClass::ExcNoFESelected());
@@ -1663,11 +1663,11 @@ namespace hp
   DoFHandler<dim,spacedim>::DoFHandler (const Triangulation<dim,spacedim> &tria)
     :
     tria(&tria, typeid(*this).name()),
-    faces (NULL)
+    faces (nullptr)
   {
     Assert ((dynamic_cast<const parallel::distributed::Triangulation< dim, spacedim >*>
              (&tria)
-             == 0),
+             == nullptr),
             ExcMessage ("The given triangulation is parallel distributed but "
                         "this class does not currently support this."));
 
@@ -1812,7 +1812,7 @@ namespace hp
   template <>
   types::global_dof_index DoFHandler<1>::n_boundary_dofs () const
   {
-    Assert (finite_elements != 0, ExcNoFESelected());
+    Assert (finite_elements != nullptr, ExcNoFESelected());
 
     DoFHandler<1,1>::cell_iterator cell;
     types::global_dof_index n = 0;
@@ -1838,7 +1838,7 @@ namespace hp
   template <typename number>
   types::global_dof_index DoFHandler<1>::n_boundary_dofs (const std::map<types::boundary_id, const Function<1,number>*> &boundary_ids) const
   {
-    Assert (finite_elements != 0, ExcNoFESelected());
+    Assert (finite_elements != nullptr, ExcNoFESelected());
 
     // check that only boundary
     // indicators 0 and 1 are allowed
@@ -1877,7 +1877,7 @@ namespace hp
   template <>
   types::global_dof_index DoFHandler<1>::n_boundary_dofs (const std::set<types::boundary_id> &boundary_ids) const
   {
-    Assert (finite_elements != 0, ExcNoFESelected());
+    Assert (finite_elements != nullptr, ExcNoFESelected());
 
     // check that only boundary
     // indicators 0 and 1 are allowed
@@ -1962,7 +1962,7 @@ namespace hp
   template<int dim, int spacedim>
   types::global_dof_index DoFHandler<dim,spacedim>::n_boundary_dofs () const
   {
-    Assert (finite_elements != 0, ExcNoFESelected());
+    Assert (finite_elements != nullptr, ExcNoFESelected());
 
     std::set<types::global_dof_index> boundary_dofs;
     std::vector<types::global_dof_index> dofs_on_face;
@@ -2001,7 +2001,7 @@ namespace hp
   types::global_dof_index
   DoFHandler<dim,spacedim>::n_boundary_dofs (const std::set<types::boundary_id> &boundary_ids) const
   {
-    Assert (finite_elements != 0, ExcNoFESelected());
+    Assert (finite_elements != nullptr, ExcNoFESelected());
     Assert (boundary_ids.find (numbers::internal_face_boundary_id) == boundary_ids.end(),
             ExcInvalidBoundaryIndicator());
 
@@ -2687,7 +2687,7 @@ namespace hp
 
     if (dynamic_cast<const parallel::shared::Triangulation< dim, spacedim >*>
         (&this->get_triangulation())
-        == 0)
+        == nullptr)
       {
         number_cache.locally_owned_dofs
           = IndexSet (number_cache.n_global_dofs);
@@ -2735,7 +2735,7 @@ namespace hp
   void DoFHandler<dim,spacedim>::clear ()
   {
     // release lock to old fe
-    finite_elements = 0;
+    finite_elements = nullptr;
 
     // release memory
     clear_space ();
@@ -3097,7 +3097,7 @@ namespace hp
   unsigned int
   DoFHandler<dim, spacedim>::max_couplings_between_dofs () const
   {
-    Assert (finite_elements != 0, ExcNoFESelected());
+    Assert (finite_elements != nullptr, ExcNoFESelected());
     return dealii::internal::hp::DoFHandler::Implementation::max_couplings_between_dofs (*this);
   }
 
@@ -3107,7 +3107,7 @@ namespace hp
   unsigned int
   DoFHandler<dim,spacedim>::max_couplings_between_boundary_dofs () const
   {
-    Assert (finite_elements != 0, ExcNoFESelected());
+    Assert (finite_elements != nullptr, ExcNoFESelected());
 
     switch (dim)
       {
@@ -3267,7 +3267,7 @@ namespace hp
     // (besides, we would trip over
     // an assertion in
     // set_active_fe_index)
-    if (finite_elements != 0)
+    if (finite_elements != nullptr)
       {
         cell_iterator cell = begin(),
                       endc = end ();
@@ -3348,7 +3348,7 @@ namespace hp
       delete levels[i];
     levels.resize (0);
     delete faces;
-    faces = NULL;
+    faces = nullptr;
 
     {
       std::vector<types::global_dof_index> tmp;
index c212cccaf849cc421197d3cc7391a74c139ca7d6..67762f159f7964c551a32a6c9bb21a1cf24a4f49 100644 (file)
@@ -91,7 +91,7 @@ namespace internal
       // already have an object for
       // this particular combination
       // of indices
-      if (fe_values_table(present_fe_values_index).get() == 0)
+      if (fe_values_table(present_fe_values_index).get() == nullptr)
         fe_values_table(present_fe_values_index)
           =
             std::shared_ptr<FEValuesType>
index 621b39bf67e475c7722042f462968c5f85e1c045..476221eaad846fe6efc0d461fc7336507413ee5e 100644 (file)
@@ -36,7 +36,7 @@ BlockMatrixArray<number,BlockVectorType>::Entry::Entry (const Entry &e)
   matrix(e.matrix)
 {
   Entry &e2 = const_cast<Entry &>(e);
-  e2.matrix = 0;
+  e2.matrix = nullptr;
 }
 
 
index 6512ae4ea848b3eee56f378f134f4f6860440a76..d51e74e5a5ee33bca4368101ebdf7b0239c80008 100644 (file)
@@ -87,7 +87,7 @@ reinit (const size_type n_block_rows,
     for (size_type j=0; j<columns; ++j)
       {
         SparsityPatternBase *sp = sub_objects[i][j];
-        sub_objects[i][j] = 0;
+        sub_objects[i][j] = nullptr;
         delete sp;
       };
   sub_objects.reinit (0,0);
index 5c080ca5685f61f31fff07e66b4cad0671b063fd..89bc4fbe3f92397b010e4a61c98eff795b3ca6b2 100644 (file)
@@ -477,7 +477,7 @@ ChunkSparsityPattern::n_nonzero_elements () const
 void
 ChunkSparsityPattern::print (std::ostream &out) const
 {
-  Assert ((sparsity_pattern.rowstart!=0) && (sparsity_pattern.colnums!=0),
+  Assert ((sparsity_pattern.rowstart!=nullptr) && (sparsity_pattern.colnums!=nullptr),
           ExcEmptyObject());
 
   AssertThrow (out, ExcIO());
@@ -507,8 +507,8 @@ ChunkSparsityPattern::print (std::ostream &out) const
 void
 ChunkSparsityPattern::print_gnuplot (std::ostream &out) const
 {
-  Assert ((sparsity_pattern.rowstart!=0) &&
-          (sparsity_pattern.colnums!=0), ExcEmptyObject());
+  Assert ((sparsity_pattern.rowstart!=nullptr) &&
+          (sparsity_pattern.colnums!=nullptr), ExcEmptyObject());
 
   AssertThrow (out, ExcIO());
 
index dd56365161799e5c2996e007ea4e0b6b4a6585fc..ab81ec6956fa7e665290098bb1d015be6fd69642 100644 (file)
@@ -521,7 +521,7 @@ ConstraintMatrix::merge (const ConstraintMatrix &other_constraints,
             {
               const ConstraintLine::Entries *other_line
                 = other_constraints.get_constraint_entries (line->entries[i].first);
-              Assert (other_line != 0,
+              Assert (other_line != nullptr,
                       ExcInternalError());
 
               const double weight = line->entries[i].second;
@@ -1234,7 +1234,7 @@ ConstraintMatrix::resolve_indices (std::vector<types::global_dof_index> &indices
       line_ptr = get_constraint_entries(indices[i]);
       // if the index is constraint, the constraints indices are added to the
       // indices vector
-      if (line_ptr!=NULL)
+      if (line_ptr!=nullptr)
         {
           const unsigned int line_size = line_ptr->size();
           for (unsigned int j=0; j<line_size; ++j)
index ebadf011a748ca0c7a4f2f2b51140a652a353c24..b5895e414b936af9ee5728339bae81f10bf018cf 100644 (file)
@@ -41,8 +41,8 @@ namespace LACExceptions
     // statically allocated description of the current error message.
     const char *petsc_message;
     const PetscErrorCode ierr = PetscErrorMessage (error_code, &petsc_message,
-                                                   /*specific=*/NULL);
-    if (ierr == 0 && petsc_message != NULL)
+                                                   /*specific=*/nullptr);
+    if (ierr == 0 && petsc_message != nullptr)
       {
         out << "The description of the error provided by PETSc is \""
             << petsc_message
index 772b76797814a10a1a82f20549bf3d14e4c7331a..61031f54c078f14a68ab8d176f974fe5170e7956 100644 (file)
@@ -1032,7 +1032,7 @@ void
 PreconditionLU<number>::initialize(const LAPACKFullMatrix<number> &M)
 {
   matrix = &M;
-  mem = 0;
+  mem = nullptr;
 }
 
 
@@ -1071,7 +1071,7 @@ void
 PreconditionLU<number>::vmult(BlockVector<number> &dst,
                               const BlockVector<number> &src) const
 {
-  Assert(mem != 0, ExcNotInitialized());
+  Assert(mem != nullptr, ExcNotInitialized());
   Vector<number> *aux = mem->alloc();
   *aux = src;
   matrix->apply_lu_factorization(*aux, false);
@@ -1084,7 +1084,7 @@ void
 PreconditionLU<number>::Tvmult(BlockVector<number> &dst,
                                const BlockVector<number> &src) const
 {
-  Assert(mem != 0, ExcNotInitialized());
+  Assert(mem != nullptr, ExcNotInitialized());
   Vector<number> *aux = mem->alloc();
   *aux = src;
   matrix->apply_lu_factorization(*aux, true);
index 3c45574bb1fd3f87c51363d5078f1a123a27bdf5..4b0b53e89f18aebadb7c11fad33073a66ea00769 100644 (file)
@@ -75,7 +75,7 @@ namespace PETScWrappers
 
   MatrixBase::MatrixBase ()
     :
-    matrix (NULL),
+    matrix (nullptr),
     last_action (VectorOperation::unknown)
   {}
 
@@ -102,7 +102,7 @@ namespace PETScWrappers
     const int m=0, n=0, n_nonzero_per_row=0;
     const PetscErrorCode ierr = MatCreateSeqAIJ(PETSC_COMM_SELF, m, n,
                                                 n_nonzero_per_row,
-                                                0, &matrix);
+                                                nullptr, &matrix);
     AssertThrow (ierr == 0, ExcPETScError(ierr));
   }
 
index fdb77fbbbc33bed282572b0a104b204a2e15a29f..fba3879f563c55b0283c586a0680b5a483772d89 100644 (file)
@@ -182,8 +182,8 @@ namespace PETScWrappers
 // a given PETSc Vec* object without allocating new memory
 // and without taking ownership of the Vec*
 
-    VectorBase  *x = 0;
-    VectorBase  *y = 0;
+    VectorBase  *x = nullptr;
+    VectorBase  *y = nullptr;
     // because we do not know,
     // if dst and src are sequential
     // or distributed vectors,
index 4480f251bfd90fec2f1ecb911b345e9954c33c2d..c2478f714668b6f8c12c9280af366022b178597b 100644 (file)
@@ -39,7 +39,7 @@ namespace PETScWrappers
       const int m=0, n=0, n_nonzero_per_row=0;
       const PetscErrorCode ierr
         = MatCreateSeqAIJ(PETSC_COMM_SELF, m, n, n_nonzero_per_row,
-                          0, &matrix);
+                          nullptr, &matrix);
       AssertThrow (ierr == 0, ExcPETScError(ierr));
     }
 
@@ -250,8 +250,8 @@ namespace PETScWrappers
                                   (communicator,
                                    local_rows, local_columns,
                                    m, n,
-                                   n_nonzero_per_row, 0,
-                                   n_offdiag_nonzero_per_row, 0,
+                                   n_nonzero_per_row, nullptr,
+                                   n_offdiag_nonzero_per_row, nullptr,
                                    &matrix);
       set_matrix_option (matrix, MAT_NEW_NONZERO_ALLOCATION_ERR, PETSC_FALSE);
 #endif
@@ -319,7 +319,7 @@ namespace PETScWrappers
                                    m, n,
                                    0, &int_row_lengths[0],
                                    0,
-                                   offdiag_row_lengths.size() ? &int_offdiag_row_lengths[0] : 0,
+                                   offdiag_row_lengths.size() ? &int_offdiag_row_lengths[0] : nullptr,
                                    &matrix);
 
 //TODO: Sometimes the actual number of nonzero entries allocated is greater than the number of nonzero entries, which petsc will complain about unless explicitly disabled with MatSetOption. There is probably a way to prevent a different number nonzero elements being allocated in the first place. (See also previous TODO).
@@ -451,7 +451,7 @@ namespace PETScWrappers
           ierr = MatMPIAIJSetPreallocationCSR (matrix,
                                                &rowstart_in_window[0],
                                                &colnums_in_window[0],
-                                               0);
+                                               nullptr);
           AssertThrow (ierr == 0, ExcPETScError(ierr));
         }
       else
@@ -460,7 +460,7 @@ namespace PETScWrappers
           ierr = MatMPIAIJSetPreallocationCSR (matrix,
                                                &i,
                                                &i,
-                                               0);
+                                               nullptr);
           AssertThrow (ierr == 0, ExcPETScError(ierr));
         }
       compress (dealii::VectorOperation::insert);
@@ -628,7 +628,7 @@ namespace PETScWrappers
           ierr = MatMPIAIJSetPreallocationCSR (matrix,
                                                &rowstart_in_window[0],
                                                &colnums_in_window[0],
-                                               0);
+                                               nullptr);
           AssertThrow (ierr == 0, ExcPETScError(ierr));
 
 #if DEAL_II_PETSC_VERSION_LT(2,3,3)
index be0af823c255034be6b512cc77ac6112406006d2..80d4d1096f58913725fb1973dfdc83903901c2a4 100644 (file)
@@ -306,7 +306,7 @@ namespace PETScWrappers
            ?
            (const PetscInt *)(&(ghostindices[0]))
            :
-           0);
+           nullptr);
 
       PetscErrorCode ierr = VecCreateGhost(communicator,
                                            local_size,
index 267e43b721b1b1d748542a0725ea56191205232a..77f3dda66928bfce0432ac53e6cc38bb135dd62b 100644 (file)
@@ -32,7 +32,7 @@ namespace PETScWrappers
 {
   PreconditionerBase::PreconditionerBase ()
     :
-    pc(NULL), matrix(NULL)
+    pc(nullptr), matrix(nullptr)
   {}
 
   PreconditionerBase::~PreconditionerBase ()
@@ -48,16 +48,16 @@ namespace PETScWrappers
   void
   PreconditionerBase::clear ()
   {
-    matrix = NULL;
+    matrix = nullptr;
 
-    if (pc!=NULL)
+    if (pc!=nullptr)
       {
 #if DEAL_II_PETSC_VERSION_LT(3,2,0)
         PetscErrorCode ierr = PCDestroy(pc);
 #else
         PetscErrorCode ierr = PCDestroy(&pc);
 #endif
-        pc = NULL;
+        pc = nullptr;
         AssertThrow (ierr == 0, ExcPETScError(ierr));
       }
   }
@@ -67,7 +67,7 @@ namespace PETScWrappers
   PreconditionerBase::vmult (VectorBase       &dst,
                              const VectorBase &src) const
   {
-    AssertThrow (pc != NULL, StandardExceptions::ExcInvalidState ());
+    AssertThrow (pc != nullptr, StandardExceptions::ExcInvalidState ());
 
     const PetscErrorCode ierr = PCApply(pc, src, dst);
     AssertThrow (ierr == 0, ExcPETScError(ierr));
@@ -79,7 +79,7 @@ namespace PETScWrappers
   {
     // only allow the creation of the
     // preconditioner once
-    AssertThrow (pc == NULL, StandardExceptions::ExcInvalidState ());
+    AssertThrow (pc == nullptr, StandardExceptions::ExcInvalidState ());
 
     MPI_Comm comm;
     // this ugly cast is necessary because the
@@ -140,7 +140,7 @@ namespace PETScWrappers
   void
   PreconditionJacobi::initialize()
   {
-    AssertThrow (pc != NULL, StandardExceptions::ExcInvalidState ());
+    AssertThrow (pc != nullptr, StandardExceptions::ExcInvalidState ());
 
     PetscErrorCode ierr = PCSetType (pc, const_cast<char *>(PCJACOBI));
     AssertThrow (ierr == 0, ExcPETScError(ierr));
index d2e9554ff812247c4731b528eadeaeb7bd294e8f..1654a29d3d067adc1921bb0db078dcc908d07a30 100644 (file)
@@ -69,7 +69,7 @@ namespace PETScWrappers
 
     // first create a solver object if this
     // is necessary
-    if (solver_data.get() == 0)
+    if (solver_data.get() == nullptr)
       {
         solver_data.reset (new SolverData());
 
@@ -87,7 +87,7 @@ namespace PETScWrappers
 
         // make sure the preconditioner has an associated matrix set
         const Mat B = preconditioner;
-        AssertThrow (B != NULL,
+        AssertThrow (B != nullptr,
                      ExcMessage("PETSc preconditioner should have an"
                                 "associated matrix set to be used in solver."));
 
index fc9addf23637308cc92c2a8f1f7b1014c694400d..913490b7e8d547c46ffed0de90f7e35d8e6e5d8f 100644 (file)
@@ -32,7 +32,7 @@ namespace PETScWrappers
   {
     const int m=0, n=0, n_nonzero_per_row=0;
     const PetscErrorCode ierr = MatCreateSeqAIJ(PETSC_COMM_SELF, m, n,
-                                                n_nonzero_per_row, 0, &matrix);
+                                                n_nonzero_per_row, nullptr, &matrix);
     AssertThrow (ierr == 0, ExcPETScError(ierr));
   }
 
@@ -147,7 +147,7 @@ namespace PETScWrappers
     // for all rows globally
     const PetscErrorCode ierr = MatCreateSeqAIJ(PETSC_COMM_SELF, m, n,
                                                 n_nonzero_per_row,
-                                                0, &matrix);
+                                                nullptr, &matrix);
     AssertThrow (ierr == 0, ExcPETScError(ierr));
 
     // set symmetric flag, if so requested
index 4f07b8012b54198a1bc7cdf3018a52aff6fae07a..42400bfbefbc97b76905cd3fd24a2ade914778c9 100644 (file)
@@ -39,7 +39,7 @@ namespace PETScWrappers
       // if the vector is local, then
       // simply access the element we
       // are interested in
-      if (dynamic_cast<const PETScWrappers::Vector *>(&vector) != 0)
+      if (dynamic_cast<const PETScWrappers::Vector *>(&vector) != nullptr)
         {
           PetscInt idx = index;
           PetscScalar value;
@@ -49,7 +49,7 @@ namespace PETScWrappers
         }
       // else see if we are dealing
       // with a parallel vector
-      else if (dynamic_cast<const PETScWrappers::MPI::Vector *>(&vector) != 0)
+      else if (dynamic_cast<const PETScWrappers::MPI::Vector *>(&vector) != nullptr)
         {
           // there is the possibility
           // that the vector has
@@ -149,7 +149,7 @@ namespace PETScWrappers
 
   VectorBase::VectorBase ()
     :
-    vector (NULL),
+    vector (nullptr),
     ghosted(false),
     last_action (::dealii::VectorOperation::unknown),
     attained_ownership(true)
@@ -472,7 +472,7 @@ namespace PETScWrappers
   {
     // We can only use our more efficient
     // routine in the serial case.
-    if (dynamic_cast<const PETScWrappers::MPI::Vector *>(this) != 0)
+    if (dynamic_cast<const PETScWrappers::MPI::Vector *>(this) != nullptr)
       {
         PetscScalar sum;
         const PetscErrorCode ierr = VecSum(vector, &sum);
index bd7d6ef50acf37576342a347f55e1c79f959444b..24481fb38a4eeac2168a2933ad108c53d5bc034d 100644 (file)
@@ -59,7 +59,7 @@ namespace SLEPcWrappers
 
   SolverBase::~SolverBase ()
   {
-    if (eps != NULL)
+    if (eps != nullptr)
       {
         // Destroy the solver object.
 #if DEAL_II_PETSC_VERSION_LT(3,2,0)
index ef6bbcf2cdced78036be9a4b35e4b533f201b6ab..a5e10174fc464fb2a3ccfc5817bc2db61a4d7b9f 100644 (file)
@@ -39,7 +39,7 @@ namespace SLEPcWrappers
 
   TransformationBase::~TransformationBase ()
   {
-    if (st!=NULL)
+    if (st!=nullptr)
       {
         const PetscErrorCode ierr = STDestroy(&st);
         AssertThrow (ierr == 0, SolverBase::ExcSLEPcError(ierr));
index 9c42688840ecb06dc4f4bb143e4b82b400377e4b..b7c51851ad09f9526b3ca285cf2c158254f65c12 100644 (file)
@@ -55,8 +55,8 @@ SparseDirectUMFPACK::SparseDirectUMFPACK ()
   :
   _m (0),
   _n (0),
-  symbolic_decomposition (0),
-  numeric_decomposition (0),
+  symbolic_decomposition (nullptr),
+  numeric_decomposition (nullptr),
   control (UMFPACK_CONTROL)
 {
   umfpack_dl_defaults (&control[0]);
@@ -68,16 +68,16 @@ void
 SparseDirectUMFPACK::clear ()
 {
   // delete objects that haven't been deleted yet
-  if (symbolic_decomposition != 0)
+  if (symbolic_decomposition != nullptr)
     {
       umfpack_dl_free_symbolic (&symbolic_decomposition);
-      symbolic_decomposition = 0;
+      symbolic_decomposition = nullptr;
     }
 
-  if (numeric_decomposition != 0)
+  if (numeric_decomposition != nullptr)
     {
       umfpack_dl_free_numeric (&numeric_decomposition);
-      numeric_decomposition = 0;
+      numeric_decomposition = nullptr;
     }
 
   {
@@ -281,14 +281,14 @@ factorize (const Matrix &matrix)
   status = umfpack_dl_symbolic (N, N,
                                 &Ap[0], &Ai[0], &Ax[0],
                                 &symbolic_decomposition,
-                                &control[0], 0);
+                                &control[0], nullptr);
   AssertThrow (status == UMFPACK_OK,
                ExcUMFPACKError("umfpack_dl_symbolic", status));
 
   status = umfpack_dl_numeric (&Ap[0], &Ai[0], &Ax[0],
                                symbolic_decomposition,
                                &numeric_decomposition,
-                               &control[0], 0);
+                               &control[0], nullptr);
   AssertThrow (status == UMFPACK_OK,
                ExcUMFPACKError("umfpack_dl_numeric", status));
 
@@ -320,7 +320,7 @@ SparseDirectUMFPACK::solve (Vector<double> &rhs_and_solution,
                         &Ap[0], &Ai[0], &Ax[0],
                         rhs_and_solution.begin(), rhs.begin(),
                         numeric_decomposition,
-                        &control[0], 0);
+                        &control[0], nullptr);
   AssertThrow (status == UMFPACK_OK, ExcUMFPACKError("umfpack_dl_solve", status));
 }
 
index 32e6523f022fac1a96b336496e1bb6ee34075c9c..6cb9e252db363d52d4b16692467f9953261dd3ad 100644 (file)
@@ -41,8 +41,8 @@ SparsityPattern::SparsityPattern ()
   :
   max_dim(0),
   max_vec_len(0),
-  rowstart(0),
-  colnums(0),
+  rowstart(nullptr),
+  colnums(nullptr),
   compressed(false),
   store_diagonal_first_in_row(false)
 {
@@ -56,8 +56,8 @@ SparsityPattern::SparsityPattern (const SparsityPattern &s)
   Subscriptor(),
   max_dim(0),
   max_vec_len(0),
-  rowstart(0),
-  colnums(0),
+  rowstart(nullptr),
+  colnums(nullptr),
   compressed(false),
   store_diagonal_first_in_row(false)
 {
@@ -78,8 +78,8 @@ SparsityPattern::SparsityPattern (const size_type m,
   :
   max_dim(0),
   max_vec_len(0),
-  rowstart(0),
-  colnums(0),
+  rowstart(nullptr),
+  colnums(nullptr),
   compressed(false),
   store_diagonal_first_in_row(m == n)
 {
@@ -94,8 +94,8 @@ SparsityPattern::SparsityPattern (const size_type m,
   :
   max_dim(0),
   max_vec_len(0),
-  rowstart(0),
-  colnums(0),
+  rowstart(nullptr),
+  colnums(nullptr),
   store_diagonal_first_in_row(m == n)
 {
   reinit (m, n, row_lengths);
@@ -108,8 +108,8 @@ SparsityPattern::SparsityPattern (const size_type m,
   :
   max_dim(0),
   max_vec_len(0),
-  rowstart(0),
-  colnums(0)
+  rowstart(nullptr),
+  colnums(nullptr)
 {
   reinit (m, m, max_per_row);
 }
@@ -121,8 +121,8 @@ SparsityPattern::SparsityPattern (const size_type               m,
   :
   max_dim(0),
   max_vec_len(0),
-  rowstart(0),
-  colnums(0)
+  rowstart(nullptr),
+  colnums(nullptr)
 {
   reinit (m, m, row_lengths);
 }
@@ -135,8 +135,8 @@ SparsityPattern::SparsityPattern (const SparsityPattern &original,
   :
   max_dim(0),
   max_vec_len(0),
-  rowstart(0),
-  colnums(0)
+  rowstart(nullptr),
+  colnums(nullptr)
 {
   Assert (original.rows==original.cols, ExcNotQuadratic());
   Assert (original.is_compressed(), ExcNotCompressed());
@@ -216,8 +216,8 @@ SparsityPattern::SparsityPattern (const SparsityPattern &original,
 
 SparsityPattern::~SparsityPattern ()
 {
-  if (rowstart != 0)  delete[] rowstart;
-  if (colnums != 0)   delete[] colnums;
+  if (rowstart != nullptr)  delete[] rowstart;
+  if (colnums != nullptr)   delete[] colnums;
 }
 
 
@@ -267,8 +267,8 @@ SparsityPattern::reinit (const size_type m,
     {
       if (rowstart)  delete[] rowstart;
       if (colnums)   delete[] colnums;
-      rowstart = 0;
-      colnums = 0;
+      rowstart = nullptr;
+      colnums = nullptr;
       max_vec_len = max_dim = rows = cols = 0;
       // if dimension is zero: ignore max_per_row
       max_row_length = 0;
@@ -304,7 +304,7 @@ SparsityPattern::reinit (const size_type m,
       if (colnums)
         {
           delete[] colnums;
-          colnums = 0;
+          colnums = nullptr;
         }
 
       max_vec_len = vec_len;
@@ -331,7 +331,7 @@ SparsityPattern::reinit (const size_type m,
       if (rowstart)
         {
           delete[] rowstart;
-          rowstart = 0;
+          rowstart = nullptr;
         }
 
       max_dim = rows;
@@ -344,7 +344,7 @@ SparsityPattern::reinit (const size_type m,
       if (colnums)
         {
           delete[] colnums;
-          colnums = 0;
+          colnums = nullptr;
         }
 
       max_vec_len = vec_len;
@@ -381,7 +381,7 @@ SparsityPattern::reinit (const size_type m,
 void
 SparsityPattern::compress ()
 {
-  Assert ((rowstart!=0) && (colnums!=0), ExcEmptyObject());
+  Assert ((rowstart!=nullptr) && (colnums!=nullptr), ExcEmptyObject());
 
   // do nothing if already compressed
   if (compressed)
@@ -616,12 +616,12 @@ SparsityPattern::empty () const
   // and freeing memory was not present in the original implementation and I
   // don't know at how many places I missed something in adding it, so I try
   // to be cautious. wb)
-  if ((rowstart==0) || (rows==0) || (cols==0))
+  if ((rowstart==nullptr) || (rows==0) || (cols==0))
     {
-      Assert (rowstart==0, ExcInternalError());
+      Assert (rowstart==nullptr, ExcInternalError());
       Assert (rows==0, ExcInternalError());
       Assert (cols==0, ExcInternalError());
-      Assert (colnums==0, ExcInternalError());
+      Assert (colnums==nullptr, ExcInternalError());
       Assert (max_vec_len==0, ExcInternalError());
 
       return true;
@@ -654,7 +654,7 @@ SparsityPattern::size_type
 SparsityPattern::operator () (const size_type i,
                               const size_type j) const
 {
-  Assert ((rowstart!=0) && (colnums!=0), ExcEmptyObject());
+  Assert ((rowstart!=nullptr) && (colnums!=nullptr), ExcEmptyObject());
   Assert (i<rows, ExcIndexRange(i,0,rows));
   Assert (j<cols, ExcIndexRange(j,0,cols));
   Assert (compressed, ExcNotCompressed());
@@ -693,7 +693,7 @@ void
 SparsityPattern::add (const size_type i,
                       const size_type j)
 {
-  Assert ((rowstart!=0) && (colnums!=0), ExcEmptyObject());
+  Assert ((rowstart!=nullptr) && (colnums!=nullptr), ExcEmptyObject());
   Assert (i<rows, ExcIndexRange(i,0,rows));
   Assert (j<cols, ExcIndexRange(j,0,cols));
   Assert (compressed==false, ExcMatrixIsCompressed());
@@ -768,7 +768,7 @@ SparsityPattern::add_entries (const size_type row,
 bool
 SparsityPattern::exists (const size_type i, const size_type j) const
 {
-  Assert ((rowstart!=0) && (colnums!=0), ExcEmptyObject());
+  Assert ((rowstart!=nullptr) && (colnums!=nullptr), ExcEmptyObject());
   Assert (i<rows, ExcIndexRange(i,0,rows));
   Assert (j<cols, ExcIndexRange(j,0,cols));
 
@@ -785,7 +785,7 @@ SparsityPattern::exists (const size_type i, const size_type j) const
 SparsityPattern::size_type
 SparsityPattern::row_position (const size_type i, const size_type j) const
 {
-  Assert ((rowstart!=0) && (colnums!=0), ExcEmptyObject());
+  Assert ((rowstart!=nullptr) && (colnums!=nullptr), ExcEmptyObject());
   Assert (i<rows, ExcIndexRange(i,0,rows));
   Assert (j<cols, ExcIndexRange(j,0,cols));
 
@@ -827,7 +827,7 @@ SparsityPattern::matrix_position (const std::size_t global_index) const
 void
 SparsityPattern::symmetrize ()
 {
-  Assert ((rowstart!=0) && (colnums!=0), ExcEmptyObject());
+  Assert ((rowstart!=nullptr) && (colnums!=nullptr), ExcEmptyObject());
   Assert (compressed==false, ExcMatrixIsCompressed());
   // Note that we only require a quadratic matrix here, no special treatment
   // of diagonals
@@ -861,7 +861,7 @@ SparsityPattern::symmetrize ()
 void
 SparsityPattern::print (std::ostream &out) const
 {
-  Assert ((rowstart!=0) && (colnums!=0), ExcEmptyObject());
+  Assert ((rowstart!=nullptr) && (colnums!=nullptr), ExcEmptyObject());
 
   AssertThrow (out, ExcIO());
 
@@ -882,7 +882,7 @@ SparsityPattern::print (std::ostream &out) const
 void
 SparsityPattern::print_gnuplot (std::ostream &out) const
 {
-  Assert ((rowstart!=0) && (colnums!=0), ExcEmptyObject());
+  Assert ((rowstart!=nullptr) && (colnums!=nullptr), ExcEmptyObject());
 
   AssertThrow (out, ExcIO());
 
@@ -934,7 +934,7 @@ SparsityPattern::print_svg (std::ostream &out) const
 SparsityPattern::size_type
 SparsityPattern::bandwidth () const
 {
-  Assert ((rowstart!=0) && (colnums!=0), ExcEmptyObject());
+  Assert ((rowstart!=nullptr) && (colnums!=nullptr), ExcEmptyObject());
   size_type b=0;
   for (size_type i=0; i<rows; ++i)
     for (size_type j=rowstart[i]; j<rowstart[i+1]; ++j)
index f57b2cfd2e40e040b5c56408d3877fa788345845..bdb4b4a65cf4271d3bba87d3086318e480687edd 100644 (file)
@@ -120,15 +120,15 @@ namespace SparsityTools
     // Use recursive if the number of partitions is less than or equal to 8
     if (nparts <= 8)
       ierr = METIS_PartGraphRecursive(&n, &ncon, &int_rowstart[0], &int_colnums[0],
-                                      NULL, NULL, NULL,
-                                      &nparts,NULL,NULL,&options[0],
+                                      nullptr, nullptr, nullptr,
+                                      &nparts,nullptr,nullptr,&options[0],
                                       &dummy,&int_partition_indices[0]);
 
     // Otherwise use kway
     else
       ierr = METIS_PartGraphKway(&n, &ncon, &int_rowstart[0], &int_colnums[0],
-                                 NULL, NULL, NULL,
-                                 &nparts,NULL,NULL,&options[0],
+                                 nullptr, nullptr, nullptr,
+                                 &nparts,nullptr,nullptr,&options[0],
                                  &dummy,&int_partition_indices[0]);
 
     // If metis returns normally, an error code METIS_OK=1 is returned from
index a152648cb9b4ee434b338819d8c34fad7a7dbfee..b131585a77643e5b91959f26e75d0f32e6f091ef 100644 (file)
@@ -237,7 +237,7 @@ TridiagonalMatrix<double>::compute_eigenvalues()
 
   const int nn = n();
   int info;
-  stev (&N, &nn, &*diagonal.begin(), &*right.begin(), 0, &one, 0, &info);
+  stev (&N, &nn, &*diagonal.begin(), &*right.begin(), nullptr, &one, nullptr, &info);
   Assert(info == 0, ExcInternalError());
 
   state = eigenvalues;
index 083d87d0e627454fb4015e27de1adf3a189b7074..f2cbadf0caa568fd1867a30fdd6d9b16446bdbdf 100644 (file)
@@ -76,7 +76,7 @@ namespace TrilinosWrappers
         {
           BlockType *p = new BlockType();
 
-          Assert (this->sub_objects[r][c] == 0,
+          Assert (this->sub_objects[r][c] == nullptr,
                   ExcInternalError());
           this->sub_objects[r][c] = p;
         }
index 28a331fe2121ea39ee3bf3d55fa019a540057dd4..078c36acf320f89e8eb9823124ccbd18540c3216 100644 (file)
@@ -106,7 +106,7 @@ namespace LinearAlgebra
     {
       // If no communication pattern is given, create one. Otherwsie, use the
       // one given.
-      if (communication_pattern == NULL)
+      if (communication_pattern == nullptr)
         {
           // The first time import is called, a communication pattern is created.
           // Check if the communication pattern already exists and if it can be
@@ -123,7 +123,7 @@ namespace LinearAlgebra
         {
           epetra_comm_pattern =
             std::dynamic_pointer_cast<const CommunicationPattern> (communication_pattern);
-          AssertThrow(epetra_comm_pattern != NULL,
+          AssertThrow(epetra_comm_pattern != nullptr,
                       ExcMessage(std::string("The communication pattern is not of type ") +
                                  "LinearAlgebra::EpetraWrappers::CommunicationPattern."));
         }
@@ -167,7 +167,7 @@ namespace LinearAlgebra
     Vector &Vector::operator+= (const VectorSpaceVector<double> &V)
     {
       // Check that casting will work.
-      Assert(dynamic_cast<const Vector *>(&V)!=NULL, ExcVectorTypeNotCompatible());
+      Assert(dynamic_cast<const Vector *>(&V)!=nullptr, ExcVectorTypeNotCompatible());
 
       // Downcast V. If fails, throws an exception.
       const Vector &down_V = dynamic_cast<const Vector &>(V);
@@ -222,7 +222,7 @@ namespace LinearAlgebra
     double Vector::operator* (const VectorSpaceVector<double> &V) const
     {
       // Check that casting will work.
-      Assert(dynamic_cast<const Vector *>(&V)!=NULL,
+      Assert(dynamic_cast<const Vector *>(&V)!=nullptr,
              ExcVectorTypeNotCompatible());
 
       // Downcast V. If fails, throws an exception.
@@ -255,7 +255,7 @@ namespace LinearAlgebra
     void Vector::add(const double a, const VectorSpaceVector<double> &V)
     {
       // Check that casting will work.
-      Assert(dynamic_cast<const Vector *>(&V)!=NULL,
+      Assert(dynamic_cast<const Vector *>(&V)!=nullptr,
              ExcVectorTypeNotCompatible());
 
       // Downcast V. If fails, throws an exception.
@@ -275,10 +275,10 @@ namespace LinearAlgebra
                      const double b, const VectorSpaceVector<double> &W)
     {
       // Check that casting will work.
-      Assert(dynamic_cast<const Vector *>(&V)!=NULL,
+      Assert(dynamic_cast<const Vector *>(&V)!=nullptr,
              ExcVectorTypeNotCompatible());
       // Check that casting will work.
-      Assert(dynamic_cast<const Vector *>(&W)!=NULL,
+      Assert(dynamic_cast<const Vector *>(&W)!=nullptr,
              ExcVectorTypeNotCompatible());
 
       // Downcast V. If fails, throws an exception.
@@ -304,7 +304,7 @@ namespace LinearAlgebra
                       const VectorSpaceVector<double> &V)
     {
       // Check that casting will work.
-      Assert(dynamic_cast<const Vector *>(&V)!=NULL,
+      Assert(dynamic_cast<const Vector *>(&V)!=nullptr,
              ExcVectorTypeNotCompatible());
 
       *this *= s;
@@ -320,7 +320,7 @@ namespace LinearAlgebra
     void Vector::scale(const VectorSpaceVector<double> &scaling_factors)
     {
       // Check that casting will work.
-      Assert(dynamic_cast<const Vector *>(&scaling_factors)!=NULL,
+      Assert(dynamic_cast<const Vector *>(&scaling_factors)!=nullptr,
              ExcVectorTypeNotCompatible());
 
       // Downcast scaling_factors. If fails, throws an exception.
@@ -340,7 +340,7 @@ namespace LinearAlgebra
     void Vector::equ(const double a, const VectorSpaceVector<double> &V)
     {
       // Check that casting will work.
-      Assert(dynamic_cast<const Vector *>(&V)!=NULL,
+      Assert(dynamic_cast<const Vector *>(&V)!=nullptr,
              ExcVectorTypeNotCompatible());
 
       // Downcast V. If fails, throws an exception.
@@ -434,7 +434,7 @@ namespace LinearAlgebra
     {
       const Epetra_MpiComm *epetra_comm
         = dynamic_cast<const Epetra_MpiComm *>(&(vector->Comm()));
-      Assert (epetra_comm != 0, ExcInternalError());
+      Assert (epetra_comm != nullptr, ExcInternalError());
       return epetra_comm->GetMpiComm();
     }
 
index 674321ec6dd52f76a61b1edb0b07cb7a5b4da36d..28564d6b873757aa55c5c8b1959c7f9083836430 100644 (file)
@@ -129,8 +129,8 @@ namespace TrilinosWrappers
 
     Ifpack_Preconditioner *ifpack = static_cast<Ifpack_Preconditioner *>
                                     (preconditioner.get());
-    Assert (ifpack != 0, ExcMessage ("Trilinos could not create this "
-                                     "preconditioner"));
+    Assert (ifpack != nullptr, ExcMessage ("Trilinos could not create this "
+                                           "preconditioner"));
 
     int ierr;
 
@@ -181,8 +181,8 @@ namespace TrilinosWrappers
 
     Ifpack_Preconditioner *ifpack = static_cast<Ifpack_Preconditioner *>
                                     (preconditioner.get());
-    Assert (ifpack != 0, ExcMessage ("Trilinos could not create this "
-                                     "preconditioner"));
+    Assert (ifpack != nullptr, ExcMessage ("Trilinos could not create this "
+                                           "preconditioner"));
 
     int ierr;
 
@@ -234,8 +234,8 @@ namespace TrilinosWrappers
 
     Ifpack_Preconditioner *ifpack = static_cast<Ifpack_Preconditioner *>
                                     (preconditioner.get());
-    Assert (ifpack != 0, ExcMessage ("Trilinos could not create this "
-                                     "preconditioner"));
+    Assert (ifpack != nullptr, ExcMessage ("Trilinos could not create this "
+                                           "preconditioner"));
 
     int ierr;
 
@@ -290,8 +290,8 @@ namespace TrilinosWrappers
 
     Ifpack_Preconditioner *ifpack = static_cast<Ifpack_Preconditioner *>
                                     (preconditioner.get());
-    Assert (ifpack != 0, ExcMessage ("Trilinos could not create this "
-                                     "preconditioner"));
+    Assert (ifpack != nullptr, ExcMessage ("Trilinos could not create this "
+                                           "preconditioner"));
 
     int ierr;
 
@@ -350,8 +350,8 @@ namespace TrilinosWrappers
 
     Ifpack_Preconditioner *ifpack = static_cast<Ifpack_Preconditioner *>
                                     (preconditioner.get());
-    Assert (ifpack != 0, ExcMessage ("Trilinos could not create this "
-                                     "preconditioner"));
+    Assert (ifpack != nullptr, ExcMessage ("Trilinos could not create this "
+                                           "preconditioner"));
 
     int ierr;
 
@@ -411,8 +411,8 @@ namespace TrilinosWrappers
 
     Ifpack_Preconditioner *ifpack = static_cast<Ifpack_Preconditioner *>
                                     (preconditioner.get());
-    Assert (ifpack != 0, ExcMessage ("Trilinos could not create this "
-                                     "preconditioner"));
+    Assert (ifpack != nullptr, ExcMessage ("Trilinos could not create this "
+                                           "preconditioner"));
 
     int ierr;
 
@@ -468,8 +468,8 @@ namespace TrilinosWrappers
 
     Ifpack_Preconditioner *ifpack = static_cast<Ifpack_Preconditioner *>
                                     (preconditioner.get());
-    Assert (ifpack != 0, ExcMessage ("Trilinos could not create this "
-                                     "preconditioner"));
+    Assert (ifpack != nullptr, ExcMessage ("Trilinos could not create this "
+                                           "preconditioner"));
 
     int ierr;
 
@@ -519,8 +519,8 @@ namespace TrilinosWrappers
 
     Ifpack_Preconditioner *ifpack = static_cast<Ifpack_Preconditioner *>
                                     (preconditioner.get());
-    Assert (ifpack != 0, ExcMessage ("Trilinos could not create this "
-                                     "preconditioner"));
+    Assert (ifpack != nullptr, ExcMessage ("Trilinos could not create this "
+                                           "preconditioner"));
 
     int ierr;
 
@@ -572,8 +572,8 @@ namespace TrilinosWrappers
 
     Ifpack_Preconditioner *ifpack = static_cast<Ifpack_Preconditioner *>
                                     (preconditioner.get());
-    Assert (ifpack != 0, ExcMessage ("Trilinos could not create this "
-                                     "preconditioner"));
+    Assert (ifpack != nullptr, ExcMessage ("Trilinos could not create this "
+                                           "preconditioner"));
 
     int ierr;
 
@@ -618,8 +618,8 @@ namespace TrilinosWrappers
 
     Ifpack_Preconditioner *ifpack = static_cast<Ifpack_Preconditioner *>
                                     (preconditioner.get());
-    Assert (ifpack != 0, ExcMessage ("Trilinos could not create this "
-                                     "preconditioner"));
+    Assert (ifpack != nullptr, ExcMessage ("Trilinos could not create this "
+                                           "preconditioner"));
 
     int ierr;
 
@@ -667,8 +667,8 @@ namespace TrilinosWrappers
 
     Ifpack_Chebyshev *ifpack = static_cast<Ifpack_Chebyshev *>
                                (preconditioner.get());
-    Assert (ifpack != 0, ExcMessage ("Trilinos could not create this "
-                                     "preconditioner"));
+    Assert (ifpack != nullptr, ExcMessage ("Trilinos could not create this "
+                                           "preconditioner"));
 
     int ierr;
 
@@ -727,8 +727,8 @@ namespace TrilinosWrappers
 
     Ifpack_Preconditioner *ifpack = static_cast<Ifpack_Preconditioner *>
                                     (preconditioner.get());
-    Assert (ifpack != 0, ExcMessage ("Trilinos could not create this "
-                                     "preconditioner"));
+    Assert (ifpack != nullptr, ExcMessage ("Trilinos could not create this "
+                                           "preconditioner"));
 
     int ierr;
 
index e245aec4b27fba9c25a17b886b3d6d9526ffe6a4..cba0f83216afe78b9ddb8e6f3d2b16bc23b793e7 100644 (file)
@@ -235,7 +235,7 @@ namespace TrilinosWrappers
       {
         ML_Epetra::MultiLevelPreconditioner *multilevel_operator =
           dynamic_cast<ML_Epetra::MultiLevelPreconditioner *> (preconditioner.get());
-        Assert (multilevel_operator != 0,
+        Assert (multilevel_operator != nullptr,
                 ExcMessage ("Preconditioner setup failed."));
         multilevel_operator->PrintUnused(0);
       }
@@ -281,7 +281,7 @@ namespace TrilinosWrappers
     vector_distributor.reset (new Epetra_Map(static_cast<TrilinosWrappers::types::int_type>(n_rows),
                                              0, communicator));
 
-    if (trilinos_matrix.get() == 0)
+    if (trilinos_matrix.get() == nullptr)
       trilinos_matrix.reset (new SparseMatrix());
 
     trilinos_matrix->reinit (*vector_distributor, *vector_distributor,
@@ -317,7 +317,7 @@ namespace TrilinosWrappers
 
     // todo: find a way to read out ML's data
     // sizes
-    if (trilinos_matrix.get() != 0)
+    if (trilinos_matrix.get() != nullptr)
       memory += trilinos_matrix->memory_consumption();
     return memory;
   }
index c69fc1adcb3550ddf28e051a89088d69d0fbca04..7589c908d76561968a4655b178a8d3779036ee66 100644 (file)
@@ -290,7 +290,7 @@ namespace TrilinosWrappers
     vector_distributor.reset (new Epetra_Map(static_cast<TrilinosWrappers::types::int_type>(n_rows),
                                              0, communicator));
 
-    if (trilinos_matrix.get() == 0)
+    if (trilinos_matrix.get() == nullptr)
       trilinos_matrix.reset (new SparseMatrix());
 
     trilinos_matrix->reinit (*vector_distributor, *vector_distributor,
@@ -317,7 +317,7 @@ namespace TrilinosWrappers
 
     // todo: find a way to read out ML's data
     // sizes
-    if (trilinos_matrix.get() != 0)
+    if (trilinos_matrix.get() != nullptr)
       memory += trilinos_matrix->memory_consumption();
     return memory;
   }
index a6d704af78f16ddaa2d1b755e3441c7e373a345a..e0622ba46a978a341904e51978f138e5e2b6571e 100644 (file)
@@ -138,7 +138,7 @@ namespace TrilinosWrappers
       // get a representation of the present row
       int ncols;
       TrilinosWrappers::types::int_type colnums = matrix->n();
-      if (value_cache.get() == 0)
+      if (value_cache.get() == nullptr)
         {
           value_cache.reset (new std::vector<TrilinosScalar> (matrix->n()));
           colnum_cache.reset (new std::vector<size_type> (matrix->n()));
@@ -447,7 +447,7 @@ namespace TrilinosWrappers
         matrix->FillComplete(*column_space_map, matrix->RowMap());
       }
 
-    if (rhs.nonlocal_matrix.get() != 0)
+    if (rhs.nonlocal_matrix.get() != nullptr)
       nonlocal_matrix.reset(new Epetra_CrsMatrix(Copy, rhs.nonlocal_matrix->Graph()));
   }
 
@@ -636,7 +636,7 @@ namespace TrilinosWrappers
         relevant_rows.fill_index_vector(indices);
         Epetra_Map relevant_map (TrilinosWrappers::types::int_type(-1),
                                  TrilinosWrappers::types::int_type(relevant_rows.n_elements()),
-                                 (indices.empty() ? 0 :
+                                 (indices.empty() ? nullptr :
                                   reinterpret_cast<TrilinosWrappers::types::int_type *>(&indices[0])),
                                  0, input_row_map.Comm());
         if (relevant_map.SameAs(input_row_map))
@@ -663,7 +663,7 @@ namespace TrilinosWrappers
         }
 
       Epetra_Map off_processor_map(-1, ghost_rows.size(),
-                                   (ghost_rows.size()>0)?(&ghost_rows[0]):NULL,
+                                   (ghost_rows.size()>0)?(&ghost_rows[0]):nullptr,
                                    0, input_row_map.Comm());
 
       std::shared_ptr<Epetra_CrsGraph> graph;
@@ -671,7 +671,7 @@ namespace TrilinosWrappers
       if (input_row_map.Comm().NumProc() > 1)
         {
           graph.reset (new Epetra_CrsGraph (Copy, input_row_map,
-                                            (n_entries_per_row.size()>0)?(&n_entries_per_row[0]):NULL,
+                                            (n_entries_per_row.size()>0)?(&n_entries_per_row[0]):nullptr,
                                             exchange_data ? false : true));
           if (have_ghost_rows == true)
             nonlocal_graph.reset (new Epetra_CrsGraphMod (off_processor_map,
@@ -679,7 +679,7 @@ namespace TrilinosWrappers
         }
       else
         graph.reset (new Epetra_CrsGraph (Copy, input_row_map, input_col_map,
-                                          (n_entries_per_row.size()>0)?(&n_entries_per_row[0]):NULL,
+                                          (n_entries_per_row.size()>0)?(&n_entries_per_row[0]):nullptr,
                                           true));
 
       // now insert the indices, select between the right matrix
@@ -701,14 +701,14 @@ namespace TrilinosWrappers
             graph->InsertGlobalIndices (global_row, row_length, &row_indices[0]);
           else
             {
-              Assert(nonlocal_graph.get() != 0, ExcInternalError());
+              Assert(nonlocal_graph.get() != nullptr, ExcInternalError());
               nonlocal_graph->InsertGlobalIndices (global_row, row_length,
                                                    &row_indices[0]);
             }
         }
 
       // finalize nonlocal graph and create nonlocal matrix
-      if (nonlocal_graph.get() != 0)
+      if (nonlocal_graph.get() != nullptr)
         {
           // must make sure the IndicesAreGlobal flag is set on all processors
           // because some processors might not call InsertGlobalIndices (and
@@ -834,7 +834,7 @@ namespace TrilinosWrappers
     matrix.reset (new Epetra_FECrsMatrix
                   (Copy, sparsity_pattern.trilinos_sparsity_pattern(), false));
 
-    if (sparsity_pattern.nonlocal_graph.get() != 0)
+    if (sparsity_pattern.nonlocal_graph.get() != nullptr)
       nonlocal_matrix.reset (new Epetra_CrsMatrix(Copy, *sparsity_pattern.nonlocal_graph));
     else
       nonlocal_matrix.reset ();
@@ -857,7 +857,7 @@ namespace TrilinosWrappers
     matrix.reset (new Epetra_FECrsMatrix
                   (Copy, sparse_matrix.trilinos_sparsity_pattern(), false));
 
-    if (sparse_matrix.nonlocal_matrix != 0)
+    if (sparse_matrix.nonlocal_matrix != nullptr)
       nonlocal_matrix.reset (new Epetra_CrsMatrix
                              (Copy, sparse_matrix.nonlocal_matrix->Graph()));
     else
@@ -883,7 +883,7 @@ namespace TrilinosWrappers
       {
         // in case we do not copy values, just
         // call the other function.
-        if (use_this_sparsity == 0)
+        if (use_this_sparsity == nullptr)
           reinit (row_parallel_partitioning, col_parallel_partitioning,
                   dealii_sparse_matrix.get_sparsity_pattern(),
                   communicator, false);
@@ -899,10 +899,10 @@ namespace TrilinosWrappers
     AssertDimension (col_parallel_partitioning.size(), dealii_sparse_matrix.n());
 
     const ::dealii::SparsityPattern &sparsity_pattern =
-      (use_this_sparsity!=0)? *use_this_sparsity :
+      (use_this_sparsity!=nullptr)? *use_this_sparsity :
       dealii_sparse_matrix.get_sparsity_pattern();
 
-    if (matrix.get() == 0 ||
+    if (matrix.get() == nullptr ||
         m() != n_rows ||
         n_nonzero_elements() != sparsity_pattern.n_nonzero_elements())
       {
@@ -1073,12 +1073,12 @@ namespace TrilinosWrappers
 
     // flush buffers
     int ierr;
-    if (nonlocal_matrix.get() != 0 && mode == Add)
+    if (nonlocal_matrix.get() != nullptr && mode == Add)
       {
         // do only export in case of an add() operation, otherwise the owning
         // processor must have set the correct entry
         nonlocal_matrix->FillComplete(*column_space_map, matrix->RowMap());
-        if (nonlocal_matrix_exporter.get() == 0)
+        if (nonlocal_matrix_exporter.get() == nullptr)
           nonlocal_matrix_exporter.reset
           (new Epetra_Export(nonlocal_matrix->RowMap(), matrix->RowMap()));
         ierr = matrix->Export(*nonlocal_matrix, *nonlocal_matrix_exporter, mode);
@@ -1674,7 +1674,7 @@ namespace TrilinosWrappers
                                                              col_value_ptr,
                                                              col_index_ptr);
       }
-    else if (nonlocal_matrix.get() != 0)
+    else if (nonlocal_matrix.get() != nullptr)
       {
         compressed = false;
         // this is the case when we have explicitly set the off-processor rows
@@ -1721,7 +1721,7 @@ namespace TrilinosWrappers
                   << " has the following indices:" << std::endl;
         std::vector<TrilinosWrappers::types::int_type> indices;
         const Epetra_CrsGraph *graph =
-          (nonlocal_matrix.get() != 0 &&
+          (nonlocal_matrix.get() != nullptr &&
            matrix->RowMap().MyGID(static_cast<TrilinosWrappers::types::int_type>(row)) == false) ?
           &nonlocal_matrix->Graph() : &matrix->Graph();
 
@@ -1751,7 +1751,7 @@ namespace TrilinosWrappers
 
     const int ierr = matrix->PutScalar(d);
     AssertThrow (ierr == 0, ExcTrilinosError(ierr));
-    if (nonlocal_matrix.get() != 0)
+    if (nonlocal_matrix.get() != nullptr)
       nonlocal_matrix->PutScalar(d);
 
     return *this;
@@ -2250,7 +2250,7 @@ namespace TrilinosWrappers
       int max_per_proc;
       TrilinosWrappers::types::int_type N_input_vector = B_->invec_leng;
       getrow_comm = B_->getrow->pre_comm;
-      if ( getrow_comm != NULL)
+      if ( getrow_comm != nullptr)
         for (TrilinosWrappers::types::int_type i = 0; i < getrow_comm->N_neighbors; i++)
           for (TrilinosWrappers::types::int_type j = 0; j < getrow_comm->neighbors[i].N_send; j++)
             AssertThrow (getrow_comm->neighbors[i].send_list[j] < N_input_vector,
@@ -2259,7 +2259,7 @@ namespace TrilinosWrappers
       ML_create_unique_col_id(N_input_vector, &(B_->getrow->loc_glob_map),
                               getrow_comm, &max_per_proc, B_->comm);
       B_->getrow->use_loc_glob_map = ML_YES;
-      if (A_->getrow->pre_comm != NULL)
+      if (A_->getrow->pre_comm != nullptr)
         ML_exchange_rows( B_, &Btmp, A_->getrow->pre_comm);
       else Btmp = B_;
 
@@ -2269,20 +2269,20 @@ namespace TrilinosWrappers
       // release temporary structures we needed
       // for multiplication
       ML_free(B_->getrow->loc_glob_map);
-      B_->getrow->loc_glob_map = NULL;
+      B_->getrow->loc_glob_map = nullptr;
       B_->getrow->use_loc_glob_map = ML_NO;
-      if (A_->getrow->pre_comm != NULL)
+      if (A_->getrow->pre_comm != nullptr)
         {
           tptr = Btmp;
-          while ( (tptr!= NULL) && (tptr->sub_matrix != B_))
+          while ( (tptr!= nullptr) && (tptr->sub_matrix != B_))
             tptr = tptr->sub_matrix;
-          if (tptr != NULL) tptr->sub_matrix = NULL;
+          if (tptr != nullptr) tptr->sub_matrix = nullptr;
           ML_RECUR_CSR_MSRdata_Destroy(Btmp);
           ML_Operator_Destroy(&Btmp);
         }
 
       // make correct data structures
-      if (A_->getrow->post_comm != NULL)
+      if (A_->getrow->post_comm != nullptr)
         ML_exchange_rows(Ctmp, &Ctmp2, A_->getrow->post_comm);
       else
         Ctmp2 = Ctmp;
@@ -2292,7 +2292,7 @@ namespace TrilinosWrappers
       ML_RECUR_CSR_MSRdata_Destroy (Ctmp);
       ML_Operator_Destroy (&Ctmp);
 
-      if (A_->getrow->post_comm != NULL)
+      if (A_->getrow->post_comm != nullptr)
         {
           ML_RECUR_CSR_MSRdata_Destroy(Ctmp2);
           ML_Operator_Destroy (&Ctmp2);
@@ -2433,7 +2433,7 @@ namespace TrilinosWrappers
 
     const Epetra_MpiComm *mpi_comm
       = dynamic_cast<const Epetra_MpiComm *>(&matrix->RangeMap().Comm());
-    Assert(mpi_comm != 0, ExcInternalError());
+    Assert(mpi_comm != nullptr, ExcInternalError());
     return mpi_comm->Comm();
 #else
 
index 55fa3b192961b20fc135e843fa65514f2d8cfa01..d75f8aa7156f7f72f48c98dd64363bdbbdd2bd0f 100644 (file)
@@ -767,8 +767,8 @@ namespace TrilinosWrappers
   SparsityPattern::compress ()
   {
     int ierr;
-    Assert (column_space_map.get() != 0, ExcInternalError());
-    if (nonlocal_graph.get() != 0)
+    Assert (column_space_map.get() != nullptr, ExcInternalError());
+    if (nonlocal_graph.get() != nullptr)
       {
         if (nonlocal_graph->IndicesAreGlobal() == false &&
             nonlocal_graph->RowMap().NumMyElements() > 0)
@@ -1051,7 +1051,7 @@ namespace TrilinosWrappers
 
     const Epetra_MpiComm *mpi_comm
       = dynamic_cast<const Epetra_MpiComm *>(&graph->RangeMap().Comm());
-    Assert (mpi_comm != 0, ExcInternalError());
+    Assert (mpi_comm != nullptr, ExcInternalError());
     return mpi_comm->Comm();
 #else
 
index 9fb3d4ef91b28d6f7ef548ca0414867a7f3f178f..9858a5d9f855a2e758efb40d3df79759ddd9f877 100644 (file)
@@ -240,7 +240,7 @@ namespace TrilinosWrappers
 #if defined(DEBUG) && defined(DEAL_II_WITH_MPI)
       const Epetra_MpiComm *comm_ptr
         = dynamic_cast<const Epetra_MpiComm *>(&(vector->Comm()));
-      Assert (comm_ptr != 0, ExcInternalError());
+      Assert (comm_ptr != nullptr, ExcInternalError());
       const size_type n_elements_global
         = Utilities::MPI::sum (owned_elements.n_elements(), comm_ptr->Comm());
 
@@ -309,7 +309,7 @@ namespace TrilinosWrappers
 #ifdef DEAL_II_WITH_MPI
           const Epetra_MpiComm *my_comm = dynamic_cast<const Epetra_MpiComm *>(&vector->Comm());
           const Epetra_MpiComm *v_comm = dynamic_cast<const Epetra_MpiComm *>(&v.vector->Comm());
-          const bool same_communicators = my_comm != NULL && v_comm != NULL &&
+          const bool same_communicators = my_comm != nullptr && v_comm != nullptr &&
                                           my_comm->DataPtr() == v_comm->DataPtr();
 #else
           const bool same_communicators = true;
@@ -361,7 +361,7 @@ namespace TrilinosWrappers
 #if defined(DEBUG) && defined(DEAL_II_WITH_MPI)
       const Epetra_MpiComm *comm_ptr
         = dynamic_cast<const Epetra_MpiComm *>(&(v.vector->Comm()));
-      Assert (comm_ptr != 0, ExcInternalError());
+      Assert (comm_ptr != nullptr, ExcInternalError());
       const size_type n_elements_global
         = Utilities::MPI::sum (owned_elements.n_elements(), comm_ptr->Comm());
 
@@ -440,7 +440,7 @@ namespace TrilinosWrappers
 #if defined(DEBUG) && defined(DEAL_II_WITH_MPI)
       const Epetra_MpiComm *comm_ptr
         = dynamic_cast<const Epetra_MpiComm *>(&(vector->Comm()));
-      Assert (comm_ptr != 0, ExcInternalError());
+      Assert (comm_ptr != nullptr, ExcInternalError());
       const size_type n_elements_global
         = Utilities::MPI::sum (owned_elements.n_elements(), comm_ptr->Comm());
 
@@ -503,7 +503,7 @@ namespace TrilinosWrappers
 #ifdef DEAL_II_WITH_MPI
       const Epetra_MpiComm *my_comm = dynamic_cast<const Epetra_MpiComm *>(&vector->Comm());
       const Epetra_MpiComm *v_comm = dynamic_cast<const Epetra_MpiComm *>(&v.vector->Comm());
-      const bool same_communicators = my_comm != NULL && v_comm != NULL &&
+      const bool same_communicators = my_comm != nullptr && v_comm != nullptr &&
                                       my_comm->DataPtr() == v_comm->DataPtr();
       // Need to ask MPI whether the communicators are the same. We would like
       // to use the following checks but currently we cannot make sure the
@@ -535,7 +535,7 @@ namespace TrilinosWrappers
       if (same_communicators && v.vector->Map().SameAs(vector->Map()))
         {
           *vector = *v.vector;
-          if (v.nonlocal_vector.get() != 0)
+          if (v.nonlocal_vector.get() != nullptr)
             nonlocal_vector.reset(new Epetra_MultiVector(v.nonlocal_vector->Map(), 1));
           last_action = Zero;
         }
@@ -558,7 +558,7 @@ namespace TrilinosWrappers
           owned_elements = v.owned_elements;
         }
 
-      if (v.nonlocal_vector.get() != 0)
+      if (v.nonlocal_vector.get() != nullptr)
         nonlocal_vector.reset(new Epetra_MultiVector(v.nonlocal_vector->Map(), 1));
 
       return *this;
@@ -744,7 +744,7 @@ namespace TrilinosWrappers
 #ifdef DEAL_II_WITH_MPI
         const Epetra_MpiComm *my_comm = dynamic_cast<const Epetra_MpiComm *>(&vector->Comm());
         const Epetra_MpiComm *v_comm = dynamic_cast<const Epetra_MpiComm *>(&v.vector->Comm());
-        const bool same_communicators = my_comm != NULL && v_comm != NULL &&
+        const bool same_communicators = my_comm != nullptr && v_comm != nullptr &&
                                         my_comm->DataPtr() == v_comm->DataPtr();
 #else
         const bool same_communicators = true;
index 528b2fe524da5f4d4f84e1e447554de162c78b25..ed7689b8f8076789d2b760b2b999df0418226d44 100644 (file)
@@ -134,7 +134,7 @@ namespace TrilinosWrappers
   VectorBase &
   VectorBase::operator = (const VectorBase &v)
   {
-    Assert (vector.get() != 0,
+    Assert (vector.get() != nullptr,
             ExcMessage("Vector is not constructed properly."));
 
     if (local_range() != v.local_range())
@@ -214,7 +214,7 @@ namespace TrilinosWrappers
     double double_mode = mode;
     const Epetra_MpiComm *comm_ptr
       = dynamic_cast<const Epetra_MpiComm *>(&(vector_partitioner().Comm()));
-    Assert (comm_ptr != 0, ExcInternalError());
+    Assert (comm_ptr != nullptr, ExcInternalError());
     Utilities::MPI::MinMaxAvg result
       = Utilities::MPI::min_max_avg (double_mode, comm_ptr->GetMpiComm());
     Assert(result.max-result.min<1e-5,
@@ -227,7 +227,7 @@ namespace TrilinosWrappers
 
     // Now pass over the information about what we did last to the vector.
     int ierr = 0;
-    if (nonlocal_vector.get() == 0 || mode != Add)
+    if (nonlocal_vector.get() == nullptr || mode != Add)
       ierr = vector->GlobalAssemble(mode);
     else
       {
@@ -372,7 +372,7 @@ namespace TrilinosWrappers
     // is zero on _all_ processors.
     const Epetra_MpiComm *mpi_comm
       = dynamic_cast<const Epetra_MpiComm *>(&vector->Map().Comm());
-    Assert(mpi_comm != 0, ExcInternalError());
+    Assert(mpi_comm != nullptr, ExcInternalError());
     unsigned int num_nonzero = Utilities::MPI::sum(flag, mpi_comm->Comm());
     return num_nonzero == 0;
 #else
@@ -475,7 +475,7 @@ namespace TrilinosWrappers
       {
         double t = (*vector)[0][j];
 
-        if (format != 0)
+        if (format != nullptr)
           std::printf (format, t);
         else
           std::printf (" %5.2f", double(t));
index e68c796566406c2aef16abe081a5b2d86c64b01f..033a7ca73d40bf5fc47c027de2978343e0b68d2e 100644 (file)
@@ -76,7 +76,7 @@ MGLevelGlobalTransfer<VectorType>::fill_and_communicate_copy_indices
   const parallel::Triangulation<dim, spacedim> *ptria =
     dynamic_cast<const parallel::Triangulation<dim, spacedim> *>
     (&mg_dof.get_tria());
-  const MPI_Comm mpi_communicator = ptria != 0 ? ptria->get_communicator() :
+  const MPI_Comm mpi_communicator = ptria != nullptr ? ptria->get_communicator() :
                                     MPI_COMM_SELF;
   perform_plain_copy =
     Utilities::MPI::min(static_cast<int>(perform_plain_copy),
@@ -95,7 +95,7 @@ MGLevelGlobalTransfer<VectorType>::clear()
   copy_indices_global_mine.clear();
   copy_indices_level_mine.clear();
   component_to_block_map.resize(0);
-  mg_constrained_dofs = 0;
+  mg_constrained_dofs = nullptr;
 }
 
 
@@ -173,7 +173,7 @@ MGLevelGlobalTransfer<LinearAlgebra::distributed::Vector<Number> >::fill_and_com
   const parallel::Triangulation<dim, spacedim> *ptria =
     dynamic_cast<const parallel::Triangulation<dim, spacedim> *>
     (&mg_dof.get_tria());
-  const MPI_Comm mpi_communicator = ptria != 0 ? ptria->get_communicator() :
+  const MPI_Comm mpi_communicator = ptria != nullptr ? ptria->get_communicator() :
                                     MPI_COMM_SELF;
 
   IndexSet index_set(mg_dof.locally_owned_dofs().size());
@@ -286,7 +286,7 @@ MGLevelGlobalTransfer<LinearAlgebra::distributed::Vector<Number> >::clear()
   copy_indices_global_mine.clear();
   copy_indices_level_mine.clear();
   component_to_block_map.resize(0);
-  mg_constrained_dofs = 0;
+  mg_constrained_dofs = nullptr;
   ghosted_global_vector.reinit(0);
   ghosted_level_vector.resize(0, 0);
 }
index 21fcd462afa3d0d2ddc1ae21e14a534d51ffe818..a560e66708053a58a56403df216f8581398aa527 100644 (file)
@@ -398,7 +398,7 @@ void MGTransferBlockBase::build_matrices (
   // impose boundary conditions
   // but only in the column of
   // the prolongation matrix
-  if (mg_constrained_dofs != 0 && mg_constrained_dofs->have_boundary_indices())
+  if (mg_constrained_dofs != nullptr && mg_constrained_dofs->have_boundary_indices())
     {
       std::vector<types::global_dof_index> constrain_indices;
       std::vector<std::vector<bool> > constraints_per_block (n_blocks);
@@ -494,7 +494,7 @@ void MGTransferBlockSelect<number>::build_matrices (
               const unsigned int block = fe.system_to_block_index(i).first;
               if (selected[block])
                 {
-                  if (mg_constrained_dofs != 0)
+                  if (mg_constrained_dofs != nullptr)
                     {
                       if (!mg_constrained_dofs->at_refinement_edge(level,level_dof_indices[i]))
                         temp_copy_indices[level_dof_indices[i] - mg_block_start[level][block]]
index f2913b8a7c874049cb38c3d81b1de1a03a618517..7606ca0d6f10f4d647a10dcbb678bfb3db75a5e4 100644 (file)
@@ -114,7 +114,7 @@ namespace internal
               for (unsigned int i=0; i<dofs_per_cell; ++i)
                 {
                   // we need to ignore if the DoF is on a refinement edge (hanging node)
-                  if (mg_constrained_dofs != 0
+                  if (mg_constrained_dofs != nullptr
                       && mg_constrained_dofs->at_refinement_edge(level, level_dof_indices[i]))
                     continue;
                   types::global_dof_index global_idx = globally_relevant.index_within_set(global_dof_indices[i]);
@@ -151,7 +151,7 @@ namespace internal
       const dealii::parallel::distributed::Triangulation<dim,spacedim> *tria =
         (dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>
          (&mg_dof.get_triangulation()));
-      AssertThrow(send_data_temp.size()==0 || tria!=NULL, ExcMessage("parallel Multigrid only works with a distributed Triangulation!"));
+      AssertThrow(send_data_temp.size()==0 || tria!=nullptr, ExcMessage("parallel Multigrid only works with a distributed Triangulation!"));
 
 #ifdef DEAL_II_WITH_MPI
       if (tria)
@@ -201,7 +201,7 @@ namespace internal
                   }
                 else
                   {
-                    const int ierr = MPI_Isend(NULL, 0, MPI_BYTE, dest, 71,
+                    const int ierr = MPI_Isend(nullptr, 0, MPI_BYTE, dest, 71,
                                                tria->get_communicator(), &*requests.rbegin());
                     AssertThrowMPI(ierr);
                   }
@@ -223,7 +223,7 @@ namespace internal
 
                 if (len==0)
                   {
-                    ierr = MPI_Recv(NULL, 0, MPI_BYTE, status.MPI_SOURCE, status.MPI_TAG,
+                    ierr = MPI_Recv(nullptr, 0, MPI_BYTE, status.MPI_SOURCE, status.MPI_TAG,
                                     tria->get_communicator(), &status);
                     AssertThrowMPI(ierr);
                     continue;
@@ -596,7 +596,7 @@ namespace internal
 
                       // set Dirichlet boundary conditions (as a list of
                       // constrained DoFs) for the child
-                      if (mg_constrained_dofs != 0)
+                      if (mg_constrained_dofs != nullptr)
                         for (unsigned int i=0; i<mg_dof.get_fe().dofs_per_cell; ++i)
                           if (mg_constrained_dofs->is_boundary_index(level,
                                                                      local_dof_indices[elem_info.lexicographic_numbering[i]]))
@@ -632,7 +632,7 @@ namespace internal
                                          &global_level_dof_indices_l0[start_index]);
 
                   dirichlet_indices[0].push_back(std::vector<unsigned short>());
-                  if (mg_constrained_dofs != 0)
+                  if (mg_constrained_dofs != nullptr)
                     for (unsigned int i=0; i<mg_dof.get_fe().dofs_per_cell; ++i)
                       if (mg_constrained_dofs->is_boundary_index(0, local_dof_indices[elem_info.lexicographic_numbering[i]]))
                         dirichlet_indices[0].back().push_back(i);
@@ -665,7 +665,7 @@ namespace internal
           const parallel::Triangulation<dim,dim> *ptria =
             (dynamic_cast<const parallel::Triangulation<dim,dim>*> (&tria));
           const MPI_Comm communicator =
-            ptria != 0 ? ptria->get_communicator() : MPI_COMM_SELF;
+            ptria != nullptr ? ptria->get_communicator() : MPI_COMM_SELF;
 
           reinit_ghosted_vector (mg_dof.locally_owned_mg_dofs(level),
                                  ghosted_level_dofs, communicator,
index a35c37353cd0968386b2ebdbbc1427ba3670c016..a97182c30d545b88a658a2d0af5c999d608d9f2d 100644 (file)
@@ -249,7 +249,7 @@ void MGTransferPrebuilt<VectorType>::build_matrices
                   = mg_dof.get_fe().get_prolongation_matrix (child,
                                                              cell->refinement_case());
 
-                if (this->mg_constrained_dofs != 0 &&
+                if (this->mg_constrained_dofs != nullptr &&
                     this->mg_constrained_dofs->have_boundary_indices())
                   for (unsigned int j=0; j<dofs_per_cell; ++j)
                     if (this->mg_constrained_dofs->is_boundary_index(level, dof_indices_parent[j]))
index d5ccb8210b56f7bdc772f4eff910067a12f11be2..19adb5148af267f522787e7f122840e2b1543684 100644 (file)
@@ -61,14 +61,14 @@ MGTransferBlockBase::MGTransferBlockBase (const ConstraintMatrix &/*c*/,
 template <typename number>
 MGTransferBlock<number>::MGTransferBlock ()
   :
-  memory(0, typeid(*this).name())
+  memory(nullptr, typeid(*this).name())
 {}
 
 
 template <typename number>
 MGTransferBlock<number>::~MGTransferBlock ()
 {
-  if (memory != 0) memory = 0;
+  if (memory != nullptr) memory = nullptr;
 }
 
 
@@ -126,7 +126,7 @@ void MGTransferBlock<number>::restrict_and_add (
         {
           if (factors.size() != 0)
             {
-              Assert (memory != 0, ExcNotInitialized());
+              Assert (memory != nullptr, ExcNotInitialized());
               Vector<number> *aux = memory->alloc();
               aux->reinit(dst.block(this->mg_block[b]));
               prolongation_matrices[from_level-1]->block(b,b).Tvmult (
index 4fa6429a8f549c5d897cdbc876744661f93ae86d..d32cb9452d8ca564caaefd5f7bbea434178d7eaf 100644 (file)
@@ -145,7 +145,7 @@ build_one_patch
           const DataPostprocessor<DoFHandlerType::space_dimension> *postprocessor
             = this->dof_data[dataset]->postprocessor;
 
-          if (postprocessor != 0)
+          if (postprocessor != nullptr)
             {
               // we have to postprocess the data, so determine, which fields
               // have to be updated
@@ -331,7 +331,7 @@ void DataOut<dim,DoFHandlerType>::build_patches
   // Check consistency of redundant template parameter
   Assert (dim==DoFHandlerType::dimension, ExcDimensionMismatch(dim, DoFHandlerType::dimension));
 
-  Assert (this->triangulation != 0,
+  Assert (this->triangulation != nullptr,
           Exceptions::DataOut::ExcNoTriangulationSelected());
 
   const unsigned int n_subdivisions = (n_subdivisions_ != 0)
index d8a7f6472fb51fecb54208a1f8bec71207b9d19a..e767e33cc092f6a79ec13be75cf2ffd36eb8cf4b 100644 (file)
@@ -82,7 +82,7 @@ namespace internal
                     x_fe_values[i] = x_fe_values[j];
                     break;
                   }
-              if (x_fe_values[i].get() == 0)
+              if (x_fe_values[i].get() == nullptr)
                 x_fe_values[i].reset(new dealii::hp::FEValues<dim,spacedim>
                                      (this->mapping_collection,
                                       *this->finite_elements[i],
@@ -107,7 +107,7 @@ namespace internal
                     x_fe_face_values[i] = x_fe_face_values[j];
                     break;
                   }
-              if (x_fe_face_values[i].get() == 0)
+              if (x_fe_face_values[i].get() == nullptr)
                 x_fe_face_values[i].reset(new dealii::hp::FEFaceValues<dim,spacedim>
                                           (this->mapping_collection,
                                            *this->finite_elements[i],
@@ -166,7 +166,7 @@ namespace internal
                     x_fe_values[i] = x_fe_values[j];
                     break;
                   }
-              if (x_fe_values[i].get() == 0)
+              if (x_fe_values[i].get() == nullptr)
                 x_fe_values[i].reset(new dealii::hp::FEValues<dim,spacedim>
                                      (this->mapping_collection,
                                       *this->finite_elements[i],
@@ -190,7 +190,7 @@ namespace internal
                     x_fe_face_values[i] = x_fe_face_values[j];
                     break;
                   }
-              if (x_fe_face_values[i].get() == 0)
+              if (x_fe_face_values[i].get() == nullptr)
                 x_fe_face_values[i].reset(new dealii::hp::FEFaceValues<dim,spacedim>
                                           (this->mapping_collection,
                                            *this->finite_elements[i],
@@ -312,7 +312,7 @@ namespace internal
       dof_handler (dofs, typeid(dealii::DataOut_DoFData<DoFHandlerType,DoFHandlerType::dimension,DoFHandlerType::space_dimension>).name()),
       names(names_in),
       data_component_interpretation (data_component_interpretation),
-      postprocessor(0, typeid(*this).name()),
+      postprocessor(nullptr, typeid(*this).name()),
       n_output_variables(names.size())
     {
       Assert (names.size() == data_component_interpretation.size(),
@@ -820,8 +820,8 @@ namespace internal
     void
     DataEntry<DoFHandlerType,VectorType>::clear ()
     {
-      vector = 0;
-      this->dof_handler = 0;
+      vector = nullptr;
+      this->dof_handler = nullptr;
     }
   }
 }
@@ -832,8 +832,8 @@ template <typename DoFHandlerType,
           int patch_dim, int patch_space_dim>
 DataOut_DoFData<DoFHandlerType,patch_dim,patch_space_dim>::DataOut_DoFData ()
   :
-  triangulation(0,typeid(*this).name()),
-  dofs(0,typeid(*this).name())
+  triangulation(nullptr,typeid(*this).name()),
+  dofs(nullptr,typeid(*this).name())
 {}
 
 
@@ -892,10 +892,10 @@ add_data_vector (const VectorType                         &vec,
                  const DataVectorType                      type,
                  const std::vector<DataComponentInterpretation::DataComponentInterpretation> &data_component_interpretation)
 {
-  Assert (triangulation != 0,
+  Assert (triangulation != nullptr,
           Exceptions::DataOut::ExcNoTriangulationSelected ());
   const unsigned int n_components =
-    dofs != 0 ? dofs->get_fe().n_components () : 1;
+    dofs != nullptr ? dofs->get_fe().n_components () : 1;
 
   std::vector<std::string> names;
   // if only one component or vector is cell vector: we only need one name
@@ -931,7 +931,7 @@ add_data_vector (const VectorType                         &vec,
                  const DataVectorType                      type,
                  const std::vector<DataComponentInterpretation::DataComponentInterpretation> &data_component_interpretation_)
 {
-  Assert (triangulation != 0,
+  Assert (triangulation != nullptr,
           Exceptions::DataOut::ExcNoTriangulationSelected ());
 
   const std::vector<DataComponentInterpretation::DataComponentInterpretation> &
@@ -949,7 +949,7 @@ add_data_vector (const VectorType                         &vec,
   if (type == type_automatic)
     {
       // in the rare case that someone has a DGP(0) attached, we can not decide what she wants here:
-      Assert((dofs == 0) || (triangulation->n_active_cells() != dofs->n_dofs()),
+      Assert((dofs == nullptr) || (triangulation->n_active_cells() != dofs->n_dofs()),
              ExcMessage("Unable to determine the type of vector automatically because the number of DoFs "
                         "is equal to the number of cells. Please specify DataVectorType."));
 
@@ -970,7 +970,7 @@ add_data_vector (const VectorType                         &vec,
       break;
 
     case type_dof_data:
-      Assert (dofs != 0,
+      Assert (dofs != nullptr,
               Exceptions::DataOut::ExcNoDoFHandlerSelected ());
       Assert (vec.size() == dofs->n_dofs(),
               Exceptions::DataOut::ExcInvalidVectorSize (vec.size(),
@@ -1010,7 +1010,7 @@ add_data_vector (const VectorType                       &vec,
   // things a bit simpler, we also don't need to deal with some of the other
   // stuff and use a different constructor of DataEntry
 
-  Assert (dofs != 0,
+  Assert (dofs != nullptr,
           Exceptions::DataOut::ExcNoDoFHandlerSelected ());
 
   Assert (vec.size() == dofs->n_dofs(),
@@ -1096,7 +1096,7 @@ add_data_vector
   // this is an extended version of the other functions where we pass a vector
   // together with its DoFHandler. if we do, we know that we have
   // type_dof_data, which makes things a bit simpler
-  if (triangulation == 0)
+  if (triangulation == nullptr)
     triangulation = SmartPointer<const Triangulation<DoFHandlerType::dimension,DoFHandlerType::space_dimension> >(&dof_handler.get_triangulation(), typeid(*this).name());
 
   Assert (&dof_handler.get_triangulation() == triangulation,
@@ -1152,8 +1152,8 @@ clear_input_data_references ()
   for (unsigned int i=0; i<cell_data.size(); ++i)
     cell_data[i]->clear ();
 
-  if (dofs != 0)
-    dofs = 0;
+  if (dofs != nullptr)
+    dofs = nullptr;
 }
 
 
@@ -1166,8 +1166,8 @@ DataOut_DoFData<DoFHandlerType,patch_dim,patch_space_dim>::clear ()
   dof_data.erase (dof_data.begin(), dof_data.end());
   cell_data.erase (cell_data.begin(), cell_data.end());
 
-  if (dofs != 0)
-    dofs = 0;
+  if (dofs != nullptr)
+    dofs = nullptr;
 
   // delete patches
   std::vector<Patch> dummy;
@@ -1320,7 +1320,7 @@ std::vector<std::shared_ptr<dealii::hp::FECollection<DoFHandlerType::dimension,
   finite_elements(this->dof_data.size());
   for (unsigned int i=0; i<this->dof_data.size(); ++i)
     {
-      Assert (dof_data[i]->dof_handler != 0,
+      Assert (dof_data[i]->dof_handler != nullptr,
               Exceptions::DataOut::ExcNoDoFHandlerSelected ());
 
       // avoid creating too many finite elements and doing a lot of work on
index a8ecfcc96d480c6aec3b3936ed5cc6132e017d75..6424125a5f785ba5b70480a89ff467cee04223c0 100644 (file)
@@ -143,7 +143,7 @@ build_one_patch (const FaceDescriptor *cell_and_face,
           const unsigned int n_components
             = this_fe_patch_values.get_fe().n_components();
           const DataPostprocessor<dim> *postprocessor=this->dof_data[dataset]->postprocessor;
-          if (postprocessor != 0)
+          if (postprocessor != nullptr)
             {
               // we have to postprocess the data, so determine, which fields
               // have to be updated
@@ -290,7 +290,7 @@ void DataOutFaces<dim,DoFHandlerType>::build_patches (const Mapping<dimension> &
   Assert (n_subdivisions >= 1,
           Exceptions::DataOut::ExcInvalidNumberOfSubdivisions(n_subdivisions));
 
-  Assert (this->triangulation != 0,
+  Assert (this->triangulation != nullptr,
           Exceptions::DataOut::ExcNoTriangulationSelected());
 
   this->validate_dataset_names();
index 664ec0e9cd299007c9a5372e21bfb84e1d20fda8..eb2b54a90db7e71d560caa9337fe789d63a3c718 100644 (file)
@@ -191,7 +191,7 @@ build_one_patch (const cell_iterator
               const unsigned int n_components
                 = fe_patch_values.get_fe().n_components();
               const DataPostprocessor<dim> *postprocessor=this->dof_data[dataset]->postprocessor;
-              if (postprocessor != 0)
+              if (postprocessor != nullptr)
                 {
                   // we have to postprocess the
                   // data, so determine, which
@@ -407,7 +407,7 @@ void DataOutRotation<dim,DoFHandlerType>::build_patches (const unsigned int n_pa
   // Check consistency of redundant
   // template parameter
   Assert (dim==dimension, ExcDimensionMismatch(dim, dimension));
-  Assert (this->triangulation != 0,
+  Assert (this->triangulation != nullptr,
           Exceptions::DataOut::ExcNoTriangulationSelected());
 
   const unsigned int n_subdivisions = (nnnn_subdivisions != 0)
index b931d0aaa0f9ca3d618527f13fdd85eb61cf571f..bdd25283eccccb8347f18bafe7f4b64fedfea598 100644 (file)
@@ -168,7 +168,7 @@ template <typename number>
 void DataOutStack<dim,spacedim,DoFHandlerType>::add_data_vector (const Vector<number> &vec,
     const std::vector<std::string> &names)
 {
-  Assert (dof_handler != 0,
+  Assert (dof_handler != nullptr,
           Exceptions::DataOut::ExcNoDoFHandlerSelected ());
   // either cell data and one name,
   // or dof data and n_components names
@@ -243,7 +243,7 @@ void DataOutStack<dim,spacedim,DoFHandlerType>::build_patches (const unsigned in
 
   Assert (n_subdivisions >= 1,
           Exceptions::DataOut::ExcInvalidNumberOfSubdivisions(n_subdivisions));
-  Assert (dof_handler != 0,
+  Assert (dof_handler != nullptr,
           Exceptions::DataOut::ExcNoDoFHandlerSelected());
 
   this->validate_dataset_names();
@@ -421,7 +421,7 @@ template <int dim, int spacedim, typename DoFHandlerType>
 void DataOutStack<dim,spacedim,DoFHandlerType>::finish_parameter_value ()
 {
   // release lock on dof handler
-  dof_handler = 0;
+  dof_handler = nullptr;
   for (typename std::vector<DataVector>::iterator i=dof_data.begin();
        i!=dof_data.end(); ++i)
     i->data.reinit (0);
index b38c6be421f761ce62955a0990d950ad62cf2255..8ab52414bc1076920bfef2013e2186ae5e871e73 100644 (file)
@@ -224,7 +224,7 @@ estimate (const Mapping<1,spacedim>                  &mapping,
 #ifdef DEAL_II_WITH_P4EST
   if (dynamic_cast<const parallel::distributed::Triangulation<1,spacedim>*>
       (&dof_handler.get_triangulation())
-      != 0)
+      != nullptr)
     Assert ((subdomain_id_ == numbers::invalid_subdomain_id)
             ||
             (subdomain_id_ ==
@@ -237,7 +237,7 @@ estimate (const Mapping<1,spacedim>                  &mapping,
   const types::subdomain_id subdomain_id
     = ((dynamic_cast<const parallel::distributed::Triangulation<1,spacedim>*>
         (&dof_handler.get_triangulation())
-        != 0)
+        != nullptr)
        ?
        dynamic_cast<const parallel::distributed::Triangulation<1,spacedim>&>
        (dof_handler.get_triangulation()).locally_owned_subdomain()
@@ -269,7 +269,7 @@ estimate (const Mapping<1,spacedim>                  &mapping,
   Assert (component_mask.n_selected_components(n_components) > 0,
           ExcInvalidComponentMask());
 
-  Assert ((coefficient == 0) ||
+  Assert ((coefficient == nullptr) ||
           (coefficient->n_components == n_components) ||
           (coefficient->n_components == 1),
           ExcInvalidCoefficient());
@@ -283,7 +283,7 @@ estimate (const Mapping<1,spacedim>                  &mapping,
             ExcDimensionMismatch(solutions[n]->size(),
                                  dof_handler.n_dofs()));
 
-  Assert ((coefficient == 0) ||
+  Assert ((coefficient == nullptr) ||
           (coefficient->n_components == n_components) ||
           (coefficient->n_components == 1),
           ExcInvalidCoefficient());
@@ -315,7 +315,7 @@ estimate (const Mapping<1,spacedim>                  &mapping,
   // coefficient, then we fill it by unity once and for all and don't set it
   // any more
   Vector<double> coefficient_values (n_components);
-  if (coefficient == 0)
+  if (coefficient == nullptr)
     for (unsigned int c=0; c<n_components; ++c)
       coefficient_values(c) = 1;
 
@@ -417,7 +417,7 @@ estimate (const Mapping<1,spacedim>                  &mapping,
 
             // if there is a coefficient, then evaluate it at the present
             // position. if there is none, reuse the preset values.
-            if (coefficient != 0)
+            if (coefficient != nullptr)
               {
                 if (coefficient->n_components == 1)
                   {
index c7a5052a2b8dbf4baa71f43b504d052b50a934ac..d7b41f505fa27d772d86b2b21b547a7280c6aca8 100644 (file)
@@ -531,7 +531,7 @@ void PointValueHistory<dim>
 ::clear ()
 {
   cleared = true;
-  dof_handler = 0;
+  dof_handler = nullptr;
   have_dof_handler = false;
 }
 
index a07d3df637a9dc99686c6f57f8761c7dc6876ba8..7c27ab681b242fc4723e30f832e98f2f25ae60de 100644 (file)
@@ -46,7 +46,7 @@ SolutionTransfer(const DoFHandlerType &dof)
 {
   Assert ((dynamic_cast<const parallel::distributed::Triangulation<DoFHandlerType::dimension, DoFHandlerType::space_dimension>*>
            (&dof_handler->get_tria())
-           == 0),
+           == nullptr),
           ExcMessage ("You are calling the dealii::SolutionTransfer class "
                       "with a DoF handler that is built on a "
                       "parallel::distributed::Triangulation. This will not "
@@ -451,7 +451,7 @@ interpolate (const std::vector<VectorType> &all_in,
           // cell stayed as it was or was refined
           if (indexptr)
             {
-              Assert (valuesptr == 0,
+              Assert (valuesptr == nullptr,
                       ExcInternalError());
 
               const unsigned int old_fe_index =
@@ -478,7 +478,7 @@ interpolate (const std::vector<VectorType> &all_in,
             // deleted
             {
               Assert (!cell->has_children(), ExcInternalError());
-              Assert (indexptr == 0,
+              Assert (indexptr == nullptr,
                       ExcInternalError());
 
               const unsigned int dofs_per_cell = cell->get_fe().dofs_per_cell;
@@ -502,7 +502,7 @@ interpolate (const std::vector<VectorType> &all_in,
                   // test we would have to
                   // store the fe_index of all
                   // cells
-                  const Vector<typename VectorType::value_type> *data = 0;
+                  const Vector<typename VectorType::value_type> *data = nullptr;
                   const unsigned int active_fe_index = cell->active_fe_index();
                   if (active_fe_index != pointerstruct->second.active_fe_index)
                     {
index 1cf56e6b0c2d04ebfc9d682d4608f7a14010df0d..7438686ebe29045baf2141ea1d9256b8b4a22368 100644 (file)
@@ -65,34 +65,34 @@ TimeDependent::insert_timestep (const TimeStepBase *position,
                                 TimeStepBase       *new_timestep)
 {
   Assert ((std::find(timesteps.begin(), timesteps.end(), position) != timesteps.end()) ||
-          (position == 0),
+          (position == nullptr),
           ExcInvalidPosition());
   // first insert the new time step
   // into the doubly linked list
   // of timesteps
-  if (position == 0)
+  if (position == nullptr)
     {
       // at the end
-      new_timestep->set_next_timestep (0);
+      new_timestep->set_next_timestep (nullptr);
       if (timesteps.size() > 0)
         {
           timesteps.back()->set_next_timestep (new_timestep);
           new_timestep->set_previous_timestep (timesteps.back());
         }
       else
-        new_timestep->set_previous_timestep (0);
+        new_timestep->set_previous_timestep (nullptr);
     }
   else if (position == timesteps[0])
     {
       // at the beginning
-      new_timestep->set_previous_timestep (0);
+      new_timestep->set_previous_timestep (nullptr);
       if (timesteps.size() > 0)
         {
           timesteps[0]->set_previous_timestep (new_timestep);
           new_timestep->set_next_timestep (timesteps[0]);
         }
       else
-        new_timestep->set_next_timestep (0);
+        new_timestep->set_next_timestep (nullptr);
     }
   else
     {
@@ -108,7 +108,7 @@ TimeDependent::insert_timestep (const TimeStepBase *position,
 
   // finally enter it into the
   // array
-  timesteps.insert ((position == 0 ?
+  timesteps.insert ((position == nullptr ?
                      timesteps.end() :
                      std::find(timesteps.begin(), timesteps.end(), position)),
                     new_timestep);
@@ -118,7 +118,7 @@ TimeDependent::insert_timestep (const TimeStepBase *position,
 void
 TimeDependent::add_timestep (TimeStepBase *new_timestep)
 {
-  insert_timestep (0, new_timestep);
+  insert_timestep (nullptr, new_timestep);
 }
 
 
@@ -131,7 +131,7 @@ void TimeDependent::delete_timestep (const unsigned int position)
   // later deletion and unlock
   // SmartPointer
   TimeStepBase *t = timesteps[position];
-  timesteps[position] = 0;
+  timesteps[position] = nullptr;
   // Now delete unsubscribed object
   delete t;
 
@@ -250,8 +250,8 @@ TimeDependent::memory_consumption () const
 
 
 TimeStepBase::TimeStepBase (const double time) :
-  previous_timestep(0),
-  next_timestep (0),
+  previous_timestep(nullptr),
+  next_timestep (nullptr),
   sweep_no (numbers::invalid_unsigned_int),
   timestep_no (numbers::invalid_unsigned_int),
   time (time),
@@ -348,7 +348,7 @@ TimeStepBase::get_timestep_no () const
 double
 TimeStepBase::get_backward_timestep () const
 {
-  Assert (previous_timestep != 0,
+  Assert (previous_timestep != nullptr,
           ExcMessage("The backward time step cannot be computed because "
                      "there is no previous time step."));
   return time - previous_timestep->time;
@@ -359,7 +359,7 @@ TimeStepBase::get_backward_timestep () const
 double
 TimeStepBase::get_forward_timestep () const
 {
-  Assert (next_timestep != 0,
+  Assert (next_timestep != nullptr,
           ExcMessage("The forward time step cannot be computed because "
                      "there is no next time step."));
   return next_timestep->time - time;
@@ -411,8 +411,8 @@ TimeStepBase::memory_consumption () const
 template <int dim>
 TimeStepBase_Tria<dim>::TimeStepBase_Tria() :
   TimeStepBase (0),
-  tria (0, typeid(*this).name()),
-  coarse_grid (0, typeid(*this).name()),
+  tria (nullptr, typeid(*this).name()),
+  coarse_grid (nullptr, typeid(*this).name()),
   flags (),
   refinement_flags(0)
 {
@@ -427,7 +427,7 @@ TimeStepBase_Tria<dim>::TimeStepBase_Tria (const double              time,
                                            const Flags              &flags,
                                            const RefinementFlags    &refinement_flags) :
   TimeStepBase (time),
-  tria(0, typeid(*this).name()),
+  tria(nullptr, typeid(*this).name()),
   coarse_grid (&coarse_grid, typeid(*this).name()),
   flags (flags),
   refinement_flags (refinement_flags)
@@ -441,13 +441,13 @@ TimeStepBase_Tria<dim>::~TimeStepBase_Tria ()
   if (!flags.delete_and_rebuild_tria)
     {
       Triangulation<dim> *t = tria;
-      tria = 0;
+      tria = nullptr;
       delete t;
     }
   else
-    Assert (tria==0, ExcInternalError());
+    Assert (tria==nullptr, ExcInternalError());
 
-  coarse_grid = 0;
+  coarse_grid = nullptr;
 }
 
 
@@ -471,12 +471,12 @@ TimeStepBase_Tria<dim>::sleep (const unsigned int sleep_level)
 {
   if (sleep_level == flags.sleep_level_to_delete_grid)
     {
-      Assert (tria!=0, ExcInternalError());
+      Assert (tria!=nullptr, ExcInternalError());
 
       if (flags.delete_and_rebuild_tria)
         {
           Triangulation<dim> *t = tria;
-          tria = 0;
+          tria = nullptr;
           delete t;
         }
     }
@@ -502,7 +502,7 @@ void TimeStepBase_Tria<dim>::save_refine_flags ()
 template <int dim>
 void TimeStepBase_Tria<dim>::restore_grid ()
 {
-  Assert (tria == 0, ExcGridNotDeleted());
+  Assert (tria == nullptr, ExcGridNotDeleted());
   Assert (refine_flags.size() == coarsen_flags.size(),
           ExcInternalError());
 
@@ -741,8 +741,8 @@ void TimeStepBase_Tria<dim>::refine_grid (const RefinementData refinement_data)
   // two pointers into this array denoting
   // the position where the two thresholds
   // are assumed
-  Vector<float>::const_iterator p_refinement_threshold=0,
-                                p_coarsening_threshold=0;
+  Vector<float>::const_iterator p_refinement_threshold=nullptr,
+                                p_coarsening_threshold=nullptr;
 
 
   // if we are to do some cell number
index aa4fab80afef4990392992f3933d75449fd850cf..1c73bce3cb01f324b2f8f3dac83b0effb1c544f3 100644 (file)
@@ -64,12 +64,12 @@ void extract(const AnyData &data)
 
   deallog << *data.try_read<double>(" d  17.") << std::endl;
 
-  if (data.try_read<char *>(" d  17.") == 0)
+  if (data.try_read<char *>(" d  17.") == nullptr)
     deallog << "(nil)" << std::endl;
   else
     AssertThrow (false, ExcInternalError());
 
-  if (data.try_read<double>("does not exist") == 0)
+  if (data.try_read<double>("does not exist") == nullptr)
     deallog << "(nil)" << std::endl;
   else
     AssertThrow (false, ExcInternalError());
index 140fd3325b0a1f42ce35838c450874c0792ead38..673063a4115897fedcd7e89e983e65eff25efb80 100644 (file)
@@ -40,7 +40,7 @@ public:
     for (unsigned int i=0; i<vectors.size(); ++i)
       {
         const VectorType *p = vectors.try_read_ptr<VectorType>(i);
-        if (p!=0)
+        if (p!=nullptr)
           {
             // this should be equal to dof->n_dofs() otherwise
             // DoFOutputOperator will complain
index cf0639d6268fc7d23616432749cf471dbb644392..762d8db0db7fb632b1f475e0dfa0a76450233ae0 100644 (file)
@@ -155,8 +155,8 @@ void test ()
     new FE_DGQ<dim>(0),
     new FE_DGQ<dim>(1),
     new FE_DGQ<dim>(2),
-    (dim<3 ? new FE_DGQ<dim>(3) : 0),
-    (dim<3 ? new FE_DGQ<dim>(4) : 0),
+    (dim<3 ? new FE_DGQ<dim>(3) : nullptr),
+    (dim<3 ? new FE_DGQ<dim>(4) : nullptr),
 
     // FE_DGP
     new FE_DGP<dim>(0),
@@ -225,7 +225,7 @@ void test ()
 
 
       for (unsigned int i=0; i<sizeof(fe_list)/sizeof(fe_list[0]); ++i)
-        if (fe_list[i] != 0)
+        if (fe_list[i] != nullptr)
           {
             deallog << dim << "d, uniform grid, fe #" << i
                     << ", " << ref_case_names[j];
@@ -235,7 +235,7 @@ void test ()
 
 
   for (unsigned int i=0; i<sizeof(fe_list)/sizeof(fe_list[0]); ++i)
-    if (fe_list[i] != 0)
+    if (fe_list[i] != nullptr)
       delete fe_list[i];
 }
 
index acccb844d70631d9974c565e04e9d39c38b60559..88eb40bfa3c31466d61c5a1767a9e9e3d6d37608 100644 (file)
@@ -29,7 +29,7 @@ void test ()
   ArrayView<int> a (&v[4], 0);
   ArrayView<int> b = a;
 
-  ArrayView<int> c (NULL, 0);
+  ArrayView<int> c (nullptr, 0);
   ArrayView<int> d = a;
 
   deallog << "OK" << std::endl;
index 5bc44585ec18a7aabd8396389e01b7061f938492..be0ae3e6f11fbf63fbb9a59c90fc3fa47d48d12a 100644 (file)
@@ -32,6 +32,24 @@ struct EqualityWithSizeofTest
   }
 };
 
+
+template<typename T>
+struct EqualityWithSizeofTest<T *>
+{
+  EqualityWithSizeofTest()
+  {
+    T *t = nullptr;
+    deallog << (sizeof(t) == dealii::MemoryConsumption::memory_consumption(t))
+            << std::endl;
+
+    std::vector<T *> vector_test(42);
+    deallog << ((sizeof(std::vector<T *>) + vector_test.capacity()*sizeof(T *))
+                == dealii::MemoryConsumption::memory_consumption(vector_test))
+            << std::endl;
+  }
+};
+
+
 int main()
 {
   std::ofstream logfile("output");
index 4e0a0b00030547e390af01bff8062e28c02877b4..c1575847bbf0250eb316cf96f90cc8734ab623fb 100644 (file)
@@ -37,7 +37,7 @@ int main()
   // started out with
   Patterns::Integer *pattern2 = Patterns::Integer::create (desc);
 
-  AssertThrow (pattern2 != 0, ExcInternalError());
+  AssertThrow (pattern2 != nullptr, ExcInternalError());
   AssertThrow (desc == pattern2->description(), ExcInternalError());
 
   deallog << desc << std::endl;
index 7f4e06b64ddf398c8e9a36d2c1d406b851c97ef8..7eb924d6dbbb7624e79fe7bebab60600d3ab5fa6 100644 (file)
@@ -71,7 +71,7 @@ get_q_face (Function<dim> &)
 Quadrature<0> &
 get_q_face (Function<1> &)
 {
-  Quadrature<0> *q = 0;
+  Quadrature<0> *q = nullptr;
   return *q;
 }
 
@@ -169,7 +169,7 @@ check ()
       Vector<float> this_error (tria.n_active_cells());
       KellyErrorEstimator<dim>::estimate (mapping, dof, q_face, neumann_bc,
                                           v, this_error,
-                                          std::vector<bool>(), 0,
+                                          std::vector<bool>(), nullptr,
                                           MultithreadInfo::n_threads(),
                                           subdomain);
       this_error *= scaling_factor;
index 13095bb33da9e3a3a7a41506e5b51d27531009c1..56aa9338620fed963767e86c3c96bc7f4cb074cb 100644 (file)
@@ -71,7 +71,7 @@ get_q_face (Function<dim> &)
 Quadrature<0> &
 get_q_face (Function<1> &)
 {
-  Quadrature<0> *q = 0;
+  Quadrature<0> *q = nullptr;
   return *q;
 }
 
@@ -169,7 +169,7 @@ check ()
       Vector<float> this_error (tria.n_active_cells());
       KellyErrorEstimator<dim>::estimate (mapping, dof, q_face, neumann_bc,
                                           v, this_error,
-                                          std::vector<bool>(), 0,
+                                          std::vector<bool>(), nullptr,
                                           MultithreadInfo::n_threads(),
                                           numbers::invalid_unsigned_int,
                                           material);
index b418b8be3d8d8b918bfcc28184d2148e26a4c7db..b00e098f2646997e9686b656d81da9b04ff3cf33 100644 (file)
@@ -762,7 +762,7 @@ void solve_problem (const std::string &solver_name)
   const RightHandSide<dim> rhs_function;
   const Solution<dim>      boundary_values;
 
-  LaplaceSolver::Base<dim> *solver = 0;
+  LaplaceSolver::Base<dim> *solver = nullptr;
   if (solver_name == "global")
     solver = new LaplaceSolver::RefinementGlobal<dim> (triangulation, fe,
                                                        quadrature,
index ba43cc56376b040d1a87b693ab068837af30e951..cf90862b7348db0a001fc3706900c45bbf73d54f 100644 (file)
@@ -2019,7 +2019,7 @@ void Framework<dim>::run (const ProblemDescription &descriptor)
   const QGauss<dim>   quadrature(descriptor.dual_fe_degree+1);
   const QGauss<dim-1> face_quadrature(descriptor.dual_fe_degree+1);
 
-  LaplaceSolver::Base<dim> *solver = 0;
+  LaplaceSolver::Base<dim> *solver = nullptr;
   switch (descriptor.refinement_criterion)
     {
     case ProblemDescription::dual_weighted_error_estimator:
@@ -2106,7 +2106,7 @@ void Framework<dim>::run (const ProblemDescription &descriptor)
 
   deallog << std::endl;
   delete solver;
-  solver = 0;
+  solver = nullptr;
 }
 
 
index 7c91cea272fe4bf575ea6bf061b15db96771b7a7..2d12f59c6200f859b888a0aec691a3f96787c70d 100644 (file)
@@ -108,7 +108,7 @@ template <int dim>
 LaplaceKernelIntegration<dim>::~LaplaceKernelIntegration()
 {
   FEValues<dim,dim+1> *fp = fe_values;
-  fe_values = 0;
+  fe_values = nullptr;
   delete fp;
 }
 
index 59a59faf051befe606c747d3e3a99d4d6f1fed15..aef5dc33134142d6cedb188166c76a7cffc07a32 100644 (file)
@@ -71,7 +71,7 @@ template<>
 Quadrature<0> &
 get_q_face <1>()
 {
-  Quadrature<0> *q = 0;
+  Quadrature<0> *q = nullptr;
   return *q;
 }
 
@@ -167,7 +167,7 @@ check ()
       Vector<float> this_error (tria.n_active_cells());
       KellyErrorEstimator<dim,spacedim>::estimate (mapping, dof, q_face, neumann_bc,
                                                    v, this_error,
-                                                   std::vector<bool>(), 0,
+                                                   std::vector<bool>(), nullptr,
                                                    MultithreadInfo::n_threads(),
                                                    subdomain);
       this_error *= scaling_factor;
index 3e5956b818e57d607463d568346e76de2a1db70d..c08315fbdb577bf106eeb3004ca00cfe211b2014 100644 (file)
@@ -101,7 +101,7 @@ template<>
 Quadrature<0> &
 get_q_face <1>()
 {
-  Quadrature<0> *q = 0;
+  Quadrature<0> *q = nullptr;
   return *q;
 }
 
index 8fa2008be51fa27eced0e2ec96899feb45c70278..e7c765249452b20014e983b907f7a247fddaf59b 100644 (file)
@@ -55,12 +55,12 @@ print_dofs (const DoFHandler<dim> &dof)
        cell != dof.end(); ++cell)
     {
       Point<dim> p = cell->center();
-      if (fevalues.get() != 0)
+      if (fevalues.get() != nullptr)
         fevalues->reinit(cell);
 
       cell->get_dof_indices (v);
       for (unsigned int i=0; i<v.size(); ++i)
-        if (fevalues.get() != 0)
+        if (fevalues.get() != nullptr)
           deallog << fevalues->quadrature_point(i) << '\t' << v[i] << std::endl;
         else
           deallog << p << '\t' << v[i] << std::endl;
@@ -88,12 +88,12 @@ print_dofs (const DoFHandler<dim> &dof, unsigned int level)
        cell != dof.end(level); ++cell)
     {
       Point<dim> p = cell->center();
-      if (fevalues.get() != 0)
+      if (fevalues.get() != nullptr)
         fevalues->reinit(cell);
 
       cell->get_mg_dof_indices (v);
       for (unsigned int i=0; i<v.size(); ++i)
-        if (fevalues.get() != 0)
+        if (fevalues.get() != nullptr)
           deallog << fevalues->quadrature_point(i) << '\t' << v[i] << std::endl;
         else
           deallog << p << '\t' << v[i] << std::endl;
index 225fd4e5ca55994421d3cb7105cdc5fb66c03df8..6ac9ef7cce59b33a0b1a834fe37df1e1595a0394 100644 (file)
@@ -55,12 +55,12 @@ print_dofs (const DoFHandler<dim> &dof)
        cell != dof.end(); ++cell)
     {
       Point<dim> p = cell->center();
-      if (fevalues.get() != 0)
+      if (fevalues.get() != nullptr)
         fevalues->reinit(cell);
 
       cell->get_dof_indices (v);
       for (unsigned int i=0; i<v.size(); ++i)
-        if (fevalues.get() != 0)
+        if (fevalues.get() != nullptr)
           deallog << fevalues->quadrature_point(i) << '\t' << v[i] << std::endl;
         else
           deallog << p << '\t' << v[i] << std::endl;
index 51c71c20a21ffe2a4b1ec51e16df70c39918bb18..a1e70392e8067966cc94183ac4ce28993f559311 100644 (file)
@@ -55,12 +55,12 @@ print_dofs (const DoFHandler<dim> &dof)
        cell != dof.end(); ++cell)
     {
       Point<dim> p = cell->center();
-      if (fevalues.get() != 0)
+      if (fevalues.get() != nullptr)
         fevalues->reinit(cell);
 
       cell->get_dof_indices (v);
       for (unsigned int i=0; i<v.size(); ++i)
-        if (fevalues.get() != 0)
+        if (fevalues.get() != nullptr)
           deallog << fevalues->quadrature_point(i) << '\t' << v[i] << std::endl;
         else
           deallog << p << '\t' << v[i] << std::endl;
index 447272021d1a3adf4d5ce0978659fda42ea684df..7568b311fef76d38b13a00139cd82f0afc203686 100644 (file)
@@ -55,12 +55,12 @@ print_dofs (const DoFHandler<dim> &dof)
        cell != dof.end(); ++cell)
     {
       Point<dim> p = cell->center();
-      if (fevalues.get() != 0)
+      if (fevalues.get() != nullptr)
         fevalues->reinit(cell);
 
       cell->get_dof_indices (v);
       for (unsigned int i=0; i<v.size(); ++i)
-        if (fevalues.get() != 0)
+        if (fevalues.get() != nullptr)
           deallog << fevalues->quadrature_point(i) << '\t' << v[i] << std::endl;
         else
           deallog << p << '\t' << v[i] << std::endl;
index d555e1562f950b03a3b2a01f47131fe9e98ee982..f0018d1b574c10be807ce9774ba428c590895ee4 100644 (file)
@@ -55,12 +55,12 @@ print_dofs (const DoFHandler<dim> &dof)
        cell != dof.end(); ++cell)
     {
       Point<dim> p = cell->center();
-      if (fevalues.get() != 0)
+      if (fevalues.get() != nullptr)
         fevalues->reinit(cell);
 
       cell->get_dof_indices (v);
       for (unsigned int i=0; i<v.size(); ++i)
-        if (fevalues.get() != 0)
+        if (fevalues.get() != nullptr)
           deallog << fevalues->quadrature_point(i) << '\t' << v[i] << std::endl;
         else
           deallog << p << '\t' << v[i] << std::endl;
index 971ecf33ab15126aed1565a4c2918f2a659fa17d..7eaeb3c7a2b94dd9a63abb958ca74f3dabd8d43f 100644 (file)
@@ -55,12 +55,12 @@ print_dofs (const DoFHandler<dim> &dof)
        cell != dof.end(); ++cell)
     {
       Point<dim> p = cell->center();
-      if (fevalues.get() != 0)
+      if (fevalues.get() != nullptr)
         fevalues->reinit(cell);
 
       cell->get_dof_indices (v);
       for (unsigned int i=0; i<v.size(); ++i)
-        if (fevalues.get() != 0)
+        if (fevalues.get() != nullptr)
           deallog << fevalues->quadrature_point(i) << '\t' << v[i] << std::endl;
         else
           deallog << p << '\t' << v[i] << std::endl;
index d475801fc940c3b32ba779f062f5761b283694b9..a17ac0315190de13dee374bcb27559dc0ae417e7 100644 (file)
@@ -55,12 +55,12 @@ print_dofs (const DoFHandler<dim> &dof)
        cell != dof.end(); ++cell)
     {
       Point<dim> p = cell->center();
-      if (fevalues.get() != 0)
+      if (fevalues.get() != nullptr)
         fevalues->reinit(cell);
 
       cell->get_dof_indices (v);
       for (unsigned int i=0; i<v.size(); ++i)
-        if (fevalues.get() != 0)
+        if (fevalues.get() != nullptr)
           deallog << fevalues->quadrature_point(i) << '\t' << v[i] << std::endl;
         else
           deallog << p << '\t' << v[i] << std::endl;
index a0028d7e43aeb763007e8a502f9190827c2688e4..242e30f0d832ce7faec361647a57c14d03afb005 100644 (file)
@@ -54,12 +54,12 @@ print_dofs (const DoFHandler<dim> &dof, stream &out)
        cell != dof.end(); ++cell)
     {
       Point<dim> p = cell->center();
-      if (fevalues.get() != 0)
+      if (fevalues.get() != nullptr)
         fevalues->reinit(cell);
 
       cell->get_dof_indices (v);
       for (unsigned int i=0; i<v.size(); ++i)
-        if (fevalues.get() != 0)
+        if (fevalues.get() != nullptr)
           out << fevalues->quadrature_point(i) << '\t' << v[i] << std::endl;
         else
           out << p << '\t' << v[i] << std::endl;
index af9ce0c49069263ee94e31d4c547c4844379daf4..ca2e43c15f547cd6ebb63000e0007d56625cd68d 100644 (file)
@@ -57,12 +57,12 @@ print_dofs (const DoFHandler<dim> &dof, stream &out)
        cell != dof.end(); ++cell)
     {
       Point<dim> p = cell->center();
-      if (fevalues.get() != 0)
+      if (fevalues.get() != nullptr)
         fevalues->reinit(cell);
 
       cell->get_dof_indices (v);
       for (unsigned int i=0; i<v.size(); ++i)
-        if (fevalues.get() != 0)
+        if (fevalues.get() != nullptr)
           out << fevalues->quadrature_point(i) << '\t' << v[i] << std::endl;
         else
           out << p << '\t' << v[i] << std::endl;
index d7e696e8b4df5e6b596dd2e807da4af462c7b148..86544fda1b311366f094e1f0cb82b3a85475b0b4 100644 (file)
@@ -197,7 +197,7 @@ private:
 
 template <int dim>
 TestCases<dim>::TestCases () :
-  tria(0), dof(0) {}
+  tria(nullptr), dof(nullptr) {}
 
 
 
@@ -213,8 +213,8 @@ TestCases<dim>::~TestCases ()
 template <int dim>
 void TestCases<dim>::create_new ()
 {
-  if (dof  != 0) delete dof;
-  if (tria != 0) delete tria;
+  if (dof  != nullptr) delete dof;
+  if (tria != nullptr) delete tria;
 
   tria = new Triangulation<dim>();
   GridGenerator::hyper_cube(*tria);
index 1c2204864b490af261cd7fed05d0dbd95d05b998..784e3f3539a49e39b69d66b7dc483e0e2aafff0b 100644 (file)
@@ -34,7 +34,7 @@ check_this (const DoFHandler<dim> &dof_handler)
 
   // with FunctionMap
   typename FunctionMap<dim>::type fm;
-  fm[0] = 0;
+  fm[0] = nullptr;
   deallog << dof_handler.n_boundary_dofs(fm) << std::endl;
 
   // with std::set
index ef60eca95da0a8d7a2972939b48fc84ea88cc3b1..ac73898bf7d22d4d369bd3ebb2a15e5442a51213 100644 (file)
@@ -44,7 +44,7 @@ check_this (const DoFHandler<dim> &dof_handler)
 
   // create sparsity pattern
   typename FunctionMap<dim>::type boundary_ids;
-  boundary_ids[0] = 0;
+  boundary_ids[0] = nullptr;
   SparsityPattern sp (dof_handler.n_boundary_dofs(boundary_ids),
                       dof_handler.max_couplings_between_dofs());
   DoFTools::make_boundary_sparsity_pattern (dof_handler, boundary_ids,
index e737b2ba4d1387666065c530aa82d93ea61c1b3e..84b801907406c4636aef2985e59b4b1b1faf9558 100644 (file)
@@ -43,7 +43,7 @@ check_this (const DoFHandler<dim> &dof_handler)
 
   // create sparsity pattern
   typename FunctionMap<dim>::type boundary_ids;
-  boundary_ids[0] = 0;
+  boundary_ids[0] = nullptr;
   DynamicSparsityPattern sp (dof_handler.n_boundary_dofs(boundary_ids));
   DoFTools::make_boundary_sparsity_pattern (dof_handler, boundary_ids,
                                             map, sp);
index 2c53c6db4296a2217a5ef9e1986fd4b3ff5429d3..ec4aff5e150212e7c54ed496413aacea5a887d54 100644 (file)
@@ -42,7 +42,7 @@ check_this (const DoFHandler<dim> &dof_handler)
   DoFTools::map_dof_to_boundary_indices (dof_handler, set, map);
 
   typename FunctionMap<dim>::type boundary_ids;
-  boundary_ids[0] = 0;
+  boundary_ids[0] = nullptr;
   const unsigned int n_boundary_dofs = dof_handler.n_boundary_dofs(boundary_ids);
   const unsigned int n_blocks = std::min (dof_handler.get_fe().n_components(),
                                           n_boundary_dofs);
index ae5ae7f6c924b4dcf18f95945e6bde164d17847c..05af7c50a625af425f52ee661ac71c63e8ba78ae 100644 (file)
@@ -42,7 +42,7 @@ check_this (const DoFHandler<dim> &dof_handler)
   DoFTools::map_dof_to_boundary_indices (dof_handler, set, map);
 
   typename FunctionMap<dim>::type boundary_ids;
-  boundary_ids[0] = 0;
+  boundary_ids[0] = nullptr;
   const types::global_dof_index n_boundary_dofs = dof_handler.n_boundary_dofs(boundary_ids);
   const unsigned int n_blocks = std::min (
                                   static_cast<types::global_dof_index>(dof_handler.get_fe().n_components()),
index 9fc47113e8dc6cd5fadd16a1e25ffdbfa686b01c..fa08031a9bfa608f44e7158f433b64b6f8f21731 100644 (file)
@@ -2013,7 +2013,7 @@ void Framework<dim>::run (const ProblemDescription &descriptor)
   const hp::QCollection<dim>   quadrature(QGauss<dim>(descriptor.dual_fe_degree+1));
   const hp::QCollection<dim-1> face_quadrature(QGauss<dim-1>(descriptor.dual_fe_degree+1));
 
-  LaplaceSolver::Base<dim> *solver = 0;
+  LaplaceSolver::Base<dim> *solver = nullptr;
   switch (descriptor.refinement_criterion)
     {
     case ProblemDescription::dual_weighted_error_estimator:
@@ -2100,7 +2100,7 @@ void Framework<dim>::run (const ProblemDescription &descriptor)
 
   deallog << std::endl;
   delete solver;
-  solver = 0;
+  solver = nullptr;
 }
 
 
index 98db0658855bc2e7db848ae56219ab13054dfddd..950ec236a08ebd5615ddc9f739829c736c4aabce 100644 (file)
@@ -150,7 +150,7 @@ void test ()
   };
 
   for (unsigned int i=0; i<sizeof(fe_list)/sizeof(fe_list[0]); ++i)
-    if (fe_list[i] != 0)
+    if (fe_list[i] != nullptr)
       {
         deallog << dim << "d, uniform grid, fe #" << i;
         check_element (tr, *fe_list[i]);
index ec80705f4d26996518b3a3e532a9131166b09d67..db94c929247141911d8b73db8cddb79909ce12f7 100644 (file)
@@ -143,10 +143,10 @@ void create_mass_matrix (const Mapping<dim>       &mapping,
                          SparseMatrix<double>     &matrix,
                          const Function<dim>   &rhs_function,
                          Vector<double>        &rhs_vector,
-                         const Function<dim> *const coefficient = 0)
+                         const Function<dim> *const coefficient = nullptr)
 {
   UpdateFlags update_flags = UpdateFlags(update_values | update_JxW_values | update_quadrature_points);
-  if (coefficient != 0)
+  if (coefficient != nullptr)
     update_flags = UpdateFlags (update_flags | update_quadrature_points);
 
   FEValues<dim> fe_values (mapping, dof.get_fe(), q, update_flags);
@@ -156,7 +156,7 @@ void create_mass_matrix (const Mapping<dim>       &mapping,
   const FiniteElement<dim>    &fe  = fe_values.get_fe();
   const unsigned int n_components  = fe.n_components();
 
-  Assert(coefficient == 0 ||
+  Assert(coefficient == nullptr ||
          coefficient->n_components==1 ||
          coefficient->n_components==n_components, ExcInternalError());
 
@@ -183,7 +183,7 @@ void create_mass_matrix (const Mapping<dim>       &mapping,
       rhs_function.vector_value_list (fe_values.get_quadrature_points(), rhs_values);
       cell_vector = 0;
 
-      if (coefficient != 0)
+      if (coefficient != nullptr)
         {
           if (coefficient->n_components==1)
             {
index 5975264ca045c8b1f200168262151df6816c7272..6dcb85830636e6f100a7fae732356e191773cd96 100644 (file)
@@ -154,10 +154,10 @@ void create_mass_matrix (const Mapping<dim>       &mapping,
                          SparseMatrix<double>     &matrix,
                          const Function<dim>   &rhs_function,
                          Vector<double>        &rhs_vector,
-                         const Function<dim> *const coefficient = 0)
+                         const Function<dim> *const coefficient = nullptr)
 {
   UpdateFlags update_flags = UpdateFlags(update_values | update_JxW_values | update_quadrature_points);
-  if (coefficient != 0)
+  if (coefficient != nullptr)
     update_flags = UpdateFlags (update_flags | update_quadrature_points);
 
   FEValues<dim> fe_values (mapping, dof.get_fe(), q, update_flags);
@@ -167,7 +167,7 @@ void create_mass_matrix (const Mapping<dim>       &mapping,
   const FiniteElement<dim>    &fe  = fe_values.get_fe();
   const unsigned int n_components  = fe.n_components();
 
-  Assert(coefficient == 0 ||
+  Assert(coefficient == nullptr ||
          coefficient->n_components==1 ||
          coefficient->n_components==n_components, ExcInternalError());
 
@@ -194,7 +194,7 @@ void create_mass_matrix (const Mapping<dim>       &mapping,
       rhs_function.vector_value_list (fe_values.get_quadrature_points(), rhs_values);
       cell_vector = 0;
 
-      if (coefficient != 0)
+      if (coefficient != nullptr)
         {
           if (coefficient->n_components==1)
             {
index aa3e3ba20e4d198fca8a548af7deebf4da556d9a..674a6d2851755fb95ea1a480561986d02b699914 100644 (file)
@@ -193,10 +193,10 @@ void create_mass_matrix (const Mapping<dim>       &mapping,
                          SparseMatrix<double>     &matrix,
                          const Function<dim>   &rhs_function,
                          Vector<double>        &rhs_vector,
-                         const Function<dim> *const coefficient = 0)
+                         const Function<dim> *const coefficient = nullptr)
 {
   UpdateFlags update_flags = UpdateFlags(update_values | update_JxW_values | update_quadrature_points);
-  if (coefficient != 0)
+  if (coefficient != nullptr)
     update_flags = UpdateFlags (update_flags | update_quadrature_points);
 
   FEValues<dim> fe_values (mapping, dof.get_fe(), q, update_flags);
@@ -206,7 +206,7 @@ void create_mass_matrix (const Mapping<dim>       &mapping,
   const FiniteElement<dim>    &fe  = fe_values.get_fe();
   const unsigned int n_components  = fe.n_components();
 
-  Assert(coefficient == 0 ||
+  Assert(coefficient == nullptr ||
          coefficient->n_components==1 ||
          coefficient->n_components==n_components, ExcInternalError());
 
@@ -233,7 +233,7 @@ void create_mass_matrix (const Mapping<dim>       &mapping,
       rhs_function.vector_value_list (fe_values.get_quadrature_points(), rhs_values);
       cell_vector = 0;
 
-      if (coefficient != 0)
+      if (coefficient != nullptr)
         {
           if (coefficient->n_components==1)
             {
index 61dc05487f142200036fddd9017f7d23a0e3134d..7146106fa01e7f91f185fec9a53a2ce0e23f2d13 100644 (file)
@@ -154,15 +154,15 @@ void test ()
     new FE_Q<dim>(1),
     new FE_Q<dim>(2),
     new FE_Q<dim>(3),
-    (dim<2 ? new FE_Q<dim>(4) : 0),
-    (dim<2 ? new FE_Q<dim>(5) : 0),
+    (dim<2 ? new FE_Q<dim>(4) : nullptr),
+    (dim<2 ? new FE_Q<dim>(5) : nullptr),
 
     // FE_DGQ
     new FE_DGQ<dim>(0),
     new FE_DGQ<dim>(1),
     new FE_DGQ<dim>(2),
-    (dim<3 ? new FE_DGQ<dim>(3) : 0),
-    (dim<3 ? new FE_DGQ<dim>(4) : 0),
+    (dim<3 ? new FE_DGQ<dim>(3) : nullptr),
+    (dim<3 ? new FE_DGQ<dim>(4) : nullptr),
 
     // FE_DGP does not
     // presently have the
@@ -176,8 +176,8 @@ void test ()
 //           new FE_DGP<dim>(3),
 
     // a non-primitive FE
-    (dim != 1 ? new FE_Nedelec<dim>(0) : 0),
-    (dim != 1 ? new FE_Nedelec<dim>(1) : 0),
+    (dim != 1 ? new FE_Nedelec<dim>(0) : nullptr),
+    (dim != 1 ? new FE_Nedelec<dim>(1) : nullptr),
 
     // some composed elements
     // of increasing
@@ -217,21 +217,21 @@ void test ()
     // really difficult
     (dim != 1 ?
     new FESystem<dim>(FE_Nedelec<dim>(0), 2)
-    : 0),
+    : nullptr),
     (dim != 1 ?
     new FESystem<dim>(FE_Nedelec<dim>(0), 2,
     FE_Q<dim> (2), 2)
-    : 0),
+    : nullptr),
     (dim != 1 ?
     new FESystem<dim>(FE_Nedelec<dim>(0), 2,
     FE_DGQ<dim> (2), 2,
     FESystem<dim>(FE_Nedelec<dim>(0), 2,
     FE_Q<dim> (2), 2), 2)
-    : 0),
+    : nullptr),
   };
 
   for (unsigned int i=0; i<sizeof(fe_list)/sizeof(fe_list[0]); ++i)
-    if (fe_list[i] != 0)
+    if (fe_list[i] != nullptr)
       {
         deallog << dim << "d, uniform grid, fe #" << i;
         check_element (tr, *fe_list[i]);
@@ -239,7 +239,7 @@ void test ()
 
 
   for (unsigned int i=0; i<sizeof(fe_list)/sizeof(fe_list[0]); ++i)
-    if (fe_list[i] != 0)
+    if (fe_list[i] != nullptr)
       delete fe_list[i];
 }
 
index 9718f8b6cfe702f81862639629acf0d9c1b71c40..2189e4657398e12cfd8e97ae762c958e6afffcef 100644 (file)
@@ -83,7 +83,7 @@ int main ()
             }
 
   // then compute new point locations and output the result
-  GridTools::laplace_transform<dim>  (new_points,tria, NULL, true);
+  GridTools::laplace_transform<dim>  (new_points,tria, nullptr, true);
   std::ofstream out ("output");
   GridOut grid_out;
   grid_out.write_eps (tria, out);
index 46caa044dccb448a70b4f6f8f675fa721a33ddc7..79598ada9d93d13d49b829b0a099ab8ee85edd85 100644 (file)
@@ -87,7 +87,7 @@ int main ()
             }
       }
 
-  GridTools::laplace_transform<dim> (new_points, tria, NULL, true);
+  GridTools::laplace_transform<dim> (new_points, tria, nullptr, true);
 
 
   GridOut grid_out;
index 77c3ab1abe496cf70a964fb8576fce483bf6b358..fc142e3f960ea278999e5e2f5f6a2f1dad754b7e 100644 (file)
@@ -74,7 +74,7 @@ void check ()
                                         ?
                                         new FE_DGQ<dim>(2)
                                         :
-                                        0);
+                                        nullptr);
 
   // define composed finite
   // elements. to limit memory
@@ -231,7 +231,7 @@ void check ()
 
   delete fe_1;
   delete fe_2;
-  if (fe_dq_quadratic != 0)
+  if (fe_dq_quadratic != nullptr)
     delete fe_dq_quadratic;
 }
 
index cc481f7423d8b155ee7c2b315b52355a03c9ec58..5896b654ad247458c90086b9e44c32d5285122cd 100644 (file)
@@ -121,7 +121,7 @@ check ()
                          rhs_function, rhs_ref);
   constraints.condense(matrix_ref, rhs_ref);
 
-  const Function<dim> *const dummy = 0;
+  const Function<dim> *const dummy = nullptr;
   MatrixTools::create_laplace_matrix (hp::MappingCollection<dim>(mapping), dof,
                                       hp::QCollection<dim>(quadrature), matrix,
                                       rhs_function, rhs, dummy, constraints);
index afba9d44aab0d7d28d7541e5843cc3ed98a3765c..9c5fad36177a6019b6a2846b8cea9348a9dea147 100644 (file)
@@ -116,7 +116,7 @@ check ()
                          hp::QCollection<dim>(quadrature), matrix_ref);
   constraints.condense(matrix_ref);
 
-  const Function<dim> *const dummy = 0;
+  const Function<dim> *const dummy = nullptr;
   MatrixTools::create_laplace_matrix (hp::MappingCollection<dim>(mapping), dof,
                                       hp::QCollection<dim>(quadrature), matrix,
                                       dummy, constraints);
index d8c57f16e0eee723c486376fa652958e79b1fddf..b120228ad78b95f9dfd5b92fc1743c9c2aa0e55f 100644 (file)
@@ -121,7 +121,7 @@ check ()
                       rhs_function, rhs_ref);
   constraints.condense(matrix_ref, rhs_ref);
 
-  const Function<dim> *const dummy = 0;
+  const Function<dim> *const dummy = nullptr;
   MatrixTools::create_mass_matrix (hp::MappingCollection<dim>(mapping), dof,
                                    hp::QCollection<dim>(quadrature), matrix,
                                    rhs_function, rhs, dummy, constraints);
index 422027c6a88071b47aa7e1283b59e3ce600308d5..ccc1f7c925c93f8ec7d7fa2f1d89d6fd696f7f73 100644 (file)
@@ -116,7 +116,7 @@ check ()
                       hp::QCollection<dim>(quadrature), matrix_ref);
   constraints.condense(matrix_ref);
 
-  const Function<dim> *const dummy = 0;
+  const Function<dim> *const dummy = nullptr;
   MatrixTools::create_mass_matrix (hp::MappingCollection<dim>(mapping), dof,
                                    hp::QCollection<dim>(quadrature), matrix,
                                    dummy, constraints);
index f7a7c7405fee9e0fd0cb7ac179c047a6037dd4dd..06fcab28858593273ec11a5919b15827c35219c5 100644 (file)
@@ -762,7 +762,7 @@ void solve_problem (const std::string &solver_name)
   const RightHandSide<dim> rhs_function;
   const Solution<dim>      boundary_values;
 
-  LaplaceSolver::Base<dim> *solver = 0;
+  LaplaceSolver::Base<dim> *solver = nullptr;
   if (solver_name == "global")
     solver = new LaplaceSolver::RefinementGlobal<dim> (triangulation, fe,
                                                        quadrature,
index d73ea43b27f78bbdbf1b1cb4769102c5fca69b29..33ba29afb1a0fa1d0c12eb754474a2d05954ac7a 100644 (file)
@@ -166,7 +166,7 @@ test_cochain(const Triangulation<dim> &tr, const FiniteElement<dim> &fe)
 
   MeshWorker::loop<dim, dim, MeshWorker::DoFInfo<dim>, MeshWorker::IntegrationInfoBox<dim> >(
     dof.begin_active(), dof.end(), dof_info, info_box,
-    cell_matrix<dim>, 0, 0, assembler);
+    cell_matrix<dim>, nullptr, nullptr, assembler);
 
   for (unsigned int b=0; b<matrices.size(); ++b)
     if (b%3 == 0)
index cce32ecb17956f4d3df8d9b04ced58353fc59f98..44d388f713a5073b0537eeea6a5cf6d009b075e2 100644 (file)
@@ -169,7 +169,7 @@ assemble(const DoFHandler<dim> &dof_handler, SparseMatrix<double> &matrix)
    dof_info,
    info_box,
    &MatrixIntegrator<dim>::cell,
-   0,
+   nullptr,
    &MatrixIntegrator<dim>::face,
    assembler);
 }
index c123a67bc03592c3ed6380a417f3969111f36351..3167def163754b1ab32a7fb21eab3e1bd2a24ecf 100644 (file)
@@ -257,7 +257,7 @@ int main ()
   deallog.attach(logfile);
   deallog.threshold_double(1.e-10);
 
-  FiniteElement<3> *fe = 0;
+  FiniteElement<3> *fe = nullptr;
 
   for (unsigned int element=0; element<2; ++element)
     {
index 2dfd81417fb47899febbc75a91313ff2793fa853..56a7d65ce725e3a53eb4dc598fee9e5f318464f0 100644 (file)
@@ -537,11 +537,11 @@ void mapping_test()
   // delete all triangulations and
   // boundary objects
   for (unsigned int i=0; i<tria_ptr.size(); ++i)
-    if (tria_ptr[i]!=0)
+    if (tria_ptr[i]!=nullptr)
       delete tria_ptr[i];
 
   for (unsigned int i=0; i<boundary_ptr.size(); ++i)
-    if (boundary_ptr[i]!=0)
+    if (boundary_ptr[i]!=nullptr)
       delete boundary_ptr[i];
 }
 
index 664f2e2194ecc43bbef09c728bb6368ea8e6a384..98a2a658234efbfd45a1ff324152f417407ceaee 100644 (file)
@@ -99,8 +99,8 @@ void partition (const SparsityPattern     &sparsity_pattern,
   // create
 
   ierr = METIS_PartGraphRecursive(&n, &ncon, &int_rowstart[0], &int_colnums[0],
-                                  NULL, NULL, NULL,
-                                  &nparts,NULL,NULL,&options[0],
+                                  nullptr, nullptr, nullptr,
+                                  &nparts,nullptr,nullptr,&options[0],
                                   &dummy,&int_partition_indices[0]);
 
   deallog << "METIS outputs:" << std::endl;
index 2ebb9c7fc07f4d600331cc677e0669c3b36ab519..32b0383f811b8c9cda3d68b6d9a3680b817fcf5c 100644 (file)
@@ -43,12 +43,12 @@ void mpi_check(const std::set<types::subdomain_id> &s)
   unsigned int tag = 1234;
   for (std::set<types::subdomain_id>::iterator it = s.begin();
        it != s.end(); ++it)
-    MPI_Send(NULL, 0, MPI_INT, *it, tag, MPI_COMM_WORLD);
+    MPI_Send(nullptr, 0, MPI_INT, *it, tag, MPI_COMM_WORLD);
 
   for (unsigned int i=0; i<s.size(); ++i)
     {
       MPI_Status status;
-      MPI_Recv(NULL, 0, MPI_INT, MPI_ANY_SOURCE, tag, MPI_COMM_WORLD, &status);
+      MPI_Recv(nullptr, 0, MPI_INT, MPI_ANY_SOURCE, tag, MPI_COMM_WORLD, &status);
       if ((s.end() == s.find(status.MPI_SOURCE)))
         deallog << status.MPI_SOURCE <<  " NOTOKAY" << std::endl;
       Assert(s.end() != s.find(status.MPI_SOURCE), ExcInternalError());
index 0afc062003359017b790e27b1a12a9f7d16caa0c..f84b5454091d3592b518af96f74f020f9c07f2da 100644 (file)
@@ -46,12 +46,12 @@ void mpi_check(const std::set<types::subdomain_id> &s)
   unsigned int tag = 1234;
   for (std::set<types::subdomain_id>::iterator it = s.begin();
        it != s.end(); ++it)
-    MPI_Send(NULL, 0, MPI_INT, *it, tag, MPI_COMM_WORLD);
+    MPI_Send(nullptr, 0, MPI_INT, *it, tag, MPI_COMM_WORLD);
 
   for (unsigned int i=0; i<s.size(); ++i)
     {
       MPI_Status status;
-      MPI_Recv(NULL, 0, MPI_INT, MPI_ANY_SOURCE, tag, MPI_COMM_WORLD, &status);
+      MPI_Recv(nullptr, 0, MPI_INT, MPI_ANY_SOURCE, tag, MPI_COMM_WORLD, &status);
       if ((s.end() == s.find(status.MPI_SOURCE)))
         deallog << status.MPI_SOURCE <<  " NOTOKAY" << std::endl;
       Assert(s.end() != s.find(status.MPI_SOURCE), ExcInternalError());
index 373354ba9d8472be1519676d66388f0a9aaf7ebb..8bfa465c8c39684c7773f15842f1e30831823be3 100644 (file)
@@ -266,8 +266,8 @@ LaplaceProblem<dim>::output_gpl(const DoFHandler<dim> &dof,
         dof.begin_mg(l), dof.end_mg(l),
         dof_info, info_box,
         std::bind(&OutputCreator<dim>::cell, &matrix_integrator, std::placeholders::_1, std::placeholders::_2),
-        0,
-        0,
+        nullptr,
+        nullptr,
         assembler);
     }
 }
index 859aa4b1eacd1ee487cd16ef067d657740d48a41..b7495cfe574c939ea09f5c5387ecad91ddc6a79f 100644 (file)
@@ -314,8 +314,8 @@ LaplaceProblem<dim>::output_gpl(const DoFHandler<dim> &dof,
         dof.begin_mg(l), dof.end_mg(l),
         dof_info, info_box,
         std::bind(&OutputCreator<dim>::cell, &matrix_integrator, std::placeholders::_1, std::placeholders::_2),
-        0,
-        0,
+        nullptr,
+        nullptr,
         assembler);
     }
 }
index d4bcc42a1bb81df843aaafa1b147b96385a00997..c5be172d7b81dc71272cf0ff5f8afbd58bea748d 100644 (file)
@@ -72,7 +72,7 @@ boundary_q (const DoFHandler<dim> &)
 const Quadrature<0> &
 boundary_q (const DoFHandler<1> &)
 {
-  static const Quadrature<0> *q = 0;
+  static const Quadrature<0> *q = nullptr;
   return *q;
 }
 
index f6bac3a8d63b0e5b4867ea422e68de963a6645f2..7174673bc82e82664fce1c585d77a8a3cc5a51b4 100644 (file)
@@ -104,7 +104,7 @@ check ()
                          rhs_function, rhs_ref);
   constraints.condense(matrix_ref, rhs_ref);
 
-  const Function<dim> *const dummy = 0;
+  const Function<dim> *const dummy = nullptr;
   MatrixTools::create_laplace_matrix (mapping, dof, quadrature, matrix,
                                       rhs_function, rhs, dummy, constraints);
 
index f582e2ffb45db70385f2afc96816e112ad036c53..2faf7d23b7a1bf0b2bf43c38b7860441a6601749 100644 (file)
@@ -108,7 +108,7 @@ check ()
                          rhs_function, rhs_ref);
   constraints.condense(matrix_ref, rhs_ref);
 
-  const Function<dim> *const dummy = 0;
+  const Function<dim> *const dummy = nullptr;
   MatrixTools::create_laplace_matrix (mapping, dof, quadrature, matrix,
                                       rhs_function, rhs, dummy, constraints);
 
index 273a3f628806ea38fb0dfcf604628f6f3b73208b..a2b2de1c93a8a035f0922094e8fd0447e867f641 100644 (file)
@@ -104,7 +104,7 @@ check ()
                          quadrature, matrix_ref);
   constraints.condense(matrix_ref);
 
-  const Function<dim> *const dummy = 0;
+  const Function<dim> *const dummy = nullptr;
   MatrixTools::create_laplace_matrix (mapping, dof, quadrature, matrix,
                                       dummy, constraints);
 
index 134b3010c130d6637e19e155199188b0208a6880..eb904bf6a68db9cd134ce9666ece562e508f521c 100644 (file)
@@ -104,7 +104,7 @@ check ()
                       rhs_function, rhs_ref);
   constraints.condense(matrix_ref, rhs_ref);
 
-  const Function<dim> *const dummy = 0;
+  const Function<dim> *const dummy = nullptr;
   MatrixTools::create_mass_matrix (mapping, dof, quadrature, matrix,
                                    rhs_function, rhs, dummy, constraints);
 
index 5a22efa4c95267708528915ba9d98c5d6489f9a8..4063c2066464bd01cd06f68a3249f3898aebae3a 100644 (file)
@@ -108,7 +108,7 @@ check ()
                       rhs_function, rhs_ref);
   constraints.condense(matrix_ref, rhs_ref);
 
-  const Function<dim> *const dummy = 0;
+  const Function<dim> *const dummy = nullptr;
   MatrixTools::create_mass_matrix (mapping, dof, quadrature, matrix,
                                    rhs_function, rhs, dummy, constraints);
 
index 71444a5f4b562e71e3ca611b0263cd55374ae16b..b9985b73c6bd7e1f4541cc1d2968edebeb87b798 100644 (file)
@@ -104,7 +104,7 @@ check ()
                       quadrature, matrix_ref);
   constraints.condense(matrix_ref);
 
-  const Function<dim> *const dummy = 0;
+  const Function<dim> *const dummy = nullptr;
   MatrixTools::create_mass_matrix (mapping, dof, quadrature, matrix,
                                    dummy, constraints);
 
index 9b2fd792d40256aadaef8c92bfcf2c87a6a523f4..f8f28a282d25576940d4f5a42feb1c839eb60d8f 100644 (file)
@@ -71,7 +71,7 @@ get_q_face (Function<dim> &)
 Quadrature<0> &
 get_q_face (Function<1> &)
 {
-  Quadrature<0> *q = 0;
+  Quadrature<0> *q = nullptr;
   return *q;
 }
 
index b5d54be577b0ec15db1f867cfc600209e11b2f73..6ec450ae4be27ae3f83671481327b09674a4583e 100644 (file)
@@ -298,7 +298,7 @@ void test_neumann(const NeumanBC<dim> &func)
                                              values,
                                              error,
                                              dealii::ComponentMask(),
-                                             0,
+                                             nullptr,
                                              dealii::numbers::invalid_unsigned_int,
                                              dealii::numbers::invalid_subdomain_id,
                                              dealii::numbers::invalid_material_id,
@@ -410,7 +410,7 @@ void test_regular(const MyFunction<dim> &func)
                                              values,
                                              error,
                                              dealii::ComponentMask(),
-                                             0,
+                                             nullptr,
                                              dealii::numbers::invalid_unsigned_int,
                                              dealii::numbers::invalid_subdomain_id,
                                              dealii::numbers::invalid_material_id,
@@ -537,7 +537,7 @@ void test_irregular(const MyFunction<dim> &func)
                                              values,
                                              error,
                                              dealii::ComponentMask(),
-                                             0,
+                                             nullptr,
                                              dealii::numbers::invalid_unsigned_int,
                                              dealii::numbers::invalid_subdomain_id,
                                              dealii::numbers::invalid_material_id,
@@ -704,7 +704,7 @@ void test(const MySecondFunction<dim> &func)
                                              values,
                                              error,
                                              dealii::ComponentMask(),
-                                             0,
+                                             nullptr,
                                              dealii::numbers::invalid_unsigned_int,
                                              dealii::numbers::invalid_subdomain_id,
                                              dealii::numbers::invalid_material_id,
index fe4d34a70a1206b2937483859269c495b7b7ef60..3d389f6e0c1eb472a43b43d9e20c0d66c73c80b1 100644 (file)
@@ -83,7 +83,7 @@ boundary_q (const DoFHandler<dim> &)
 const Quadrature<0> &
 boundary_q (const DoFHandler<1> &)
 {
-  static const Quadrature<0> *q = 0;
+  static const Quadrature<0> *q = nullptr;
   return *q;
 }
 
index 27a58b0e90a418c7a63819a2bc0cfc86eb75b3f1..b8d70f6dd8abc675145c4185cd66fad7535fe6fc 100644 (file)
@@ -660,7 +660,7 @@ namespace Step18
                                         incremental_displacement,
                                         error_per_cell,
                                         ComponentMask(),
-                                        0,
+                                        nullptr,
                                         MultithreadInfo::n_threads(),
                                         this_mpi_process);
     const unsigned int n_local_cells = triangulation.n_locally_owned_active_cells ();
index 8f24216ae4b051ed6abd96fb75da6b5705170da0..75fbf0c3c19886118d4eab97fa0f7153da03561f 100644 (file)
@@ -687,7 +687,7 @@ namespace Step18
                                         incremental_displacement,
                                         error_per_cell,
                                         ComponentMask(),
-                                        0,
+                                        nullptr,
                                         MultithreadInfo::n_threads(),
                                         this_mpi_process);
     const unsigned int n_local_cells = triangulation.n_locally_owned_active_cells ();
index 35dd8db3e972b2281ddca860c35a59935fd74511..bb2fbb37af6c7c80987e6b500a80f6278a46d75a 100644 (file)
@@ -60,7 +60,7 @@ bool getaffinity(unsigned int &bits_set,unsigned int &mask)
 int get_num_thread_env()
 {
   const char *penv = getenv ("DEAL_II_NUM_THREADS");
-  if (penv!=NULL)
+  if (penv!=nullptr)
     {
       int max_threads_env = -1;
       try
index 74ae826d29a35e65f5b9c261b8e85fa9c0dc6215..81abf94ff723fa235033d350dd6a087f281aa900 100644 (file)
@@ -71,7 +71,7 @@ void test ()
   // p2 should have been created, and should
   // have been different from the address of
   // p1
-  AssertThrow (p2 != 0, ExcInternalError());
+  AssertThrow (p2 != nullptr, ExcInternalError());
   AssertThrow (p1 != p2, ExcInternalError());
 
   delete p1;
index 1c189e94ac25a8e3068c63cfe53cee5978d78600..ecce228c4c06fc24d217f612cba1b72c889008f9 100644 (file)
@@ -100,8 +100,8 @@ void test ()
     pair_1.first.c = c;
     pair_1.second.c = c;
 
-    pair_2.first.c = 0;
-    pair_2.second.c = 0;
+    pair_2.first.c = nullptr;
+    pair_2.second.c = nullptr;
 
     verify (pair_1, pair_2);
 
index 4a8fe5e8a211226641510670c08b63265744a3a6..dfe266bc7c747512dd6f65bb6bb2de1e3ce48cfd 100644 (file)
@@ -36,7 +36,7 @@ int main (int argc,char **argv)
       logfile << "Initializing SLEPc (PETSc): "
               << std::flush;
 
-      SlepcInitialize (&argc, &argv, 0, 0);
+      SlepcInitialize (&argc, &argv, nullptr, nullptr);
       {
         logfile << "ok"
                 << std::endl;
index 31944567987c87e85a37259153f30739a5a4a182..a6ea0b733a0a6b2f12c13ba879ca217cf76a601f 100644 (file)
@@ -39,7 +39,7 @@ int main (int argc, char **argv)
       logfile << "Initializing SLEPc (PETSc): "
               << std::flush;
 
-      SlepcInitialize (&argc, &argv, 0, 0);
+      SlepcInitialize (&argc, &argv, nullptr, nullptr);
       {
         logfile << "ok"
                 << std::endl;
index 45a152fc1b83c9b4ce142d3a93749764ecb46434..47f631cc5e422bd797b186d6e558255f930a360c 100644 (file)
@@ -46,7 +46,7 @@ reinit_vector (const dealii::DoFHandler<dim,spacedim> &mg_dof,
   const dealii::parallel::distributed::Triangulation<dim,spacedim> *tria =
     (dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>
      (&mg_dof.get_triangulation()));
-  AssertThrow(tria!=NULL, ExcMessage("multigrid with Trilinos vectors only works with distributed Triangulation!"));
+  AssertThrow(tria!=nullptr, ExcMessage("multigrid with Trilinos vectors only works with distributed Triangulation!"));
 
   for (unsigned int level=v.min_level();
        level<=v.max_level(); ++level)
index fbf2eddd7ad514b32c82ea6a00f55910394ce00b..994292aaff7f76d03f61799408a315f003682fb3 100644 (file)
@@ -75,7 +75,7 @@ void test(VectorTools::NormType norm, double value, double exp = 2.0)
   Vector<double> cellwise_errors (tria.n_active_cells());
   QIterated<dim> quadrature (QTrapez<1>(), 5);
 
-  const dealii::Function<dim,double> *w = 0;
+  const dealii::Function<dim,double> *w = nullptr;
   VectorTools::integrate_difference (dofh,
                                      solution,
                                      ZeroFunction<dim>(dim),
index 8fc47d8e782f1828d8e84186084382798d9a847a..6c74729f074bb96e3e54eae4b0f61ed89b89d7cb 100644 (file)
@@ -83,7 +83,7 @@ void test(VectorTools::NormType norm, double value, double exp = 2.0)
   Vector<double> cellwise_errors (tria.n_active_cells());
   QIterated<dim> quadrature (QTrapez<1>(), 5);
 
-  const dealii::Function<dim,double> *w = 0;
+  const dealii::Function<dim,double> *w = nullptr;
   VectorTools::integrate_difference (dofh,
                                      solution,
                                      ZeroFunction<dim>(dim),
index 52f8e36b563080fe42998151590f29da236c08c8..9ba8a56ef88072e8dc38b916dcceb6e8297daad4 100644 (file)
@@ -83,7 +83,7 @@ void test(VectorTools::NormType norm, double value, double exp = 2.0)
   Vector<double> cellwise_errors (tria.n_active_cells());
   QIterated<dim> quadrature (QTrapez<1>(), 5);
 
-  const dealii::Function<dim,double> *w = 0;
+  const dealii::Function<dim,double> *w = nullptr;
   VectorTools::integrate_difference (dofh,
                                      solution,
                                      ZeroFunction<dim>(dim),

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.