]> https://gitweb.dealii.org/ - code-gallery.git/commitdiff
Fix the remaining compiler errors. 110/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Tue, 19 Jul 2022 21:04:02 +0000 (15:04 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Tue, 19 Jul 2022 21:08:50 +0000 (15:08 -0600)
I live under no illusion that everything will just work as expected,
but being able to compile is a good first step :-)

Nonlinear_PoroViscoelasticity/nonlinear-poro-viscoelasticity.cc
time_dependent_navier_stokes/time_dependent_navier_stokes.cc
two_phase_flow/LevelSetSolver.cc
two_phase_flow/MultiPhase.cc
two_phase_flow/NavierStokesSolver.cc
two_phase_flow/TestLevelSet.cc
two_phase_flow/TestNavierStokes.cc

index 1e527e61769d47b8253fec2558880312f574255f..fce41fe1d609868912b2288d6cb4404789e927a5 100644 (file)
@@ -49,7 +49,6 @@
 #include <deal.II/grid/grid_out.h>\r
 #include <deal.II/grid/manifold_lib.h>\r
 #include <deal.II/grid/tria_accessor.h>\r
-#include <deal.II/grid/tria_boundary_lib.h>\r
 #include <deal.II/grid/tria_iterator.h>\r
 \r
 #include <deal.II/fe/fe_dgp_monomial.h>\r
@@ -2006,9 +2005,7 @@ namespace NonLinearPoroViscoElasticity
         DoFRenumbering::component_wise(dof_handler_ref, block_component);\r
 \r
         // Count the number of DoFs in each block\r
-        dofs_per_block.clear();\r
-        dofs_per_block.resize(n_blocks);\r
-        DoFTools::count_dofs_per_block(dof_handler_ref, dofs_per_block, block_component);\r
+        dofs_per_block = DoFTools::count_dofs_per_fe_block(dof_handler_ref, block_component);\r
 \r
         // Setup the sparsity pattern and tangent matrix\r
         all_locally_owned_dofs = DoFTools::locally_owned_dofs_per_subdomain (dof_handler_ref);\r
@@ -3763,7 +3760,7 @@ namespace NonLinearPoroViscoElasticity
             for (unsigned int d=0; d<(solution_p_vector.size()); ++d)\r
                 solution_vector[solution_u_vector.size()+d] = solution_p_vector[d];\r
 \r
-            Functions::FEFieldFunction<dim,DoFHandler<dim>,Vector<double>>\r
+            Functions::FEFieldFunction<dim,Vector<double>>\r
             find_solution(dof_handler_ref, solution_vector);\r
 \r
             for (unsigned int p=0; p<tracked_vertices_IN.size(); ++p)\r
@@ -4005,7 +4002,7 @@ namespace NonLinearPoroViscoElasticity
                                      0.5);\r
 \r
             const double rot_angle = 3.0*numbers::PI/2.0;\r
-            GridTools::rotate( rot_angle, 1, this->triangulation);\r
+            GridTools::rotate( Point<3>::unit_vector(1), rot_angle, this->triangulation);\r
 \r
             this->triangulation.reset_manifold(0);\r
             static const CylindricalManifold<dim> manifold_description_3d(2);\r
@@ -4032,7 +4029,7 @@ namespace NonLinearPoroViscoElasticity
             {\r
               VectorTools::interpolate_boundary_values(this->dof_handler_ref,\r
                                                        2,\r
-                                                       ConstantFunction<dim>(this->parameters.drained_pressure,this->n_components),\r
+                                                       Functions::ConstantFunction<dim>(this->parameters.drained_pressure,this->n_components),\r
                                                        constraints,\r
                                                        (this->fe.component_mask(this->pressure)));\r
             }\r
@@ -4225,7 +4222,7 @@ namespace NonLinearPoroViscoElasticity
             {\r
               VectorTools::interpolate_boundary_values(this->dof_handler_ref,\r
                                                        101,\r
-                                                       ConstantFunction<dim>(this->parameters.drained_pressure,this->n_components),\r
+                                                       Functions::ConstantFunction<dim>(this->parameters.drained_pressure,this->n_components),\r
                                                        constraints,\r
                                                        (this->fe.component_mask(this->pressure)));\r
             }\r
