]> https://gitweb.dealii.org/ - dealii.git/commitdiff
extend tests/mpi/periodicity_01 to complex-valued PETSc
authorDenis Davydov <davydden@gmail.com>
Mon, 28 Mar 2016 18:15:40 +0000 (20:15 +0200)
committerDenis Davydov <davydden@gmail.com>
Tue, 29 Mar 2016 18:48:46 +0000 (20:48 +0200)
tests/mpi/periodicity_01.cc
tests/mpi/periodicity_01.with_petsc=true.mpirun=3.output.2 [new file with mode: 0644]
tests/mpi/periodicity_01.with_petsc=true.mpirun=5.output.2 [new file with mode: 0644]
tests/mpi/periodicity_01.with_petsc=true.mpirun=7.output.2 [new file with mode: 0644]

index b64c039f85c6e1da49b2fbcc501509cca8fc0d2a..fae79441fbb00bdb39e0de856ec438ee0ca2dc71 100644 (file)
@@ -81,7 +81,7 @@ namespace Step40
     void solve ();
     void refine_grid ();
     void get_point_value (const Point<dim> point, const int proc,
-                          Vector<double> &value) const;
+                          Vector<PetscScalar> &value) const;
     void check_periodicity (const unsigned int cycle) const;
     void output_results (const unsigned int cycle) const;
 
@@ -192,8 +192,8 @@ namespace Step40
     const unsigned int   dofs_per_cell = fe.dofs_per_cell;
     const unsigned int   n_q_points    = quadrature_formula.size();
 
-    FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
-    Vector<double>       cell_rhs (dofs_per_cell);
+    FullMatrix<PetscScalar>   cell_matrix (dofs_per_cell, dofs_per_cell);
+    Vector<PetscScalar>       cell_rhs (dofs_per_cell);
 
     std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
