]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix more PETSc complex tests 13961/head
authorMartin Kronbichler <martin.kronbichler@uni-a.de>
Sun, 12 Jun 2022 19:14:00 +0000 (21:14 +0200)
committerMartin Kronbichler <martin.kronbichler@uni-a.de>
Sun, 12 Jun 2022 22:08:34 +0000 (00:08 +0200)
tests/simplex/step-17.cc
tests/simplex/step-18.cc
tests/simplex/step-40.cc
tests/simplex/step-40.mpirun=1.with_petsc=true.output
tests/simplex/step-40.mpirun=4.with_petsc=true.with_metis=true.output

index ec73dbcf7c518202ea86be17ef856d6ffbc64e36..0da2d021f597fe90de8917f8a208aac62ac60284 100644 (file)
@@ -311,12 +311,13 @@ namespace Step17
     system_matrix.compress(VectorOperation::add);
     system_rhs.compress(VectorOperation::add);
 
-    std::map<types::global_dof_index, double> boundary_values;
-    VectorTools::interpolate_boundary_values(mapping,
-                                             dof_handler,
-                                             0,
-                                             Functions::ZeroFunction<dim>(dim),
-                                             boundary_values);
+    std::map<types::global_dof_index, PetscScalar> boundary_values;
+    VectorTools::interpolate_boundary_values(
+      mapping,
+      dof_handler,
+      0,
+      Functions::ZeroFunction<dim, PetscScalar>(dim),
+      boundary_values);
     MatrixTools::apply_boundary_values(
       boundary_values, system_matrix, solution, system_rhs, false);
   }
index 37ba34f885ca14a7952374ad459dbcad29f6bd2d..b8a099550bbaa1b9b5a7ebcba3a4c8dc21ad2eb4 100644 (file)
@@ -639,13 +639,14 @@ namespace Step18
 #endif
 
 
-    FEValuesExtractors::Scalar                z_component(dim - 1);
-    std::map<types::global_dof_index, double> boundary_values;
-    VectorTools::interpolate_boundary_values(mapping,
-                                             dof_handler,
-                                             0,
-                                             Functions::ZeroFunction<dim>(dim),
-                                             boundary_values);
+    FEValuesExtractors::Scalar                     z_component(dim - 1);
+    std::map<types::global_dof_index, PetscScalar> boundary_values;
+    VectorTools::interpolate_boundary_values(
+      mapping,
+      dof_handler,
+      0,
+      Functions::ZeroFunction<dim, PetscScalar>(dim),
+      boundary_values);
     VectorTools::interpolate_boundary_values(
       mapping,
       dof_handler,
index 8ded4a77a8a15528a059666a8512c436fa322fef..c08c073809b41a643f0763d5bb4ad8c931b865ff 100644 (file)
@@ -288,7 +288,7 @@ namespace Step40
                                            system_rhs,
                                            preconditioner),
                               solver_control.last_step(),
-                              5,
+                              1,
                               9);
 
     constraints.distribute(completely_distributed_solution);
@@ -340,12 +340,7 @@ namespace Step40
   void
   LaplaceProblem<dim>::run()
   {
-    deallog << "Running with "
-#ifdef USE_PETSC_LA
-            << "PETSc"
-#else
-            << "Trilinos"
-#endif
+    deallog << "Running "
             << " on " << Utilities::MPI::n_mpi_processes(mpi_communicator)
             << " MPI rank(s)..." << std::endl;
 
index 5693999f8470e3544d37da655d0b4dc4bc3fc3fd..011082cbfda6c0a604f0d2979fadcb3372065245 100644 (file)
@@ -1,6 +1,6 @@
 
-DEAL::Running with PETSc on 1 MPI rank(s)...
+DEAL::Running on 1 MPI rank(s)...
 DEAL::   Number of active cells:       512
 DEAL::   Number of degrees of freedom: 1089
-DEAL::Solver stopped within 5 - 9 iterations
+DEAL::Solver stopped within 1 - 9 iterations
 DEAL::0.0124965
index bff795f87f2b1166b7acb730fdace8b0b443d076..2fd1c694edb006e61114159c001302c2f853c612 100644 (file)
@@ -1,6 +1,6 @@
 
-DEAL::Running with PETSc on 4 MPI rank(s)...
+DEAL::Running on 4 MPI rank(s)...
 DEAL::   Number of active cells:       512
 DEAL::   Number of degrees of freedom: 1089
-DEAL::Solver stopped within 5 - 9 iterations
+DEAL::Solver stopped within 1 - 9 iterations
 DEAL::0.0124965

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.