@@ -4401,13 +4398,13 @@ namespace NonLinearPoroViscoElasticity
             {\r
               VectorTools::interpolate_boundary_values(this->dof_handler_ref,\r
                                                        1,\r
-                                                       ConstantFunction<dim>(this->parameters.drained_pressure,this->n_components),\r
+                                                       Functions::ConstantFunction<dim>(this->parameters.drained_pressure,this->n_components),\r
                                                        constraints,\r
                                                        (this->fe.component_mask(this->pressure)));\r
 \r
               VectorTools::interpolate_boundary_values(this->dof_handler_ref,\r
                                                        2,\r
-                                                       ConstantFunction<dim>(this->parameters.drained_pressure,this->n_components),\r
+                                                       Functions::ConstantFunction<dim>(this->parameters.drained_pressure,this->n_components),\r
                                                        constraints,\r
                                                        (this->fe.component_mask(this->pressure)));\r
             }\r
@@ -4606,7 +4603,7 @@ namespace NonLinearPoroViscoElasticity
               {\r
                   VectorTools::interpolate_boundary_values(this->dof_handler_ref,\r
                                                            100,\r
-                                                           ConstantFunction<dim>(this->parameters.drained_pressure,this->n_components),\r
+                                                           Functions::ConstantFunction<dim>(this->parameters.drained_pressure,this->n_components),\r
                                                            constraints,\r
                                                            (this->fe.component_mask(this->pressure)));\r
               }\r
@@ -4647,7 +4644,7 @@ namespace NonLinearPoroViscoElasticity
 \r
                 VectorTools::interpolate_boundary_values( this->dof_handler_ref,\r
                                                            5,\r
-                                                           ConstantFunction<dim>(value[2],this->n_components),\r
+                                                           Functions::ConstantFunction<dim>(value[2],this->n_components),\r
                                                            constraints,\r
                                                            this->fe.component_mask(direction));\r
             }\r
@@ -4762,7 +4759,7 @@ namespace NonLinearPoroViscoElasticity
               {\r
                   VectorTools::interpolate_boundary_values(this->dof_handler_ref,\r
                                                            100,\r
-                                                           ConstantFunction<dim>(this->parameters.drained_pressure,this->n_components),\r
+                                                           Functions::ConstantFunction<dim>(this->parameters.drained_pressure,this->n_components),\r
                                                            constraints,\r
                                                            (this->fe.component_mask(this->pressure)));\r
               }\r
@@ -4792,7 +4789,7 @@ namespace NonLinearPoroViscoElasticity
 \r
                 VectorTools::interpolate_boundary_values( this->dof_handler_ref,\r
                                                            5,\r
-                                                           ConstantFunction<dim>(value[2],this->n_components),\r
+                                                           Functions::ConstantFunction<dim>(value[2],this->n_components),\r
                                                            constraints,\r
                                                            this->fe.component_mask(direction) );\r
 \r
@@ -4912,7 +4909,7 @@ namespace NonLinearPoroViscoElasticity
               {\r
                   VectorTools::interpolate_boundary_values(this->dof_handler_ref,\r
                                                            100,\r
-                                                           ConstantFunction<dim>(this->parameters.drained_pressure,this->n_components),\r
+                                                           Functions::ConstantFunction<dim>(this->parameters.drained_pressure,this->n_components),\r
                                                            constraints,\r
                                                            (this->fe.component_mask(this->pressure)));\r
               }\r
@@ -4942,7 +4939,7 @@ namespace NonLinearPoroViscoElasticity
 \r
                 VectorTools::interpolate_boundary_values( this->dof_handler_ref,\r
                                                            4,\r
-                                                           ConstantFunction<dim>(value[0],this->n_components),\r
+                                                           Functions::ConstantFunction<dim>(value[0],this->n_components),\r
                                                            constraints,\r
                                                            this->fe.component_mask(direction));\r
 \r
@@ -4968,7 +4965,7 @@ namespace NonLinearPoroViscoElasticity
                     const double current_time = this->time.get_current();\r
                     const double final_time   = this->time.get_end();\r
                     const double num_cycles   = 3.0;\r
-                    const Point< 3, double> axis (0.0,1.0,0.0);\r
+                    const Tensor<1,3> axis ({0.0,1.0,0.0});\r
                     const double angle = numbers::PI;\r
                     static const Tensor< 2, dim, double> R(Physics::Transformations::Rotations::rotation_matrix_3d(axis,angle));\r
 \r
index 848337aca5978697654a4e8831ebafd2538584e5..d53f0ae0d599b1c0bd399504fff181e062d2403e 100644 (file)
@@ -17,9 +17,9 @@
 #include <deal.II/lac/sparse_direct.h>
 #include <deal.II/lac/sparsity_tools.h>
 
