From 6d22b3e91519018a99108f943c2de549386a9e5f Mon Sep 17 00:00:00 2001 From: wolf Date: Tue, 16 Feb 1999 14:41:46 +0000 Subject: [PATCH] Revert Guido's changes total_dofs->n_dofs. git-svn-id: https://svn.dealii.org/trunk@815 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/deal.II/source/numerics/matrices.cc | 102 ++++++++++---------- 1 file changed, 51 insertions(+), 51 deletions(-) diff --git a/deal.II/deal.II/source/numerics/matrices.cc b/deal.II/deal.II/source/numerics/matrices.cc index 3f58bea326..9075fc1e9f 100644 --- a/deal.II/deal.II/source/numerics/matrices.cc +++ b/deal.II/deal.II/source/numerics/matrices.cc @@ -85,10 +85,10 @@ void MatrixCreator::create_mass_matrix (const DoFHandler &dof, const FiniteElement &fe, const Boundary &boundary, dSMatrix &matrix) { - const unsigned int n_dofs = fe.total_dofs; + const unsigned int total_dofs = fe.total_dofs; - dFMatrix local_mass_matrix (n_dofs, n_dofs); - vector dofs_on_this_cell (n_dofs); + dFMatrix local_mass_matrix (total_dofs, total_dofs); + vector dofs_on_this_cell (total_dofs); DoFHandler::active_cell_iterator cell = dof.begin_active(), endc = dof.end(); @@ -97,8 +97,8 @@ void MatrixCreator::create_mass_matrix (const DoFHandler &dof, cell->get_dof_indices (dofs_on_this_cell); fe.get_local_mass_matrix (cell, boundary, local_mass_matrix); - for (unsigned int i=0; i void MassMatrix::assemble (dFMatrix &cell_matrix, const FEValues &fe_values, const typename Triangulation::cell_iterator &) const { - const unsigned int n_dofs = fe_values.total_dofs, + const unsigned int total_dofs = fe_values.total_dofs, n_q_points = fe_values.n_quadrature_points; - Assert (cell_matrix.n() == n_dofs, - ExcWrongSize(cell_matrix.n(), n_dofs)); - Assert (cell_matrix.m() == n_dofs, - ExcWrongSize(cell_matrix.m(), n_dofs)); + Assert (cell_matrix.n() == total_dofs, + ExcWrongSize(cell_matrix.n(), total_dofs)); + Assert (cell_matrix.m() == total_dofs, + ExcWrongSize(cell_matrix.m(), total_dofs)); Assert (cell_matrix.all_zero(), ExcObjectNotEmpty()); const dFMatrix &values = fe_values.get_shape_values (); @@ -562,8 +562,8 @@ void MassMatrix::assemble (dFMatrix &cell_matrix, vector coefficient_values (fe_values.n_quadrature_points); coefficient->value_list (fe_values.get_quadrature_points(), coefficient_values); - for (unsigned int i=0; i::assemble (dFMatrix &cell_matrix, coefficient_values[point]); } else - for (unsigned int i=0; i::assemble (dFMatrix &cell_matrix, const Triangulation::cell_iterator &) const { Assert (right_hand_side != 0, ExcNoRHSSelected()); - const unsigned int n_dofs = fe_values.total_dofs, + const unsigned int total_dofs = fe_values.total_dofs, n_q_points = fe_values.n_quadrature_points; - Assert (cell_matrix.n() == n_dofs, - ExcWrongSize(cell_matrix.n(), n_dofs)); - Assert (cell_matrix.m() == n_dofs, - ExcWrongSize(cell_matrix.m(), n_dofs)); - Assert (rhs.size() == n_dofs, - ExcWrongSize(rhs.size(), n_dofs)); + Assert (cell_matrix.n() == total_dofs, + ExcWrongSize(cell_matrix.n(), total_dofs)); + Assert (cell_matrix.m() == total_dofs, + ExcWrongSize(cell_matrix.m(), total_dofs)); + Assert (rhs.size() == total_dofs, + ExcWrongSize(rhs.size(), total_dofs)); Assert (cell_matrix.all_zero(), ExcObjectNotEmpty()); Assert (rhs.all_zero(), ExcObjectNotEmpty()); @@ -611,9 +611,9 @@ void MassMatrix::assemble (dFMatrix &cell_matrix, coefficient->value_list (fe_values.get_quadrature_points(), coefficient_values); for (unsigned int point=0; point::assemble (dFMatrix &cell_matrix, } else for (unsigned int point=0; point::assemble (dVector &rhs, const Triangulation::cell_iterator &) const { Assert (right_hand_side != 0, ExcNoRHSSelected()); - const unsigned int n_dofs = fe_values.total_dofs, + const unsigned int total_dofs = fe_values.total_dofs, n_q_points = fe_values.n_quadrature_points; - Assert (rhs.size() == n_dofs, ExcWrongSize(rhs.size(), n_dofs)); + Assert (rhs.size() == total_dofs, ExcWrongSize(rhs.size(), total_dofs)); Assert (rhs.all_zero(), ExcObjectNotEmpty()); const dFMatrix &values = fe_values.get_shape_values (); @@ -657,7 +657,7 @@ void MassMatrix::assemble (dVector &rhs, right_hand_side->value_list (fe_values.get_quadrature_points(), rhs_values); for (unsigned int point=0; point::assemble (dFMatrix &cell_matrix, const Triangulation::cell_iterator &) const { Assert (right_hand_side != 0, ExcNoRHSSelected()); - const unsigned int n_dofs = fe_values.total_dofs, + const unsigned int total_dofs = fe_values.total_dofs, n_q_points = fe_values.n_quadrature_points; - Assert (cell_matrix.n() == n_dofs, - ExcWrongSize(cell_matrix.n(), n_dofs)); - Assert (cell_matrix.m() == n_dofs, - ExcWrongSize(cell_matrix.m(), n_dofs)); - Assert (rhs.size() == n_dofs, - ExcWrongSize(rhs.size(), n_dofs)); + Assert (cell_matrix.n() == total_dofs, + ExcWrongSize(cell_matrix.n(), total_dofs)); + Assert (cell_matrix.m() == total_dofs, + ExcWrongSize(cell_matrix.m(), total_dofs)); + Assert (rhs.size() == total_dofs, + ExcWrongSize(rhs.size(), total_dofs)); Assert (cell_matrix.all_zero(), ExcObjectNotEmpty()); Assert (rhs.all_zero(), ExcObjectNotEmpty()); @@ -706,9 +706,9 @@ void LaplaceMatrix::assemble (dFMatrix &cell_matrix, coefficient->value_list (fe_values.get_quadrature_points(), coefficient_values); for (unsigned int point=0; point::assemble (dFMatrix &cell_matrix, } else for (unsigned int point=0; point void LaplaceMatrix::assemble (dFMatrix &cell_matrix, const FEValues &fe_values, const Triangulation::cell_iterator &) const { - const unsigned int n_dofs = fe_values.total_dofs, + const unsigned int total_dofs = fe_values.total_dofs, n_q_points = fe_values.n_quadrature_points; - Assert (cell_matrix.n() == n_dofs, - ExcWrongSize(cell_matrix.n(), n_dofs)); - Assert (cell_matrix.m() == n_dofs, - ExcWrongSize(cell_matrix.m(), n_dofs)); + Assert (cell_matrix.n() == total_dofs, + ExcWrongSize(cell_matrix.n(), total_dofs)); + Assert (cell_matrix.m() == total_dofs, + ExcWrongSize(cell_matrix.m(), total_dofs)); Assert (cell_matrix.all_zero(), ExcObjectNotEmpty()); const vector > >&gradients = fe_values.get_shape_grads (); @@ -757,8 +757,8 @@ void LaplaceMatrix::assemble (dFMatrix &cell_matrix, coefficient->value_list (fe_values.get_quadrature_points(), coefficient_values); for (unsigned int point=0; point::assemble (dFMatrix &cell_matrix, } else for (unsigned int point=0; point::assemble (dVector &rhs, const Triangulation::cell_iterator &) const { Assert (right_hand_side != 0, ExcNoRHSSelected()); - const unsigned int n_dofs = fe_values.total_dofs, + const unsigned int total_dofs = fe_values.total_dofs, n_q_points = fe_values.n_quadrature_points; - Assert (rhs.size() == n_dofs, ExcWrongSize(rhs.size(), n_dofs)); + Assert (rhs.size() == total_dofs, ExcWrongSize(rhs.size(), total_dofs)); Assert (rhs.all_zero(), ExcObjectNotEmpty()); const dFMatrix &values = fe_values.get_shape_values (); @@ -793,7 +793,7 @@ void LaplaceMatrix::assemble (dVector &rhs, right_hand_side->value_list (fe_values.get_quadrature_points(), rhs_values); for (unsigned int point=0; point