From: bangerth Date: Wed, 17 Nov 2010 20:00:48 +0000 (+0000) Subject: Remove links that doxygen on 'top' does not grok. X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=38c1591861c873684e74e40d1d02d6c97b93fa33;p=dealii-svn.git Remove links that doxygen on 'top' does not grok. git-svn-id: https://svn.dealii.org/trunk@22798 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/include/deal.II/lac/matrix_block.h b/deal.II/include/deal.II/lac/matrix_block.h index ca8d59c04a..6616f6d2ff 100644 --- a/deal.II/include/deal.II/lac/matrix_block.h +++ b/deal.II/include/deal.II/lac/matrix_block.h @@ -133,10 +133,10 @@ class MatrixBlock * pattern must be equal. */ void reinit(const BlockSparsityPattern& sparsity); - + operator MATRIX&(); operator const MATRIX&() const; - + /** * Add value to the * element (i,j). Throws @@ -325,13 +325,13 @@ class MatrixBlock * matching #matrix. */ template - void Tvmult_add (VECTOR& w, const VECTOR& v) const; - + void Tvmult_add (VECTOR& w, const VECTOR& v) const; + /** * The memory used by this object. */ unsigned int memory_consumption () const; - + /** * The block number computed from * an index by using @@ -378,7 +378,7 @@ class MatrixBlock * block. */ BlockIndices column_indices; - + friend void internal::reinit<>(MatrixBlock&, const BlockSparsityPattern&); }; @@ -402,7 +402,7 @@ class MatrixBlockVector * The type of object stored. */ typedef MatrixBlock value_type; - + /** * Add a new matrix block at the * position (row,column) @@ -418,7 +418,7 @@ class MatrixBlockVector * pattern from the block system. */ void reinit(const BlockSparsityPattern& sparsity); - + /** * Clears the object. * @@ -437,7 +437,7 @@ class MatrixBlockVector * blocks at the end. */ void clear (bool really_clean = false); - + /** * The memory used by this object. */ @@ -448,13 +448,13 @@ class MatrixBlockVector * the block at position i. */ const value_type& block(unsigned int i) const; - + /** * Access a reference to * the block at position i. */ value_type& block(unsigned int i); - + /** * Access the matrix at position * i for read and write @@ -509,7 +509,7 @@ class MGMatrixBlockVector * The number of blocks. */ unsigned int size () const; - + /** * Add a new matrix block at the * position (row,column) @@ -520,7 +520,7 @@ class MGMatrixBlockVector */ void add(unsigned int row, unsigned int column, const std::string& name); - + /** * For matrices using a * SparsityPattern, this function @@ -556,7 +556,7 @@ class MGMatrixBlockVector * refinement edge. */ void reinit_edge_flux(const MGLevelObject& sparsity); - + /** * Clears the object. * @@ -575,67 +575,67 @@ class MGMatrixBlockVector * blocks at the end. */ void clear (bool really_clean = false); - + /** * Access a constant reference to * the matrix block at position i. */ const value_type& block(unsigned int i) const; - + /** * Access a reference to * the matrix block at position i. */ value_type& block(unsigned int i); - + /** * Access a constant reference to * the edge matrix block at position i. */ const value_type& block_in(unsigned int i) const; - + /** * Access a reference to * the edge matrix block at position i. */ value_type& block_in(unsigned int i); - + /** * Access a constant reference to * the edge matrix block at position i. */ const value_type& block_out(unsigned int i) const; - + /** * Access a reference to * the edge matrix block at position i. */ value_type& block_out(unsigned int i); - + /** * Access a constant reference to * the edge flux matrix block at position i. */ const value_type& block_up(unsigned int i) const; - + /** * Access a reference to * the edge flux matrix block at position i. */ value_type& block_up(unsigned int i); - + /** * Access a constant reference to * the edge flux matrix block at position i. */ const value_type& block_down(unsigned int i) const; - + /** * Access a reference to * the edge flux matrix block at position i. */ value_type& block_down(unsigned int i); - + /** * The memory used by this object. */ @@ -643,13 +643,13 @@ class MGMatrixBlockVector private: /// Clear one of the matrix objects void clear_object(NamedData > >&); - - /// Flag for storing #matrices_in and #matrices_out + + /// Flag for storing matrices_in and matrices_out const bool edge_matrices; - /// Flag for storing #flux_matrices_up and #flux_matrices_down + /// Flag for storing flux_matrices_up and flux_matrices_down const bool edge_flux_matrices; - + /// The level matrices NamedData > > matrices; /// The matrix from the interior of a level to the refinement edge @@ -675,7 +675,7 @@ namespace internal v.column_indices = p.get_column_indices(); } - + template void reinit(MatrixBlock >& v, const BlockSparsityPattern& p) @@ -775,7 +775,7 @@ MatrixBlock::add (const std::vector& r_indices, { Assert(row_indices.size() != 0, ExcNotInitialized()); Assert(column_indices.size() != 0, ExcNotInitialized()); - + AssertDimension (r_indices.size(), values.m()); AssertDimension (c_indices.size(), values.n()); @@ -798,7 +798,7 @@ MatrixBlock::add (const unsigned int b_row, { Assert(row_indices.size() != 0, ExcNotInitialized()); Assert(column_indices.size() != 0, ExcNotInitialized()); - + const std::pair bi = row_indices.global_to_local(b_row); @@ -835,7 +835,7 @@ MatrixBlock::add (const std::vector &indices, { Assert(row_indices.size() != 0, ExcNotInitialized()); Assert(column_indices.size() != 0, ExcNotInitialized()); - + AssertDimension (indices.size(), values.m()); Assert (values.n() == values.m(), ExcNotQuadratic()); @@ -857,7 +857,7 @@ MatrixBlock::add (const unsigned int row, { Assert(row_indices.size() != 0, ExcNotInitialized()); Assert(column_indices.size() != 0, ExcNotInitialized()); - + AssertDimension (col_indices.size(), values.size()); add (row, col_indices.size(), &col_indices[0], &values[0], elide_zero_values); @@ -1011,7 +1011,7 @@ MGMatrixBlockVector::add( MGLevelObject > p(0, 1); p[0].row = row; p[0].column = column; - + matrices.add(p, name); if (edge_matrices) { @@ -1173,7 +1173,7 @@ MGMatrixBlockVector::reinit_edge_flux(const MGLevelObject