From: Daniel Arndt Date: Thu, 21 Jun 2018 21:01:06 +0000 (+0200) Subject: Fix comments in @code blocks in matrix_free headers X-Git-Tag: v9.1.0-rc1~1003^2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=refs%2Fpull%2F6821%2Fhead;p=dealii.git Fix comments in @code blocks in matrix_free headers --- diff --git a/include/deal.II/matrix_free/fe_evaluation.h b/include/deal.II/matrix_free/fe_evaluation.h index b6f8680764..e677010dd6 100644 --- a/include/deal.II/matrix_free/fe_evaluation.h +++ b/include/deal.II/matrix_free/fe_evaluation.h @@ -1658,8 +1658,9 @@ protected: * phi.quadrature_point(q_index); * // Need to evaluate function for each component in VectorizedArray * VectorizedArray f_value; - * for (unsigned int v=0; v::n_array_elements; - * ++v) + * for (unsigned int v=0; + * v::n_array_elements; + * ++v) * { * Point p; * for (unsigned int d=0; d::n_array_elements > dofs_per_cell ? - * (dofs_per_cell - i) : VectorizedArray::n_array_elements; + * (dofs_per_cell - i) : + * VectorizedArray::n_array_elements; * * // Set n_items unit vectors * for (unsigned int j=0; j a tensor is returned, * * @code - * get_value -> Tensor<1,n_components,VectorizedArray > - * get_gradient -> Tensor<1,n_components,Tensor<1,dim,VectorizedArray > - * > + * get_value -> Tensor<1,n_components,VectorizedArray> + * get_gradient -> Tensor<1,n_components,Tensor<1,dim,VectorizedArray> * @endcode * * In a similar vein, the submit_value() and submit_gradient() calls take diff --git a/include/deal.II/matrix_free/operators.h b/include/deal.II/matrix_free/operators.h index a4eb280ca5..897506eda7 100644 --- a/include/deal.II/matrix_free/operators.h +++ b/include/deal.II/matrix_free/operators.h @@ -171,7 +171,8 @@ namespace MatrixFreeOperators * matrix_free_inhomogeneous.reinit(dof_handler, constraints_no_dirichlet, * quadrature, additional_data); * operator_inhomogeneous.initialize(matrix_free_inhomogeneous, - * selected_blocks); LinearAlgebra::distributed::Vector inhomogeneity; + * selected_blocks); + * LinearAlgebra::distributed::Vector inhomogeneity; * matrix_free_inhomogeneous.initialize_dof_vector(inhomogeneity); * constraints_with_dirichlet.distribute(inhomogeneity); * operator_inhomogeneous.vmult(system_rhs, inhomogeneity); @@ -789,7 +790,7 @@ namespace MatrixFreeOperators * fe_eval.reinit(cell); * for (unsigned int q=0; q