]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix double brackets 4220/head
authorDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Fri, 7 Apr 2017 09:30:47 +0000 (11:30 +0200)
committerDaniel Arndt <d.arndt@math.uni-goettingen.de>
Sat, 8 Apr 2017 18:43:54 +0000 (20:43 +0200)
31 files changed:
include/deal.II/base/array_view.h
include/deal.II/base/index_set.h
include/deal.II/base/memory_consumption.h
include/deal.II/base/parameter_handler.h
include/deal.II/base/thread_management.h
include/deal.II/base/time_stepping.templates.h
include/deal.II/dofs/dof_accessor.templates.h
include/deal.II/fe/fe_enriched.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/lac/la_parallel_vector.templates.h
include/deal.II/lac/petsc_compatibility.h
include/deal.II/lac/precondition.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/solver_bicgstab.h
include/deal.II/lac/solver_cg.h
include/deal.II/lac/solver_minres.h
include/deal.II/lac/solver_richardson.h
include/deal.II/matrix_free/dof_info.templates.h
include/deal.II/matrix_free/matrix_free.h
include/deal.II/matrix_free/operators.h
include/deal.II/meshworker/integration_info.h
include/deal.II/meshworker/simple.h
include/deal.II/multigrid/mg_coarse.h
include/deal.II/numerics/matrix_creator.templates.h
source/base/parameter_handler.cc
source/fe/fe_enriched.cc
source/fe/fe_tools_extrapolate.cc

index a9f0788161b52fd3a89c0e686f61ef81d07d1539..e629a122136e49a7c6b1a92a5ad4a0fb0d3590f0 100644 (file)
@@ -157,7 +157,7 @@ template <typename ElementType>
 inline
 ArrayView<ElementType>::ArrayView()
   :
-  starting_element ((nullptr)),
+  starting_element (nullptr),
   n_elements(0)
 {}
 
index 57492087ef1ed83de9935dec4f2f8902590fa0a6..6a5e153197b5dd1918f75fc5a797e05219c8ca4a 100644 (file)
@@ -917,7 +917,7 @@ IndexSet::size_type IndexSet::IntervalAccessor::n_elements() const
 inline
 bool IndexSet::IntervalAccessor::is_valid() const
 {
-  return index_set !=nullptr&& 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((nullptr))
+  : accessor(nullptr)
 {}
 
 inline
index af99222dd5ca3f198f42e8ba641f16a0f784b0d6..94d3ee412ce7900e45bfeae6a5bc33942c13b371 100644 (file)
@@ -280,7 +280,7 @@ namespace MemoryConsumption
   inline
   std::size_t memory_consumption (const char *string)
   {
-    if (string == (nullptr))
+    if (string == nullptr)
       {
         return 0;
       }
index 489ed9cee3b4136b5799dabfd46fd1b899331127..80230f5101d2ab914615550c8fce165996eafb91 100644 (file)
@@ -288,7 +288,7 @@ 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 nullptr otherwise. Ownership
+     * description() on an existing object), or @p nullptr otherwise. Ownership
      * of the returned object is transferred to the caller of this function,
      * which should be freed using @p delete.
      */
index 938729295459b04ec8492f91a6b9a48bd2063b6d..a1c48bc546e67790596cf54c5f0ec7b9f3b3676f 100644 (file)
@@ -2900,7 +2900,7 @@ namespace Threads
     TaskDescriptor<RT>::TaskDescriptor (const std::function<RT ()> &function)
       :
       function (function),
-      task((nullptr)),
+      task(nullptr),
       task_is_done (false)
     {}
 
index f7342a1a0e79a58b0fad9c28a54c72dfc24174a9..1c891570930b243e8b740c50f9fe46bcbe207c55 100644 (file)
@@ -415,7 +415,7 @@ namespace TimeStepping
     refine_tol(refine_tol),
     coarsen_tol(coarsen_tol),
     last_same_as_first(false),
-    last_stage((nullptr))
+    last_stage(nullptr)
   {
     initialize(method);
   }
@@ -665,10 +665,10 @@ namespace TimeStepping
   template <typename VectorType>
   void EmbeddedExplicitRungeKutta<VectorType>::free_memory()
   {
-    if (last_stage!=(nullptr))
+    if (last_stage!=nullptr)
       delete last_stage;
 
-    last_stage = (nullptr);
+    last_stage = nullptr;
   }
 
 
@@ -762,7 +762,7 @@ namespace TimeStepping
     // Save the last stage if necessary
     if (last_same_as_first==true)
       {
-        if (last_stage==(nullptr))
+        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!=(nullptr))
+        if (last_stage!=nullptr)
           {
             f_stages[0] = *last_stage;
             i = 1;
index a3e5fc0ab43f927d02321eb4cd801c86f9f02403..7c45c37a3ccd84caee04a2f1e9371096a4aa1ee4 100644 (file)
@@ -60,7 +60,7 @@ DoFAccessor (const Triangulation<DoFHandlerType::dimension,DoFHandlerType::space
                                                index),
   dof_handler(const_cast<DoFHandlerType *>(dof_handler))
 {
-  Assert (tria ==nullptr|| &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."));
 }
index 8f2de8c5d8be2862c56f345faa413941efbc3ecb..097da0edb76897a4d36b60ceebd4f9b0334ce8dd 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),
- *                                    (nullptr));
+ *                                    nullptr);
  * @endcode
  * and will result in the correct constraints for enriched DoFs attributed to
  * support points on the interface between the two regions.