-#include <deal.II/lac/petsc_parallel_block_sparse_matrix.h>
-#include <deal.II/lac/petsc_parallel_sparse_matrix.h>
-#include <deal.II/lac/petsc_parallel_vector.h>
+#include <deal.II/lac/petsc_block_sparse_matrix.h>
+#include <deal.II/lac/petsc_sparse_matrix.h>
+#include <deal.II/lac/petsc_vector.h>
 #include <deal.II/lac/petsc_precondition.h>
 #include <deal.II/lac/petsc_solver.h>
 
@@ -645,9 +645,7 @@ namespace fluid
     std::vector<unsigned int> block_component(dim + 1, 0);
     block_component[dim] = 1;
     DoFRenumbering::component_wise(dof_handler, block_component);
-    dofs_per_block.resize(2);
-    DoFTools::count_dofs_per_block(
-      dof_handler, dofs_per_block, block_component);
+    dofs_per_block = DoFTools::count_dofs_per_fe_block(dof_handler, block_component);
     // Partitioning.
     unsigned int dof_u = dofs_per_block[0];
     unsigned int dof_p = dofs_per_block[1];
@@ -720,7 +718,7 @@ namespace fluid
     sparsity_pattern.copy_from(dsp);
     SparsityTools::distribute_sparsity_pattern(
       dsp,
-      dof_handler.locally_owned_dofs_per_processor(),
+      dof_handler.locally_owned_dofs(),
       mpi_communicator,
       locally_relevant_dofs);
 
@@ -1074,7 +1072,7 @@ namespace fluid
     FEValuesExtractors::Vector velocity(0);
     KellyErrorEstimator<dim>::estimate(dof_handler,
                                        face_quad_formula,
-                                       typename FunctionMap<dim>::type(),
+                                       {},
                                        present_solution,
                                        estimated_error_per_cell,
                                        fe.component_mask(velocity));
index 6f36032566252a00917135e6d3a0588c05283c99..a732b0afebd545d4eed5ad9ecdc313be5d5201d6 100644 (file)
@@ -4,9 +4,9 @@
 #include <deal.II/lac/vector.h>
 #include <deal.II/lac/full_matrix.h>
 #include <deal.II/lac/solver_cg.h>
-#include <deal.II/lac/petsc_parallel_sparse_matrix.h>
 #include <deal.II/lac/petsc_sparse_matrix.h>
-#include <deal.II/lac/petsc_parallel_vector.h>
+#include <deal.II/lac/petsc_sparse_matrix.h>
+#include <deal.II/lac/petsc_vector.h>
 #include <deal.II/lac/petsc_solver.h>
 #include <deal.II/lac/petsc_precondition.h>
 #include <deal.II/grid/grid_generator.h>
@@ -490,87 +490,57 @@ void LevelSetSolver<dim>::setup()
   DynamicSparsityPattern dsp (locally_relevant_dofs_LS);
   DoFTools::make_sparsity_pattern (dof_handler_LS,dsp,constraints,false);
   SparsityTools::distribute_sparsity_pattern (dsp,
-                                              dof_handler_LS.n_locally_owned_dofs_per_processor(),
+                                              dof_handler_LS.locally_owned_dofs(),
                                               mpi_communicator,
                                               locally_relevant_dofs_LS);
