]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Indentation
authorDaniel Arndt <arndtd@ornl.gov>
Wed, 7 Dec 2022 22:12:47 +0000 (22:12 +0000)
committerDaniel Arndt <arndtd@ornl.gov>
Thu, 8 Dec 2022 22:13:15 +0000 (17:13 -0500)
include/deal.II/lac/la_parallel_vector.templates.h
include/deal.II/lac/read_write_vector.templates.h
source/grid/grid_tools.cc
source/particles/particle_handler.cc
tests/lac/parallel_vector_01.cc
tests/lac/parallel_vector_04.cc
tests/lac/parallel_vector_14.cc
tests/lac/parallel_vector_16.cc
tests/lac/parallel_vector_21.cc
tests/lac/parallel_vector_22.cc
tests/lac/parallel_vector_23.cc

index 3b3beaafbee3ab1d7d34040ba0bc1a6938e07711..a07df612ab8b2b69ad443d4f85148516e8ee0ff1 100644 (file)
@@ -482,7 +482,7 @@ namespace LinearAlgebra
             KOKKOS_LAMBDA(size_type i, RealType & update) {
               update = Kokkos::max(update, Kokkos::abs(data.values(i)));
             },
-           Kokkos::Max<RealType, Kokkos::HostSpace>(result));
+            Kokkos::Max<RealType, Kokkos::HostSpace>(result));
         }
       };
     } // namespace internal
index 040ccd4ee24a90bd28526e1f48185ad6fbb3aede..08135c2d1033a47e14328c7a60b3e90085e9ca66 100644 (file)
@@ -177,7 +177,12 @@ namespace LinearAlgebra
 
         const unsigned int n_elements =
           communication_pattern->locally_owned_size();
-       Kokkos::deep_copy(Kokkos::View<Number*, Kokkos::HostSpace>(tmp_vector.begin(), n_elements), Kokkos::View<const Number*, ::dealii::MemorySpace::Device::kokkos_space>(values, n_elements));
+        Kokkos::deep_copy(
+          Kokkos::View<Number *, Kokkos::HostSpace>(tmp_vector.begin(),
+                                                    n_elements),
+          Kokkos::View<const Number *,
+                       ::dealii::MemorySpace::Device::kokkos_space>(
+            values, n_elements));
         tmp_vector.update_ghost_values();
 
         const IndexSet &stored = rw_vector.get_stored_elements();