index 56b9f2aba6e29b2bdd1bbe499fae2d4f8e697b1c..f6326892cb5abbb7898362c70554020046ed922b 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 @pnullptrby default. Note
+ * The value of these user indices or pointers is @p nullptr by 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 0c105a5c6243b69f5f291b724d281cf17b3ffa7b..37798404f699d1d0151704f1791929c4c128ee24 100644 (file)
@@ -1104,7 +1104,7 @@ public:
   void set_user_pointer (void *p) const;
 
   /**
-   * Reset the user pointer to a @pnullptrpointer. See
+   * Reset the user pointer to a @p nullptr pointer. See
    * @ref GlossUserData
    * for more information.
    */
index 3380734e6693a1ba75ee0778a023aff71d515d23..18c532198ae5937da3ad84c3689e08bdb23ea147 100644 (file)
@@ -2134,7 +2134,7 @@ inline
 TriaAccessor<0, dim, spacedim>::
 TriaAccessor (const TriaAccessor<structdim2,dim2,spacedim2> &)
   :
-  tria ((nullptr)),
+  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 ((nullptr)),
+  tria (nullptr),
   global_vertex_index (numbers::invalid_unsigned_int)
 {
   Assert(false, ExcImpossibleInDim(0));
index d23101c5b4affbcd7de21c189600bb0d9e714d6a..b886ca165822ec6a241ce2990d9f8fc13b211d56 100644 (file)
@@ -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() == (nullptr))
+      if (communication_pattern.get() == nullptr)
         {
           // Split the IndexSet of V in locally owned elements and ghost indices
           // then create the communication pattern
@@ -1552,7 +1552,7 @@ namespace LinearAlgebra
                            const bool         scientific,
                            const bool         across) const
     {
-      Assert (partitioner.get() !=nullptr, ExcInternalError());
+      Assert (partitioner.get() != nullptr, ExcInternalError());
       AssertThrow (out, ExcIO());
       std::ios::fmtflags old_flags = out.flags();
       unsigned int old_precision = out.precision (precision);
index b3bb1309a5fca34cd89386d408ae932f2b8bd5ff..abcbbdf657741fde5132f020ef6d89693f3d127c 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 ((nullptr), 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 (nullptr).
+    // 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 (nullptr).
+    // PETSc will check whether or not matrix is nullptr.
 #if DEAL_II_PETSC_VERSION_LT(3, 2, 0)
     return KSPDestroy (krylov_solver);
 #else
index b11311965efd21388eb3acc6d8cae4ab47dc2415..3d92b78eff95ad19ea901e8af7834e1e0a6bf986 100644 (file)
@@ -1912,10 +1912,10 @@ namespace internal
                               std::shared_ptr<DiagonalMatrix<VectorType> > &preconditioner,
                               VectorType                                         &diagonal_inverse)
     {
-      if (preconditioner.get() ==nullptr||
+      if (preconditioner.get() == nullptr ||
           preconditioner->m() != matrix.m())
         {
-          if (preconditioner.get() == (nullptr))
+          if (preconditioner.get() == nullptr)
             preconditioner.reset(new DiagonalMatrix<VectorType>());
 
           Assert(preconditioner->m() == 0,
index 9a28632cf822df351c4ed137aaad797dcd649bdd..2f38a41ea4da85efd38470e20d5052945c2ab853 100644 (file)
@@ -624,7 +624,7 @@ namespace LinearAlgebra
   inline
   ReadWriteVector<Number>::ReadWriteVector ()
     :
-    val((nullptr))
+    val(nullptr)
   {
     reinit(0, true);
   }
@@ -636,7 +636,7 @@ namespace LinearAlgebra
   ReadWriteVector<Number>::ReadWriteVector (const ReadWriteVector<Number> &v)
     :
     Subscriptor(),
-    val((nullptr))
+    val(nullptr)
   {
     this->operator=(v);
   }
@@ -647,7 +647,7 @@ namespace LinearAlgebra
   inline
   ReadWriteVector<Number>::ReadWriteVector (const size_type size)
     :
-    val((nullptr))
+    val(nullptr)
   {
     reinit (size, false);
   }
@@ -658,7 +658,7 @@ namespace LinearAlgebra
   inline
   ReadWriteVector<Number>::ReadWriteVector (const IndexSet &locally_stored_indices)
     :
-    val((nullptr))
+    val(nullptr)
   {
     reinit (locally_stored_indices);
   }
index 0436e49d874cfb5ba47fe68298f1d431363c95d5..fd25e4b344125015be2d91eb6a6ca0cbefaace83 100644 (file)
@@ -52,14 +52,14 @@ namespace LinearAlgebra
   {
     if (new_alloc_size == 0)
       {
-        if (val != (nullptr))
+        if (val != nullptr)
           free(val);
-        val = (nullptr);
+        val = nullptr;
         thread_loop_partitioner.reset(new parallel::internal::TBBPartitioner());
       }
     else
       {
-        if (val != (nullptr))
+        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() == (nullptr))
+    if (communication_pattern.get() == nullptr)
       {
         comm_pattern.reset(new Utilities::MPI::Partitioner(vec.locally_owned_elements(),
                                                            get_stored_elements(),
@@ -305,7 +305,7 @@ namespace LinearAlgebra
 
     // If no communication pattern is given, create one. Otherwise, use the one
     // given.
-    if (communication_pattern == (nullptr))
+    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 == (nullptr))
+            if (epetra_comm_pattern == nullptr)
               epetra_comm_pattern = std::make_shared<const EpetraWrappers::CommunicationPattern>(
                                       create_epetra_comm_pattern(source_elements, mpi_comm));
           }
index cb1aebfeb6e34381c78b8c330b003fbbc6750f2a..ad6b0dc641ff326376d7a5bf43e58117c4f2ee16 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 = (nullptr));
+                    VectorType *temp_ghost_vector = nullptr);
 
     /**
      * The mapping from indices to blocks. Each row of this pattern enumerates
index 2745f93ffd1cf33c0957a25594ffaec49f519d0f..df2d5ca800dcfa4e8f4f32d42b3ccbf5ff1aaec4 100644 (file)
@@ -296,15 +296,15 @@ SolverBicgstab<VectorType>::SolverBicgstab (SolverControl        &cn,
                                             const AdditionalData &data)
   :
   Solver<VectorType>(cn),
-  Vx((nullptr)),
-  Vr((nullptr)),
-  Vrbar((nullptr)),
-  Vp((nullptr)),
-  Vy((nullptr)),
-  Vz((nullptr)),
-  Vt((nullptr)),
-  Vv((nullptr)),
-  Vb((nullptr)),
+  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 9faae8f510d903f2157e5a9127296bd0e52838a6..53fcf63bdfabe84ac43149b14de70b63225a9772 100644 (file)
@@ -327,9 +327,9 @@ SolverCG<VectorType>::SolverCG (SolverControl        &cn,
                                 const AdditionalData     &data)
   :
   Solver<VectorType>(cn,mem),
-  Vr((nullptr)),
-  Vp((nullptr)),
-  Vz((nullptr)),
+  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((nullptr)),
-  Vp((nullptr)),
-  Vz((nullptr)),
+  Vr(nullptr),
+  Vp(nullptr),
+  Vz(nullptr),
   additional_data(data)
 {}
 
index 0cde0917e7d699c7f8a52770a41ec250f30b1bc3..72f407422a431dd07607662da694a01343d4e316 100644 (file)
@@ -169,13 +169,13 @@ SolverMinRes<VectorType>::SolverMinRes (SolverControl        &cn,
                                         const AdditionalData &)
   :
   Solver<VectorType>(cn),
-  Vu0((nullptr)),
-  Vu1((nullptr)),
-  Vu2((nullptr)),
-  Vm0((nullptr)),
-  Vm1((nullptr)),
-  Vm2((nullptr)),
-  Vv((nullptr)),
+  Vu0(nullptr),
+  Vu1(nullptr),
+  Vu2(nullptr),
+  Vm0(nullptr),
+  Vm1(nullptr),
+  Vm2(nullptr),
+  Vv(nullptr),
   res2(numbers::signaling_nan<double>())
 {}
 
index bdfe70b3f4ec59062082aa1cb7c9d61a81202f5a..f387cfcbbd5b1aa655519b5c6ecad31dde60199d 100644 (file)
@@ -194,8 +194,8 @@ SolverRichardson<VectorType>::SolverRichardson(SolverControl            &cn,
                                                const AdditionalData     &data)
   :
   Solver<VectorType> (cn,mem),
-  Vr((nullptr)),
-  Vd((nullptr)),
+  Vr(nullptr),
+  Vd(nullptr),
   additional_data(data)
 {}
 
@@ -206,8 +206,8 @@ SolverRichardson<VectorType>::SolverRichardson(SolverControl        &cn,
                                                const AdditionalData &data)
   :
   Solver<VectorType> (cn),
-  Vr((nullptr)),
-  Vd((nullptr)),
+  Vr(nullptr),
+  Vd(nullptr),
   additional_data(data),
   res(numbers::signaling_nan<double>())
 {}
index 7c49f391a9ec6b395b59dd721db663b2d4c92a14..f1d7f473bb532edcdaafdc4844091ade40a358c9 100644 (file)
@@ -182,7 +182,7 @@ namespace internal
                                ConstraintValues<double> &constraint_values,
                                bool                            &cell_at_boundary)
     {
-      Assert (vector_partitioner.get() !=nullptr, 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;
index 65b46baa1207c8bee9fd7514f601e39c2839d3f3..e770c02af48e3122236bc6c5f7689da2b1e00790 100644 (file)
@@ -2100,7 +2100,7 @@ namespace internal
                 const internal::MatrixFreeFunctions::TaskInfo &task_info_in,
                 const bool is_blocked_in)
         :
-        dummy ((nullptr)),
+        dummy (nullptr),
         worker (worker_in),
         partition (partition_in),
         task_info (task_info_in),
@@ -2137,7 +2137,7 @@ namespace internal
                      const internal::MatrixFreeFunctions::TaskInfo &task_info_in,
                      const bool    is_blocked_in = false)
         :
-        dummy ((nullptr)),
+        dummy (nullptr),
         function (function_in),
         partition (partition_in),
         task_info (task_info_in),
@@ -2265,7 +2265,7 @@ namespace internal
                      const internal::MatrixFreeFunctions::TaskInfo &task_info_in,
                      const bool    is_blocked_in)
         :
-        dummy ((nullptr)),
+        dummy (nullptr),
         worker (worker_in),
         partition (partition_in),
         task_info (task_info_in),
index 22ac681c594f65bfea8c6bd252fc5773cd74bc9b..2717bee872edadf5642da6b8ebc251cd4da87f9e 100644 (file)
@@ -931,7 +931,7 @@ namespace MatrixFreeOperators
   {
     (void) col;
     Assert (row == col, ExcNotImplemented());
-    Assert (inverse_diagonal_entries.get() !=nullptr&&
+    Assert (inverse_diagonal_entries.get() != nullptr &&
             inverse_diagonal_entries->m() > 0, ExcNotInitialized());
     return 1.0/(*inverse_diagonal_entries)(row,row);
   }
@@ -1344,7 +1344,8 @@ namespace MatrixFreeOperators
   std::size_t
   Base<dim,VectorType>::memory_consumption () const
   {
-    return inverse_diagonal_entries.get() !=nullptr? inverse_diagonal_entries->memory_consumption() : sizeof(*this);
+    return inverse_diagonal_entries.get() != nullptr ?
+           inverse_diagonal_entries->memory_consumption() : sizeof(*this);
   }
 
 
@@ -1362,7 +1363,7 @@ namespace MatrixFreeOperators
   const std::shared_ptr<DiagonalMatrix<VectorType> > &
   Base<dim,VectorType>::get_matrix_diagonal_inverse() const
   {
-    Assert(inverse_diagonal_entries.get() !=nullptr&&
+    Assert(inverse_diagonal_entries.get() != nullptr &&
            inverse_diagonal_entries->m() > 0, ExcNotInitialized());
     return inverse_diagonal_entries;
   }
@@ -1399,7 +1400,7 @@ namespace MatrixFreeOperators
   MGInterfaceOperator<OperatorType>::MGInterfaceOperator ()
     :
     Subscriptor(),
-    mf_base_operator((nullptr))
+    mf_base_operator(nullptr)
   {
   }
 
@@ -1409,7 +1410,7 @@ namespace MatrixFreeOperators
   void
   MGInterfaceOperator<OperatorType>::clear ()
   {
-    mf_base_operator = (nullptr);
+    mf_base_operator = nullptr;
   }
 
 
index 5bbb513d2bc91f311c69ede9dce0e33a0e5be7cc..c494c1174cfb83e051a4462fa46d24e0f57ac546 100644 (file)
@@ -633,7 +633,7 @@ namespace MeshWorker
   inline const FiniteElement<dim, spacedim> &
   IntegrationInfo<dim,spacedim>::finite_element() const
   {
-    Assert (fe_pointer !=nullptr, ExcNotInitialized());
+    Assert (fe_pointer != nullptr, ExcNotInitialized());
     return *fe_pointer;
   }
 
index 4e09dc91be3fa1d318d2e79fc697cb789e890ba5..0dba648c89cf3deea0b9db1a7e0ec1919166a8ff 100644 (file)
@@ -524,7 +524,7 @@ namespace MeshWorker
                                                                  info.indices:
                                                                  info.indices_by_block[i];
 
-              if (constraints !=nullptr)
+              if (constraints != nullptr)
                 constraints->distribute_local_to_global(info.vector(k).block(i), ldi, *v);
               else
                 v->add(ldi, info.vector(k).block(i));
index 14680ac30de77094890d5f6aa3ba816347b14543..0fa4ed65559dd5385cbb194cde44dfc3d8490e7a 100644 (file)
@@ -308,13 +308,13 @@ private:
 /* ------------------ Functions for MGCoarseGridApplySmoother -----------*/
 template<class VectorType>
 MGCoarseGridApplySmoother<VectorType>::MGCoarseGridApplySmoother ()
-  : coarse_smooth((nullptr))
+  : coarse_smooth(nullptr)
 {
 }
 
 template<class VectorType>
 MGCoarseGridApplySmoother<VectorType>::MGCoarseGridApplySmoother (const MGSmootherBase<VectorType> &coarse_smooth)
-  : coarse_smooth((nullptr))
+  : coarse_smooth(nullptr)
 {
   initialize(coarse_smooth);
 }
index 1d85dcbe3c7b4a041d3b4f2108387c32232569f8..a7aa61c31dec2cd2054efb684e3f6922eb88b2c0 100644 (file)
@@ -1220,7 +1220,7 @@ namespace MatrixCreator
     Assert (boundary_functions.size() != 0, ExcInternalError());
     Assert (dof_to_boundary_mapping.size() == dof.n_dofs(),
             ExcInternalError());
-    Assert (coefficient ==nullptr ||
+    Assert (coefficient == nullptr ||
             coefficient->n_components==1 ||
             coefficient->n_components==n_components, ExcComponentMismatch());
 
@@ -1637,7 +1637,7 @@ namespace MatrixCreator
     Assert (boundary_functions.size() != 0, ExcInternalError());
     Assert (dof_to_boundary_mapping.size() == dof.n_dofs(),
             ExcInternalError());
-    Assert (coefficient ==nullptr ||
+    Assert (coefficient == nullptr ||
             coefficient->n_components==1 ||
             coefficient->n_components==n_components, ExcComponentMismatch());
 
index a197206a23d1156ce3362a043545655b396ed9dd..a688c1d0c1360c48d9efe07fe435a837a8836530 100644 (file)
@@ -83,19 +83,19 @@ namespace Patterns
       return p;
 
     p = Double::create(description);
-    if (p !=nullptr )
+    if (p != nullptr )
       return p;
 
     p = Selection::create(description);
-    if (p !=nullptr )
+    if (p != nullptr )
       return p;
 
     p = List::create(description);
-    if (p !=nullptr )
+    if (p != nullptr )
       return p;
 
     p = MultipleSelection::create(description);
-    if (p !=nullptr )
+    if (p != nullptr )
       return p;
 
     p = Bool::create(description);
@@ -103,11 +103,11 @@ namespace Patterns
       return p;
 
     p = Anything::create(description);
-    if (p !=nullptr )
+    if (p != nullptr )
       return p;
 
     p = FileName::create(description);
-    if (p !=nullptr )
+    if (p != nullptr )
       return p;
 
     p = DirectoryName::create(description);
index 2fea36bcab2c58c1857b945e4770ab7ff1270fe4..2b84fd86419fc863888afba6db52ed66b864d172 100644 (file)
@@ -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) !=nullptr,
+          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 5c8d76ba01959a1ff2612191ea62b745cd3b3aea..fa654fd04337ac1162eb0f97ebadfc174bf53678 100644 (file)
@@ -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 !=nullptr, 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 !=nullptr, 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 !=nullptr, 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 !=nullptr, 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 !=nullptr, 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 !=nullptr, 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);

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.