-  MC_matrix.reinit (mpi_communicator,
-                    dsp,
-                    dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                    dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                    Utilities::MPI::this_mpi_process(mpi_communicator));
-  Cx_matrix.reinit (mpi_communicator,
-                    dsp,
-                    dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                    dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                    Utilities::MPI::this_mpi_process(mpi_communicator));
-  CTx_matrix.reinit (mpi_communicator,
-                     dsp,
-                     dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                     dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                     Utilities::MPI::this_mpi_process(mpi_communicator));
-  Cy_matrix.reinit (mpi_communicator,
-                    dsp,
-                    dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                    dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                    Utilities::MPI::this_mpi_process(mpi_communicator));
-  CTy_matrix.reinit (mpi_communicator,
-                     dsp,
-                     dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                     dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                     Utilities::MPI::this_mpi_process(mpi_communicator));
+  MC_matrix.reinit (dof_handler_LS.locally_owned_dofs(),
+                    dof_handler_LS.locally_owned_dofs(),
+                    dsp, mpi_communicator);
+  Cx_matrix.reinit (dof_handler_LS.locally_owned_dofs(),
+                    dof_handler_LS.locally_owned_dofs(),
+                    dsp, mpi_communicator);
+  CTx_matrix.reinit (dof_handler_LS.locally_owned_dofs(),
+                     dof_handler_LS.locally_owned_dofs(),
+                     dsp, mpi_communicator);
+  Cy_matrix.reinit (dof_handler_LS.locally_owned_dofs(),
+                    dof_handler_LS.locally_owned_dofs(),
+                    dsp, mpi_communicator);
+  CTy_matrix.reinit (dof_handler_LS.locally_owned_dofs(),
+                     dof_handler_LS.locally_owned_dofs(),
+                     dsp, mpi_communicator);
   if (dim==3)
     {
-      Cz_matrix.reinit (mpi_communicator,
-                        dsp,
-                        dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                        dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                        Utilities::MPI::this_mpi_process(mpi_communicator));
-      CTz_matrix.reinit (mpi_communicator,
-                         dsp,
-                         dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                         dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                         Utilities::MPI::this_mpi_process(mpi_communicator));
+      Cz_matrix.reinit (dof_handler_LS.locally_owned_dofs(),
+                        dof_handler_LS.locally_owned_dofs(),
+                        dsp, mpi_communicator);
+      CTz_matrix.reinit (dof_handler_LS.locally_owned_dofs(),
+                         dof_handler_LS.locally_owned_dofs(),
+                         dsp, mpi_communicator);
     }
-  dLij_matrix.reinit (mpi_communicator,
-                      dsp,
-                      dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                      dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                      Utilities::MPI::this_mpi_process(mpi_communicator));
-  EntRes_matrix.reinit (mpi_communicator,
-                        dsp,
-                        dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                        dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                        Utilities::MPI::this_mpi_process(mpi_communicator));
-  SuppSize_matrix.reinit (mpi_communicator,
-                          dsp,
-                          dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                          dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                          Utilities::MPI::this_mpi_process(mpi_communicator));
-  dCij_matrix.reinit (mpi_communicator,
-                      dsp,
-                      dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                      dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                      Utilities::MPI::this_mpi_process(mpi_communicator));
-  A_matrix.reinit (mpi_communicator,
-                   dsp,
-                   dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                   dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                   Utilities::MPI::this_mpi_process(mpi_communicator));
-  LxA_matrix.reinit (mpi_communicator,
-                     dsp,
-                     dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                     dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                     Utilities::MPI::this_mpi_process(mpi_communicator));
-  Akp1_matrix.reinit (mpi_communicator,
-                      dsp,
-                      dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                      dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                      Utilities::MPI::this_mpi_process(mpi_communicator));
-  LxAkp1_matrix.reinit (mpi_communicator,
-                        dsp,
-                        dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                        dof_handler_LS.n_locally_owned_dofs_per_processor(),
-                        Utilities::MPI::this_mpi_process(mpi_communicator));
+  dLij_matrix.reinit (dof_handler_LS.locally_owned_dofs(),
+                      dof_handler_LS.locally_owned_dofs(),
+                      dsp, mpi_communicator);
+  EntRes_matrix.reinit (dof_handler_LS.locally_owned_dofs(),
+                        dof_handler_LS.locally_owned_dofs(),
+                        dsp, mpi_communicator);
+  SuppSize_matrix.reinit (dof_handler_LS.locally_owned_dofs(),
+                          dof_handler_LS.locally_owned_dofs(),
+                          dsp, mpi_communicator);
+  dCij_matrix.reinit (dof_handler_LS.locally_owned_dofs(),
+                      dof_handler_LS.locally_owned_dofs(),
+                      dsp, mpi_communicator);
+  A_matrix.reinit (dof_handler_LS.locally_owned_dofs(),
+                   dof_handler_LS.locally_owned_dofs(),
+                   dsp, mpi_communicator);
+  LxA_matrix.reinit (dof_handler_LS.locally_owned_dofs(),
+                     dof_handler_LS.locally_owned_dofs(),
+                     dsp, mpi_communicator);
+  Akp1_matrix.reinit (dof_handler_LS.locally_owned_dofs(),
+                      dof_handler_LS.locally_owned_dofs(),
+                      dsp, mpi_communicator);
+  LxAkp1_matrix.reinit (dof_handler_LS.locally_owned_dofs(),
+                        dof_handler_LS.locally_owned_dofs(),
+                        dsp, mpi_communicator);
   //COMPUTE MASS MATRICES (AND OTHERS) FOR FIRST TIME STEP //
   assemble_ML();
   invert_ML();
