From: denis.davydov Date: Wed, 21 May 2014 19:58:56 +0000 (+0000) Subject: updated the test for matrix_scalar_product and matrix_norm_square X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=ff3b59df665d781db8826999ac93e2a9e8af9571;p=dealii-svn.git updated the test for matrix_scalar_product and matrix_norm_square git-svn-id: https://svn.dealii.org/branches/branch_petscscalar_complex@32962 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/tests/petsc_complex/parallel_sparse_matrix_01.cc b/tests/petsc_complex/parallel_sparse_matrix_01.cc index 16f73b2cae..0483a943c8 100644 --- a/tests/petsc_complex/parallel_sparse_matrix_01.cc +++ b/tests/petsc_complex/parallel_sparse_matrix_01.cc @@ -49,43 +49,22 @@ using namespace dealii; -static const unsigned int dim = 2; - -void test () +template +void test (const unsigned int poly_degree = 1) { MPI_Comm mpi_communicator (MPI_COMM_WORLD); const unsigned int n_mpi_processes (Utilities::MPI::n_mpi_processes(mpi_communicator)); const unsigned int this_mpi_process (Utilities::MPI::this_mpi_process(mpi_communicator)); - - ConditionalOStream pcout (std::cout, - (Utilities::MPI::this_mpi_process(mpi_communicator) - == 0)); parallel::distributed::Triangulation tria(mpi_communicator, typename Triangulation::MeshSmoothing (Triangulation::smoothing_on_refinement | Triangulation::smoothing_on_coarsening)); - if (false) - { - Triangulation triangulation1; - Triangulation triangulation2; - Triangulation triangulation12; - GridGenerator::hyper_cube (triangulation1, -1,0); //create a square [-1,0]^d domain - GridGenerator::hyper_cube (triangulation2, -1,0); //create a square [-1,0]^d domain - Point shift_vector; - shift_vector[0] = 1.0; - GridTools::shift(shift_vector,triangulation2); - GridGenerator::merge_triangulations (triangulation1, triangulation2, tria); - } - else - { - GridGenerator::hyper_cube (tria, -1,0); - //tria.refine_global (1); - } + GridGenerator::hyper_cube (tria, -1,0); + tria.refine_global (3); - const unsigned int poly_degree = 1; FE_Q fe(poly_degree); DoFHandler dof_handler(tria); @@ -95,7 +74,7 @@ void test () IndexSet locally_relevant_dofs; DoFTools::extract_locally_relevant_dofs (dof_handler,locally_relevant_dofs); - PETScWrappers::MPI::Vector vector, conjugate; + PETScWrappers::MPI::Vector vector; PETScWrappers::MPI::SparseMatrix mass_matrix; @@ -116,8 +95,6 @@ void test () //assemble mass matrix: mass_matrix = 0.0; { - //a separate quadrature formula - //enough for mass and kinetic matrices assembly QGauss quadrature_formula(poly_degree+1); FEValues fe_values (fe, quadrature_formula, update_values | update_gradients | update_JxW_values); @@ -158,44 +135,48 @@ void test () mass_matrix.compress (VectorOperation::add); } - vector = std::complex(1.0,-1.0); - - //deallog<<"original vector: "< norm1 = vector*tmp; + deallog<<"(conj(vector),M vector): "< norm = + const std::complex norm2 = mass_matrix.matrix_scalar_product(vector, vector); - deallog< norm3 = + mass_matrix.matrix_norm_square(vector); + deallog<<"matrix_norm_square(vec): "<(); } \ No newline at end of file diff --git a/tests/petsc_complex/parallel_sparse_matrix_01.mpirun=3.output b/tests/petsc_complex/parallel_sparse_matrix_01.mpirun=3.output new file mode 100644 index 0000000000..a75f75beb6 --- /dev/null +++ b/tests/petsc_complex/parallel_sparse_matrix_01.mpirun=3.output @@ -0,0 +1,12 @@ + +DEAL::symmetric: 1 +DEAL::hermitian: 1 +DEAL::(conj(vector),M vector): +DEAL::real part: 337.563 +DEAL::imaginary part: 0 +DEAL::matrix_scalar_product(vec,vec): +DEAL::real part: 337.563 +DEAL::imaginary part: 0 +DEAL::matrix_norm_square(vec): +DEAL::real part: 337.563 +DEAL::imaginary part: 0 diff --git a/tests/petsc_complex/parallel_sparse_matrix_01.output b/tests/petsc_complex/parallel_sparse_matrix_01.output deleted file mode 100644 index 52906fdae5..0000000000 --- a/tests/petsc_complex/parallel_sparse_matrix_01.output +++ /dev/null @@ -1,6 +0,0 @@ - -DEAL::symmetric: 1 -DEAL::hermitian: 1 -DEAL::conj*vmult:(2.00000,0.00000) -DEAL::vector*vmult:(0.00000,-2.00000) -DEAL::matrix_scalar_product: (2.00000,0.00000)