From: bangerth Date: Tue, 1 May 2012 12:23:31 +0000 (+0000) Subject: Untabify files. X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=99e108a22c6b44725aa55d5d50740d62da03f642;p=dealii-svn.git Untabify files. git-svn-id: https://svn.dealii.org/trunk@25473 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/doc/doxygen/headers/distributed.h b/deal.II/doc/doxygen/headers/distributed.h index abddb98a80..a733ed9eb7 100644 --- a/deal.II/doc/doxygen/headers/distributed.h +++ b/deal.II/doc/doxygen/headers/distributed.h @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2009, 2010 by the deal.II authors +// Copyright (C) 2009, 2010, 2012 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -347,17 +347,17 @@ namespace parallel { - /** - * A namespace for class and - * functions that support %parallel - * computing on %distributed memory - * machines. See the @ref - * distributed module for an - * overview of the facilities this - * namespace offers. - * - * @ingroup distributed - */ + /** + * A namespace for class and + * functions that support %parallel + * computing on %distributed memory + * machines. See the @ref + * distributed module for an + * overview of the facilities this + * namespace offers. + * + * @ingroup distributed + */ namespace distributed { } diff --git a/deal.II/doc/doxygen/headers/glossary.h b/deal.II/doc/doxygen/headers/glossary.h index be447fff23..89b313db88 100644 --- a/deal.II/doc/doxygen/headers/glossary.h +++ b/deal.II/doc/doxygen/headers/glossary.h @@ -541,14 +541,14 @@ * The full reference for the paper is as follows: * @code @Article{BBHK11, - author = {Wolfgang Bangerth and Carsten Burstedde and Timo Heister + author = {Wolfgang Bangerth and Carsten Burstedde and Timo Heister and Martin Kronbichler}, - title = {Algorithms and data structures for massively parallel generic + title = {Algorithms and data structures for massively parallel generic adaptive finite element codes}, - journal = {ACM Trans. Math. Softw.}, - year = 2011, - volume = 38, - pages = {14/1--28}} + journal = {ACM Trans. Math. Softw.}, + year = 2011, + volume = 38, + pages = {14/1--28}} * @endcode * It is also available as * IAMCS @@ -652,14 +652,14 @@ * The full reference for this paper is as follows: * @code Article{BK07, - author = {Wolfgang Bangerth and Oliver Kayser-Herold}, - title = {Data Structures and Requirements for hp Finite Element + author = {Wolfgang Bangerth and Oliver Kayser-Herold}, + title = {Data Structures and Requirements for hp Finite Element Software}, - journal = {ACM Trans. Math. Softw.}, - year = 2009, - volume = 36, - number = 1, - pages = {4/1--4/31} + journal = {ACM Trans. Math. Softw.}, + year = 2009, + volume = 36, + number = 1, + pages = {4/1--4/31} } * @endcode * It is available as Technical Report ISC-07-04-MATH from the @@ -761,10 +761,10 @@ Article{BK07, * The full reference for this paper is as follows: * @code Article{JK10, - author = {B. Janssen and G. Kanschat}, - title = {Adaptive multilevel methods with local smoothing}, - journal = {submitted}, - year = 2010 + author = {B. Janssen and G. Kanschat}, + title = {Adaptive multilevel methods with local smoothing}, + journal = {submitted}, + year = 2010 } * @endcode * It is available as Technical Report IAMCS-2009-131 from the diff --git a/deal.II/doc/doxygen/headers/matrices.h b/deal.II/doc/doxygen/headers/matrices.h index 351b28180c..1ec2f373fe 100644 --- a/deal.II/doc/doxygen/headers/matrices.h +++ b/deal.II/doc/doxygen/headers/matrices.h @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2003, 2004, 2006, 2007, 2010 by the deal.II authors +// Copyright (C) 2003, 2004, 2006, 2007, 2010, 2012 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -70,27 +70,27 @@ template class MATRIX { public: - /** - * @name Solver interface - */ - /*@{*/ - /** - * The matrix vector product $u = Av$. - */ + /** + * @name Solver interface + */ + /*@{*/ + /** + * The matrix vector product $u = Av$. + */ void vmult(VECTOR& u, const VECTOR& v) const; - /** - * The matrix vector product $u = A^Tv$. - */ + /** + * The matrix vector product $u = A^Tv$. + */ void Tvmult(VECTOR& u, const VECTOR& v) const; - /** - * The matrix vector product $u += Av$. - */ + /** + * The matrix vector product $u += Av$. + */ void vmult_add(VECTOR& u, const VECTOR& v) const; - /** - * The matrix vector product $u += A^Tv$. - */ + /** + * The matrix vector product $u += A^Tv$. + */ void Tvmult_add(VECTOR& u, const VECTOR& v) const; - /*@}*/ + /*@}*/ }; /** diff --git a/deal.II/doc/doxygen/headers/multithreading.h b/deal.II/doc/doxygen/headers/multithreading.h index 194308e9e1..40407affe1 100644 --- a/deal.II/doc/doxygen/headers/multithreading.h +++ b/deal.II/doc/doxygen/headers/multithreading.h @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2006, 2008, 2009, 2010, 2011 by the deal.II authors +// Copyright (C) 2006, 2008, 2009, 2010, 2011, 2012 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -359,7 +359,7 @@ const InputIterator1 &end_in_1, const InputIterator2 &begin_in_2, const OutputIterator &begin_out, - FunctionObject &function) + FunctionObject &function) { InputIterator1 in_1 = begin_in_1; InputIterator2 in_2 = begin_in_2; @@ -390,9 +390,9 @@ * @code parallel::transform (x.begin(), x.end(), y.begin(), - z.begin(), - (boost::lambda::_1 + boost::lambda::_2), - 1000); + z.begin(), + (boost::lambda::_1 + boost::lambda::_2), + 1000); * @endcode * * In this example, we used the vmult_on_subrange function on sub-ranges @@ -568,13 +568,13 @@ double norm_sqr = 0; for (unsigned int row=0; row task_group; for (typename DoFHandler::active_cell_iterator cell = dof_handler.begin_active(); - cell != dof_handler.end(); ++cell) + cell != dof_handler.end(); ++cell) task_group += Threads::new_task (&MyClass::assemble_on_one_cell, *this, - cell); + cell); task_group.join_all (); } * @endcode @@ -688,9 +688,9 @@ void MyClass::assemble_system () { WorkStream::run (dof_handler.begin_active(), - dof_handler.end(), - *this, - &MyClass::assemble_on_one_cell); + dof_handler.end(), + *this, + &MyClass::assemble_on_one_cell); } * @endcode * @@ -711,7 +711,7 @@ for (unsigned int i=0; iget_dof_indices (data.dof_indices); @@ -843,7 +843,7 @@ for (unsigned int i=0; i::assemble_on_one_cell, - &MyClass::copy_local_to_global, - per_task_data); + dof_handler.end(), + *this, + &MyClass::assemble_on_one_cell, + &MyClass::copy_local_to_global, + per_task_data); } * @endcode * @@ -900,10 +900,10 @@ std::vector dof_indices; PerTaskData (const FiniteElement &fe) - : - cell_matrix (fe.dofs_per_cell, fe.dofs_per_cell), - cell_rhs (fe.dofs_per_cell), - dof_indices (fe.dofs_per_cell) + : + cell_matrix (fe.dofs_per_cell, fe.dofs_per_cell), + cell_rhs (fe.dofs_per_cell), + dof_indices (fe.dofs_per_cell) {} } @@ -913,15 +913,15 @@ ScratchData (const FiniteElement &fe, const Quadrature &quadrature, const UpdateFlags update_flags) - : - fe_values (fe, quadrature, update_flags) + : + fe_values (fe, quadrature, update_flags) {} - + ScratchData (const ScratchData &scratch) - : - fe_values (scratch.fe_values.get_fe(), - scratch.fe_values.get_quadrature(), - scratch.fe_values.get_update_flags()) + : + fe_values (scratch.fe_values.get_fe(), + scratch.fe_values.get_quadrature(), + scratch.fe_values.get_update_flags()) {} } * @endcode @@ -930,19 +930,19 @@ template void MyClass::assemble_on_one_cell (const typename DoFHandler::active_cell_iterator &cell, ScratchData &scratch, - PerTaskData &data) + PerTaskData &data) { scratch.fe_values.reinit (cell); ... } * @endcode - * Just as for the PerTaskData structure, we will create a + * Just as for the PerTaskData structure, we will create a * sample ScratchData object and pass it to the work stream - * object, which will replicate it as many times as necessary. For this - * to work ScratchData structures need to copyable. Since FEValues - * objects are rather complex and cannot be copied implicitly, we provided - * our own copy constructor for the ScratchData structure. - * + * object, which will replicate it as many times as necessary. For this + * to work ScratchData structures need to copyable. Since FEValues + * objects are rather complex and cannot be copied implicitly, we provided + * our own copy constructor for the ScratchData structure. + * * The same approach, putting things into the ScratchData * data structure, should be used for everything that is expensive to * construct. This holds, in particular, for everything that needs to @@ -953,7 +953,7 @@ template void MyClass::assemble_on_one_cell (const typename DoFHandler::active_cell_iterator &cell, ScratchData &scratch, - PerTaskData &data) + PerTaskData &data) { std::vector rhs_values (fe_values.n_quadrature_points); rhs_function.value_list (data.fe_values.get_quadrature_points, @@ -970,24 +970,24 @@ ScratchData (const FiniteElement &fe, const Quadrature &quadrature, const UpdateFlags update_flags) - : - rhs_values (quadrature.size()), - fe_values (fe, quadrature, update_flags) + : + rhs_values (quadrature.size()), + fe_values (fe, quadrature, update_flags) {} - + ScratchData (const ScratchData &scratch) - : - rhs_values (scratch.rhs_values), - fe_values (scratch.fe_values.get_fe(), - scratch.fe_values.get_quadrature(), - scratch.fe_values.get_update_flags()) + : + rhs_values (scratch.rhs_values), + fe_values (scratch.fe_values.get_fe(), + scratch.fe_values.get_quadrature(), + scratch.fe_values.get_update_flags()) {} } template void MyClass::assemble_on_one_cell (const typename DoFHandler::active_cell_iterator &cell, ScratchData &scratch, - PerTaskData &data) + PerTaskData &data) { rhs_function.value_list (scratch.fe_values.get_quadrature_points, scratch.rhs_values) @@ -1007,18 +1007,18 @@ * identical: * @code WorkStream::run (dof_handler.begin_active(), - dof_handler.end(), - *this, - &MyClass::assemble_on_one_cell, - &MyClass::copy_local_to_global, - per_task_data); + dof_handler.end(), + *this, + &MyClass::assemble_on_one_cell, + &MyClass::copy_local_to_global, + per_task_data); // ...is the same as: WorkStream::run (dof_handler.begin_active(), - dof_handler.end(), - std_cxx1x::bind(&MyClass::assemble_on_one_cell, *this, - std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3), - std_cxx1x::bind(&MyClass::copy_local_to_global, *this, std_cxx1x::_1), - per_task_data); + dof_handler.end(), + std_cxx1x::bind(&MyClass::assemble_on_one_cell, *this, + std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3), + std_cxx1x::bind(&MyClass::copy_local_to_global, *this, std_cxx1x::_1), + per_task_data); * @endcode * Note how std_cxx1x::bind produces a function object that takes three * arguments by binding the member function to the *this @@ -1040,7 +1040,7 @@ const typename DoFHandler::active_cell_iterator &cell, ScratchData &scratch, PerTaskData &data, - const double current_time) + const double current_time) { ... } * @endcode * Because WorkStream expects to be able to call the worker function with @@ -1049,17 +1049,17 @@ * to it: * @code WorkStream::run (dof_handler.begin_active(), - dof_handler.end(), - std_cxx1x::bind(&MyClass::assemble_on_one_cell, - *this, - current_solution, - std_cxx1x::_1, - std_cxx1x::_2, - std_cxx1x::_3, - previous_time+time_step), - std_cxx1x::bind(&MyClass::copy_local_to_global, - *this, std_cxx1x::_1), - per_task_data); + dof_handler.end(), + std_cxx1x::bind(&MyClass::assemble_on_one_cell, + *this, + current_solution, + std_cxx1x::_1, + std_cxx1x::_2, + std_cxx1x::_3, + previous_time+time_step), + std_cxx1x::bind(&MyClass::copy_local_to_global, + *this, std_cxx1x::_1), + per_task_data); * @endcode * Here, we bind the object, the linearization point argument, and the * current time argument to the function before we hand it off to @@ -1146,10 +1146,10 @@ Vector error_per_cell (triangulation.n_active_cells()); KellyErrorEstimator::estimate (dof_handler, - QGauss(3), - typename FunctionMap::type(), - solution, - estimated_error_per_cell); + QGauss(3), + typename FunctionMap::type(), + solution, + estimated_error_per_cell); thread.join (); * @endcode * diff --git a/deal.II/doc/doxygen/headers/update_flags.h b/deal.II/doc/doxygen/headers/update_flags.h index 5e2d97ae76..8d86e1381e 100644 --- a/deal.II/doc/doxygen/headers/update_flags.h +++ b/deal.II/doc/doxygen/headers/update_flags.h @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2006, 2007 by the deal.II authors +// Copyright (C) 2006, 2007, 2012 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -24,7 +24,7 @@ have to compute @f[ A^K_{ij} = \sum_{q}J^{-1}(\hat{\bf x}_q) \hat \nabla \varphi_i(\hat{\bf x}_q) \cdot J^{-1}(\hat{\bf x}_q) \hat \nabla \varphi_j(\hat{\bf x}_q)\ |\textrm{det}\ J(\hat{\bf x}_q)| - w_q, + w_q, @f] where a hat indicates reference coordinates, and $J(\hat{\bf x}_q)$ is the Jacobian @@ -100,7 +100,7 @@ of a FEValues object that uses a FE_RaviartThomas element, then we can set update_once=update_values and update_each=0 for the FiniteElement, but need to set update_once=0 update_each=update_jacobians for the Mapping object. - + To accomodate this structure, at the time a FEValues object is constructed, it asks both the FiniteElement and the Mapping object it uses the following:
    @@ -123,7 +123,7 @@ required from the Mapping. The function in FEValues computing the actual set of flags from the desired one looks like this: flags |= fe->update_once (flags) - | fe->update_each (flags); + | fe->update_each (flags); flags |= mapping->update_once (flags) | mapping->update_each (flags); diff --git a/deal.II/doc/doxygen/headers/vector_valued.h b/deal.II/doc/doxygen/headers/vector_valued.h index 5465698458..a1642ae729 100644 --- a/deal.II/doc/doxygen/headers/vector_valued.h +++ b/deal.II/doc/doxygen/headers/vector_valued.h @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2008, 2011 by the deal.II authors +// Copyright (C) 2008, 2011, 2012 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -279,13 +279,13 @@ { for (unsigned int j=0; j phi_i_grad - = fe_values[displacements].gradient (i,q_point); - const double phi_i_div - = fe_values[displacements].divergence (i,q_point); + for (unsigned int i=0; i phi_i_grad + = fe_values[displacements].gradient (i,q_point); + const double phi_i_div + = fe_values[displacements].divergence (i,q_point); - for (unsigned int j=0; j phi_j_grad - = fe_values[displacements].gradient (j,q_point); - const double phi_j_div - = fe_values[displacements].divergence (j,q_point); + for (unsigned int j=0; j phi_j_grad + = fe_values[displacements].gradient (j,q_point); + const double phi_j_div + = fe_values[displacements].divergence (j,q_point); - cell_matrix(i,j) - += (lambda_values[q_point] * - phi_i_div * phi_j_div - + - mu_values[q_point] * - scalar_product(phi_i_grad, phi_j_grad) - + - mu_values[q_point] * - scalar_product(phi_i_grad, transpose(phi_j_grad)) - ) * - fe_values.JxW(q_point); - } - } + cell_matrix(i,j) + += (lambda_values[q_point] * + phi_i_div * phi_j_div + + + mu_values[q_point] * + scalar_product(phi_i_grad, phi_j_grad) + + + mu_values[q_point] * + scalar_product(phi_i_grad, transpose(phi_j_grad)) + ) * + fe_values.JxW(q_point); + } + } * @endcode * * The scalar product between two tensors used in this bilinear form is @@ -464,7 +464,7 @@ template double scalar_product (const Tensor<2,dim> &u, - const Tensor<2,dim> &v) + const Tensor<2,dim> &v) { double tmp = 0; for (unsigned int i=0; i &u, * * @code for (unsigned int q_point=0; q_point phi_i_symmgrad - = fe_values[displacements].symmetric_gradient (i,q_point); - const double phi_i_div - = fe_values[displacements].divergence (i,q_point); + for (unsigned int i=0; i phi_i_symmgrad + = fe_values[displacements].symmetric_gradient (i,q_point); + const double phi_i_div + = fe_values[displacements].divergence (i,q_point); - for (unsigned int j=0; j phi_j_symmgrad - = fe_values[displacements].symmetric_gradient (j,q_point); - const double phi_j_div - = fe_values[displacements].divergence (j,q_point); + for (unsigned int j=0; j phi_j_symmgrad + = fe_values[displacements].symmetric_gradient (j,q_point); + const double phi_j_div + = fe_values[displacements].divergence (j,q_point); - cell_matrix(i,j) - += (phi_i_div * phi_j_div * - lambda_values[q_point] - + - 2 * - (phi_i_symmgrad * phi_j_symmgrad) * - mu_values[q_point]) * - fe_values.JxW(q_point)); - } - } + cell_matrix(i,j) + += (phi_i_div * phi_j_div * + lambda_values[q_point] + + + 2 * + (phi_i_symmgrad * phi_j_symmgrad) * + mu_values[q_point]) * + fe_values.JxW(q_point)); + } + } * @endcode * * So if, again, this is not the code we use in step-8, what do @@ -746,7 +746,7 @@ scalar_product (const Tensor<2,dim> &u, cg.solve (system_matrix.block(0,0), solution.block(0), - tmp, + tmp, PreconditionIdentity()); * @endcode * @@ -935,8 +935,8 @@ scalar_product (const Tensor<2,dim> &u, DataOut data_out; data_out.attach_dof_handler (dof_handler); data_out.add_data_vector (solution, solution_names, - DataOut::type_dof_data, - data_component_interpretation); + DataOut::type_dof_data, + data_component_interpretation); data_out.build_patches (); * @endcode * In other words, we here create an array of dim+1 elements in