index 89e0aa96b9aa90dbe0033b2cbd9cbfe4952fb7be..771fd2b3609d0f18715c6dd2413d1fddc0b50ac4 100644 (file)
@@ -4,8 +4,8 @@
 #include <deal.II/lac/vector.h>
 #include <deal.II/lac/full_matrix.h>
 #include <deal.II/lac/solver_cg.h>
-#include <deal.II/lac/petsc_parallel_sparse_matrix.h>
-#include <deal.II/lac/petsc_parallel_vector.h>
+#include <deal.II/lac/petsc_sparse_matrix.h>
+#include <deal.II/lac/petsc_vector.h>
 #include <deal.II/lac/petsc_solver.h>
 #include <deal.II/lac/petsc_precondition.h>
 #include <deal.II/grid/grid_generator.h>
index 3f013b2680b9d7a7f951ce9d009d5777eb1b3f3d..742284798f31021aa695b234e57c00a823c90349 100644 (file)
@@ -4,8 +4,8 @@
 #include <deal.II/lac/vector.h>
 #include <deal.II/lac/full_matrix.h>
 #include <deal.II/lac/solver_cg.h>
-#include <deal.II/lac/petsc_parallel_sparse_matrix.h>
-#include <deal.II/lac/petsc_parallel_vector.h>
+#include <deal.II/lac/petsc_sparse_matrix.h>
+#include <deal.II/lac/petsc_vector.h>
 #include <deal.II/lac/petsc_solver.h>
 #include <deal.II/lac/petsc_precondition.h>
 #include <deal.II/grid/grid_generator.h>
@@ -25,7 +25,7 @@
 #include <deal.II/lac/sparsity_tools.h>
 #include <deal.II/distributed/tria.h>
 #include <deal.II/distributed/grid_refinement.h>
-#include <deal.II/lac/petsc_parallel_vector.h>
+#include <deal.II/lac/petsc_vector.h>
 #include <deal.II/base/convergence_table.h>
 #include <deal.II/base/timer.h>
 #include <deal.II/base/parameter_handler.h>
@@ -551,39 +551,44 @@ void NavierStokesSolver<dim>::setup_VECTORS()
   DynamicSparsityPattern dsp_Matrix(locally_relevant_dofs_U);
   DoFTools::make_sparsity_pattern(dof_handler_U,dsp_Matrix,constraints,false);
   SparsityTools::distribute_sparsity_pattern(dsp_Matrix,
-                                             dof_handler_U.n_locally_owned_dofs_per_processor(),mpi_communicator,
+                                             dof_handler_U.locally_owned_dofs(),
+                                             mpi_communicator,
                                              locally_relevant_dofs_U);
-  system_Matrix_u.reinit(mpi_communicator,dsp_Matrix,
-                         dof_handler_U.n_locally_owned_dofs_per_processor(),
-                         dof_handler_U.n_locally_owned_dofs_per_processor(),
-                         Utilities::MPI::this_mpi_process(mpi_communicator));
-  system_Matrix_v.reinit(mpi_communicator,dsp_Matrix,
-                         dof_handler_U.n_locally_owned_dofs_per_processor(),
-                         dof_handler_U.n_locally_owned_dofs_per_processor(),
-                         Utilities::MPI::this_mpi_process(mpi_communicator));
-  system_Matrix_w.reinit(mpi_communicator,dsp_Matrix,
-                         dof_handler_U.n_locally_owned_dofs_per_processor(),
-                         dof_handler_U.n_locally_owned_dofs_per_processor(),
-                         Utilities::MPI::this_mpi_process(mpi_communicator));
+  system_Matrix_u.reinit(dof_handler_U.locally_owned_dofs(),
+                         dof_handler_U.locally_owned_dofs(),
+                         dsp_Matrix,
+                         mpi_communicator);
+  system_Matrix_v.reinit(dof_handler_U.locally_owned_dofs(),
+                         dof_handler_U.locally_owned_dofs(),
+                         dsp_Matrix,
+                         mpi_communicator);
+  system_Matrix_w.reinit(dof_handler_U.locally_owned_dofs(),
+                         dof_handler_U.locally_owned_dofs(),
+                         dsp_Matrix,
+                         mpi_communicator);
   rebuild_Matrix_U=true;
   // sparsity pattern for S
   DynamicSparsityPattern dsp_S(locally_relevant_dofs_P);
   DoFTools::make_sparsity_pattern(dof_handler_P,dsp_S,constraints_psi,false);
   SparsityTools::distribute_sparsity_pattern(dsp_S,
-                                             dof_handler_P.n_locally_owned_dofs_per_processor(),mpi_communicator,
+                                             dof_handler_P.locally_owned_dofs(),
+                                             mpi_communicator,
                                              locally_relevant_dofs_P);
