From d27bf1245c1bbf2592e4f4a90edac3288db28404 Mon Sep 17 00:00:00 2001 From: wolf Date: Tue, 23 May 2000 13:16:20 +0000 Subject: [PATCH] Adapt to recent changes in the lib. git-svn-id: https://svn.dealii.org/trunk@2926 0785d39b-7218-0410-832d-ea1e28bc413d --- tests/deal.II/wave-test-3.cc | 27 ++++++++++++++------------- 1 file changed, 14 insertions(+), 13 deletions(-) diff --git a/tests/deal.II/wave-test-3.cc b/tests/deal.II/wave-test-3.cc index ada2e99351..4f5057ff95 100644 --- a/tests/deal.II/wave-test-3.cc +++ b/tests/deal.II/wave-test-3.cc @@ -2701,7 +2701,7 @@ fe_values.reinit (cell); weights[point] * density_values[point]; - total_energy += 1./2. * cell_matrix.matrix_norm (local_v); + total_energy += 1./2. * cell_matrix.matrix_norm_square (local_v); // now for the part with the laplace // matrix @@ -2715,7 +2715,7 @@ fe_values.reinit (cell); gradients[j][point]) * weights[point] * stiffness_values[point]; - total_energy += 1./2. * cell_matrix.matrix_norm (local_u); + total_energy += 1./2. * cell_matrix.matrix_norm_square (local_u); }; return total_energy; @@ -4336,8 +4336,9 @@ void WaveParameters<2>::make_coarse_grid (const string &name) { const InitialMesh initial_mesh = initial_mesh_list[name]; - coarse_grid = new Triangulation(MeshSmoothing(smoothing_on_refinement | - eliminate_refined_inner_islands)); + coarse_grid = new Triangulation + (Triangulation::MeshSmoothing(Triangulation::smoothing_on_refinement | + Triangulation::eliminate_refined_inner_islands)); switch (initial_mesh) { @@ -5253,13 +5254,13 @@ unsigned int TimeStep_Wave::solve (const UserMatrix &matrix, const Vector &rhs) const { SolverControl control(2000, 1.e-12); PrimitiveVectorMemory<> memory; - SolverCG pcg(control,memory); + SolverCG<> pcg(control,memory); // solve - pcg.solve (matrix, solution, rhs, - PreconditionUseMatrix - (matrix, - &UserMatrix::precondition)); + pcg.template solve (matrix, solution, rhs, + PreconditionUseMatrix + (matrix, + &UserMatrix::precondition)); // distribute solution constraints.distribute (solution); @@ -5467,13 +5468,13 @@ TimeStep_Wave::compute_energy () { switch (next_action) { case primal_problem: - energy.first = 0.5*laplace_matrix.matrix_norm (u); - energy.second = 0.5*mass_matrix.matrix_norm(v); + energy.first = 0.5*laplace_matrix.matrix_norm_square (u); + energy.second = 0.5*mass_matrix.matrix_norm_square(v); break; case dual_problem: - energy.first = 0.5*laplace_matrix.matrix_norm (v); - energy.second = 0.5*mass_matrix.matrix_norm(u); + energy.first = 0.5*laplace_matrix.matrix_norm_square (v); + energy.second = 0.5*mass_matrix.matrix_norm_square(u); break; default: -- 2.39.5