index 6821c57fe52099163a8879c86a753bbc068aa69a..9d5da20c39de90c70cb29d82145958b604e56311 100644 (file)
@@ -2963,7 +2963,7 @@ namespace GridTools
           {
             if (!used_vertices_rtree.empty())
               {
-               Assert(false, ExcInternalError());
+                Assert(false, ExcInternalError());
               }
             else
               {
index ffa7c14d7a00919f0dc6db58c6f3f0dfbb210b0b..20f260cc6b5c09de0d81d3640eba2632f26767b6 100644 (file)
@@ -1395,7 +1395,7 @@ namespace Particles
 
           if (!found_cell)
             {
-                   Assert(false, ExcInternalError());
+              Assert(false, ExcInternalError());
             }
 
           if (!found_cell)
index a0923b67afbde73a37b4769d6b6786e5f9e6188a..60dfbc9f2ba23d16a6296710c5b05533790eba07 100644 (file)
@@ -84,7 +84,7 @@ main(int argc, char **argv)
 
   unsigned int myid = Utilities::MPI::this_mpi_process(MPI_COMM_WORLD);
   deallog.push(Utilities::int_to_string(myid));
-  
+
   if (myid == 0)
     {
       initlog();
index a3ccdb10c394961dc472a762246be100c9a3274e..a3cb0938547cebf80dc2de56fc4bc92b0875c3e2 100644 (file)
@@ -70,12 +70,15 @@ test()
     {
       unsigned int local_index = partitioner->global_to_local(1);
       double *     values_dev  = v.get_values();
-      Kokkos::deep_copy(Kokkos::View<double, MemorySpace::Device::kokkos_space>(values_dev+local_index), 7);
+      Kokkos::deep_copy(Kokkos::View<double, MemorySpace::Device::kokkos_space>(
+                          values_dev + local_index),
+                        7);
     }
 
-  unsigned int        allocated_size = local_relevant.n_elements();
-  Kokkos::View<double*, MemorySpace::Device::kokkos_space> v_device(v.get_values(), allocated_size);
-  Kokkos::View<double*, Kokkos::HostSpace> v_host("v_host", allocated_size);
+  unsigned int allocated_size = local_relevant.n_elements();
+  Kokkos::View<double *, MemorySpace::Device::kokkos_space> v_device(
+    v.get_values(), allocated_size);
+  Kokkos::View<double *, Kokkos::HostSpace> v_host("v_host", allocated_size);
   Kokkos::deep_copy(v_host, v_device);
 
   AssertThrow(v_host[partitioner->global_to_local(myid * 2)] == myid * 4.0,
index fbb594bef1ec49d3e97d777d2ffb8c5282102577..4ff6f1bbeca5763974121611a2ff50f74b049bf9 100644 (file)
@@ -68,7 +68,8 @@ test()
 
       v.import(rw_vector, VectorOperation::insert);
 
-      LinearAlgebra::distributed::Vector<double, MemorySpace::Device> w(v), u(v);
+      LinearAlgebra::distributed::Vector<double, MemorySpace::Device> w(v),
+        u(v);
       u = 0;
 
       v *= 2.0;
index b59379f96719c604992b9c2da17818555ab4a6ee..21e0f5cc2358566024abb528da9d51ab88095a90 100644 (file)
@@ -54,15 +54,18 @@ test()
 
   LinearAlgebra::distributed::Vector<double, MemorySpace::Device> v(
     local_owned, local_relevant, MPI_COMM_WORLD);
-  Kokkos::View<double*, MemorySpace::Device::kokkos_space> v_view(v.get_values(), local_relevant.n_elements());
+  Kokkos::View<double *, MemorySpace::Device::kokkos_space> v_view(
+    v.get_values(), local_relevant.n_elements());
 
-  deallog << "Local range of proc 0: " << v.get_partitioner()->local_range().first << " "
+  deallog << "Local range of proc 0: "
+          << v.get_partitioner()->local_range().first << " "
           << v.get_partitioner()->local_range().second << std::endl;
 
   // set local values
   for (types::global_dof_index i = 0; i < local_size; ++i)
     {
-           Kokkos::deep_copy(Kokkos::subview(v_view, i), min_index + myid * local_size + i);
+      Kokkos::deep_copy(Kokkos::subview(v_view, i),
+                        min_index + myid * local_size + i);
     }
 
   deallog << "vector norm: " << v.l2_norm() << std::endl;
@@ -74,10 +77,18 @@ test()
 
   v.zero_out_ghost_values();
   const auto &partitioner = v.get_partitioner();
-  Kokkos::deep_copy(Kokkos::subview(v_view, partitioner->global_to_local(min_index + 38)), min_index);
-  Kokkos::deep_copy(Kokkos::subview(v_view, partitioner->global_to_local(min_index + 39)), min_index*2);
-  Kokkos::deep_copy(Kokkos::subview(v_view, partitioner->global_to_local(min_index + 41)), min_index+7);
-  Kokkos::deep_copy(Kokkos::subview(v_view, partitioner->global_to_local(min_index + 42)), -static_cast<double>(min_index));
+  Kokkos::deep_copy(
+    Kokkos::subview(v_view, partitioner->global_to_local(min_index + 38)),
+    min_index);
+  Kokkos::deep_copy(
+    Kokkos::subview(v_view, partitioner->global_to_local(min_index + 39)),
+    min_index * 2);
+  Kokkos::deep_copy(
+    Kokkos::subview(v_view, partitioner->global_to_local(min_index + 41)),
+    min_index + 7);
+  Kokkos::deep_copy(
+    Kokkos::subview(v_view, partitioner->global_to_local(min_index + 42)),
+    -static_cast<double>(min_index));
   v.compress(VectorOperation::add);
   v.update_ghost_values();
   v.print(deallog.get_file_stream(), 12, false, false);
index 3a1890530fb72254f9472f1e94af17b4d48c428b..ac37704758e27c6755b01e6ff5d8893592820c4b 100644 (file)
@@ -50,10 +50,14 @@ test()
   v2.reinit(v, true);
 
   // set locally owned range of v2 manually
-  Kokkos::View<double*, MemorySpace::Device::kokkos_space> v2_view(v2.get_values(), v2.local_size());
+  Kokkos::View<double *, MemorySpace::Device::kokkos_space> v2_view(
+    v2.get_values(), v2.local_size());
   Kokkos::deep_copy(v2_view, 1.);
 
-  Kokkos::parallel_for(v2.local_size(), KOKKOS_LAMBDA(int i) { KOKKOS_IMPL_DO_NOT_USE_PRINTF("%d: %f\n", i, v2_view(i));});
+  Kokkos::parallel_for(
+    v2.local_size(), KOKKOS_LAMBDA(int i) {
+      KOKKOS_IMPL_DO_NOT_USE_PRINTF("%d: %f\n", i, v2_view(i));
+    });
   // add entries to ghost values
   // Because of limitation in import, the IndexSet of the ReadWriteVector needs
   // to have the local elements.
index 43c2ddb1925bc68ce83166666b3f80836a6c3a43..1697623d1118672a0d3967ebebba4a4413748f71 100644 (file)
 
 template <typename Number>
 double
-print_value(Numbervalues_dev, unsigned int index)
+print_value(Number *values_dev, unsigned int index)
 {
   static Kokkos::View<Number, Kokkos::HostSpace> cpu_value("cpu_value");
-  Kokkos::deep_copy(cpu_value, Kokkos::View<Number>(values_dev+index));
+  Kokkos::deep_copy(cpu_value, Kokkos::View<Number>(values_dev + index));
   return cpu_value();
 }
 
@@ -59,12 +59,17 @@ test()
   // create vector
   LinearAlgebra::distributed::Vector<double, MemorySpace::Device> v(
     local_owned, local_relevant, MPI_COMM_WORLD);
-  Kokkos::View<double*, MemorySpace::Device::kokkos_space> v_device(v.get_values(), local_relevant.n_elements());
+  Kokkos::View<double *, MemorySpace::Device::kokkos_space> v_device(
+    v.get_values(), local_relevant.n_elements());
   const auto &partitioner = v.get_partitioner();
 
   // set local values
-  Kokkos::deep_copy(Kokkos::subview(v_device, partitioner->global_to_local(myid * 2)), myid*2.0);
-  Kokkos::deep_copy(Kokkos::subview(v_device, partitioner->global_to_local(myid * 2+1)), myid*2.0+1.0);
+  Kokkos::deep_copy(Kokkos::subview(v_device,
+                                    partitioner->global_to_local(myid * 2)),
+                    myid * 2.0);
+  Kokkos::deep_copy(Kokkos::subview(v_device,
+                                    partitioner->global_to_local(myid * 2 + 1)),
+                    myid * 2.0 + 1.0);
   v.compress(VectorOperation::add);
   v *= 2.0;
 
@@ -82,8 +87,8 @@ test()
   // set ghost dof on owning processor and maximize
   if (myid != 0)
     Kokkos::deep_copy(Kokkos::subview(v_device,
-                        partitioner->global_to_local(1)),
-                        7. * myid);
+                                      partitioner->global_to_local(1)),
+                      7. * myid);
   v.compress(VectorOperation::max);
 
   // import ghosts onto all procs
@@ -111,7 +116,9 @@ test()
   // set ghost dof on non-owning processors and minimize
   v.zero_out_ghost_values();
   if (myid == 0)
-    Kokkos::deep_copy(Kokkos::subview(v_device, partitioner->global_to_local(1)), -1);
+    Kokkos::deep_copy(Kokkos::subview(v_device,
+                                      partitioner->global_to_local(1)),
+                      -1);
   v.compress(VectorOperation::min);
   v.update_ghost_values();
 
@@ -125,7 +132,9 @@ test()
   v.zero_out_ghost_values();
   v = 1.0;
   if (myid == 0)
-    Kokkos::deep_copy(Kokkos::subview(v_device, partitioner->global_to_local(1)), -1);
+    Kokkos::deep_copy(Kokkos::subview(v_device,
+                                      partitioner->global_to_local(1)),
+                      -1);
 
   // maximize
   v.compress(VectorOperation::max);
@@ -142,7 +151,8 @@ test()
   // maximum is -1:
   v.zero_out_ghost_values();
   v = 1.0;
-  Kokkos::deep_copy(Kokkos::subview(v_device, partitioner->global_to_local(1)), -1);
+  Kokkos::deep_copy(Kokkos::subview(v_device, partitioner->global_to_local(1)),
+                    -1);
   v.compress(VectorOperation::max);
   v.update_ghost_values();
   deallog << myid << ":"
@@ -154,7 +164,8 @@ test()
   // than zero
   v.zero_out_ghost_values();
   v = -1.0;
-  Kokkos::deep_copy(Kokkos::subview(v_device, partitioner->global_to_local(1)), -1);
+  Kokkos::deep_copy(Kokkos::subview(v_device, partitioner->global_to_local(1)),
+                    -1);
   v.compress(VectorOperation::max);
   deallog << myid << ":"
           << "ghost entry after first max: "
index 264e2864ad7d602f90c1379164ecd1e6b0bc2da3..16bcfa90e6a4895c816976478309c401be9deca4 100644 (file)
 
 template <typename Number>
 double
-print_value(Numbervalues_dev, unsigned int index)
+print_value(Number *values_dev, unsigned int index)
 {
   static Kokkos::View<Number, Kokkos::HostSpace> cpu_value("cpu_value");
-  Kokkos::deep_copy(cpu_value, Kokkos::View<Number>(values_dev+index));
+  Kokkos::deep_copy(cpu_value, Kokkos::View<Number>(values_dev + index));
   return cpu_value();
 }
 

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.