-  system_S.reinit(mpi_communicator,dsp_S,dof_handler_P.n_locally_owned_dofs_per_processor(),
-                  dof_handler_P.n_locally_owned_dofs_per_processor(),
-                  Utilities::MPI::this_mpi_process(mpi_communicator));
+  system_S.reinit(dof_handler_P.locally_owned_dofs(),
+                  dof_handler_P.locally_owned_dofs(),
+                  dsp_S,
+                  mpi_communicator);
   // sparsity pattern for M
   DynamicSparsityPattern dsp_M(locally_relevant_dofs_P);
   DoFTools::make_sparsity_pattern(dof_handler_P,dsp_M,constraints_psi,false);
   SparsityTools::distribute_sparsity_pattern(dsp_M,
-                                             dof_handler_P.n_locally_owned_dofs_per_processor(),mpi_communicator,
+                                             dof_handler_P.locally_owned_dofs(),
+                                             mpi_communicator,
                                              locally_relevant_dofs_P);
-  system_M.reinit(mpi_communicator,dsp_M,dof_handler_P.n_locally_owned_dofs_per_processor(),
-                  dof_handler_P.n_locally_owned_dofs_per_processor(),
-                  Utilities::MPI::this_mpi_process(mpi_communicator));
+  system_M.reinit(dof_handler_P.locally_owned_dofs(),
+                  dof_handler_P.locally_owned_dofs(),
+                  dsp_M,
+                  mpi_communicator);
   rebuild_S_M=true;
 }
 
index 3426be6223fc700c3dec0ce52464ef318b84d229..541a56fde08647c1ce9fa274945b67ddb768326b 100644 (file)
@@ -4,8 +4,8 @@
 #include <deal.II/lac/vector.h>
 #include <deal.II/lac/full_matrix.h>
 #include <deal.II/lac/solver_cg.h>
-#include <deal.II/lac/petsc_parallel_sparse_matrix.h>
-#include <deal.II/lac/petsc_parallel_vector.h>
+#include <deal.II/lac/petsc_sparse_matrix.h>
+#include <deal.II/lac/petsc_vector.h>
 #include <deal.II/lac/petsc_solver.h>
 #include <deal.II/lac/petsc_precondition.h>
 #include <deal.II/grid/grid_generator.h>
@@ -25,7 +25,7 @@
 #include <deal.II/lac/sparsity_tools.h>
 #include <deal.II/distributed/tria.h>
 #include <deal.II/distributed/grid_refinement.h>
-#include <deal.II/lac/petsc_parallel_vector.h>
+#include <deal.II/lac/petsc_vector.h>
 #include <deal.II/base/convergence_table.h>
 #include <deal.II/base/timer.h>
 #include <deal.II/base/parameter_handler.h>
index 651da17045a50159fc925e51080bffff1df30e9a..0e074ac260d5b6a8d35dbfc43cca5c94cb37a6d7 100644 (file)
@@ -4,8 +4,8 @@
 #include <deal.II/lac/vector.h>
 #include <deal.II/lac/full_matrix.h>
 #include <deal.II/lac/solver_cg.h>
-#include <deal.II/lac/petsc_parallel_sparse_matrix.h>
-#include <deal.II/lac/petsc_parallel_vector.h>
+#include <deal.II/lac/petsc_sparse_matrix.h>
+#include <deal.II/lac/petsc_vector.h>
 #include <deal.II/lac/petsc_solver.h>
 #include <deal.II/lac/petsc_precondition.h>
 #include <deal.II/grid/grid_generator.h>
@@ -25,7 +25,7 @@
 #include <deal.II/lac/sparsity_tools.h>
 #include <deal.II/distributed/tria.h>
 #include <deal.II/distributed/grid_refinement.h>
-#include <deal.II/lac/petsc_parallel_vector.h>
+#include <deal.II/lac/petsc_vector.h>
 #include <deal.II/base/convergence_table.h>
 #include <deal.II/base/timer.h>
 #include <deal.II/base/parameter_handler.h>

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.