From 6aaeaf2c16085d0d68bfe1f6fc6273aeff5acf3b Mon Sep 17 00:00:00 2001 From: wolf Date: Thu, 30 May 2002 14:49:44 +0000 Subject: [PATCH] Remove reference to to-be-deprecated functions. git-svn-id: https://svn.dealii.org/trunk@5942 0785d39b-7218-0410-832d-ea1e28bc413d --- tests/deal.II/wave-test-3.cc | 216 +++++++++++++---------------------- 1 file changed, 77 insertions(+), 139 deletions(-) diff --git a/tests/deal.II/wave-test-3.cc b/tests/deal.II/wave-test-3.cc index 5dcbe6c44a..6748fb48ac 100644 --- a/tests/deal.II/wave-test-3.cc +++ b/tests/deal.II/wave-test-3.cc @@ -1926,7 +1926,7 @@ void EndEnergy::compute_vectors (const PartOfDomain pod, }; -fe_values.reinit (cell); + fe_values.reinit (cell); fe_values_primal.reinit (primal_cell); fe_values_primal.get_function_values (*v, local_v); fe_values_primal.get_function_grads (*u, local_u_grad); @@ -1936,23 +1936,19 @@ fe_values.reinit (cell); stiffness->value_list (fe_values.get_quadrature_points(), stiffness_values); - const std::vector > > &shape_grads = fe_values.get_shape_grads (); - const FullMatrix &shape_values = fe_values.get_shape_values (); - const std::vector &JxW_values (fe_values.get_JxW_values()); - std::vector local_functional1 (dofs_per_cell, 0); std::vector local_functional2 (dofs_per_cell, 0); for (unsigned int shape_func=0; shape_funcget_dof_indices (cell_dof_indices); @@ -2035,19 +2031,15 @@ void SeismicSignal::compute_functionals (Vector &j1, (face->vertex(1)(1) == y_offset)) { fe_face_values.reinit (cell, face_no); - const FullMatrix &shape_values = fe_face_values. - get_shape_values (); - const std::vector &JxW_values (fe_face_values. - get_JxW_values()); const std::vector > &q_points (fe_face_values.get_quadrature_points()); std::vector local_integral (dofs_per_cell, 0); for (unsigned int shape_func=0; shape_func ::weight(q_points[point], time)) * - JxW_values[point]; + fe_face_values.JxW(point); cell->get_dof_indices (cell_dof_indices); for (unsigned int shape_func=0; shape_func::compute_functionals (Vector &j1, continue; fe_face_values.reinit (cell, face_no); - const FullMatrix &shape_values = fe_face_values.get_shape_values (); - const std::vector &JxW_values = fe_face_values.get_JxW_values(); cell->get_dof_indices (dof_indices); for (unsigned int i=0; i::compute_endtime_vectors (Vector &final_u_bar, fe_values.reinit (cell); - const FullMatrix &shape_values = fe_values.get_shape_values (); - const std::vector &JxW_values (fe_values.get_JxW_values()); - std::vector local_functional (dofs_per_cell, 0); for (unsigned int shape_func=0; shape_funcget_dof_indices (cell_dof_indices); for (unsigned int shape_func=0; shape_func::compute_functionals (Vector &j1, (cell->center()(0) < -0.4)) { fe_values.reinit (cell); - const FullMatrix &shape_values = fe_values.get_shape_values (); - const std::vector &JxW_values = fe_values.get_JxW_values(); cell->get_dof_indices (dof_indices); for (unsigned int i=0; i::compute_functionals (Vector &j1, (cell->center()(0) < 0.03)) { fe_values.reinit (cell); - const FullMatrix &shape_values = fe_values.get_shape_values (); - const std::vector &JxW_values = fe_values.get_JxW_values(); cell->get_dof_indices (dof_indices); for (unsigned int i=0; i::compute_energy (const PartOfDomain pod) const }; -fe_values.reinit (cell); - const FullMatrix &values = fe_values.get_shape_values(); - const std::vector > >&gradients = fe_values.get_shape_grads (); - const std::vector &weights = fe_values.get_JxW_values (); - + fe_values.reinit (cell); cell->get_dof_values (*u, local_u); cell->get_dof_values (*v, local_v); @@ -2502,9 +2481,9 @@ fe_values.reinit (cell); for (unsigned int point=0; pointdofs_per_cell; ++i) for (unsigned int j=0; jdofs_per_cell; ++j) - cell_matrix(i,j) += (values(i,point) * - values(j,point)) * - weights[point] * + cell_matrix(i,j) += (fe_values.shape_value(i,point) * + fe_values.shape_value(j,point)) * + fe_values.JxW(point) * density_values[point]; total_energy += 1./2. * cell_matrix.matrix_norm_square (local_v); @@ -2515,9 +2494,9 @@ fe_values.reinit (cell); for (unsigned int point=0; pointdofs_per_cell; ++i) for (unsigned int j=0; jdofs_per_cell; ++j) - cell_matrix(i,j) += (gradients[i][point] * - gradients[j][point]) * - weights[point] * + cell_matrix(i,j) += (fe_values.shape_grad(i,point) * + fe_values.shape_grad(j,point)) * + fe_values.JxW(point) * stiffness_values[point]; total_energy += 1./2. * cell_matrix.matrix_norm_square (local_u); }; @@ -2639,14 +2618,13 @@ double EvaluateSeismicSignal::evaluate () { { face_values.reinit (cell, face); face_values.get_function_values (*u, face_u); - const std::vector &JxW_values (face_values.get_JxW_values()); const std::vector > &q_points (face_values.get_quadrature_points()); double local_integral = 0; for (unsigned int point=0; point::evaluate () { face_values.reinit (cell, face_no); face_values.get_function_values (*u, face_u); - const std::vector &JxW_values (face_values.get_JxW_values()); double local_integral = 0; for (unsigned int point=0; point::evaluate () { { fe_values.reinit (cell); fe_values.get_function_values (*u, cell_u); - const std::vector &JxW_values (fe_values.get_JxW_values()); double local_integral = 0; for (unsigned int point=0; point::evaluate () { { fe_values.reinit (cell); fe_values.get_function_values (*u, cell_u); - const std::vector &JxW_values (fe_values.get_JxW_values()); - const std::vector > &quadrature_points (fe_values.get_quadrature_points()); - double local_integral = 0; for (unsigned int point=0; point fe_values (fe, quadrature, FullMatrix cell_laplace_matrix (dofs_per_cell, dofs_per_cell); -for (typename DoFHandler::active_cell_iterator cell=dof_handler->begin_active(); + for (typename DoFHandler::active_cell_iterator cell=dof_handler->begin_active(); cell != dof_handler->end(); ++cell) { fe_values.reinit (cell); @@ -5005,18 +4978,13 @@ for (typename DoFHandler::active_cell_iterator cell=dof_handler->begin_acti cell_laplace_matrix.clear (); cell->get_dof_indices (dof_indices_on_cell); - const FullMatrix &shape_values = fe_values.get_shape_values (); - const std::vector > > &shape_grads = fe_values.get_shape_grads (); - const std::vector &JxW_values = fe_values.get_JxW_values (); - if (!density_constant || !stiffness_constant) { - const std::vector > &quadrature_points = fe_values.get_quadrature_points (); if (!density_constant) - parameters.density->value_list (quadrature_points, + parameters.density->value_list (fe_values.get_quadrature_points (), density_values); if (!stiffness_constant) - parameters.stiffness->value_list (quadrature_points, + parameters.stiffness->value_list (fe_values.get_quadrature_points (), stiffness_values); }; @@ -5024,13 +4992,13 @@ for (typename DoFHandler::active_cell_iterator cell=dof_handler->begin_acti for (unsigned int i=0; i::build_rhs (const DoFHandler::cell_iterator &old_cell, if (!old_cell->has_children() && !new_cell->has_children()) { fe_values.reinit (old_cell); - const FullMatrix &values = fe_values.get_shape_values (); - const std::vector > >&gradients = fe_values.get_shape_grads (); - const std::vector &weights = fe_values.get_JxW_values (); - FullMatrix cell_matrix (dofs_per_cell, dofs_per_cell); std::vector density_values(fe_values.n_quadrature_points); @@ -5497,9 +5461,9 @@ TimeStep_Dual::build_rhs (const DoFHandler::cell_iterator &old_cell, for (unsigned int point=0; point tmp (dofs_per_cell); @@ -5524,9 +5488,9 @@ TimeStep_Dual::build_rhs (const DoFHandler::cell_iterator &old_cell, for (unsigned int point=0; point::collect_from_children (const DoFHandler::cell_iterator else { fe_values.reinit (old_child); - const FullMatrix &values = fe_values.get_shape_values(); - const std::vector > >&gradients = fe_values.get_shape_grads (); - const std::vector &weights = fe_values.get_JxW_values (); - old_child->get_dof_values (previous_time_level.u, local_old_dof_values_u); old_child->get_dof_values (previous_time_level.v, local_old_dof_values_v); @@ -5644,9 +5604,9 @@ TimeStep_Dual::collect_from_children (const DoFHandler::cell_iterator for (unsigned int point=0; point::collect_from_children (const DoFHandler::cell_iterator for (unsigned int point=0; point::distribute_to_children (const DoFHandler::cell_iterator else { fe_values.reinit (new_child); - const FullMatrix &values = fe_values.get_shape_values(); - const std::vector > >&gradients = fe_values.get_shape_grads (); - const std::vector &weights = fe_values.get_JxW_values (); - cell_matrix.clear (); std::vector density_values(fe_values.n_quadrature_points); parameters.density->value_list (fe_values.get_quadrature_points(), @@ -5745,9 +5701,9 @@ TimeStep_Dual::distribute_to_children (const DoFHandler::cell_iterator for (unsigned int point=0; point::distribute_to_children (const DoFHandler::cell_iterator for (unsigned int point=0; point stiffness(fe_values.n_quadrature_points); FullMatrix laplace_matrix (tmp1.size(), tmp1.size()); fe_values.reinit (cell); - const FullMatrix &values = fe_values.get_shape_values(); - const std::vector > >&gradients = fe_values.get_shape_grads (); - const std::vector > >&second_derivatives - = fe_values.get_shape_2nd_derivatives (); - const std::vector &weights = fe_values.get_JxW_values (); - std::vector density_values(fe_values.n_quadrature_points); parameters.density->value_list (fe_values.get_quadrature_points(), density_values); @@ -6413,20 +6363,20 @@ std::vector stiffness(fe_values.n_quadrature_points); for (unsigned int i=0; i::build_rhs (const DoFHandler::cell_iterator &old_cell, fe_values.reinit (old_cell); FullMatrix cell_matrix (dofs_per_cell, dofs_per_cell); - const FullMatrix &values = fe_values.get_shape_values (); - const std::vector > >&gradients = fe_values.get_shape_grads (); - const std::vector &weights = fe_values.get_JxW_values (); - std::vector density_values(fe_values.n_quadrature_points); parameters.density->value_list (fe_values.get_quadrature_points(), density_values); for (unsigned int point=0; point tmp (dofs_per_cell); @@ -7296,9 +7242,9 @@ TimeStep_Primal::build_rhs (const DoFHandler::cell_iterator &old_cell, for (unsigned int point=0; point cell_matrix (dofs_per_cell, dofs_per_cell); else { fe_values.reinit (old_child); - const FullMatrix &values = fe_values.get_shape_values (); - const std::vector > >&gradients = fe_values.get_shape_grads (); - const std::vector &weights = fe_values.get_JxW_values (); - old_child->get_dof_values (previous_time_level.u, local_old_dof_values_u); old_child->get_dof_values (previous_time_level.v, local_old_dof_values_v); @@ -7419,9 +7361,9 @@ FullMatrix cell_matrix (dofs_per_cell, dofs_per_cell); for (unsigned int point=0; point cell_matrix (dofs_per_cell, dofs_per_cell); for (unsigned int point=0; point::distribute_to_children (const DoFHandler::cell_iterat else { fe_values.reinit (new_child); - const FullMatrix &values = fe_values.get_shape_values (); - const std::vector > >&gradients = fe_values.get_shape_grads (); - const std::vector &weights = fe_values.get_JxW_values (); - cell_matrix.clear (); std::vector density_values(fe_values.n_quadrature_points); parameters.density->value_list (fe_values.get_quadrature_points(), @@ -7521,9 +7459,9 @@ TimeStep_Primal::distribute_to_children (const DoFHandler::cell_iterat for (unsigned int point=0; point::distribute_to_children (const DoFHandler::cell_iterat for (unsigned int point=0; point