* translate global row and column indices to local ones.
*
* @ingroup data
+ * @see @ref GlossBlockLA "Block (linear algebra)"
* @author Wolfgang Bangerth, Guido Kanschat, 2000, 2007
*/
class BlockIndices : public Subscriptor
// $Id$
// Version: $Name$
//
-// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2009 by the deal.II authors
+// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2009, 2010 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
* apply the @p vmult of the original matrix (or preconditioner) to a
* block vector.
*
+ * @see @ref GlossBlockLA "Block (linear algebra)"
* @author Guido Kanschat, 2000
*/
template <class MATRIX>
// $Id$
// Version: $Name$
//
-// Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009 by the deal.II authors
+// Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
* GrowingVectorMemory type, since it remembers the vector and avoids
* reallocating.
*
- * @ line Growing
+ * @line Growing
*
* Now, we are ready to build a <i>2x2</i> BlockMatrixArray.
* @line Block
* and is described in the documentation of
* BlockTrianglePrecondition.
*
- * @author Guido Kanschat, 2000 - 2005
+ * @see @ref GlossBlockLA "Block (linear algebra)"
+ * @author Guido Kanschat, 2000-2005
*/
template <typename number = double>
class BlockMatrixArray : public Subscriptor
// $Id$
// Version: $Name$
//
-// Copyright (C) 2004, 2005, 2006, 2007, 2008, 2009 by the deal.II authors
+// Copyright (C) 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
* want to do things differently depending on whether a template type
* denotes a regular or a block matrix type.
*
+ * @see @ref GlossBlockLA "Block (linear algebra)"
* @author Wolfgang Bangerth, 2009
*/
template <typename MatrixType>
* @<double@></tt>; others can be generated in application programs (see the
* section on @ref Instantiations in the manual).
*
+ * @see @ref GlossBlockLA "Block (linear algebra)"
* @author Wolfgang Bangerth, 2000, 2004
*/
template <typename MatrixType>
// $Id$
// Version: $Name$
//
-// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2009 by the deal.II authors
+// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2009, 2010 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
* the calls to the individual blocks to the functions implemented in the base
* class. See there also for a description of when this class is useful.
*
+ * @see @ref GlossBlockLA "Block (linear algebra)"
* @author Wolfgang Bangerth, 2000, 2004
*/
template <typename number>
// $Id$
// Version: $Name$
//
-// Copyright (C) 2002, 2003, 2004, 2005, 2006, 2009 by the deal.II authors
+// Copyright (C) 2002, 2003, 2004, 2005, 2006, 2009, 2010 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
* are functions for the multiplication with BlockVector and
* access to the individual blocks.
*
+ * @see @ref GlossBlockLA "Block (linear algebra)"
* @author Guido Kanschat, 2002, 2003
*/
template<typename Number>
// $Id$
// Version: $Name$
//
-// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009 by the deal.II authors
+// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
* You will in general not want to use this class, but one of the
* derived classes.
*
+ * @see @ref GlossBlockLA "Block (linear algebra)"
* @author Wolfgang Bangerth, 2000, 2001
*/
template <class SparsityPatternBase>
// $Id$
// Version: $Name$
//
-// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009 by the deal.II authors
+// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
* @<double@></tt>; others can be generated in application programs (see the
* section on @ref Instantiations in the manual).
*
+ * @see @ref GlossBlockLA "Block (linear algebra)"
* @author Wolfgang Bangerth, Guido Kanschat, 1999, 2000, 2001, 2002, 2004
*/
template <typename Number>
// $Id$
// Version: $Name$
//
-// Copyright (C) 2004, 2005, 2006, 2007 by the deal.II authors
+// Copyright (C) 2004, 2005, 2006, 2007, 2010 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
* debug version does not check consistency here for performance
* reasons!
*
+ * @see @ref GlossBlockLA "Block (linear algebra)"
* @author Wolfgang Bangerth, Guido Kanschat, 1999, 2000, 2001, 2002, 2004
*/
template <class VectorType>
*
* @ingroup Matrix2
* @ingroup vector_valued
+ * @see @ref GlossBlockLA "Block (linear algebra)"
* @author Guido Kanschat, 2006
*/
template <class MATRIX>
// $Id$
// Version: $Name$
//
-// Copyright (C) 2004, 2005, 2006, 2007 by the deal.II authors
+// Copyright (C) 2004, 2005, 2006, 2007, 2010 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
* the same reason as is documented with the BlockSparsityPattern class.
*
* @ingroup Matrix1
+ * @see @ref GlossBlockLA "Block (linear algebra)"
* @author Wolfgang Bangerth, 2004
*/
class BlockSparseMatrix : public BlockMatrixBase<PETScWrappers::SparseMatrix>
// $Id$
// Version: $Name$
//
-// Copyright (C) 2004, 2005, 2006, 2007 by the deal.II authors
+// Copyright (C) 2004, 2005, 2006, 2007, 2010 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
* that are specific to the underlying vector type.
*
* @ingroup Vectors
+ * @see @ref GlossBlockLA "Block (linear algebra)"
* @author Wolfgang Bangerth, 2004
*/
class BlockVector : public BlockVectorBase<Vector>
// $Id$
// Version: $Name$
//
-// Copyright (C) 2004, 2005, 2006, 2007 by the deal.II authors
+// Copyright (C) 2004, 2005, 2006, 2007, 2010 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
* the same reason as is documented with the BlockSparsityPattern class.
*
* @ingroup Matrix1
+ * @see @ref GlossBlockLA "Block (linear algebra)"
* @author Wolfgang Bangerth, 2004
*/
class BlockSparseMatrix : public BlockMatrixBase<SparseMatrix>
* of these blocks to be stored on the local process.
*
* @ingroup Vectors
+ * @see @ref GlossBlockLA "Block (linear algebra)"
* @author Wolfgang Bangerth, 2004
*/
class BlockVector : public BlockVectorBase<Vector>
// $Id$
// Version: $Name$
//
-// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009 by the deal.II authors
+// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
* example, <tt>number==double, inverse_type=float</tt> might be a viable
* choice.
*
+ * @see @ref GlossBlockLA "Block (linear algebra)"
* @author Ralf Hartmann, Guido Kanschat, 1999, 2000
*/
template<class MATRIX, typename inverse_type = typename MATRIX::value_type>
// $Id$
// Version: $Name$
//
-// Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2009 by the deal.II authors
+// Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2009, 2010 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
* schur.postprocess (u, p);
* @endverbatim
*
+ * @see @ref GlossBlockLA "Block (linear algebra)"
* @author Guido Kanschat, 2000, 2001, 2002
*/
template <class MA_inverse, class MB, class MDt, class MC>
// $Id$
// Version: $Name$
//
-// Copyright (C) 2008 by the deal.II authors
+// Copyright (C) 2008, 2010 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
* the same reason as is documented with the BlockSparsityPattern class.
*
* @ingroup Matrix1
+ * @see @ref GlossBlockLA "Block (linear algebra)"
* @author Martin Kronbichler, Wolfgang Bangerth, 2008
*/
class BlockSparseMatrix : public BlockMatrixBase<SparseMatrix>
// $Id$
// Version: $Name$
//
-// Copyright (C) 2008, 2009 by the deal.II authors
+// Copyright (C) 2008, 2009, 2010 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
*
* @ingroup Vectors
* @ingroup TrilinosWrappers
+ * @see @ref GlossBlockLA "Block (linear algebra)"
* @author Martin Kronbichler, Wolfgang Bangerth, 2008, 2009
*/
class BlockVector : public BlockVectorBase<Vector>
*
* @ingroup Vectors
* @ingroup TrilinosWrappers
+ * @see @ref GlossBlockLA "Block (linear algebra)"
* @author Martin Kronbichler, 2008
*/
class BlockVector : public BlockVectorBase<Vector>