@@ -203,14 +203,14 @@ namespace Step40
     for (; cell!=endc; ++cell)
       if (cell->is_locally_owned())
         {
-          cell_matrix = 0;
-          cell_rhs = 0;
+          cell_matrix = PetscScalar();
+          cell_rhs = PetscScalar();
 
           fe_values.reinit (cell);
 
           for (unsigned int q_point=0; q_point<n_q_points; ++q_point)
             {
-              double rhs_value
+              PetscScalar rhs_value
                 = (std::cos(2*numbers::PI*fe_values.quadrature_point(q_point)[0]) *
                    std::exp(-1*fe_values.quadrature_point(q_point)[0]) *
                    std::cos(2*numbers::PI*fe_values.quadrature_point(q_point)[1]) *
@@ -259,6 +259,7 @@ namespace Step40
 
     PETScWrappers::SolverCG solver(solver_control, mpi_communicator);
 
+#ifndef PETSC_USE_COMPLEX
     // Ask for a symmetric preconditioner by setting the first parameter in
     // AdditionalData to true.
     PETScWrappers::PreconditionBoomerAMG
@@ -267,6 +268,10 @@ namespace Step40
 
     solver.solve (system_matrix, completely_distributed_solution, system_rhs,
                   preconditioner);
+#else
+    solver.solve (system_matrix, completely_distributed_solution, system_rhs,
+                  PETScWrappers::PreconditionJacobi(system_matrix));
+#endif
 
     pcout << "   Solved in " << solver_control.last_step()
           << " iterations." << std::endl;
@@ -295,7 +300,7 @@ namespace Step40
 
   template <int dim>
   void LaplaceProblem<dim>::get_point_value
-  (const Point<dim> point, const int proc, Vector<double> &value) const
+  (const Point<dim> point, const int proc, Vector<PetscScalar> &value) const
   {
     typename DoFHandler<dim>::active_cell_iterator cell
       = GridTools::find_active_cell_around_point (dof_handler, point);
@@ -305,15 +310,34 @@ namespace Step40
                                 point, value);
 
     std::vector<double> tmp (value.size());
+    std::vector<double> tmp2 (value.size());
+#ifdef PETSC_USE_COMPLEX
+    std::vector<double> tmpI (value.size());
+    std::vector<double> tmp2I (value.size());
+
+    for (unsigned int i=0; i<value.size(); ++i)
+      {
+        tmp[i]=PetscRealPart(value[i]);
+        tmpI[i]=PetscImaginaryPart(value[i]);
+      }
+#else
     for (unsigned int i=0; i<value.size(); ++i)
       tmp[i]=value[i];
+#endif
 
-    std::vector<double> tmp2 (value.size());
     MPI_Reduce(&(tmp[0]), &(tmp2[0]), value.size(), MPI_DOUBLE,
                MPI_SUM, proc, mpi_communicator);
 
+#ifdef PETSC_USE_COMPELX
+    MPI_Reduce(&(tmpI[0]), &(tmp2I[0]), value.size(), MPI_DOUBLE,
+               MPI_SUM, proc, mpi_communicator);
+
+    for (unsigned int i=0; i<value.size(); ++i)
+      value[i]=std::complex<double>(tmp2[i],tmp2I[i]);
+#else
     for (unsigned int i=0; i<value.size(); ++i)
       value[i]=tmp2[i];
+#endif
   }
 
   template <int dim>
@@ -330,8 +354,8 @@ namespace Step40
 
     for (unsigned int i=1; i< n_points; i++)
       {
-        Vector<double> value1(1);
-        Vector<double> value2(1);
+        Vector<PetscScalar> value1(1);
+        Vector<PetscScalar> value2(1);
 
         Point <2> point1;
         point1(0)=1.*i/n_points;
@@ -345,13 +369,15 @@ namespace Step40
 
         if (Utilities::MPI::this_mpi_process(mpi_communicator)==0)
           {
-            pcout << point1 << "\t" << value1[0] << std::endl;
+            pcout << point1 << "\t" << PetscRealPart(value1[0]) << std::endl;
             if (std::abs(value2[0]-value1[0])>1e-8)
               {
                 std::cout<<point1<< "\t" << value1[0] << std::endl;
                 std::cout<<point2<< "\t" << value2[0] << std::endl;
                 Assert(false, ExcInternalError());
               }
+            Assert(std::fabs(PetscImaginaryPart(value1[0]))<1e-10,
+                   ExcInternalError());
           }
       }
   }
@@ -366,10 +392,10 @@ namespace Step40
     for (unsigned int i=1; i< n_points; i++)
       for (unsigned int j=1; j< n_points; j++)
         {
-          Vector<double> value1(1);
-          Vector<double> value2(1);
-          Vector<double> value3(1);
-          Vector<double> value4(1);
+          Vector<PetscScalar> value1(1);
+          Vector<PetscScalar> value2(1);
+          Vector<PetscScalar> value3(1);
+          Vector<PetscScalar> value4(1);
 
           Point <3> point1;
           point1(0)=1.*i/n_points;
@@ -395,20 +421,24 @@ namespace Step40
 
           if (Utilities::MPI::this_mpi_process(mpi_communicator)==0)
             {
-              pcout << point1 << "\t" << value1[0] << std::endl;
+              pcout << point1 << "\t" << PetscRealPart(value1[0]) << std::endl;
               if (std::abs(value2[0]-value1[0])>1e-8)
                 {
                   std::cout<<point1<< "\t" << value1[0] << std::endl;
                   std::cout<<point2<< "\t" << value2[0] << std::endl;
                   Assert(false, ExcInternalError());
                 }
-              pcout << point3 << "\t" << value3[0] << std::endl;
+              Assert(std::fabs(PetscImaginaryPart(value1[0]))<1e-10,
+                     ExcInternalError());
+              pcout << point3 << "\t" << PetscRealPart(value3[0]) << std::endl;
               if (std::abs(value4[0]-value3[0])>1e-8)
                 {
                   std::cout<<point3<< "\t" << value3[0] << std::endl;
                   std::cout<<point4<< "\t" << value4[0] << std::endl;
                   Assert(false, ExcInternalError());
                 }
+              Assert(std::fabs(PetscImaginaryPart(value3[0]))<1e-10,
+                     ExcInternalError());
             }
         }
   }
