From e0bcd5d7d3fb89493333e3d4290b60676c7e2e97 Mon Sep 17 00:00:00 2001 From: guido Date: Tue, 22 Feb 2000 20:05:29 +0000 Subject: [PATCH] new heads git-svn-id: https://svn.dealii.org/trunk@2474 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/lac/include/lac/block_vector.h | 52 +++++++------- .../lac/include/lac/block_vector.templates.h | 55 +++++---------- deal.II/lac/include/lac/full_matrix.h | 38 +++++------ .../lac/include/lac/full_matrix.templates.h | 55 +++++---------- deal.II/lac/include/lac/precondition.h | 30 ++++---- deal.II/lac/include/lac/precondition_block.h | 25 ++++--- .../lac/precondition_block.templates.h | 31 ++++----- .../lac/include/lac/precondition_selector.h | 26 ++++--- deal.II/lac/include/lac/solver.h | 32 +++++---- deal.II/lac/include/lac/solver_bicgstab.h | 24 ++++--- deal.II/lac/include/lac/solver_cg.h | 35 +++++----- deal.II/lac/include/lac/solver_control.h | 32 ++++----- deal.II/lac/include/lac/solver_gmres.h | 38 ++++++----- deal.II/lac/include/lac/solver_qmrs.h | 33 +++++---- deal.II/lac/include/lac/solver_richardson.h | 27 ++++---- deal.II/lac/include/lac/solver_selector.h | 30 ++++---- deal.II/lac/include/lac/sparse_ilu.h | 26 +++---- .../lac/include/lac/sparse_ilu.templates.h | 48 ++++++------- .../lac/include/lac/sparse_matrix.2.templates | 16 ++++- deal.II/lac/include/lac/sparse_matrix.h | 54 ++++++--------- .../lac/include/lac/sparse_matrix.templates.h | 47 ++++--------- deal.II/lac/include/lac/sparse_vanka.h | 29 ++++---- .../lac/include/lac/sparse_vanka.templates.h | 38 ++++++----- deal.II/lac/include/lac/sparsity_pattern.h | 46 ++++++------- deal.II/lac/include/lac/vector.h | 68 ++++++++----------- deal.II/lac/include/lac/vector.templates.h | 62 +++++------------ deal.II/lac/include/lac/vector_memory.h | 32 ++++----- deal.II/lac/source/full_matrix.double.cc | 22 +++--- deal.II/lac/source/full_matrix.float.cc | 22 +++--- deal.II/lac/source/precondition_block.cc | 24 +++---- deal.II/lac/source/solver_control.cc | 24 ++++--- deal.II/lac/source/sparse_ilu.cc | 14 +++- deal.II/lac/source/sparse_matrix.double.cc | 21 +++--- deal.II/lac/source/sparse_matrix.float.cc | 21 +++--- .../lac/source/sparse_matrix.long_double.cc | 21 +++--- deal.II/lac/source/sparse_vanka.cc | 14 +++- deal.II/lac/source/sparsity_pattern.cc | 41 ++++------- deal.II/lac/source/vector.cc | 14 +++- deal.II/lac/source/vector.long_double.cc | 14 +++- 39 files changed, 628 insertions(+), 653 deletions(-) diff --git a/deal.II/lac/include/lac/block_vector.h b/deal.II/lac/include/lac/block_vector.h index 3c5754e7bc..82a5fb649e 100644 --- a/deal.II/lac/include/lac/block_vector.h +++ b/deal.II/lac/include/lac/block_vector.h @@ -1,6 +1,18 @@ -/* $Id$ */ -#ifndef __lac__block_vector_H -#define __lac__block_vector_H +//---------------------------- block_vector.h --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- block_vector.h --------------------------- +#ifndef __deal2__block_vector_h +#define __deal2__block_vector_h + #include #include @@ -136,9 +148,9 @@ class BlockVector * $l_\infty$-norm of a vector. */ Number linfty_norm () const; - - - /** + + +/** * Change the dimension of the vector to * #N#. The reserved memory for this vector * remains unchanged if possible, to make @@ -214,9 +226,8 @@ class BlockVector // */ // const_iterator end () const; - - - /** + +/** * @name 2: Data-Access */ //@{ @@ -231,9 +242,9 @@ class BlockVector */ Number& operator() (const unsigned int i); //@} - - - /** + + +/** * @name 3: Modification of vectors */ //@{ @@ -329,9 +340,9 @@ class BlockVector const Number b, const BlockVector& W); //@} - - - /** + + +/** * @name 5: Mixed stuff */ //@{ @@ -429,10 +440,6 @@ class BlockVector }; - - - - /*----------------------- Inline functions ----------------------------------*/ @@ -444,7 +451,6 @@ unsigned int BlockVector::size () const } - // template // inline // BlockVector::iterator BlockVector::begin () { @@ -452,7 +458,6 @@ unsigned int BlockVector::size () const // }; - // template // inline // BlockVector::const_iterator BlockVector::begin () const { @@ -460,7 +465,6 @@ unsigned int BlockVector::size () const // }; - // template // inline // BlockVector::iterator BlockVector::end () { @@ -468,7 +472,6 @@ unsigned int BlockVector::size () const // }; - // template // inline // BlockVector::const_iterator BlockVector::end () const { @@ -476,7 +479,6 @@ unsigned int BlockVector::size () const // }; - template inline Number BlockVector::operator() (const unsigned int i) const @@ -490,7 +492,6 @@ Number BlockVector::operator() (const unsigned int i) const } - template inline Number& BlockVector::operator() (const unsigned int i) @@ -524,5 +525,4 @@ BlockVector::block(unsigned int i) const } - #endif diff --git a/deal.II/lac/include/lac/block_vector.templates.h b/deal.II/lac/include/lac/block_vector.templates.h index eaa93a2c13..6d54d753bf 100644 --- a/deal.II/lac/include/lac/block_vector.templates.h +++ b/deal.II/lac/include/lac/block_vector.templates.h @@ -1,9 +1,18 @@ -// $Id$ +//---------------------------- block_vector.templates.h --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- block_vector.templates.h --------------------------- +#ifndef __deal2__block_vector_templates_h +#define __deal2__block_vector_templates_h -// This file was once part of the DEAL Library -// DEAL is Copyright(1995) by -// Roland Becker, Guido Kanschat, Franz-Theo Suttmeier -// Revised and extended by Wolfgang Bangerth, 1998, 1999 #include #include @@ -17,7 +26,6 @@ static inline Number sqr (const Number x) }; - template BlockVector::BlockVector () { @@ -26,7 +34,6 @@ BlockVector::BlockVector () } - template BlockVector::BlockVector (const vector& n) { @@ -36,7 +43,6 @@ BlockVector::BlockVector (const vector& n) } - template BlockVector::BlockVector (const BlockVector& v) { @@ -49,7 +55,6 @@ BlockVector::BlockVector (const BlockVector& v } - // see the .h file for why this function was disabled // // template @@ -68,7 +73,6 @@ BlockVector::BlockVector (const BlockVector& v // } - template void BlockVector::reinit (const vector& n, const bool fast) @@ -87,7 +91,6 @@ void BlockVector::reinit (const vector& n, } - template void BlockVector::reinit (const BlockVector& v, const bool fast) @@ -101,15 +104,12 @@ void BlockVector::reinit (const BlockVector& v } - - template BlockVector::~BlockVector () { } - template void BlockVector::clear () { @@ -120,7 +120,6 @@ void BlockVector::clear () } - template bool BlockVector::all_zero () const { @@ -133,7 +132,6 @@ bool BlockVector::all_zero () const } - template Number BlockVector::operator * (const BlockVector& v) const { @@ -146,7 +144,6 @@ Number BlockVector::operator * (const BlockVector Number BlockVector::norm_sqr () const { @@ -159,7 +156,6 @@ Number BlockVector::norm_sqr () const }; - template Number BlockVector::mean_value () const { @@ -172,7 +168,6 @@ Number BlockVector::mean_value () const } - template Number BlockVector::l1_norm () const { @@ -185,7 +180,6 @@ Number BlockVector::l1_norm () const } - template Number BlockVector::l2_norm () const { @@ -193,7 +187,6 @@ Number BlockVector::l2_norm () const } - template Number BlockVector::linfty_norm () const { @@ -206,9 +199,6 @@ Number BlockVector::linfty_norm () const } return sum; } - - - template @@ -219,7 +209,6 @@ BlockVector& BlockVector::operator += (const B } - template BlockVector& BlockVector::operator -= (const BlockVector& v) { @@ -231,7 +220,6 @@ BlockVector& BlockVector::operator -= (const B } - template void BlockVector::add (const Number v) { @@ -242,7 +230,6 @@ void BlockVector::add (const Number v) } - template void BlockVector::add (const BlockVector& v) { @@ -253,7 +240,6 @@ void BlockVector::add (const BlockVector& v) } - template void BlockVector::add (const Number a, const BlockVector& v) @@ -265,7 +251,6 @@ void BlockVector::add (const Number a, } - template void BlockVector::add (const Number a, const BlockVector& v, @@ -279,7 +264,6 @@ void BlockVector::add (const Number a, } - template void BlockVector::sadd (const Number x, const BlockVector& v) @@ -291,7 +275,6 @@ void BlockVector::sadd (const Number x, } - template void BlockVector::sadd (const Number x, const Number a, const BlockVector& v) @@ -303,7 +286,6 @@ void BlockVector::sadd (const Number x, const Number a, } - template void BlockVector::sadd (const Number x, const Number a, const BlockVector& v, @@ -317,7 +299,6 @@ void BlockVector::sadd (const Number x, const Number a, } - template void BlockVector::sadd (const Number x, const Number a, const BlockVector& v, @@ -334,7 +315,6 @@ void BlockVector::sadd (const Number x, const Number a, } - template void BlockVector::scale (const Number factor) { @@ -345,7 +325,6 @@ void BlockVector::scale (const Number factor) } - template void BlockVector::equ (const Number a, const BlockVector& v, @@ -359,7 +338,6 @@ void BlockVector::equ (const Number a, } - template void BlockVector::equ (const Number a, const BlockVector& v) @@ -382,7 +360,6 @@ BlockVector& BlockVector::operator = (const Nu } - template BlockVector& BlockVector::operator = (const BlockVector& v) @@ -395,7 +372,6 @@ BlockVector::operator = (const BlockVector& v) } - template template BlockVector& @@ -426,7 +402,6 @@ void BlockVector::print (ostream &out, } - template void BlockVector::block_write (ostream &out) const { @@ -445,3 +420,5 @@ void BlockVector::block_read (istream &in) components[i].block_read(in); } } + +#endif diff --git a/deal.II/lac/include/lac/full_matrix.h b/deal.II/lac/include/lac/full_matrix.h index 5eadbb8a25..a7c7aa1a54 100644 --- a/deal.II/lac/include/lac/full_matrix.h +++ b/deal.II/lac/include/lac/full_matrix.h @@ -1,14 +1,20 @@ -/*---------------------------- fullmatrix.h ---------------------------*/ -// $Id$ -#ifndef __lac_fullmatrix_H -#define __lac_fullmatrix_H -/*---------------------------- fullmatrix.h ---------------------------*/ +//---------------------------- full_matrix.h --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- full_matrix.h --------------------------- +#ifndef __deal2__full_matrix_h +#define __deal2__full_matrix_h -// This file is part of the DEAL Library -// DEAL is Copyright(1995) by -// Roland Becker, Guido Kanschat, Franz-Theo Suttmeier -// Revised by Wolfgang Bangerth +/*---------------------------- fullmatrix.h ---------------------------*/ #include #include @@ -19,7 +25,6 @@ template class Vector; - /** * Rectangular/quadratic full matrix. * @@ -128,9 +133,9 @@ class FullMatrix : public Subscriptor */ template FullMatrix& operator = (const FullMatrix& src); - - - /** + + +/** * Fill rectangular block. * * The matrix #src# is copied @@ -655,9 +660,6 @@ class FullMatrix : public Subscriptor }; - - - /*-------------------------Inline functions -------------------------------*/ template @@ -720,9 +722,7 @@ FullMatrix::operator() (const unsigned int i, const unsigned int j) } - - /*---------------------------- fullmatrix.h ---------------------------*/ -/* end of #ifndef __lac_fullmatrix_H */ + #endif /*---------------------------- fullmatrix.h ---------------------------*/ diff --git a/deal.II/lac/include/lac/full_matrix.templates.h b/deal.II/lac/include/lac/full_matrix.templates.h index d441ee3450..d73fa76fe4 100644 --- a/deal.II/lac/include/lac/full_matrix.templates.h +++ b/deal.II/lac/include/lac/full_matrix.templates.h @@ -1,4 +1,18 @@ -// $Id$ +//---------------------------- full_matrix.templates.h --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- full_matrix.templates.h --------------------------- +#ifndef __deal2__full_matrix_templates_h +#define __deal2__full_matrix_templates_h + #include #include @@ -57,7 +71,6 @@ FullMatrix::~FullMatrix () }; - template void FullMatrix::reinit (const unsigned int mm, @@ -103,7 +116,6 @@ FullMatrix::reinit (const unsigned int mm, }; - template void FullMatrix::reinit (const unsigned int n) @@ -137,7 +149,6 @@ FullMatrix::all_zero () const }; - template template void @@ -269,7 +280,6 @@ FullMatrix::vmult (Vector& dst, } - template template void FullMatrix::Tvmult (Vector &dst, @@ -296,7 +306,6 @@ void FullMatrix::Tvmult (Vector &dst, } - template template double FullMatrix::residual (Vector& dst, @@ -324,7 +333,6 @@ double FullMatrix::residual (Vector& dst, } - template template void FullMatrix::forward (Vector& dst, @@ -347,7 +355,6 @@ void FullMatrix::forward (Vector& dst, } - template template void FullMatrix::backward (Vector& dst, @@ -367,7 +374,6 @@ void FullMatrix::backward (Vector& dst, } - template FullMatrix& FullMatrix::operator = (const FullMatrix& m) @@ -381,7 +387,6 @@ FullMatrix::operator = (const FullMatrix& m) } - template template FullMatrix& @@ -396,7 +401,6 @@ FullMatrix::operator = (const FullMatrix& m) } - template template void FullMatrix::fill (const FullMatrix& src, @@ -412,7 +416,6 @@ void FullMatrix::fill (const FullMatrix& src, } - template void FullMatrix::add_row (const unsigned int i, const number s, @@ -425,7 +428,6 @@ void FullMatrix::add_row (const unsigned int i, } - template void FullMatrix::add_row (const unsigned int i, const number s, @@ -441,7 +443,6 @@ void FullMatrix::add_row (const unsigned int i, } - template void FullMatrix::add_col (const unsigned int i, const number s, const unsigned int j) @@ -453,7 +454,6 @@ void FullMatrix::add_col (const unsigned int i, const number s, } - template void FullMatrix::add_col (const unsigned int i, const number s, const unsigned int j, const number t, @@ -466,7 +466,6 @@ void FullMatrix::add_col (const unsigned int i, const number s, } - template void FullMatrix::swap_row (const unsigned int i, const unsigned int j) { @@ -480,7 +479,6 @@ void FullMatrix::swap_row (const unsigned int i, const unsigned int j) } - template void FullMatrix::swap_col (const unsigned int i, const unsigned int j) { @@ -494,7 +492,6 @@ void FullMatrix::swap_col (const unsigned int i, const unsigned int j) } - template void FullMatrix::diagadd (const number src) { @@ -506,7 +503,6 @@ void FullMatrix::diagadd (const number src) } - template template void FullMatrix::mmult (FullMatrix& dst, @@ -529,7 +525,6 @@ void FullMatrix::mmult (FullMatrix& dst, } - /*void FullMatrix::mmult (FullMatrix& dst, const FullMatrix& src) const { Assert (val != 0, ExcEmptyMatrix()); @@ -550,7 +545,6 @@ void FullMatrix::mmult (FullMatrix& dst, }*/ - template template void FullMatrix::Tmmult (FullMatrix& dst, const FullMatrix& src) const @@ -572,7 +566,6 @@ void FullMatrix::Tmmult (FullMatrix& dst, const FullMatrix::Tmmult(FullMatrix& dst, const FullMatrix& src) const { Assert (val != 0, ExcEmptyMatrix()); @@ -593,7 +586,6 @@ void FullMatrix::Tmmult (FullMatrix& dst, const FullMatrix template double FullMatrix::matrix_norm (const Vector &v) const @@ -623,7 +615,6 @@ double FullMatrix::matrix_norm (const Vector &v) const }; - template template double FullMatrix::matrix_scalar_product (const Vector &u, @@ -655,7 +646,6 @@ double FullMatrix::matrix_scalar_product (const Vector &u, }; - template number FullMatrix::l1_norm () const { @@ -676,7 +666,6 @@ number FullMatrix::l1_norm () const }; - template number FullMatrix::linfty_norm () const { @@ -697,7 +686,6 @@ number FullMatrix::linfty_norm () const }; - template void FullMatrix::print (ostream& s, int w, int p) const @@ -713,7 +701,6 @@ FullMatrix::print (ostream& s, int w, int p) const } - template template void @@ -836,7 +823,6 @@ FullMatrix::add (const number s,const FullMatrix& src) } - template template void @@ -959,7 +945,6 @@ FullMatrix::add_diag (const number s, const FullMatrix& src) } - template template void @@ -1086,7 +1071,6 @@ FullMatrix::Tadd (const number s, const FullMatrix& src) } - template bool FullMatrix::operator == (const FullMatrix &m) const @@ -1101,7 +1085,6 @@ FullMatrix::operator == (const FullMatrix &m) const }; - template double FullMatrix::determinant () const @@ -1131,7 +1114,6 @@ FullMatrix::determinant () const }; - template number FullMatrix::norm2 () const @@ -1145,7 +1127,6 @@ FullMatrix::norm2 () const } - template void FullMatrix::clear () { @@ -1154,7 +1135,6 @@ void FullMatrix::clear () }; - template void FullMatrix::invert (const FullMatrix &M) @@ -1311,7 +1291,6 @@ FullMatrix::invert (const FullMatrix &M) AssertThrow (false, ExcNotImplemented(dim_range)); }; }; - template @@ -1453,7 +1432,6 @@ FullMatrix::householder(Vector& src) } - template template double @@ -1470,3 +1448,6 @@ FullMatrix::least_squares(Vector& dst, Vector& src) for (unsigned int i=n() ; i @@ -314,9 +317,4 @@ PreconditionLACSolver::operator() (VECTOR& dst, } - - -/*---------------------------- precondition.h ---------------------------*/ -/* end of #ifndef __precondition_H */ #endif -/*---------------------------- precondition.h ---------------------------*/ diff --git a/deal.II/lac/include/lac/precondition_block.h b/deal.II/lac/include/lac/precondition_block.h index beca0f1f7f..5c64cf7236 100644 --- a/deal.II/lac/include/lac/precondition_block.h +++ b/deal.II/lac/include/lac/precondition_block.h @@ -1,8 +1,18 @@ -/*---------------------------- precondition_block.h ---------------------------*/ -/* $Id$ */ -#ifndef __precondition_block_H -#define __precondition_block_H -/*---------------------------- precondition_block.h ---------------------------*/ +//---------------------------- precondition_block.h --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- precondition_block.h --------------------------- +#ifndef __deal2__precondition_block_h +#define __deal2__precondition_block_h + #include #include @@ -190,7 +200,6 @@ class PreconditionBlock: public Subscriptor }; - /** * Block SOR preconditioning. * @@ -243,9 +252,5 @@ class PreconditionBlockSOR : public PreconditionBlock }; - -/*------------------------ precondition_block.h ---------------------------*/ -/* end of #ifndef __precondition_block_H */ #endif -/*------------------------ precondition_block.h ---------------------------*/ diff --git a/deal.II/lac/include/lac/precondition_block.templates.h b/deal.II/lac/include/lac/precondition_block.templates.h index 6f373177be..3084c1fb19 100644 --- a/deal.II/lac/include/lac/precondition_block.templates.h +++ b/deal.II/lac/include/lac/precondition_block.templates.h @@ -1,6 +1,17 @@ -/*----------------- precondition_block.templates.h ----------------------*/ -/* $Id$ */ -/* Ralf Hartmann, University of Heidelberg */ +//---------------------------- precondition_block.templates.h --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- precondition_block.templates.h --------------------------- +#ifndef __deal2__precondition_block_templates_h +#define __deal2__precondition_block_templates_h #include @@ -15,7 +26,6 @@ PreconditionBlock::PreconditionBlock (): A(0) {}; - template PreconditionBlock::~PreconditionBlock () { @@ -24,7 +34,6 @@ PreconditionBlock::~PreconditionBlock () } - template void PreconditionBlock::clear () { @@ -34,7 +43,6 @@ void PreconditionBlock::clear () } - template void PreconditionBlock::use_matrix( const SparseMatrix &M) @@ -43,21 +51,18 @@ void PreconditionBlock::use_matrix( } - template void PreconditionBlock::set_block_size(unsigned int bsize) { blocksize=bsize; } - template unsigned int PreconditionBlock::block_size() const { return blocksize; } - template void PreconditionBlock::invert_diagblocks() { @@ -119,7 +124,6 @@ void PreconditionBlock::invert_diagblocks() } - /*--------------------- PreconditionBlockSOR -----------------------*/ template @@ -127,12 +131,10 @@ PreconditionBlockSOR::PreconditionBlockSOR(const number ome omega(omega) {} - template PreconditionBlockSOR::~PreconditionBlockSOR(){} - template template void PreconditionBlockSOR::operator() (Vector &dst, @@ -211,7 +213,4 @@ void PreconditionBlockSOR::operator() (Vector } - - - -/*---------------------- precondition_block.templates.h ----------------*/ +#endif diff --git a/deal.II/lac/include/lac/precondition_selector.h b/deal.II/lac/include/lac/precondition_selector.h index 0b321c392c..b7e8c7cde3 100644 --- a/deal.II/lac/include/lac/precondition_selector.h +++ b/deal.II/lac/include/lac/precondition_selector.h @@ -1,9 +1,17 @@ -/*---------------------- precondition_selector.h -------------------------*/ -/* $Id$ */ -/* Ralf Hartmann, University of Heidelberg */ -#ifndef __precondition_selector_H -#define __precondition_selector_H -/*---------------------- precondition_selector.h -------------------------*/ +//---------------------------- precondition_selector.h --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- precondition_selector.h --------------------------- +#ifndef __deal2__precondition_selector_h +#define __deal2__precondition_selector_h #include @@ -116,7 +124,7 @@ class PreconditionSelector DeclException0 (ExcNoMatrixGivenToUse); - protected: +protected: /** * Stores the name of the @@ -202,8 +210,4 @@ string PreconditionSelector::get_precondition_names() } - -/*---------------------------- precondition_selector.h ---------------------------*/ -/* end of #ifndef __precondition_selector_H */ #endif -/*---------------------------- precondition_selector.h ---------------------------*/ diff --git a/deal.II/lac/include/lac/solver.h b/deal.II/lac/include/lac/solver.h index 530a8b2f5c..98a1742317 100644 --- a/deal.II/lac/include/lac/solver.h +++ b/deal.II/lac/include/lac/solver.h @@ -1,15 +1,22 @@ -/*---------------------------- solver.h ---------------------------*/ -/* $Id$ */ -#ifndef __solver_H -#define __solver_H -/*---------------------------- solver.h ---------------------------*/ - +//---------------------------- solver.h --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- solver.h --------------------------- +#ifndef __deal2__solver_h +#define __deal2__solver_h #include - /** * Base class for iterative solvers. * @@ -134,10 +141,9 @@ class Solver enum ReturnState { success=0, exceeded, breakdown }; - - - - /** + + +/** * Constructor. Assign a control * object which stores the required * precision and an object to provide @@ -181,7 +187,6 @@ SolverControl & Solver::control() const }; - template inline Solver::Solver(SolverControl &cn, VectorMemory &mem) @@ -190,7 +195,4 @@ Solver::Solver(SolverControl &cn, VectorMemory &mem) {}; -/*---------------------------- solver.h ---------------------------*/ -/* end of #ifndef __solver_H */ #endif -/*---------------------------- solver.h ---------------------------*/ diff --git a/deal.II/lac/include/lac/solver_bicgstab.h b/deal.II/lac/include/lac/solver_bicgstab.h index 097b58b144..32e15a9fbf 100644 --- a/deal.II/lac/include/lac/solver_bicgstab.h +++ b/deal.II/lac/include/lac/solver_bicgstab.h @@ -1,8 +1,18 @@ -/*---------------------------- solver_bicgstab.h ---------------------------*/ -/* $Id$ */ -#ifndef __solver_bicgstab_H -#define __solver_bicgstab_H -/*---------------------------- solver_bicgstab.h ---------------------------*/ +//---------------------------- solver_bicgstab.h --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- solver_bicgstab.h --------------------------- +#ifndef __deal2__solver_bicgstab_h +#define __deal2__solver_bicgstab_h + #include #include @@ -185,7 +195,6 @@ SolverBicgstab::start() } - template template typename Solver::ReturnState @@ -284,7 +293,4 @@ SolverBicgstab::solve(const Matrix &A, } -/*---------------------------- solver_bicgstab.h ---------------------------*/ -/* end of #ifndef __solver_bicgstab_H */ #endif -/*---------------------------- solver_bicgstab.h ---------------------------*/ diff --git a/deal.II/lac/include/lac/solver_cg.h b/deal.II/lac/include/lac/solver_cg.h index e71d502691..f046c77529 100644 --- a/deal.II/lac/include/lac/solver_cg.h +++ b/deal.II/lac/include/lac/solver_cg.h @@ -1,9 +1,17 @@ -/*---------------------------- solver_cg.h ---------------------------*/ -/* $Id$ */ -#ifndef __solver_cg_H -#define __solver_cg_H -/*---------------------------- solver_cg.h ---------------------------*/ - +//---------------------------- solver_cg.h --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- solver_cg.h --------------------------- +#ifndef __deal2__solver_cg_h +#define __deal2__solver_cg_h #include @@ -12,7 +20,6 @@ #include - /** * Preconditioned cg method. * @@ -98,10 +105,8 @@ class SolverCG : public Solver }; - - /*------------------------- Implementation ----------------------------*/ - + template SolverCG::SolverCG(SolverControl &cn, @@ -118,7 +123,6 @@ SolverCG::criterion() }; - template template typename Solver::ReturnState @@ -196,8 +200,8 @@ SolverCG::solve (const Matrix &A, it++; }; - - // Deallocate Memory + +// Deallocate Memory memory.free(Vr); memory.free(Vp); @@ -215,9 +219,4 @@ SolverCG::solve (const Matrix &A, }; - - -/*---------------------------- solver_cg.h ---------------------------*/ -/* end of #ifndef __solver_cg_H */ #endif -/*---------------------------- solver_cg.h ---------------------------*/ diff --git a/deal.II/lac/include/lac/solver_control.h b/deal.II/lac/include/lac/solver_control.h index 4e24bcd645..343463c643 100644 --- a/deal.II/lac/include/lac/solver_control.h +++ b/deal.II/lac/include/lac/solver_control.h @@ -1,8 +1,17 @@ -/*---------------------------- solver_control.h ---------------------------*/ -/* $Id$ */ -#ifndef __solver_control_H -#define __solver_control_H -/*---------------------------- solver_control.h ---------------------------*/ +//---------------------------- solver_control.h --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- solver_control.h --------------------------- +#ifndef __deal2__solver_control_h +#define __deal2__solver_control_h #include @@ -161,10 +170,6 @@ class SolverControl : public Subscriptor }; - - - - /** * Specialization of #SolverControl# which returns #success# if either * the specified tolerance is achieved or if the initial residual (or @@ -216,9 +221,9 @@ class ReductionControl : public SolverControl * criterion. */ double initial_value() const; - - protected: + +protected: /** * Desired reduction factor. */ @@ -239,9 +244,4 @@ class ReductionControl : public SolverControl }; - - -/*---------------------------- solver_control.h ---------------------------*/ -/* end of #ifndef __solver_control_H */ #endif -/*---------------------------- solver_control.h ---------------------------*/ diff --git a/deal.II/lac/include/lac/solver_gmres.h b/deal.II/lac/include/lac/solver_gmres.h index 1dbd82e1c6..d20e0bdb5f 100644 --- a/deal.II/lac/include/lac/solver_gmres.h +++ b/deal.II/lac/include/lac/solver_gmres.h @@ -1,7 +1,19 @@ -/*---------------------------- solver_pgmres.h ---------------------------*/ -/* $Id$ */ -#ifndef __solver_pgmres_H -#define __solver_pgmres_H +//---------------------------- solver_gmres.h --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- solver_gmres.h --------------------------- +#ifndef __deal2__solver_gmres_h +#define __deal2__solver_gmres_h + + /*---------------------------- solver_pgmres.h ---------------------------*/ @@ -12,7 +24,6 @@ #include - /** * Implementation of the Restarted Preconditioned Direct Generalized * Minimal Residual Method. The stopping criterion is the norm of the @@ -135,8 +146,6 @@ class SolverGMRES : public Solver }; - - /* --------------------- Inline and template functions ------------------- */ @@ -152,7 +161,6 @@ SolverGMRES::SolverGMRES (SolverControl &cn, }; - template inline void @@ -180,8 +188,6 @@ SolverGMRES::givens_rotation (Vector &h, } - - template template typename Solver::ReturnState @@ -236,7 +242,7 @@ SolverGMRES::solve (const MATRIX& A, h (n_tmp_vectors-1); - unsigned int dim = 0; +unsigned int dim = 0; SolverControl::State iteration_state = SolverControl::iterate; @@ -250,8 +256,8 @@ SolverGMRES::solve (const MATRIX& A, VECTOR &v = *tmp_vectors[0]; VECTOR &p = *tmp_vectors[n_tmp_vectors-1]; - - /////////////////////////////////// + +/////////////////////////////////// // outer iteration: loop until we // either reach convergence or the // maximum number of iterations is @@ -394,9 +400,6 @@ SolverGMRES::solve (const MATRIX& A, }; - - - template double SolverGMRES::criterion () @@ -409,8 +412,7 @@ SolverGMRES::criterion () }; - /*---------------------------- solver_pgmres.h ---------------------------*/ -/* end of #ifndef __solver_pgmres_H */ + #endif /*---------------------------- solver_pgmres.h ---------------------------*/ diff --git a/deal.II/lac/include/lac/solver_qmrs.h b/deal.II/lac/include/lac/solver_qmrs.h index 1dcda2651e..b9e7a04ca3 100644 --- a/deal.II/lac/include/lac/solver_qmrs.h +++ b/deal.II/lac/include/lac/solver_qmrs.h @@ -1,8 +1,18 @@ -/*---------------------------- solver_qmrs.h ---------------------------*/ -/* $Id$ */ -#ifndef __lac__solver_qmrs_H -#define __lac__solver_qmrs_H -/*---------------------------- solver_qmrs.h ---------------------------*/ +//---------------------------- solver_qmrs.h --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- solver_qmrs.h --------------------------- +#ifndef __deal2__solver_qmrs_h +#define __deal2__solver_qmrs_h + //TODO: Check for programming errors!!! @@ -163,10 +173,8 @@ class SolverQMRS : public Solver }; - - /*------------------------- Implementation ----------------------------*/ - + template SolverQMRS::SolverQMRS(SolverControl &cn, @@ -185,7 +193,6 @@ SolverQMRS::criterion() }; - template template typename Solver::ReturnState @@ -289,8 +296,8 @@ SolverQMRS::iterate(const Preconditioner& precondition) rho = q*v; //deallog << "rho:" << rho << endl; - - while (state == SolverControl::iterate) + +while (state == SolverControl::iterate) { step++; it++; // Step 1 @@ -345,8 +352,4 @@ SolverQMRS::iterate(const Preconditioner& precondition) } - -/*---------------------------- solver_qmrs.h ---------------------------*/ -/* end of #ifndef __solver_qmrs_H */ #endif -/*---------------------------- solver_qmrs.h ---------------------------*/ diff --git a/deal.II/lac/include/lac/solver_richardson.h b/deal.II/lac/include/lac/solver_richardson.h index c1db38f4bf..cc327c6860 100644 --- a/deal.II/lac/include/lac/solver_richardson.h +++ b/deal.II/lac/include/lac/solver_richardson.h @@ -1,17 +1,23 @@ -/*---------------------------- solver_richardson.h ---------------------------*/ -/* $Id$ */ -/* Ralf Hartmann, University of Heidelberg */ -#ifndef __solver_richardson_H -#define __solver_richardson_H -/*---------------------------- solver_richardson.h ---------------------------*/ - +//---------------------------- solver_richardson.h --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- solver_richardson.h --------------------------- +#ifndef __deal2__solver_richardson_h +#define __deal2__solver_richardson_h #include #include - /** * Implementation of the richardson iteration method. The stopping criterion * is the norm of the residual. @@ -115,8 +121,6 @@ class SolverRichardson : public Solver }; - - /*----------------- Implementation of the Richardson Method ------------------*/ @@ -186,7 +190,4 @@ SolverRichardson::set_omega(double om) } -/*------------------ solver_richardson.h ----------------------*/ -/* end of #ifndef __solver_richardson_H */ #endif -/*------------------ solver_richardson.h ----------------------*/ diff --git a/deal.II/lac/include/lac/solver_selector.h b/deal.II/lac/include/lac/solver_selector.h index c1b4c3c48f..aa47cfbfc6 100644 --- a/deal.II/lac/include/lac/solver_selector.h +++ b/deal.II/lac/include/lac/solver_selector.h @@ -1,9 +1,18 @@ -/*---------------------------- solver_selector.h ---------------------------*/ -/* $Id$ */ -/* Ralf Hartmann, University of Heidelberg */ -#ifndef __solver_selector_H -#define __solver_selector_H -/*---------------------------- solver_selector.h ---------------------------*/ +//---------------------------- solver_selector.h --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- solver_selector.h --------------------------- +#ifndef __deal2__solver_selector_h +#define __deal2__solver_selector_h + #include #include @@ -193,7 +202,6 @@ class SolverSelector }; - /* --------------------- Inline and template functions ------------------- */ @@ -207,13 +215,11 @@ SolverSelector::SolverSelector(string solver_name, {}; - template SolverSelector::~SolverSelector() {}; - template template typename Solver::ReturnState @@ -253,7 +259,6 @@ SolverSelector::solve(const Matrix &A, }; - template string SolverSelector::get_solver_names() { @@ -261,7 +266,6 @@ string SolverSelector::get_solver_names() }; - template void SolverSelector::set_data( const typename SolverGMRES::AdditionalData &data) @@ -294,8 +298,4 @@ void SolverSelector::set_data( }; - -/*---------------------------- solver_selector.h ---------------------------*/ -/* end of #ifndef __solver_selector_H */ #endif -/*---------------------------- solver_selector.h ---------------------------*/ diff --git a/deal.II/lac/include/lac/sparse_ilu.h b/deal.II/lac/include/lac/sparse_ilu.h index 51b9fac3c7..0a51693e66 100644 --- a/deal.II/lac/include/lac/sparse_ilu.h +++ b/deal.II/lac/include/lac/sparse_ilu.h @@ -1,15 +1,22 @@ -/*---------------------------- matrix_decompositions.h ---------------------------*/ -/* $Id$ */ -#ifndef __sparse_ilu_H -#define __sparse_ilu_H -/*---------------------------- sparse_ilu.h ---------------------------*/ +//---------------------------- sparse_ilu.h --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- sparse_ilu.h --------------------------- +#ifndef __deal2__sparse_ilu_h +#define __deal2__sparse_ilu_h #include - - /** * Incomplete LU decomposition of a sparse matrix into another sparse matrix. * A given matrix is decomposed into a incomplete LU factorization, where @@ -207,9 +214,4 @@ SparseILU::operator() (Vector &dst, } - - -/*---------------------------- sparse_ilu.h ---------------------------*/ -/* end of #ifndef __sparse_ilu_H */ #endif -/*---------------------------- sparse_ilu.h ---------------------------*/ diff --git a/deal.II/lac/include/lac/sparse_ilu.templates.h b/deal.II/lac/include/lac/sparse_ilu.templates.h index e3569dbdf2..d930662c08 100644 --- a/deal.II/lac/include/lac/sparse_ilu.templates.h +++ b/deal.II/lac/include/lac/sparse_ilu.templates.h @@ -1,7 +1,19 @@ -/*---------------------------- matrix_decompositions.templates.h ---------------------------*/ -/* $Id$ */ -#ifndef __matrix_decompositions_templates_H -#define __matrix_decompositions_templates_H +//---------------------------- sparse_ilu.templates.h --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- sparse_ilu.templates.h --------------------------- +#ifndef __deal2__sparse_ilu_templates_h +#define __deal2__sparse_ilu_templates_h + + /*---------------------------- matrix_decompositions.templates.h ---------------------------*/ @@ -12,20 +24,17 @@ #include - template SparseILU::SparseILU () {}; - template SparseILU::SparseILU (const SparsityPattern &sparsity) : SparseMatrix (sparsity) {}; - template void SparseILU::reinit () { @@ -33,7 +42,6 @@ void SparseILU::reinit () }; - template void SparseILU::reinit (const SparsityPattern &sparsity) { @@ -41,8 +49,6 @@ void SparseILU::reinit (const SparsityPattern &sparsity) }; - - template template void SparseILU::decompose (const SparseMatrix &matrix, @@ -53,9 +59,9 @@ void SparseILU::decompose (const SparseMatrix &matrix, Assert (matrix.m()==m(), ExcSizeMismatch(matrix.m(), m())); Assert (strengthen_diagonal>=0, ExcInvalidStrengthening (strengthen_diagonal)); - - - // first thing: copy over all elements + + +// first thing: copy over all elements // of #matrix# to the present object // // note that some elements in this @@ -104,9 +110,9 @@ void SparseILU::decompose (const SparseMatrix &matrix, *diagonal_element += strengthen_diagonal * rowsum; }; - - - // now work only on this + + +// now work only on this // matrix const SparsityPattern &sparsity = get_sparsity_pattern(); const unsigned int * const rowstart_indices = sparsity.get_rowstart_indices(); @@ -127,8 +133,8 @@ void SparseILU::decompose (const SparseMatrix &matrix, a[i,j] -= a[i,k] * a[k,j] */ - - // i := row + +// i := row for (unsigned int row=1; row::decompose (const SparseMatrix &matrix, }; - - template template void SparseILU::apply_decomposition (Vector &dst, @@ -332,9 +336,7 @@ void SparseILU::apply_decomposition (Vector &dst, }; - - /*---------------------------- matrix_decompositions.templates.h ---------------------------*/ -/* end of #ifndef __matrix_decompositions_templates_H */ + #endif /*---------------------------- matrix_decompositions.templates.h ---------------------------*/ diff --git a/deal.II/lac/include/lac/sparse_matrix.2.templates b/deal.II/lac/include/lac/sparse_matrix.2.templates index 865b835b97..0755a0dcce 100644 --- a/deal.II/lac/include/lac/sparse_matrix.2.templates +++ b/deal.II/lac/include/lac/sparse_matrix.2.templates @@ -1,4 +1,18 @@ -// $Id$ +//---------------------------- sparse_matrix.2.templates --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- sparse_matrix.2.templates --------------------------- + + + // Driver file for SparseMatrix functions with two types. // TYPEMAT and TYPE2 are defined in sparsematrix?.cc diff --git a/deal.II/lac/include/lac/sparse_matrix.h b/deal.II/lac/include/lac/sparse_matrix.h index 911b599239..3aa504e119 100644 --- a/deal.II/lac/include/lac/sparse_matrix.h +++ b/deal.II/lac/include/lac/sparse_matrix.h @@ -1,14 +1,20 @@ -/*---------------------------- sparsematrix.h ---------------------------*/ -/* $Id$ */ -#ifndef __sparsematrix_H -#define __sparsematrix_H -/*---------------------------- sparsematrix.h ---------------------------*/ +//---------------------------- sparse_matrix.h --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- sparse_matrix.h --------------------------- +#ifndef __deal2__sparse_matrix_h +#define __deal2__sparse_matrix_h -// This file was once part of the DEAL Library -// DEAL is Copyright(1995) by -// Roland Becker, Guido Kanschat, Franz-Theo Suttmeier -// Revised, modified and extended by Wolfgang Bangerth +/*---------------------------- sparsematrix.h ---------------------------*/ #include @@ -17,7 +23,6 @@ #include - /** * Sparse matrix. * @@ -63,9 +68,9 @@ class SparseMatrix : public Subscriptor * #copy_from# function. */ SparseMatrix (const SparseMatrix &); - - - /** + + +/** * Constructor. Takes the given matrix * sparsity structure to represent the * sparsity pattern of this matrix. You @@ -91,9 +96,8 @@ class SparseMatrix : public Subscriptor */ SparseMatrix& operator = (const SparseMatrix &); - - /** +/** * Reinitialize the object but keep to * the sparsity pattern previously used. * This may be necessary if you #reinit#'d @@ -645,18 +649,14 @@ class SparseMatrix : public Subscriptor somenumber *partial_norm) const; - // make all other sparse matrices +// make all other sparse matrices // friends template friend class SparseMatrix; }; - - - /*---------------------- Inline functions -----------------------------------*/ - template inline @@ -667,7 +667,6 @@ unsigned int SparseMatrix::m () const }; - template inline unsigned int SparseMatrix::n () const @@ -677,7 +676,6 @@ unsigned int SparseMatrix::n () const }; - template inline void SparseMatrix::set (const unsigned int i, @@ -694,7 +692,6 @@ void SparseMatrix::set (const unsigned int i, }; - template inline void SparseMatrix::add (const unsigned int i, const unsigned int j, @@ -709,9 +706,6 @@ void SparseMatrix::add (const unsigned int i, const unsigned int j, }; - - - template inline number SparseMatrix::operator () (const unsigned int i, @@ -724,7 +718,6 @@ number SparseMatrix::operator () (const unsigned int i, }; - template inline number SparseMatrix::diag_element (const unsigned int i) const @@ -740,7 +733,6 @@ number SparseMatrix::diag_element (const unsigned int i) const }; - template inline number & SparseMatrix::diag_element (const unsigned int i) @@ -756,7 +748,6 @@ number & SparseMatrix::diag_element (const unsigned int i) }; - template inline number @@ -770,7 +761,6 @@ SparseMatrix::raw_entry (const unsigned int row, }; - template inline number SparseMatrix::global_entry (const unsigned int j) const @@ -780,7 +770,6 @@ number SparseMatrix::global_entry (const unsigned int j) const }; - template inline number & SparseMatrix::global_entry (const unsigned int j) @@ -790,9 +779,8 @@ number & SparseMatrix::global_entry (const unsigned int j) }; - /*---------------------------- sparsematrix.h ---------------------------*/ -/* end of #ifndef __sparsematrix_H */ + #endif /*---------------------------- sparsematrix.h ---------------------------*/ diff --git a/deal.II/lac/include/lac/sparse_matrix.templates.h b/deal.II/lac/include/lac/sparse_matrix.templates.h index 55a63344b4..c9e7d1a7ef 100644 --- a/deal.II/lac/include/lac/sparse_matrix.templates.h +++ b/deal.II/lac/include/lac/sparse_matrix.templates.h @@ -1,9 +1,17 @@ -// $Id$ - -// This file was once part of the DEAL Library -// DEAL is Copyright(1995) by -// Roland Becker, Guido Kanschat, Franz-Theo Suttmeier -// Revised, modified and extended by Wolfgang Bangerth, 1998, 1999 +//---------------------------- sparse_matrix.templates.h --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- sparse_matrix.templates.h --------------------------- +#ifndef __deal2__sparse_matrix_templates_h +#define __deal2__sparse_matrix_templates_h #include @@ -24,9 +32,6 @@ #endif - - - template SparseMatrix::SparseMatrix () : cols(0), @@ -48,7 +53,6 @@ SparseMatrix::SparseMatrix (const SparseMatrix &m) : }; - template SparseMatrix& SparseMatrix::operator = (const SparseMatrix &m) @@ -61,7 +65,6 @@ SparseMatrix::operator = (const SparseMatrix &m) }; - template SparseMatrix::SparseMatrix (const SparsityPattern &c) : cols(&c), @@ -73,7 +76,6 @@ SparseMatrix::SparseMatrix (const SparsityPattern &c) : }; - template SparseMatrix::~SparseMatrix () { @@ -86,7 +88,6 @@ SparseMatrix::~SparseMatrix () }; - template void SparseMatrix::reinit () @@ -115,7 +116,6 @@ SparseMatrix::reinit () } - template void SparseMatrix::reinit (const SparsityPattern &sparsity) @@ -130,7 +130,6 @@ SparseMatrix::reinit (const SparsityPattern &sparsity) }; - template void SparseMatrix::clear () @@ -144,7 +143,6 @@ SparseMatrix::clear () }; - template bool SparseMatrix::empty () const @@ -156,7 +154,6 @@ SparseMatrix::empty () const }; - template unsigned int SparseMatrix::n_nonzero_elements () const @@ -166,7 +163,6 @@ SparseMatrix::n_nonzero_elements () const }; - template template SparseMatrix & @@ -183,7 +179,6 @@ SparseMatrix::copy_from (const SparseMatrix &matrix) }; - template template void @@ -203,7 +198,6 @@ SparseMatrix::add_scaled (const number factor, }; - template template void @@ -274,7 +268,6 @@ SparseMatrix::vmult (Vector& dst, const Vector& }; - template template void @@ -303,7 +296,6 @@ SparseMatrix::threaded_vmult (Vector &dst, }; - template template void @@ -327,7 +319,6 @@ SparseMatrix::Tvmult (Vector& dst, const Vector& } - template template void @@ -374,7 +365,6 @@ SparseMatrix::Tvmult_add (Vector& dst, const Vector template somenumber @@ -453,7 +443,6 @@ SparseMatrix::matrix_norm (const Vector& v) const }; - template template void @@ -639,7 +628,6 @@ SparseMatrix::threaded_residual (Vector &dst, }; - template template void @@ -665,7 +653,6 @@ SparseMatrix::precondition_Jacobi (Vector& dst, }; - template template void @@ -733,7 +720,6 @@ SparseMatrix::precondition_SSOR (Vector& dst, } - template template void @@ -749,7 +735,6 @@ SparseMatrix::precondition_SOR (Vector& dst, const Vector template void @@ -877,7 +862,6 @@ SparseMatrix::SSOR (Vector& dst, const number om) const } - template const SparsityPattern & SparseMatrix::get_sparsity_pattern () const @@ -887,7 +871,6 @@ SparseMatrix::get_sparsity_pattern () const }; - template void SparseMatrix::print (ostream &out) const { Assert (cols != 0, ExcMatrixNotInitialized()); @@ -901,7 +884,6 @@ void SparseMatrix::print (ostream &out) const { }; - template void SparseMatrix::print_formatted (ostream &out, const unsigned int precision, @@ -941,3 +923,4 @@ void SparseMatrix::print_formatted (ostream &out, // out.setf (0, ios::floatfield); // reset output format }; +#endif diff --git a/deal.II/lac/include/lac/sparse_vanka.h b/deal.II/lac/include/lac/sparse_vanka.h index 76b0d1ad81..328d2b43e0 100644 --- a/deal.II/lac/include/lac/sparse_vanka.h +++ b/deal.II/lac/include/lac/sparse_vanka.h @@ -1,10 +1,20 @@ -/*---------------------------- sparse_vanka.h ---------------------------*/ -/* $Id$ */ -#ifndef __sparse_vanka_H -#define __sparse_vanka_H -/* Copyright Guido Kanschat, 1999 */ -/*---------------------------- sparse_vanka.h ---------------------------*/ +//---------------------------- sparse_vanka.h --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- sparse_vanka.h --------------------------- +#ifndef __deal2__sparse_vanka_h +#define __deal2__sparse_vanka_h + +/* Copyright Guido Kanschat, 1999 */ #include @@ -310,7 +320,6 @@ class SparseVanka }; - /** * Block version of the sparse Vanka preconditioner. This class * divides the matrix into blocks and works on the diagonal blocks @@ -525,10 +534,4 @@ class SparseBlockVanka : public SparseVanka }; - - - -/*---------------------------- sparse_vanka.h ---------------------------*/ -/* end of #ifndef __sparse_vanka_H */ #endif -/*---------------------------- sparse_vanka.h ---------------------------*/ diff --git a/deal.II/lac/include/lac/sparse_vanka.templates.h b/deal.II/lac/include/lac/sparse_vanka.templates.h index fa2be95f8b..013a9e9e52 100644 --- a/deal.II/lac/include/lac/sparse_vanka.templates.h +++ b/deal.II/lac/include/lac/sparse_vanka.templates.h @@ -1,5 +1,18 @@ -// $Id$ -// Copyright Guido Kanschat, 1999 +//---------------------------- sparse_vanka.templates.h --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- sparse_vanka.templates.h --------------------------- +#ifndef __deal2__sparse_vanka_templates_h +#define __deal2__sparse_vanka_templates_h + #include #include @@ -14,7 +27,6 @@ #include - template SparseVanka::SparseVanka(const SparseMatrix &M, const vector &selected, @@ -48,7 +60,6 @@ SparseVanka::~SparseVanka() } - template void SparseVanka::compute_inverses () @@ -113,7 +124,6 @@ SparseVanka::compute_inverses () }; - template void SparseVanka::compute_inverses (const unsigned int begin, @@ -132,7 +142,6 @@ SparseVanka::compute_inverses (const unsigned int begin, }; - template void SparseVanka::compute_inverse (const unsigned int row, @@ -205,8 +214,6 @@ SparseVanka::compute_inverse (const unsigned int row, }; - - template template void @@ -221,8 +228,6 @@ SparseVanka::operator ()(Vector &dst, }; - - template template void @@ -242,7 +247,7 @@ SparseVanka::apply_preconditioner (Vector &dst, = matrix->get_sparsity_pattern(); - // store whether we shall work on +// store whether we shall work on // the whole matrix, or only on // blocks. this variable is used to // optimize access to vectors a @@ -383,8 +388,6 @@ SparseVanka::apply_preconditioner (Vector &dst, }; - - template SparseBlockVanka::SparseBlockVanka (const SparseMatrix &M, const vector &selected, @@ -402,7 +405,6 @@ SparseBlockVanka::SparseBlockVanka (const SparseMatrix &M, }; - template void SparseBlockVanka::compute_dof_masks (const SparseMatrix &M, @@ -567,8 +569,6 @@ SparseBlockVanka::compute_dof_masks (const SparseMatrix &M, }; - - template template void SparseBlockVanka::operator() (Vector &dst, @@ -608,5 +608,7 @@ void SparseBlockVanka::operator() (Vector &dst, apply_preconditioner (dst, src, &dof_masks[block]); #endif - }; -}; + } +} + +#endif diff --git a/deal.II/lac/include/lac/sparsity_pattern.h b/deal.II/lac/include/lac/sparsity_pattern.h index 992a1e48c4..29bb0bdfc1 100644 --- a/deal.II/lac/include/lac/sparsity_pattern.h +++ b/deal.II/lac/include/lac/sparsity_pattern.h @@ -1,9 +1,17 @@ -/*---------------------------- sparsity_pattern.h ---------------------------*/ -/* $Id$ */ -#ifndef __sparsity_pattern_H -#define __sparsity_pattern_H -/*---------------------------- sparsity_pattern.h ---------------------------*/ - +//---------------------------- sparsity_pattern.h --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- sparsity_pattern.h --------------------------- +#ifndef __deal2__sparsity_pattern_h +#define __deal2__sparsity_pattern_h #include @@ -13,8 +21,6 @@ #include - - /** * Structure representing the sparsity pattern of a sparse matrix. * @@ -491,9 +497,9 @@ class SparsityPattern : public Subscriptor * information! */ const unsigned int * get_column_numbers () const; - - - /** + + +/** * Exception */ DeclException1 (ExcInvalidNumber, @@ -670,17 +676,14 @@ class SparsityPattern : public Subscriptor */ bool compressed; - - template friend class SparseMatrix; -}; - +template friend class SparseMatrix; +}; /*---------------------- Inline functions -----------------------------------*/ - inline unsigned int SparsityPattern::n_rows () const @@ -689,7 +692,6 @@ SparsityPattern::n_rows () const }; - inline unsigned int SparsityPattern::n_cols () const @@ -698,7 +700,6 @@ SparsityPattern::n_cols () const }; - inline bool SparsityPattern::is_compressed () const @@ -707,7 +708,6 @@ SparsityPattern::is_compressed () const }; - inline const unsigned int * SparsityPattern::get_rowstart_indices () const @@ -716,7 +716,6 @@ SparsityPattern::get_rowstart_indices () const }; - inline const unsigned int * SparsityPattern::get_column_numbers () const @@ -725,7 +724,6 @@ SparsityPattern::get_column_numbers () const }; - inline unsigned int SparsityPattern::row_length (const unsigned int row) const @@ -735,7 +733,6 @@ SparsityPattern::row_length (const unsigned int row) const } - inline unsigned int SparsityPattern::column_number (const unsigned int row, @@ -748,7 +745,6 @@ SparsityPattern::column_number (const unsigned int row, } - inline unsigned int SparsityPattern::n_nonzero_elements () const @@ -759,8 +755,4 @@ SparsityPattern::n_nonzero_elements () const }; - -/*---------------------------- sparsity_pattern.h ---------------------------*/ -/* end of #ifndef __sparsity_pattern_H */ #endif -/*---------------------------- sparsity_pattern.h ---------------------------*/ diff --git a/deal.II/lac/include/lac/vector.h b/deal.II/lac/include/lac/vector.h index b20d240a08..b5017424a1 100644 --- a/deal.II/lac/include/lac/vector.h +++ b/deal.II/lac/include/lac/vector.h @@ -1,19 +1,23 @@ -/*---------------------------- vector.h ---------------------------*/ -/* $Id$ */ -#ifndef __vector_H -#define __vector_H -/*---------------------------- vector.h ---------------------------*/ +//---------------------------- vector.h --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- vector.h --------------------------- +#ifndef __deal2__vector_h +#define __deal2__vector_h -// This file was once part of the DEAL Library -// DEAL is Copyright(1995) by -// Roland Becker, Guido Kanschat, Franz-Theo Suttmeier -// Revised and extended by Wolfgang Bangerth #include #include - /** * Numerical Vector of data. For this class there are different * types of functions available. The first type of function mesures @@ -43,9 +47,9 @@ class Vector { typedef value_type& reference; typedef const value_type& const_reference; typedef size_t size_type; - - /** + +/** * @name 1: Basic Object-handling */ //@{ @@ -153,9 +157,9 @@ class Vector { * $l_\infty$-norm of a vector. */ Number linfty_norm () const; - - - /** + + +/** * Change the dimension of the vector to * #N#. The reserved memory for this vector * remains unchanged if possible, to make @@ -233,9 +237,9 @@ class Vector { */ const_iterator end () const; //@} - - - /** + + +/** * @name 2: Data-Access */ //@{ @@ -250,9 +254,9 @@ class Vector { */ Number& operator() (const unsigned int i); //@} - - - /** + + +/** * @name 3: Modification of vectors */ //@{ @@ -358,9 +362,9 @@ class Vector { void ratio (const Vector &a, const Vector &b); //@} - - - /** + + +/** * @name 5: Mixed stuff */ //@{ @@ -463,10 +467,6 @@ class Vector { }; - - - - /*----------------------- Inline functions ----------------------------------*/ @@ -478,7 +478,6 @@ unsigned int Vector::size () const } - template inline Vector::iterator Vector::begin () { @@ -486,7 +485,6 @@ Vector::iterator Vector::begin () { }; - template inline Vector::const_iterator Vector::begin () const { @@ -494,7 +492,6 @@ Vector::const_iterator Vector::begin () const { }; - template inline Vector::iterator Vector::end () { @@ -502,7 +499,6 @@ Vector::iterator Vector::end () { }; - template inline Vector::const_iterator Vector::end () const { @@ -510,7 +506,6 @@ Vector::const_iterator Vector::end () const { }; - template inline Number Vector::operator() (const unsigned int i) const @@ -520,7 +515,6 @@ Number Vector::operator() (const unsigned int i) const } - template inline Number& Vector::operator() (const unsigned int i) @@ -530,10 +524,4 @@ Number& Vector::operator() (const unsigned int i) } - - - -/*---------------------------- vector.h ---------------------------*/ -/* end of #ifndef __vector_H */ #endif -/*---------------------------- vector.h ---------------------------*/ diff --git a/deal.II/lac/include/lac/vector.templates.h b/deal.II/lac/include/lac/vector.templates.h index d1855941f3..5d79eb4257 100644 --- a/deal.II/lac/include/lac/vector.templates.h +++ b/deal.II/lac/include/lac/vector.templates.h @@ -1,9 +1,18 @@ -// $Id$ +//---------------------------- vector.templates.h --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- vector.templates.h --------------------------- +#ifndef __deal2__vector_templates_h +#define __deal2__vector_templates_h -// This file was once part of the DEAL Library -// DEAL is Copyright(1995) by -// Roland Becker, Guido Kanschat, Franz-Theo Suttmeier -// Revised and extended by Wolfgang Bangerth, 1998, 1999 #include #include @@ -16,7 +25,6 @@ static inline Number sqr (const Number x) { }; - template Vector::Vector () : dim(0), @@ -25,7 +33,6 @@ Vector::Vector () : {} - template Vector::Vector (const unsigned int n) : dim(0), @@ -36,7 +43,6 @@ Vector::Vector (const unsigned int n) : } - template Vector::Vector (const Vector& v) : dim(v.size()), @@ -52,7 +58,6 @@ Vector::Vector (const Vector& v) : } - // see the .h file for why this function was disabled // // template @@ -71,7 +76,6 @@ Vector::Vector (const Vector& v) : // } - template void Vector::reinit (const unsigned int n, const bool fast) { if (n==0) @@ -95,15 +99,12 @@ void Vector::reinit (const unsigned int n, const bool fast) { } - template void Vector::reinit (const Vector& v, const bool fast) { reinit (v.size(), fast); }; - - template Vector::~Vector () { @@ -111,7 +112,6 @@ Vector::~Vector () } - template void Vector::clear () { if (dim>0) @@ -119,7 +119,6 @@ void Vector::clear () { } - template bool Vector::all_zero () const { Assert (dim!=0, ExcEmptyVector()); @@ -133,7 +132,6 @@ bool Vector::all_zero () const { }; - template Number Vector::operator * (const Vector& v) const { @@ -170,7 +168,6 @@ Number Vector::operator * (const Vector& v) const } - template Number Vector::norm_sqr () const { @@ -201,7 +198,6 @@ Number Vector::norm_sqr () const }; - template Number Vector::mean_value () const { @@ -232,7 +228,6 @@ Number Vector::mean_value () const }; - template Number Vector::l1_norm () const { @@ -263,7 +258,6 @@ Number Vector::l1_norm () const }; - template Number Vector::l2_norm () const { @@ -271,7 +265,6 @@ Number Vector::l2_norm () const }; - template Number Vector::linfty_norm () const { Assert (dim!=0, ExcEmptyVector()); @@ -295,9 +288,6 @@ Number Vector::linfty_norm () const { return max (max(max0, max1), max(max2, max3)); }; - - - template @@ -310,7 +300,6 @@ Vector& Vector::operator += (const Vector& v) } - template Vector& Vector::operator -= (const Vector& v) { @@ -327,7 +316,6 @@ Vector& Vector::operator -= (const Vector& v) } - template void Vector::add (const Number v) { @@ -340,7 +328,6 @@ void Vector::add (const Number v) } - template void Vector::add (const Vector& v) { @@ -355,7 +342,6 @@ void Vector::add (const Vector& v) } - template void Vector::add (const Number a, const Vector& v) { @@ -370,7 +356,6 @@ void Vector::add (const Number a, const Vector& v) } - template void Vector::add (const Number a, const Vector& v, const Number b, const Vector& w) @@ -387,7 +372,6 @@ void Vector::add (const Number a, const Vector& v, } - template void Vector::sadd (const Number x, const Vector& v) { @@ -401,7 +385,6 @@ void Vector::sadd (const Number x, const Vector& v) } - template void Vector::sadd (const Number x, const Number a, const Vector& v) { @@ -415,7 +398,6 @@ void Vector::sadd (const Number x, const Number a, const Vector& } - template void Vector::sadd (const Number x, const Number a, const Vector& v, const Number b, const Vector& w) @@ -432,7 +414,6 @@ void Vector::sadd (const Number x, const Number a, } - template void Vector::sadd (const Number x, const Number a, const Vector& v, const Number b, @@ -453,7 +434,6 @@ void Vector::sadd (const Number x, const Number a, } - template void Vector::scale (const Number factor) { @@ -465,7 +445,6 @@ void Vector::scale (const Number factor) } - template void Vector::equ (const Number a, const Vector& u, const Number b, const Vector& v) @@ -482,7 +461,6 @@ void Vector::equ (const Number a, const Vector& u, } - template void Vector::equ (const Number a, const Vector& u) { @@ -496,7 +474,6 @@ void Vector::equ (const Number a, const Vector& u) } - template void Vector::ratio (const Vector &a, const Vector &b) { Assert (dim!=0, ExcEmptyVector()); @@ -514,7 +491,6 @@ void Vector::ratio (const Vector &a, const Vector &b) { }; - template Vector& Vector::operator = (const Number s) { @@ -524,7 +500,6 @@ Vector& Vector::operator = (const Number s) } - template Vector& Vector::operator = (const Vector& v) @@ -538,7 +513,6 @@ Vector::operator = (const Vector& v) } - template template Vector& @@ -553,7 +527,6 @@ Vector::operator = (const Vector& v) } - template void Vector::print (FILE* f, const char* format) const { @@ -565,7 +538,6 @@ void Vector::print (FILE* f, const char* format) const } - template void Vector::print (const char* format) const { @@ -577,7 +549,6 @@ void Vector::print (const char* format) const } - template void Vector::print (ostream &out, unsigned int precision, @@ -606,7 +577,6 @@ void Vector::print (ostream &out, }; - template void Vector::block_write (ostream &out) const { AssertThrow (out, ExcIO()); @@ -621,7 +591,6 @@ void Vector::block_write (ostream &out) const { }; - template void Vector::block_read (istream &in) { AssertThrow (in, ExcIO()); @@ -643,5 +612,6 @@ void Vector::block_read (istream &in) { in >> c; AssertThrow (c==']', ExcIO()); AssertThrow (in, ExcIO()); -}; +} +#endif diff --git a/deal.II/lac/include/lac/vector_memory.h b/deal.II/lac/include/lac/vector_memory.h index aab9e728c5..c0960b7ca2 100644 --- a/deal.II/lac/include/lac/vector_memory.h +++ b/deal.II/lac/include/lac/vector_memory.h @@ -1,8 +1,17 @@ -/*---------------------------- vector_memory.h ---------------------------*/ -/* $Id$ */ -#ifndef __lac__vector_memory_H -#define __lac__vector_memory_H -/*---------------------------- vector_memory.h ---------------------------*/ +//---------------------------- vector_memory.h --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- vector_memory.h --------------------------- +#ifndef __deal2__vector_memory_h +#define __deal2__vector_memory_h #include @@ -11,7 +20,6 @@ #include - /** * Memory management for vectors. This class is used by all * iterative methods to allocate space for auxilliary @@ -58,9 +66,6 @@ class VectorMemory : public Subscriptor }; - - - /** * Simple memory management. This memory class is just made for * tests. It just allocates and deletes @@ -160,7 +165,6 @@ class GrowingVectorMemory : public VectorMemory }; - /* --------------------- inline functions ---------------------- */ @@ -178,7 +182,6 @@ GrowingVectorMemory::GrowingVectorMemory(const unsigned int initial_size } - template GrowingVectorMemory::~GrowingVectorMemory() { @@ -199,7 +202,6 @@ GrowingVectorMemory::~GrowingVectorMemory() } - template Vector* GrowingVectorMemory::alloc() @@ -220,8 +222,7 @@ GrowingVectorMemory::alloc() return t.second; } - - + template void GrowingVectorMemory::free(const Vector* const v) @@ -238,8 +239,5 @@ GrowingVectorMemory::free(const Vector* const v) } -/*---------------------------- vector_memory.h ---------------------------*/ -/* end of #ifndef __vector_memory_H */ #endif -/*---------------------------- vector_memory.h ---------------------------*/ diff --git a/deal.II/lac/source/full_matrix.double.cc b/deal.II/lac/source/full_matrix.double.cc index 1818ba60d0..4af35357f1 100644 --- a/deal.II/lac/source/full_matrix.double.cc +++ b/deal.II/lac/source/full_matrix.double.cc @@ -1,14 +1,16 @@ -// $Id$ +//---------------------------- full_matrix.double.cc --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- full_matrix.double.cc --------------------------- -// Driver for FullMatrix template instantiation. - -/* Instantiation is controlled by preprocessor symbols: - * - * 1. TYPEMAT : numerical type used in the matrix - * 2. TYPEVEC : numerical type for vector entries - * 3. TYPERES : numerical type for entries in the right hand side vector - * 4. TYPEMAT2: numerical type for the second matrix - */ #include diff --git a/deal.II/lac/source/full_matrix.float.cc b/deal.II/lac/source/full_matrix.float.cc index 1871cb4d52..ec174e7f26 100644 --- a/deal.II/lac/source/full_matrix.float.cc +++ b/deal.II/lac/source/full_matrix.float.cc @@ -1,14 +1,16 @@ -// $Id$ +//---------------------------- full_matrix.float.cc --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- full_matrix.float.cc --------------------------- -// Driver for FullMatrix template instantiation. - -/* Instantiation is controlled by preprocessor symbols: - * - * 1. TYPEMAT : numerical type used in the matrix - * 2. TYPEVEC : numerical type for vector entries - * 3. TYPERES : numerical type for entries in the right hand side vector - * 4. TYPEMAT2: numerical type for the second matrix - */ #include diff --git a/deal.II/lac/source/precondition_block.cc b/deal.II/lac/source/precondition_block.cc index 528dd90c02..823b11b638 100644 --- a/deal.II/lac/source/precondition_block.cc +++ b/deal.II/lac/source/precondition_block.cc @@ -1,14 +1,20 @@ -/*---------------------------- precondition_block.cc ---------------------------*/ -/* $Id$ */ -/* Ralf Hartmann, University of Heidelberg */ - +//---------------------------- precondition_block.cc --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- precondition_block.cc --------------------------- #include - - // explicit instantiations for "float" PreconditionBlock template class PreconditionBlock; @@ -40,7 +46,6 @@ template void PreconditionBlockSOR::operator() ( // higher precision than the matrix itself - // explicit instantiations for "double" PreconditionBlockSOR template class PreconditionBlockSOR; @@ -58,8 +63,3 @@ template void PreconditionBlockSOR::operator() ( Vector &, const Vector &) const; - - - - -/*---------------------------- precondition_block.cc ---------------------------*/ diff --git a/deal.II/lac/source/solver_control.cc b/deal.II/lac/source/solver_control.cc index 1ef8150cba..d2577d4042 100644 --- a/deal.II/lac/source/solver_control.cc +++ b/deal.II/lac/source/solver_control.cc @@ -1,4 +1,16 @@ -// $Id$ +//---------------------------- solver_control.cc --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- solver_control.cc --------------------------- + #include #include @@ -39,9 +51,9 @@ SolverControl::check (const unsigned int step, { deallog << "Starting value " << check_value << endl; } - - if (step>=maxsteps) + +if (step>=maxsteps) { if (log_result) deallog << "Failure step " << step @@ -59,7 +71,6 @@ SolverControl::check (const unsigned int step, }; - double SolverControl::last_value() const { @@ -67,7 +78,6 @@ SolverControl::last_value() const }; - unsigned int SolverControl::last_step() const { @@ -75,12 +85,9 @@ SolverControl::last_step() const }; - - /*----------------------- ReductionControl ---------------------------------*/ - ReductionControl::ReductionControl(const unsigned int n, const double tol, const double red, @@ -100,7 +107,6 @@ double ReductionControl::initial_value() const { return initial_val; }; - SolverControl::State diff --git a/deal.II/lac/source/sparse_ilu.cc b/deal.II/lac/source/sparse_ilu.cc index 7d48252d6b..3aa33b6997 100644 --- a/deal.II/lac/source/sparse_ilu.cc +++ b/deal.II/lac/source/sparse_ilu.cc @@ -1,4 +1,16 @@ -/* $Id$ */ +//---------------------------- sparse_ilu.cc --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- sparse_ilu.cc --------------------------- + #include diff --git a/deal.II/lac/source/sparse_matrix.double.cc b/deal.II/lac/source/sparse_matrix.double.cc index 5768bb4f37..69ca4421c0 100644 --- a/deal.II/lac/source/sparse_matrix.double.cc +++ b/deal.II/lac/source/sparse_matrix.double.cc @@ -1,13 +1,16 @@ -// $Id$ +//---------------------------- sparse_matrix.double.cc --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- sparse_matrix.double.cc --------------------------- -// SparseMatrix template instantiation - - -/* Instantiation is controlled by preprocessor symbols: - * - * 1. TYPEMAT : numerical type used in the matrix - * 2. TYPE2 : numerical type for function arguments - */ #include #include diff --git a/deal.II/lac/source/sparse_matrix.float.cc b/deal.II/lac/source/sparse_matrix.float.cc index 7a8a327aeb..b239526912 100644 --- a/deal.II/lac/source/sparse_matrix.float.cc +++ b/deal.II/lac/source/sparse_matrix.float.cc @@ -1,13 +1,16 @@ -// $Id$ +//---------------------------- sparse_matrix.float.cc --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- sparse_matrix.float.cc --------------------------- -// SparseMatrix template instantiation - - -/* Instantiation is controlled by preprocessor symbols: - * - * 1. TYPEMAT : numerical type used in the matrix - * 2. TYPE2 : numerical type for function arguments - */ #include #include diff --git a/deal.II/lac/source/sparse_matrix.long_double.cc b/deal.II/lac/source/sparse_matrix.long_double.cc index 62f326ca38..50a8cadfb3 100644 --- a/deal.II/lac/source/sparse_matrix.long_double.cc +++ b/deal.II/lac/source/sparse_matrix.long_double.cc @@ -1,13 +1,16 @@ -// $Id$ +//---------------------------- sparse_matrix.long_double.cc --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- sparse_matrix.long_double.cc --------------------------- -// SparseMatrix template instantiation - - -/* Instantiation is controlled by preprocessor symbols: - * - * 1. TYPEMAT : numerical type used in the matrix - * 2. TYPE2 : numerical type for function arguments - */ #include #include diff --git a/deal.II/lac/source/sparse_vanka.cc b/deal.II/lac/source/sparse_vanka.cc index 687577c6f1..b23b455b4d 100644 --- a/deal.II/lac/source/sparse_vanka.cc +++ b/deal.II/lac/source/sparse_vanka.cc @@ -1,4 +1,16 @@ -/* $Id$ */ +//---------------------------- sparse_vanka.cc --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- sparse_vanka.cc --------------------------- + #include diff --git a/deal.II/lac/source/sparsity_pattern.cc b/deal.II/lac/source/sparsity_pattern.cc index 6c6bf1689f..e010645ef5 100644 --- a/deal.II/lac/source/sparsity_pattern.cc +++ b/deal.II/lac/source/sparsity_pattern.cc @@ -1,9 +1,15 @@ -// $Id$ - -// This file was once part of the DEAL Library -// DEAL is Copyright(1995) by -// Roland Becker, Guido Kanschat, Franz-Theo Suttmeier -// Revised, modified and extended by Wolfgang Bangerth, 1998, 1999 +//---------------------------- sparsity_pattern.cc --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- sparsity_pattern.cc --------------------------- #include @@ -25,7 +31,6 @@ SparsityPattern::SparsityPattern () : }; - SparsityPattern::SparsityPattern (const SparsityPattern &s) : Subscriptor(), max_dim(0), @@ -42,7 +47,6 @@ SparsityPattern::SparsityPattern (const SparsityPattern &s) : }; - SparsityPattern::SparsityPattern (const unsigned int m, const unsigned int n, const unsigned int max_per_row) @@ -55,7 +59,6 @@ SparsityPattern::SparsityPattern (const unsigned int m, }; - SparsityPattern::SparsityPattern (const unsigned int m, const unsigned int n, const vector &row_lengths) @@ -68,7 +71,6 @@ SparsityPattern::SparsityPattern (const unsigned int m, }; - SparsityPattern::SparsityPattern (const unsigned int n, const unsigned int max_per_row) : max_dim(0), @@ -80,7 +82,6 @@ SparsityPattern::SparsityPattern (const unsigned int n, }; - SparsityPattern::SparsityPattern (const unsigned int m, const vector &row_lengths) : max_dim(0), @@ -92,7 +93,6 @@ SparsityPattern::SparsityPattern (const unsigned int m, }; - SparsityPattern::SparsityPattern (const SparsityPattern &original, const unsigned int max_per_row, const unsigned int extra_off_diagonals) @@ -176,7 +176,6 @@ SparsityPattern::SparsityPattern (const SparsityPattern &original, }; - SparsityPattern::~SparsityPattern () { if (rowstart != 0) delete[] rowstart; @@ -184,7 +183,6 @@ SparsityPattern::~SparsityPattern () } - SparsityPattern & SparsityPattern::operator = (const SparsityPattern &s) { @@ -202,8 +200,6 @@ SparsityPattern::operator = (const SparsityPattern &s) }; - - void SparsityPattern::reinit (const unsigned int m, const unsigned int n, @@ -216,7 +212,6 @@ SparsityPattern::reinit (const unsigned int m, }; - void SparsityPattern::reinit (const unsigned int m, const unsigned int n, @@ -256,7 +251,7 @@ SparsityPattern::reinit (const unsigned int m, *max_element(row_lengths.begin(), row_lengths.end())); - // allocate memory for the rowstart +// allocate memory for the rowstart // values, if necessary if (rows > max_dim) { @@ -320,8 +315,8 @@ SparsityPattern::compress () // now allocate the respective memory unsigned int *new_colnums = new unsigned int[nonzero_elements]; - - // reserve temporary storage to + +// reserve temporary storage to // store the entries of one row vector tmp_entries (max_row_length); @@ -403,7 +398,6 @@ SparsityPattern::compress () }; - bool SparsityPattern::empty () const { // let's try to be on the safe side of @@ -429,7 +423,6 @@ SparsityPattern::empty () const { }; - unsigned int SparsityPattern::max_entries_per_row () const { @@ -451,7 +444,6 @@ SparsityPattern::max_entries_per_row () const }; - unsigned int SparsityPattern::operator () (const unsigned int i, const unsigned int j) const @@ -496,7 +488,6 @@ SparsityPattern::operator () (const unsigned int i, } - void SparsityPattern::add (const unsigned int i, const unsigned int j) @@ -526,7 +517,6 @@ SparsityPattern::add (const unsigned int i, } - void SparsityPattern::print_gnuplot (ostream &out) const { @@ -540,7 +530,6 @@ SparsityPattern::print_gnuplot (ostream &out) const } - unsigned int SparsityPattern::bandwidth () const { diff --git a/deal.II/lac/source/vector.cc b/deal.II/lac/source/vector.cc index ce8f4baeb5..79bc6a33bb 100644 --- a/deal.II/lac/source/vector.cc +++ b/deal.II/lac/source/vector.cc @@ -1,4 +1,16 @@ -// $Id$ +//---------------------------- vector.cc --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- vector.cc --------------------------- + #include diff --git a/deal.II/lac/source/vector.long_double.cc b/deal.II/lac/source/vector.long_double.cc index 2fc8e16f28..7e49c8ce26 100644 --- a/deal.II/lac/source/vector.long_double.cc +++ b/deal.II/lac/source/vector.long_double.cc @@ -1,4 +1,16 @@ -// $Id$ +//---------------------------- vector.long_double.cc --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- vector.long_double.cc --------------------------- + #include -- 2.39.5