From 5639bc74304e067e6541212a24aa2e68ee4276c0 Mon Sep 17 00:00:00 2001 From: David Wells Date: Thu, 22 Oct 2015 19:26:09 -0400 Subject: [PATCH] Remove unnecessary dealii:: qualifiers. --- .../deal.II/numerics/vector_tools.templates.h | 28 +++++++++---------- source/distributed/grid_refinement.cc | 6 ++-- source/grid/grid_refinement.cc | 8 +++--- 3 files changed, 21 insertions(+), 21 deletions(-) diff --git a/include/deal.II/numerics/vector_tools.templates.h b/include/deal.II/numerics/vector_tools.templates.h index 928a9b3acc..eabe985aa0 100644 --- a/include/deal.II/numerics/vector_tools.templates.h +++ b/include/deal.II/numerics/vector_tools.templates.h @@ -623,7 +623,7 @@ namespace VectorTools Assert(u2.size()==dof2.n_dofs(), ExcDimensionMismatch(u2.size(),dof2.n_dofs())); - dealii::Vector cache; + Vector cache; // Looping over the finest common // mesh, this means that source and @@ -780,7 +780,7 @@ namespace VectorTools constraints_and_b_v_are_compatible(constraints, boundary_values); // set up mass matrix and right hand side - dealii::Vector vec (dof.n_dofs()); + Vector vec (dof.n_dofs()); SparsityPattern sparsity; { DynamicSparsityPattern dsp (dof.n_dofs(), dof.n_dofs()); @@ -790,7 +790,7 @@ namespace VectorTools sparsity.copy_from (dsp); } SparseMatrix mass_matrix (sparsity); - dealii::Vector tmp (mass_matrix.n()); + Vector tmp (mass_matrix.n()); // If the constraint matrix does not conflict with the given boundary // values (i.e., it either does not contain boundary values or it contains @@ -1721,7 +1721,7 @@ namespace VectorTools // of the number of // components of the // function - dealii::Vector function_values (fe.n_components()); + Vector function_values (fe.n_components()); if (fe.n_components() == 1) function_values(0) = boundary_function.value (cell->vertex(direction)); @@ -1793,7 +1793,7 @@ namespace VectorTools // points. have two arrays for scalar and vector functions to use the // more efficient one respectively std::vector dof_values_scalar; - std::vector > dof_values_system; + std::vector > dof_values_system; dof_values_scalar.reserve (DoFTools::max_dofs_per_face (dof)); dof_values_system.reserve (DoFTools::max_dofs_per_face (dof)); @@ -1906,7 +1906,7 @@ namespace VectorTools // allocating temporary if possible if (dof_values_system.size() < fe.dofs_per_face) dof_values_system.resize (fe.dofs_per_face, - dealii::Vector(fe.n_components())); + Vector(fe.n_components())); else dof_values_system.resize (fe.dofs_per_face); @@ -6028,17 +6028,17 @@ namespace VectorTools void resize_vectors (const unsigned int n_q_points, const unsigned int n_components); - std::vector > function_values; + std::vector > function_values; std::vector > > function_grads; std::vector weight_values; - std::vector > weight_vectors; + std::vector > weight_vectors; - std::vector > psi_values; + std::vector > psi_values; std::vector > > psi_grads; std::vector psi_scalar; std::vector tmp_values; - std::vector > tmp_vector_values; + std::vector > tmp_vector_values; std::vector > tmp_gradients; std::vector > > tmp_vector_gradients; @@ -6071,23 +6071,23 @@ namespace VectorTools const unsigned int n_components) { function_values.resize (n_q_points, - dealii::Vector(n_components)); + Vector(n_components)); function_grads.resize (n_q_points, std::vector >(n_components)); weight_values.resize (n_q_points); weight_vectors.resize (n_q_points, - dealii::Vector(n_components)); + Vector(n_components)); psi_values.resize (n_q_points, - dealii::Vector(n_components)); + Vector(n_components)); psi_grads.resize (n_q_points, std::vector >(n_components)); psi_scalar.resize (n_q_points); tmp_values.resize (n_q_points); tmp_vector_values.resize (n_q_points, - dealii::Vector(n_components)); + Vector(n_components)); tmp_gradients.resize (n_q_points); tmp_vector_gradients.resize (n_q_points, std::vector >(n_components)); diff --git a/source/distributed/grid_refinement.cc b/source/distributed/grid_refinement.cc index 81c6f0f6d2..262c50e7b4 100644 --- a/source/distributed/grid_refinement.cc +++ b/source/distributed/grid_refinement.cc @@ -153,7 +153,7 @@ namespace void get_locally_owned_indicators (const parallel::distributed::Triangulation &tria, const VectorType &criteria, - dealii::Vector &locally_owned_indicators) + Vector &locally_owned_indicators) { Assert (locally_owned_indicators.size() == tria.n_locally_owned_active_cells(), ExcInternalError()); @@ -482,7 +482,7 @@ namespace parallel // vector of indicators the // ones that correspond to // cells that we locally own - dealii::Vector + Vector locally_owned_indicators (tria.n_locally_owned_active_cells()); get_locally_owned_indicators (tria, criteria, @@ -561,7 +561,7 @@ namespace parallel // vector of indicators the // ones that correspond to // cells that we locally own - dealii::Vector + Vector locally_owned_indicators (tria.n_locally_owned_active_cells()); get_locally_owned_indicators (tria, criteria, diff --git a/source/grid/grid_refinement.cc b/source/grid/grid_refinement.cc index f93af05734..629e6ed1e4 100644 --- a/source/grid/grid_refinement.cc +++ b/source/grid/grid_refinement.cc @@ -385,7 +385,7 @@ GridRefinement::refine_and_coarsen_fixed_number (Triangulation &tr if (refine_cells || coarsen_cells) { - dealii::Vector tmp (criteria); + Vector tmp (criteria); if (refine_cells) { std::nth_element (tmp.begin(), tmp.begin()+refine_cells, @@ -426,7 +426,7 @@ GridRefinement::refine_and_coarsen_fixed_fraction (Triangulation & // error, which is what we have to sum // up and compare with // @p{fraction_of_error*total_error}. - dealii::Vector tmp; + Vector tmp; tmp = criteria; const double total_error = tmp.l1_norm(); @@ -435,7 +435,7 @@ GridRefinement::refine_and_coarsen_fixed_fraction (Triangulation & std::sort (tmp.begin(), tmp.end(), std::greater()); // compute thresholds - typename dealii::Vector::const_iterator + typename Vector::const_iterator pp=tmp.begin(); for (double sum=0; (sum & double top_threshold = ( pp != tmp.begin () ? (*pp+*(pp-1))/2 : *pp ); - typename dealii::Vector::const_iterator + typename Vector::const_iterator qq=(tmp.end()-1); for (double sum=0; (sum