diff --git a/tests/mpi/periodicity_01.with_petsc=true.mpirun=3.output.2 b/tests/mpi/periodicity_01.with_petsc=true.mpirun=3.output.2
new file mode 100644 (file)
index 0000000..020358c
--- /dev/null
@@ -0,0 +1,163 @@
+
+Testing for dim=2
+
+Cycle 0:
+DEAL::Starting value 0.00436405
+DEAL::Convergence step 29 value 0
+   Solved in 29 iterations.
+0.500000 0.00000       -0.00549678
+
+Cycle 1:
+DEAL::Starting value 0.00331324
+DEAL::Convergence step 46 value 0
+   Solved in 46 iterations.
+0.250000 0.00000       -0.00130251
+0.500000 0.00000       -0.00550617
+0.750000 0.00000       -0.00183466
+
+Cycle 2:
+DEAL::Starting value 0.00282011
+DEAL::Convergence step 63 value 0
+   Solved in 63 iterations.
+0.125000 0.00000       0.00141483
+0.250000 0.00000       -0.00124254
+0.375000 0.00000       -0.00429173
+0.500000 0.00000       -0.00545458
+0.625000 0.00000       -0.00429054
+0.750000 0.00000       -0.00185255
+0.875000 0.00000       0.000356647
+
+Testing for dim=3
+
+Cycle 0:
+DEAL::Starting value 0.00284988
+DEAL::Convergence step 33 value 0
+   Solved in 33 iterations.
+0.500000 0.500000 0.00000      0.000839383
+0.500000 0.00000 0.500000      0.000542250
+
+Cycle 1:
+DEAL::Starting value 0.00241917
+DEAL::Convergence step 62 value 0
+   Solved in 62 iterations.
+0.250000 0.250000 0.00000      -7.02574e-05
+0.250000 0.00000 0.250000      -8.84955e-05
+0.250000 0.500000 0.00000      2.30224e-05
+0.250000 0.00000 0.500000      -1.58988e-05
+0.250000 0.750000 0.00000      -5.50224e-05
+0.250000 0.00000 0.750000      -6.78044e-05
+0.500000 0.250000 0.00000      -0.000245815
+0.500000 0.00000 0.250000      -0.000367442
+0.500000 0.500000 0.00000      0.000854616
+0.500000 0.00000 0.500000      0.000545283
+0.500000 0.750000 0.00000      -7.60057e-05
+0.500000 0.00000 0.750000      -0.000116497
+0.750000 0.250000 0.00000      -0.000105394
+0.750000 0.00000 0.250000      -0.000112911
+0.750000 0.500000 0.00000      -2.69468e-06
+0.750000 0.00000 0.500000      -3.29142e-05
+0.750000 0.750000 0.00000      -7.97320e-05
+0.750000 0.00000 0.750000      -8.82296e-05
+
+Cycle 2:
+DEAL::Starting value 0.00208338
+DEAL::Convergence step 90 value 0
+   Solved in 90 iterations.
+0.125000 0.125000 0.00000      0.000714896
+0.125000 0.00000 0.125000      0.000732888
+0.125000 0.250000 0.00000      4.21241e-05
+0.125000 0.00000 0.250000      6.67244e-05
+0.125000 0.375000 0.00000      -0.000451000
+0.125000 0.00000 0.375000      -0.000348082
+0.125000 0.500000 0.00000      -0.000540492
+0.125000 0.00000 0.500000      -0.000389894
+0.125000 0.625000 0.00000      -0.000333853
+0.125000 0.00000 0.625000      -0.000227459
+0.125000 0.750000 0.00000      -4.30474e-05
+0.125000 0.00000 0.750000      -3.85607e-05
+0.125000 0.875000 0.00000      0.000218364
+0.125000 0.00000 0.875000      0.000150624
+0.250000 0.125000 0.00000      -0.000102974
+0.250000 0.00000 0.125000      -0.000107813
+0.250000 0.250000 0.00000      -7.06290e-05
+0.250000 0.00000 0.250000      -8.58914e-05
+0.250000 0.375000 0.00000      -2.80802e-05
+0.250000 0.00000 0.375000      -5.09368e-05
+0.250000 0.500000 0.00000      -2.22203e-06
+0.250000 0.00000 0.500000      -2.71771e-05
+0.250000 0.625000 0.00000      -1.09299e-05
+0.250000 0.00000 0.625000      -3.17431e-05
+0.250000 0.750000 0.00000      -5.07980e-05
+0.250000 0.00000 0.750000      -6.33648e-05
+0.250000 0.875000 0.00000      -9.87957e-05
+0.250000 0.00000 0.875000      -0.000103668
+0.375000 0.125000 0.00000      -0.00101184
+0.375000 0.00000 0.125000      -0.00104895
+0.375000 0.250000 0.00000      -0.000213964
+0.375000 0.00000 0.250000      -0.000284205
+0.375000 0.375000 0.00000      0.000442810
+0.375000 0.00000 0.375000      0.000274644
+0.375000 0.500000 0.00000      0.000616793
+0.375000 0.00000 0.500000      0.000394006
+0.375000 0.625000 0.00000      0.000372231
+0.375000 0.00000 0.625000      0.000207540
+0.375000 0.750000 0.00000      -5.19075e-05
+0.375000 0.00000 0.750000      -8.76469e-05
+0.375000 0.875000 0.00000      -0.000484075
+0.375000 0.00000 0.875000      -0.000427601
+0.500000 0.125000 0.00000      -0.00131821
+0.500000 0.00000 0.125000      -0.00136606
+0.500000 0.250000 0.00000      -0.000273020
+0.500000 0.00000 0.250000      -0.000364090
+0.500000 0.375000 0.00000      0.000588192
+0.500000 0.00000 0.375000      0.000370504
+0.500000 0.500000 0.00000      0.000816320
+0.500000 0.00000 0.500000      0.000527723
+0.500000 0.625000 0.00000      0.000496202
+0.500000 0.00000 0.625000      0.000283291
+0.500000 0.750000 0.00000      -5.86240e-05
+0.500000 0.00000 0.750000      -0.000103628
+0.500000 0.875000 0.00000      -0.000627027
+0.500000 0.00000 0.875000      -0.000552959
+0.625000 0.125000 0.00000      -0.000926278
+0.625000 0.00000 0.125000      -0.000960435
+0.625000 0.250000 0.00000      -0.000220905
+0.625000 0.00000 0.250000      -0.000286844
+0.625000 0.375000 0.00000      0.000368717
+0.625000 0.00000 0.375000      0.000216623
+0.625000 0.500000 0.00000      0.000530333
+0.625000 0.00000 0.500000      0.000330746
+0.625000 0.625000 0.00000      0.000314226
+0.625000 0.00000 0.625000      0.000166179
+0.625000 0.750000 0.00000      -6.93567e-05
+0.625000 0.00000 0.750000      -0.000103178
+0.625000 0.875000 0.00000      -0.000466912
+0.625000 0.00000 0.875000      -0.000419439
+0.750000 0.125000 0.00000      -0.000179286
+0.750000 0.00000 0.125000      -0.000185378
+0.750000 0.250000 0.00000      -0.000104709
+0.750000 0.00000 0.250000      -0.000119333
+0.750000 0.375000 0.00000      -3.05754e-05
+0.750000 0.00000 0.375000      -5.60127e-05
+0.750000 0.500000 0.00000      -1.89151e-06
+0.750000 0.00000 0.500000      -2.99975e-05
+0.750000 0.625000 0.00000      -2.44780e-05
+0.750000 0.00000 0.625000      -4.77630e-05
+0.750000 0.750000 0.00000      -7.84822e-05
+0.750000 0.00000 0.750000      -9.01734e-05
+0.750000 0.875000 0.00000      -0.000142966
+0.750000 0.00000 0.875000      -0.000142512
+0.875000 0.125000 0.00000      0.000456000
+0.875000 0.00000 0.125000      0.000475880
+0.875000 0.250000 0.00000      1.30647e-06
+0.875000 0.00000 0.250000      3.27430e-05
+0.875000 0.375000 0.00000      -0.000364914
+0.875000 0.00000 0.375000      -0.000280671
+0.875000 0.500000 0.00000      -0.000453633
+0.875000 0.00000 0.500000      -0.000336703
+0.875000 0.625000 0.00000      -0.000312918
+0.875000 0.00000 0.625000      -0.000230032
+0.875000 0.750000 0.00000      -7.87644e-05
+0.875000 0.00000 0.750000      -6.52054e-05
+0.875000 0.875000 0.00000      0.000142725
+0.875000 0.00000 0.875000      0.000106650
diff --git a/tests/mpi/periodicity_01.with_petsc=true.mpirun=5.output.2 b/tests/mpi/periodicity_01.with_petsc=true.mpirun=5.output.2
new file mode 100644 (file)
index 0000000..020358c
--- /dev/null
@@ -0,0 +1,163 @@
+
+Testing for dim=2
+
+Cycle 0:
+DEAL::Starting value 0.00436405
+DEAL::Convergence step 29 value 0
+   Solved in 29 iterations.
+0.500000 0.00000       -0.00549678
+
+Cycle 1:
+DEAL::Starting value 0.00331324
+DEAL::Convergence step 46 value 0
+   Solved in 46 iterations.
+0.250000 0.00000       -0.00130251
+0.500000 0.00000       -0.00550617
+0.750000 0.00000       -0.00183466
+
+Cycle 2:
+DEAL::Starting value 0.00282011
+DEAL::Convergence step 63 value 0
+   Solved in 63 iterations.
+0.125000 0.00000       0.00141483
+0.250000 0.00000       -0.00124254
+0.375000 0.00000       -0.00429173
+0.500000 0.00000       -0.00545458
+0.625000 0.00000       -0.00429054
+0.750000 0.00000       -0.00185255
+0.875000 0.00000       0.000356647
+
+Testing for dim=3
+
+Cycle 0:
+DEAL::Starting value 0.00284988
+DEAL::Convergence step 33 value 0
+   Solved in 33 iterations.
+0.500000 0.500000 0.00000      0.000839383
+0.500000 0.00000 0.500000      0.000542250
+
+Cycle 1:
+DEAL::Starting value 0.00241917
+DEAL::Convergence step 62 value 0
+   Solved in 62 iterations.
+0.250000 0.250000 0.00000      -7.02574e-05
+0.250000 0.00000 0.250000      -8.84955e-05
+0.250000 0.500000 0.00000      2.30224e-05
+0.250000 0.00000 0.500000      -1.58988e-05
+0.250000 0.750000 0.00000      -5.50224e-05
+0.250000 0.00000 0.750000      -6.78044e-05
+0.500000 0.250000 0.00000      -0.000245815
+0.500000 0.00000 0.250000      -0.000367442
+0.500000 0.500000 0.00000      0.000854616
+0.500000 0.00000 0.500000      0.000545283
+0.500000 0.750000 0.00000      -7.60057e-05
+0.500000 0.00000 0.750000      -0.000116497
+0.750000 0.250000 0.00000      -0.000105394
+0.750000 0.00000 0.250000      -0.000112911
+0.750000 0.500000 0.00000      -2.69468e-06
+0.750000 0.00000 0.500000      -3.29142e-05
+0.750000 0.750000 0.00000      -7.97320e-05
+0.750000 0.00000 0.750000      -8.82296e-05
+
+Cycle 2:
+DEAL::Starting value 0.00208338
+DEAL::Convergence step 90 value 0
+   Solved in 90 iterations.
+0.125000 0.125000 0.00000      0.000714896
+0.125000 0.00000 0.125000      0.000732888
+0.125000 0.250000 0.00000      4.21241e-05
+0.125000 0.00000 0.250000      6.67244e-05
+0.125000 0.375000 0.00000      -0.000451000
+0.125000 0.00000 0.375000      -0.000348082
+0.125000 0.500000 0.00000      -0.000540492
+0.125000 0.00000 0.500000      -0.000389894
+0.125000 0.625000 0.00000      -0.000333853
+0.125000 0.00000 0.625000      -0.000227459
+0.125000 0.750000 0.00000      -4.30474e-05
+0.125000 0.00000 0.750000      -3.85607e-05
+0.125000 0.875000 0.00000      0.000218364
+0.125000 0.00000 0.875000      0.000150624
+0.250000 0.125000 0.00000      -0.000102974
+0.250000 0.00000 0.125000      -0.000107813
+0.250000 0.250000 0.00000      -7.06290e-05
+0.250000 0.00000 0.250000      -8.58914e-05
+0.250000 0.375000 0.00000      -2.80802e-05
+0.250000 0.00000 0.375000      -5.09368e-05
+0.250000 0.500000 0.00000      -2.22203e-06
+0.250000 0.00000 0.500000      -2.71771e-05
+0.250000 0.625000 0.00000      -1.09299e-05
+0.250000 0.00000 0.625000      -3.17431e-05
+0.250000 0.750000 0.00000      -5.07980e-05
+0.250000 0.00000 0.750000      -6.33648e-05
+0.250000 0.875000 0.00000      -9.87957e-05
+0.250000 0.00000 0.875000      -0.000103668
+0.375000 0.125000 0.00000      -0.00101184
+0.375000 0.00000 0.125000      -0.00104895
+0.375000 0.250000 0.00000      -0.000213964
+0.375000 0.00000 0.250000      -0.000284205
+0.375000 0.375000 0.00000      0.000442810
+0.375000 0.00000 0.375000      0.000274644
+0.375000 0.500000 0.00000      0.000616793
+0.375000 0.00000 0.500000      0.000394006
+0.375000 0.625000 0.00000      0.000372231
+0.375000 0.00000 0.625000      0.000207540
+0.375000 0.750000 0.00000      -5.19075e-05
+0.375000 0.00000 0.750000      -8.76469e-05
+0.375000 0.875000 0.00000      -0.000484075
+0.375000 0.00000 0.875000      -0.000427601
+0.500000 0.125000 0.00000      -0.00131821
+0.500000 0.00000 0.125000      -0.00136606
+0.500000 0.250000 0.00000      -0.000273020
+0.500000 0.00000 0.250000      -0.000364090
+0.500000 0.375000 0.00000      0.000588192
+0.500000 0.00000 0.375000      0.000370504
+0.500000 0.500000 0.00000      0.000816320
+0.500000 0.00000 0.500000      0.000527723
+0.500000 0.625000 0.00000      0.000496202
+0.500000 0.00000 0.625000      0.000283291
+0.500000 0.750000 0.00000      -5.86240e-05
+0.500000 0.00000 0.750000      -0.000103628
+0.500000 0.875000 0.00000      -0.000627027
+0.500000 0.00000 0.875000      -0.000552959
+0.625000 0.125000 0.00000      -0.000926278
+0.625000 0.00000 0.125000      -0.000960435
+0.625000 0.250000 0.00000      -0.000220905
+0.625000 0.00000 0.250000      -0.000286844
+0.625000 0.375000 0.00000      0.000368717
+0.625000 0.00000 0.375000      0.000216623
+0.625000 0.500000 0.00000      0.000530333
+0.625000 0.00000 0.500000      0.000330746
+0.625000 0.625000 0.00000      0.000314226
+0.625000 0.00000 0.625000      0.000166179
+0.625000 0.750000 0.00000      -6.93567e-05
+0.625000 0.00000 0.750000      -0.000103178
+0.625000 0.875000 0.00000      -0.000466912
+0.625000 0.00000 0.875000      -0.000419439
+0.750000 0.125000 0.00000      -0.000179286
+0.750000 0.00000 0.125000      -0.000185378
+0.750000 0.250000 0.00000      -0.000104709
+0.750000 0.00000 0.250000      -0.000119333
+0.750000 0.375000 0.00000      -3.05754e-05
+0.750000 0.00000 0.375000      -5.60127e-05
+0.750000 0.500000 0.00000      -1.89151e-06
+0.750000 0.00000 0.500000      -2.99975e-05
+0.750000 0.625000 0.00000      -2.44780e-05
+0.750000 0.00000 0.625000      -4.77630e-05
+0.750000 0.750000 0.00000      -7.84822e-05
+0.750000 0.00000 0.750000      -9.01734e-05
+0.750000 0.875000 0.00000      -0.000142966
+0.750000 0.00000 0.875000      -0.000142512
+0.875000 0.125000 0.00000      0.000456000
+0.875000 0.00000 0.125000      0.000475880
+0.875000 0.250000 0.00000      1.30647e-06
+0.875000 0.00000 0.250000      3.27430e-05
+0.875000 0.375000 0.00000      -0.000364914
+0.875000 0.00000 0.375000      -0.000280671
+0.875000 0.500000 0.00000      -0.000453633
+0.875000 0.00000 0.500000      -0.000336703
+0.875000 0.625000 0.00000      -0.000312918
+0.875000 0.00000 0.625000      -0.000230032
+0.875000 0.750000 0.00000      -7.87644e-05
+0.875000 0.00000 0.750000      -6.52054e-05
+0.875000 0.875000 0.00000      0.000142725
+0.875000 0.00000 0.875000      0.000106650
diff --git a/tests/mpi/periodicity_01.with_petsc=true.mpirun=7.output.2 b/tests/mpi/periodicity_01.with_petsc=true.mpirun=7.output.2
new file mode 100644 (file)
index 0000000..020358c
--- /dev/null
@@ -0,0 +1,163 @@
+
+Testing for dim=2
+
+Cycle 0:
+DEAL::Starting value 0.00436405
+DEAL::Convergence step 29 value 0
+   Solved in 29 iterations.
+0.500000 0.00000       -0.00549678
+
+Cycle 1:
+DEAL::Starting value 0.00331324
+DEAL::Convergence step 46 value 0
+   Solved in 46 iterations.
+0.250000 0.00000       -0.00130251
+0.500000 0.00000       -0.00550617
+0.750000 0.00000       -0.00183466
+
+Cycle 2:
+DEAL::Starting value 0.00282011
+DEAL::Convergence step 63 value 0
+   Solved in 63 iterations.
+0.125000 0.00000       0.00141483
+0.250000 0.00000       -0.00124254
+0.375000 0.00000       -0.00429173
+0.500000 0.00000       -0.00545458
+0.625000 0.00000       -0.00429054
+0.750000 0.00000       -0.00185255
+0.875000 0.00000       0.000356647
+
+Testing for dim=3
+
+Cycle 0:
+DEAL::Starting value 0.00284988
+DEAL::Convergence step 33 value 0
+   Solved in 33 iterations.
+0.500000 0.500000 0.00000      0.000839383
+0.500000 0.00000 0.500000      0.000542250
+
+Cycle 1:
+DEAL::Starting value 0.00241917
+DEAL::Convergence step 62 value 0
+   Solved in 62 iterations.
+0.250000 0.250000 0.00000      -7.02574e-05
+0.250000 0.00000 0.250000      -8.84955e-05
+0.250000 0.500000 0.00000      2.30224e-05
+0.250000 0.00000 0.500000      -1.58988e-05
+0.250000 0.750000 0.00000      -5.50224e-05
+0.250000 0.00000 0.750000      -6.78044e-05
+0.500000 0.250000 0.00000      -0.000245815
+0.500000 0.00000 0.250000      -0.000367442
+0.500000 0.500000 0.00000      0.000854616
+0.500000 0.00000 0.500000      0.000545283
+0.500000 0.750000 0.00000      -7.60057e-05
+0.500000 0.00000 0.750000      -0.000116497
+0.750000 0.250000 0.00000      -0.000105394
+0.750000 0.00000 0.250000      -0.000112911
+0.750000 0.500000 0.00000      -2.69468e-06
+0.750000 0.00000 0.500000      -3.29142e-05
+0.750000 0.750000 0.00000      -7.97320e-05
+0.750000 0.00000 0.750000      -8.82296e-05
+
+Cycle 2:
+DEAL::Starting value 0.00208338
+DEAL::Convergence step 90 value 0
+   Solved in 90 iterations.
+0.125000 0.125000 0.00000      0.000714896
+0.125000 0.00000 0.125000      0.000732888
+0.125000 0.250000 0.00000      4.21241e-05
+0.125000 0.00000 0.250000      6.67244e-05
+0.125000 0.375000 0.00000      -0.000451000
+0.125000 0.00000 0.375000      -0.000348082
+0.125000 0.500000 0.00000      -0.000540492
+0.125000 0.00000 0.500000      -0.000389894
+0.125000 0.625000 0.00000      -0.000333853
+0.125000 0.00000 0.625000      -0.000227459
+0.125000 0.750000 0.00000      -4.30474e-05
+0.125000 0.00000 0.750000      -3.85607e-05
+0.125000 0.875000 0.00000      0.000218364
+0.125000 0.00000 0.875000      0.000150624
+0.250000 0.125000 0.00000      -0.000102974
+0.250000 0.00000 0.125000      -0.000107813
+0.250000 0.250000 0.00000      -7.06290e-05
+0.250000 0.00000 0.250000      -8.58914e-05
+0.250000 0.375000 0.00000      -2.80802e-05
+0.250000 0.00000 0.375000      -5.09368e-05
+0.250000 0.500000 0.00000      -2.22203e-06
+0.250000 0.00000 0.500000      -2.71771e-05
+0.250000 0.625000 0.00000      -1.09299e-05
+0.250000 0.00000 0.625000      -3.17431e-05
+0.250000 0.750000 0.00000      -5.07980e-05
+0.250000 0.00000 0.750000      -6.33648e-05
+0.250000 0.875000 0.00000      -9.87957e-05
+0.250000 0.00000 0.875000      -0.000103668
+0.375000 0.125000 0.00000      -0.00101184
+0.375000 0.00000 0.125000      -0.00104895
+0.375000 0.250000 0.00000      -0.000213964
+0.375000 0.00000 0.250000      -0.000284205
+0.375000 0.375000 0.00000      0.000442810
+0.375000 0.00000 0.375000      0.000274644
+0.375000 0.500000 0.00000      0.000616793
+0.375000 0.00000 0.500000      0.000394006
+0.375000 0.625000 0.00000      0.000372231
+0.375000 0.00000 0.625000      0.000207540
+0.375000 0.750000 0.00000      -5.19075e-05
+0.375000 0.00000 0.750000      -8.76469e-05
+0.375000 0.875000 0.00000      -0.000484075
+0.375000 0.00000 0.875000      -0.000427601
+0.500000 0.125000 0.00000      -0.00131821
+0.500000 0.00000 0.125000      -0.00136606
+0.500000 0.250000 0.00000      -0.000273020
+0.500000 0.00000 0.250000      -0.000364090
+0.500000 0.375000 0.00000      0.000588192
+0.500000 0.00000 0.375000      0.000370504
+0.500000 0.500000 0.00000      0.000816320
+0.500000 0.00000 0.500000      0.000527723
+0.500000 0.625000 0.00000      0.000496202
+0.500000 0.00000 0.625000      0.000283291
+0.500000 0.750000 0.00000      -5.86240e-05
+0.500000 0.00000 0.750000      -0.000103628
+0.500000 0.875000 0.00000      -0.000627027
+0.500000 0.00000 0.875000      -0.000552959
+0.625000 0.125000 0.00000      -0.000926278
+0.625000 0.00000 0.125000      -0.000960435
+0.625000 0.250000 0.00000      -0.000220905
+0.625000 0.00000 0.250000      -0.000286844
+0.625000 0.375000 0.00000      0.000368717
+0.625000 0.00000 0.375000      0.000216623
+0.625000 0.500000 0.00000      0.000530333
+0.625000 0.00000 0.500000      0.000330746
+0.625000 0.625000 0.00000      0.000314226
+0.625000 0.00000 0.625000      0.000166179
+0.625000 0.750000 0.00000      -6.93567e-05
+0.625000 0.00000 0.750000      -0.000103178
+0.625000 0.875000 0.00000      -0.000466912
+0.625000 0.00000 0.875000      -0.000419439
+0.750000 0.125000 0.00000      -0.000179286
+0.750000 0.00000 0.125000      -0.000185378
+0.750000 0.250000 0.00000      -0.000104709
+0.750000 0.00000 0.250000      -0.000119333
+0.750000 0.375000 0.00000      -3.05754e-05
+0.750000 0.00000 0.375000      -5.60127e-05
+0.750000 0.500000 0.00000      -1.89151e-06
+0.750000 0.00000 0.500000      -2.99975e-05
+0.750000 0.625000 0.00000      -2.44780e-05
+0.750000 0.00000 0.625000      -4.77630e-05
+0.750000 0.750000 0.00000      -7.84822e-05
+0.750000 0.00000 0.750000      -9.01734e-05
+0.750000 0.875000 0.00000      -0.000142966
+0.750000 0.00000 0.875000      -0.000142512
+0.875000 0.125000 0.00000      0.000456000
+0.875000 0.00000 0.125000      0.000475880
+0.875000 0.250000 0.00000      1.30647e-06
+0.875000 0.00000 0.250000      3.27430e-05
+0.875000 0.375000 0.00000      -0.000364914
+0.875000 0.00000 0.375000      -0.000280671
+0.875000 0.500000 0.00000      -0.000453633
+0.875000 0.00000 0.500000      -0.000336703
+0.875000 0.625000 0.00000      -0.000312918
+0.875000 0.00000 0.625000      -0.000230032
+0.875000 0.750000 0.00000      -7.87644e-05
+0.875000 0.00000 0.750000      -6.52054e-05
+0.875000 0.875000 0.00000      0.000142725
+0.875000 0.00000 0.875000      0.000106650

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.