-/*---------------------------- convergence_table.h ---------------------------*/
-/* $Id$ */
-#ifndef __convergence_table_H
-#define __convergence_table_H
-/*---------------------------- convergence_table.h ---------------------------*/
+//---------------------------- convergence_table.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.
+//
+//---------------------------- convergence_table.h ---------------------------
+#ifndef __deal2__convergence_table_h
+#define __deal2__convergence_table_h
#include <base/table_handler.h>
const string &reference_column_key,
const RateMode rate_mode);
-
- /**
+
+/**
* Evaluates the convergence rates of the
* data column #data_column_key#
* due to the #RateMode#.
<< "Rate column <" << arg1 << "> does already exist.");
};
-
-
-
-/*---------------------------- convergence_table.h ---------------------------*/
-/* end of #ifndef __convergence_table_H */
#endif
-/*---------------------------- convergence_table.h ---------------------------*/
-/*---------------------------- data_out_base.h ---------------------------*/
-/* $Id$ */
-#ifndef __data_out_base_H
-#define __data_out_base_H
-/*---------------------------- data_out_base.h ---------------------------*/
+//---------------------------- data_out_base.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.
+//
+//---------------------------- data_out_base.h ---------------------------
+#ifndef __deal2__data_out_base_h
+#define __deal2__data_out_base_h
#include <base/forward_declarations.h>
#include <string>
-
-
-
-
/**
* This is a base class for output of data on meshes of very general
* form. It basically only provides a set of functions for several output
};
- /**
+/**
* Flags describing the details of
* output in UCD format.
*/
void parse_parameters (ParameterHandler &prm);
};
-
- /**
+
+/**
* Flags describing the details of
* output in encapsulated postscript
* format.
ColorFunction color_function;
- /**
+/**
* Default colorization function. This
* one does what one usually wants:
* It shifts colors from black (lowest
const GmvFlags &flags,
ostream &out);
-
- /**
+
+/**
* Exception
*/
DeclException2 (ExcUnexpectedNumberOfDatasets,
};
-
-
-
-
/**
* This class is the interface to the #DataOutBase# class, as already its name
*/
void set_flags (const GmvFlags &gmv_flags);
-
- /**
+
+/**
* Provide a function which tells us which
* suffix with a given output format
* usually has. At present the following
};
-
-
-/*---------------------------- data_out_base.h ---------------------------*/
-/* end of #ifndef __data_out_base_H */
#endif
-/*---------------------------- data_out_base.h ---------------------------*/
-/*---------------------------- exceptions.h ---------------------------*/
-/* $Id$ */
-#ifndef __exceptions_H
-#define __exceptions_H
-/*---------------------------- exceptions.h ---------------------------*/
+//---------------------------- exceptions.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.
+//
+//---------------------------- exceptions.h ---------------------------
+#ifndef __deal2__exceptions_h
+#define __deal2__exceptions_h
#include <iostream>
*/
virtual void PrintInfo (ostream &out) const;
-
- /**
+
+/**
* Function derived from the base class
* which allows to pass information like
* the line and name of the file where the
};
-
/**
* This routine does the main work for the
* exception generation mechanism used in the
};
-
/**
* This routine does the main work for the
* exception generation mechanism used in the
};
-
-
#ifdef DEBUG ////////////////////////////////////////
/**
#endif ////////////////////////////////////////
-
/**
* This is the main routine in the exception mechanism for run-time mode
* error checking. See the
__PRETTY_FUNCTION__, #cond, #exc, exc);\
}
-
-
/**
* See the #ExceptionBase# class for a detailed description.
using namespace StandardExceptions;
-
-/*---------------------------- exceptions.h ---------------------------*/
-/* end of #ifndef __exceptions_H */
#endif
-/*---------------------------- exceptions.h ---------------------------*/
-/*---------------------------- function.h ---------------------------*/
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
-#ifndef __function_H
-#define __function_H
-/*---------------------------- function.h ---------------------------*/
+//---------------------------- function.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.
+//
+//---------------------------- function.h ---------------------------
+#ifndef __deal2__function_h
+#define __deal2__function_h
#include <base/forward_declarations.h>
#include <vector>
-
/**
* This class is a model for a general function. It serves the purpose
* of representing scalar and vector valued functions. To this end, we
};
-
-
/**
* Provide a function which always returns zero. Obviously, also the
* derivates of this function are zero. Also, it returns zero on all
};
-
-
-
/**
* Provide a function which always returns a constant value, which is
* delivered upon construction. Obviously, the derivates of this
};
-
-
-/*---------------------------- function.h ---------------------------*/
-/* end of #ifndef __function_H */
#endif
-/*---------------------------- function.h ---------------------------*/
-/*---------------------------- function_lib.h ---------------------------*/
-/* $Id$ */
-/* Copyright Guido Kanschat, University of Minnesota, 1999 */
-#ifndef __function_lib_H
-#define __function_lib_H
-/*---------------------------- function_lib.h ---------------------------*/
+//---------------------------- function_lib.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.
+//
+//---------------------------- function_lib.h ---------------------------
+#ifndef __deal2__function_lib_h
+#define __deal2__function_lib_h
#include <base/function.h>
};
-
-/*---------------------------- function_lib.h ---------------------------*/
-/* end of #ifndef __function_lib_H */
#endif
-/*---------------------------- function_lib.h ---------------------------*/
-/*---------------------------- functiontime.h ---------------------------*/
-/* $Id$ */
-/* Copyright W. Bangerth, Guido Kanschat
- * University of Heidelberg, 1998, 1999 */
-#ifndef __functiontime_H
-#define __functiontime_H
-/*---------------------------- functiontime.h ---------------------------*/
+//---------------------------- function_time.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.
+//
+//---------------------------- function_time.h ---------------------------
+#ifndef __deal2__function_time_h
+#define __deal2__function_time_h
#include <base/exceptions.h>
return time;
};
-/*---------------------------- functiontime.h ---------------------------*/
-/* end of #ifndef __functiontime_H */
#endif
-/*---------------------------- functiontime.h ---------------------------*/
+
-// $Id$
+//---------------------------- job_identifier.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.
+//
+//---------------------------- job_identifier.h ---------------------------
+#ifndef __deal2__job_identifier_h
+#define __deal2__job_identifier_h
-#ifndef __jobidentifier_H
-#define __jobidentifier_H
#include <string>
-/*---------------------------- logstream.h ---------------------------*/
-/* $Id$ */
-#ifndef __logstream_H
-#define __logstream_H
-/*---------------------------- logstream.h ---------------------------*/
+//---------------------------- logstream.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.
+//
+//---------------------------- logstream.h ---------------------------
+#ifndef __deal2__logstream_h
+#define __deal2__logstream_h
#include <base/exceptions.h>
#include <iostream>
-
-
/**
* A class that simplifies the process of execution logging. It does so by
* providing
};
-
-
/* ----------------------------- Inline functions and templates ---------------- */
}
-
-
/**
* Replacement of #endl# for #LogStream#.
*
extern LogStream deallog;
-
-
-/*---------------------------- logstream.h ---------------------------*/
-/* end of #ifndef __logstream_H */
#endif
-/*---------------------------- logstream.h ---------------------------*/
-/********************** parameter-handler.h ****************************/
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
-#ifndef __parameter_handler_H
-#define __parameter_handler_H
-/********************** parameter-handler.h ****************************/
+//---------------------------- parameter_handler.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.
+//
+//---------------------------- parameter_handler.h ---------------------------
+#ifndef __deal2__parameter_handler_h
+#define __deal2__parameter_handler_h
// public classes; to be declared below
class ostream;
-
/**
* List of possible output formats.
*/
};
-
/**
* Declare some regexps which
* may be used to define patterns.
};
- /**
+/**
* This class is much like the #Selection#
* class, but it allows the input to be
* a comma-separated list of values which
};
-
-
-
/**
* The #ParameterHandler# class provides a standard interface to an input file
* which provides at run-time for program parameters such as time step sizes,
void clear ();
- /**
+/**
* Declare a new entry with name #entry#,
* default and for which
* any input has to match the #pattern#
void print_parameters_section (ostream &out,
const OutputStyle Style,
const unsigned int indent_level);
-
-
- /**
+
+/**
* Exception
*/
DeclException1 (ExcEntryAlreadyExists,
friend class MultipleParameterLoop;
};
-
-
-
/**
* The class #MultipleParameterLoop# offers an easy possibility to test several
return status;
}
-/********************** parameter-handler.h ****************************/
-/* end of #ifndef __parameter_handler_H */
+
#endif
-/********************** parameter-handler.h ****************************/
+
-/*---------------------------- point.h ---------------------------*/
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
-#ifndef __point_H
-#define __point_H
-/*---------------------------- point.h ---------------------------*/
+//---------------------------- point.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.
+//
+//---------------------------- point.h ---------------------------
+#ifndef __deal2__point_h
+#define __deal2__point_h
#include <base/exceptions.h>
double square () const;
- /**
+/**
* Exception
*/
DeclException1 (ExcDimTooSmall,
};
-
-
-
-
-
/*------------------------------- Inline functions: Point ---------------------------*/
-
template <int dim>
inline
Point<dim>::Point (const bool initialize) :
Tensor<1,dim>(t) {};
-
template <>
inline
Point<1>::Point (const double x) {
};
-
template <>
inline
Point<1>::Point (const double, const double) {
};
-
template <>
inline
Point<1>::Point (const double, const double, const double) {
};
-
template <>
inline
Point<2>::Point (const double x, const double y) {
};
-
template <>
inline
Point<2>::Point (const double, const double, const double) {
};
-
template <>
inline
Point<3>::Point (const double, const double) {
};
-
template <>
inline
Point<3>::Point (const double x, const double y, const double z) {
};
-
template <>
inline
Point<4>::Point (const double, const double) {
};
-
template <>
inline
Point<4>::Point (const double, const double, const double) {
};
-
template <int dim>
inline
double Point<dim>::operator () (const unsigned int index) const {
};
-
template <int dim>
inline
double & Point<dim>::operator () (const unsigned int index) {
};
-
template <int dim>
inline
Point<dim> Point<dim>::operator + (const Point<dim> &p) const {
};
-
template <int dim>
inline
Point<dim> Point<dim>::operator - (const Point<dim> &p) const {
};
-
template <int dim>
inline
Point<dim> Point<dim>::operator * (const double factor) const {
};
-
template <int dim>
inline
double Point<dim>::operator * (const Point<dim> &p) const {
};
-
template <int dim>
inline
Point<dim> operator * (const double factor, const Point<dim> &p) {
};
-
template <int dim>
inline
Point<dim> Point<dim>::operator / (const double factor) const {
};
-
template <int dim>
inline
double Point<dim>::square () const {
};
-
-
-
-/*---------------------------- point.h ---------------------------*/
-/* end of #ifndef __point_H */
#endif
-/*---------------------------- point.h ---------------------------*/
-/*---------------------------- quadrature.h ---------------------------*/
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
-#ifndef __quadrature_H
-#define __quadrature_H
-/*---------------------------- quadrature.h ---------------------------*/
+//---------------------------- quadrature.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.
+//
+//---------------------------- quadrature.h ---------------------------
+#ifndef __deal2__quadrature_h
+#define __deal2__quadrature_h
#include <base/point.h>
#include <vector>
-
/**
* Base class for quadrature formulae in arbitrary dimensions. This class
* stores quadrature points and weights on the unit line [0,1], unit
};
-
/**
* Quadrature formula constructed by iteration of another quadrature formula in
* each direction. In more than one space dimension, the resulting quadrature
};
-
-
/**
* This class is a helper class to facilitate the usage of quadrature formulae
* on faces or subfaces of cells. It computes the locations of quadrature
};
-
-
-
-/*---------------------------- quadrature.h ---------------------------*/
-/* end of #ifndef __quadrature_H */
#endif
-/*---------------------------- quadrature.h ---------------------------*/
-/*---------------------------- quadrature_lib.h ---------------------------*/
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
-#ifndef __quadrature_lib_H
-#define __quadrature_lib_H
-/*---------------------------- quadrature_lib.h ---------------------------*/
+//---------------------------- quadrature_lib.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.
+//
+//---------------------------- quadrature_lib.h ---------------------------
+#ifndef __deal2__quadrature_lib_h
+#define __deal2__quadrature_lib_h
#include <base/quadrature.h>
};
-
/**
* 3-Point-Gauss quadrature formula, exact for polynomials of degree 5.
*
};
-
/**
* 4-Point-Gauss quadrature formula, exact for polynomials of degree 7.
*
};
-
-
/**
* 5-Point-Gauss quadrature formula, exact for polynomials of degree 9.
*
};
-
/**
* 6-Point-Gauss quadrature formula, exact for polynomials of degree 11.
* I have not found explicite
};
-
/**
* 7-Point-Gauss quadrature formula, exact for polynomials of degree 13.
* I have not found explicite
};
-
/**
* 8-Point-Gauss quadrature formula, exact for polynomials of degree 15.
* I have not found explicite
};
-
-
-
/**
* Midpoint quadrature rule, exact for linear polynomials.
*/
};
-
/**
* Simpson quadrature rule, exact for polynomials of degree 3.
*/
};
-
/**
* Trapezoidal quadrature rule, exact for linear polynomials.
*/
};
-
-/*---------------------------- quadrature_lib.h ---------------------------*/
-/* end of #ifndef __quadrature_lib_H */
#endif
-/*---------------------------- quadrature_lib.h ---------------------------*/
-/*---------------------------- smartpointer.h ---------------------------*/
-/* $Id$ */
-#ifndef __smartpointer_H
-#define __smartpointer_H
-/*---------------------------- smartpointer.h ---------------------------*/
+//---------------------------- smartpointer.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.
+//
+//---------------------------- smartpointer.h ---------------------------
+#ifndef __deal2__smartpointer_h
+#define __deal2__smartpointer_h
+
#ifndef __subscriptor_H
#include <base/subscriptor.h>
*/
SmartPointer (T *t);
-
- /**
+/**
* Destructor, removing the subscription.
*/
~SmartPointer();
};
-
-
-
/* --------------------------- inline Template functions ------------------------------*/
{};
-
template <typename T>
SmartPointer<T>::SmartPointer (T *t) :
t (t)
};
-
template <typename T>
SmartPointer<T>::SmartPointer (const SmartPointer<T> &tt) :
t (tt.t)
};
-
template <typename T>
SmartPointer<T>::~SmartPointer ()
{
};
-
template <typename T>
SmartPointer<T> & SmartPointer<T>::operator = (T *tt)
{
};
-
template <typename T>
SmartPointer<T> & SmartPointer<T>::operator = (const SmartPointer<T>& tt)
{
};
-
template <typename T>
inline
SmartPointer<T>::operator T* () const
};
-
template <typename T>
inline
T & SmartPointer<T>::operator * () const
};
-
template <typename T>
inline
T * SmartPointer<T>::operator -> () const
};
-
-
-
-/*---------------------------- smartpointer.h ---------------------------*/
-/* end of #ifndef __smartpointer_H */
#endif
-/*---------------------------- smartpointer.h ---------------------------*/
-/*---------------------------- subscriptor.h ---------------------------*/
-/* $Id$ */
-#ifndef __subscriptor_H
-#define __subscriptor_H
-/*---------------------------- subscriptor.h ---------------------------*/
+//---------------------------- subscriptor.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.
+//
+//---------------------------- subscriptor.h ---------------------------
+#ifndef __deal2__subscriptor_h
+#define __deal2__subscriptor_h
#ifndef __exceptions_H
* when #unsubscribe# is called.
*/
DeclException0(ExcNotUsed);
-
- private:
+
+private:
/**
* Store the number of objects which
* subscribed to this object. Initialally,
};
-
-
-
-/*---------------------------- subscriptor.h ---------------------------*/
-/* end of #ifndef __subscriptor_H */
#endif
-/*---------------------------- subscriptor.h ---------------------------*/
-/*---------------------------- table_handler.h ---------------------------*/
-/* $Id$ */
-#ifndef __table_handler_H
-#define __table_handler_H
-/*---------------------------- table_handler.h ---------------------------*/
-
+//---------------------------- table_handler.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.
+//
+//---------------------------- table_handler.h ---------------------------
+#ifndef __deal2__table_handler_h
+#define __deal2__table_handler_h
#include <base/exceptions.h>
#include <fstream>
-
/**
* Abstract base class for the #TableEntry# class. See there.
* This class is not to be used by the user.
};
-
-
/**
* The #TableHandler# stores #TableEntries# of arbitrary value type and
* writes the table as text or in tex format to an output stream. The value
};
-
-
-
-/*---------------------------- table_handler.h ---------------------------*/
-/* end of #ifndef __table_handler_H */
#endif
-/*---------------------------- table_handler.h ---------------------------*/
-/*---------------------------- tensor.h ---------------------------*/
-/* $Id$ */
-#ifndef __tensor_H
-#define __tensor_H
-/*---------------------------- tensor.h ---------------------------*/
+//---------------------------- tensor.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.
+//
+//---------------------------- tensor.h ---------------------------
+#ifndef __deal2__tensor_h
+#define __deal2__tensor_h
#include <base/tensor_base.h>
* index of the tensor marches fastest.
*/
void unroll(Vector<double> & result) const;
-
- /**
+
+/**
* Reset all values to zero.
*/
void clear ();
};
-
-
/*--------------------------- Inline functions -----------------------------*/
// in the following, declarations of operators look rather weird because they are
// split over several lines. this is necessary, however, because otherwise doc++
};
-
template <int rank_, int dim>
inline
Tensor<rank_,dim>::Tensor (const array_type &initializer)
subtensor[i] = Tensor<rank_-1,dim>(initializer[i]);
};
-
-
template <int rank_, int dim>
inline
};
-
template <int rank_, int dim>
inline
const Tensor<rank_-1,dim> &
};
-
template <int rank_, int dim>
inline
Tensor<rank_,dim> &
};
-
template <int rank_, int dim>
inline
bool
};
-
template <int rank_, int dim>
inline
bool
};
-
template <int rank_, int dim>
inline
Tensor<rank_,dim> &
};
-
template <int rank_, int dim>
inline
Tensor<rank_,dim> &
};
-
template <int rank_, int dim>
inline
Tensor<rank_,dim> &
};
-
template <int rank_, int dim>
inline
Tensor<rank_,dim> &
};
-
template <int rank_, int dim>
inline
Tensor<rank_,dim>
};
-
template <int rank_, int dim>
inline
Tensor<rank_,dim>
};
-
template <int rank_, int dim>
inline
void Tensor<rank_,dim>::clear ()
};
-
-
-
/* ----------------- Non-member functions operating on tensors. ------------ */
-
/* Exception class. This is certainly not the best possible place for its
declaration, but at present, local classes to any of Tensor<> can't
be properly accessed (haven't investigated why). If anyone has a better
<< "Invalid tensor index " << arg1);
-
template <int dim>
inline
void contract (Tensor<1,dim> &dest,
};
-
template <int dim>
inline
void contract (Tensor<2,dim> &dest,
};
-
template <int dim>
inline
void contract (Tensor<2,dim> &dest,
};
-
template <int dim>
inline
void contract (Tensor<2,dim> &dest,
};
-
template <int dim>
inline
void contract (Tensor<3,dim> &dest,
};
-
template <int dim>
inline
void contract (Tensor<3,dim> &dest,
};
-
template <int dim>
inline
void contract (Tensor<4,dim> &dest,
};
-
template <int rank>
inline
double determinant (const Tensor<rank,1> &t) {
};
-
-
inline
double determinant (const Tensor<2,2> &t) {
return ((t[0][0] * t[1][1]) -
};
-
inline
double determinant (const Tensor<2,3> &t) {
// get this using Maple:
-t[2][0]*t[0][2]*t[1][1] );
};
-
-
-
-
-/*---------------------------- tensor.h ---------------------------*/
-/* end of #ifndef __tensor_H */
#endif
-/*---------------------------- tensor.h ---------------------------*/
-/*---------------------------- tensor_base.h ---------------------------*/
-/* $Id$ */
-#ifndef __tensor_base_H
-#define __tensor_base_H
-/*---------------------------- tensor_base.h ---------------------------*/
+//---------------------------- tensor_base.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.
+//
+//---------------------------- tensor_base.h ---------------------------
+#ifndef __deal2__tensor_base_h
+#define __deal2__tensor_base_h
// single this file out from tensor.h, since we want to derive Point<dim>
template <typename number> class Vector;
-
// general template; specialized for rank==1; the general template is in
// tensor.h
template <int rank, int dim> class Tensor;
<< "Given dimensions must be >= 1, but was " << arg1);
- /**
+/**
* Prints the values of this point in the
* form #x1 x2 x3 etc#.
*/
ostream & operator << (ostream &out, const Tensor<1,dim> &p);
-
-
-
-
/*------------------------------- Inline functions: Tensor ---------------------------*/
// in the following, declarations of operators look rather weird because they are
// split over several lines. this is necessary, however, because otherwise doc++
// gets really confused about this all... :-(
-
template <int dim>
inline
Tensor<1,dim>::Tensor (const bool initialize)
};
-
template <int dim>
inline
Tensor<1,dim>::Tensor (const array_type &initializer)
};
-
template <int dim>
inline
Tensor<1,dim>::Tensor (const Tensor<1,dim> &p)
};
-
template <int dim>
inline
double Tensor<1,dim>::operator [] (const unsigned int index) const
};
-
template <int dim>
inline
double & Tensor<1,dim>::operator [] (const unsigned int index)
};
-
template <int dim>
inline
Tensor<1,dim> & Tensor<1,dim>::operator = (const Tensor<1,dim> &p)
};
-
template <int dim>
inline
bool Tensor<1,dim>::operator == (const Tensor<1,dim> &p) const
};
-
template <int dim>
inline
bool Tensor<1,dim>::operator != (const Tensor<1,dim> &p) const
};
-
template <int dim>
inline
Tensor<1,dim> & Tensor<1,dim>::operator += (const Tensor<1,dim> &p)
};
-
template <int dim>
inline
Tensor<1,dim> & Tensor<1,dim>::operator -= (const Tensor<1,dim> &p)
};
-
template <int dim>
inline
Tensor<1,dim> & Tensor<1,dim>::operator *= (const double &s)
};
-
template <int dim>
inline
Tensor<1,dim> & Tensor<1,dim>::operator /= (const double &s)
};
-
template <int dim>
inline
double Tensor<1,dim>::operator * (const Tensor<1,dim> &p) const
};
-
template <int dim>
inline
Tensor<1,dim> Tensor<1,dim>::operator + (const Tensor<1,dim> &p) const
};
-
template <int dim>
inline
Tensor<1,dim> Tensor<1,dim>::operator - (const Tensor<1,dim> &p) const
};
-
template <int dim>
inline
void Tensor<1,dim>::clear ()
};
-
-
-
-
template <int dim>
inline
ostream & operator << (ostream &out, const Tensor<1,dim> &p)
return out;
};
-
-
-
-
-/*---------------------------- tensor_base.h ---------------------------*/
-/* end of #ifndef __tensor_base_H */
#endif
-/*---------------------------- tensor_base.h ---------------------------*/
-/*---------------------------- tensorfunction.h ---------------------------*/
-/* $Id$ */
-/* Copyright G. Kanschat, University of Heidelberg, 1999 */
-#ifndef __tensorfunction_H
-#define __tensorfunction_H
-/*---------------------------- tensorfunction.h ---------------------------*/
+//---------------------------- tensor_function.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.
+//
+//---------------------------- tensor_function.h ---------------------------
+#ifndef __deal2__tensor_function_h
+#define __deal2__tensor_function_h
#include <base/exceptions.h>
#include <base/forward_declarations.h>
-
-
/**
* This class is a model for a tensor valued function.
* It returns the value
};
-
-
-
-
-/*---------------------------- tensorfunction.h ---------------------------*/
-/* end of #ifndef __tensorfunction_H */
#endif
-/*---------------------------- tensorfunction.h ---------------------------*/
+
-/*---------------------------- thread_manager.h ---------------------------*/
-/* $Id$ */
-#ifndef __thread_manager_H
-#define __thread_manager_H
-/*---------------------------- thread_manager.h ---------------------------*/
+//---------------------------- thread_manager.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.
+//
+//---------------------------- thread_manager.h ---------------------------
+#ifndef __deal2__thread_manager_h
+#define __deal2__thread_manager_h
#ifdef DEAL_II_USE_MT
void_mem_fun (void_mem_fun) {};
};
-
- /**
+
+/**
* This class is used to package all
* data needed to call a specific unary
* member function of an object. It is
};
- /**
+/**
* This class is used to package
* all data needed to call a
* specific ternary member
mem_fun (0),
void_mem_fun (void_mem_fun) {};
};
-
- /**
+
+/**
* This class is used to package
* all data needed to call a
* specific quaternary member
void_mem_fun (void_mem_fun) {};
};
-
- /**
+
+/**
* This class is used to package
* all data needed to call a
* specific hexary member
};
- /**
+/**
* This class is used to package
* all data needed to call a
* specific nonary member
};
- /**
+/**
* This class is used to package
* all data needed to call a
* specific decary member
arg10 (arg10),
mem_fun (mem_fun) {};
};
-
-
-
- /**
+
+/**
* This class is used to package
* all data needed to call a
* global function. See the
};
- /**
+/**
* This class is used to package
* all data needed to call a
* global function. See the
};
- /**
+/**
* Wrapper function to allow spawning
* threads for member functions as well,
* rather than for global functions only.
size_t stack_size = 0);
-
- /**
+/**
* Wrapper function to allow spawning
* threads for member functions as well,
* rather than for global functions only.
size_t stack_size = 0);
-
- /**
+/**
* Wrapper function to allow spawning
* threads for funtions.
*
ACE_hthread_t thread_handles[] = 0,
void *stack[] = 0,
size_t stack_size[] = 0);
-
-
- private:
+private:
- /**
+
+/**
* This is a function satisfying the
* requirements for thread entry points.
* It takes as argument all the
static void * thread_entry_point10 (void *_arg);
- /**
+/**
* This is a function satisfying the
* requirements for thread entry points.
* It takes as argument all the
};
-
/* ------------------------------ Template functions -------------------------------- */
};
-
template <typename ObjectClass, typename Arg>
int ThreadManager::spawn (Mem_Fun_Data1<ObjectClass,Arg> *mem_fun_data,
long flags,
};
-
template <typename ObjectClass, typename Arg1, typename Arg2>
int ThreadManager::spawn (Mem_Fun_Data2<ObjectClass,Arg1,Arg2> *mem_fun_data,
long flags,
};
-
template <typename ObjectClass, typename Arg1, typename Arg2, typename Arg3>
int ThreadManager::spawn (Mem_Fun_Data3<ObjectClass,Arg1,Arg2,Arg3> *mem_fun_data,
long flags,
};
-
template <typename ObjectClass, typename Arg1, typename Arg2, typename Arg3, typename Arg4>
int ThreadManager::spawn (Mem_Fun_Data4<ObjectClass,Arg1,Arg2,Arg3,Arg4> *mem_fun_data,
long flags,
};
-
template <typename ObjectClass, typename Arg1, typename Arg2,
typename Arg3, typename Arg4,
typename Arg5>
};
-
template <typename ObjectClass, typename Arg1, typename Arg2,
typename Arg3, typename Arg4,
typename Arg5, typename Arg6>
};
-
template <typename ObjectClass, typename Arg1, typename Arg2,
typename Arg3, typename Arg4,
typename Arg5, typename Arg6,
};
-
template <typename ObjectClass, typename Arg1, typename Arg2,
typename Arg3, typename Arg4,
typename Arg5, typename Arg6,
};
-
template <typename ObjectClass, typename Arg1, typename Arg2,
typename Arg3, typename Arg4,
typename Arg5, typename Arg6,
};
-
-
-
template <typename Arg1, typename Arg2,
typename Arg3, typename Arg4,
typename Arg5, typename Arg6,
};
-
template <typename ObjectClass, typename Arg>
int ThreadManager::spawn_n (size_t n,
Mem_Fun_Data1<ObjectClass,Arg> *mem_fun_data,
};
-
template <typename ObjectClass, typename Arg1, typename Arg2>
int ThreadManager::spawn_n (size_t n,
Mem_Fun_Data2<ObjectClass,Arg1,Arg2> *mem_fun_data,
};
-
template <typename ObjectClass, typename Arg1, typename Arg2, typename Arg3>
int ThreadManager::spawn_n (size_t n,
Mem_Fun_Data3<ObjectClass,Arg1,Arg2,Arg3> *mem_fun_data,
};
-
template <typename ObjectClass, typename Arg1, typename Arg2, typename Arg3, typename Arg4>
int ThreadManager::spawn_n (size_t n,
Mem_Fun_Data4<ObjectClass,Arg1,Arg2,Arg3,Arg4> *mem_fun_data,
};
-
template <typename ObjectClass, typename Arg1, typename Arg2,
typename Arg3, typename Arg4,
typename Arg5>
};
-
template <typename ObjectClass, typename Arg1, typename Arg2,
typename Arg3, typename Arg4,
typename Arg5, typename Arg6>
};
-
-
template <typename Arg1, typename Arg2,
typename Arg3, typename Arg4,
typename Arg5, typename Arg6,
};
-
template <typename Class, typename Arg>
void * ThreadManager::thread_entry_point1 (void *_arg)
{
};
-
template <typename Class, typename Arg1, typename Arg2>
void * ThreadManager::thread_entry_point2 (void *_arg)
{
};
-
template <typename Class, typename Arg1, typename Arg2, typename Arg3>
void * ThreadManager::thread_entry_point3 (void *_arg)
{
};
-
template <typename Class, typename Arg1, typename Arg2, typename Arg3, typename Arg4>
void * ThreadManager::thread_entry_point4 (void *_arg)
{
};
-
template <typename Class, typename Arg1, typename Arg2,
typename Arg3, typename Arg4,
typename Arg5>
};
-
template <typename Class, typename Arg1, typename Arg2,
typename Arg3, typename Arg4,
typename Arg5, typename Arg6>
};
-
template <typename Class, typename Arg1, typename Arg2,
typename Arg3, typename Arg4,
typename Arg5, typename Arg6,
};
-
template <typename Class, typename Arg1, typename Arg2,
typename Arg3, typename Arg4,
typename Arg5, typename Arg6,
};
-
template <typename Arg1, typename Arg2,
typename Arg3, typename Arg4,
typename Arg5, typename Arg6>
};
-
#endif
-/*---------------------------- thread_manager.h ---------------------------*/
-/* end of #ifndef __thread_manager_H */
-#endif
-/*---------------------------- thread_manager.h ---------------------------*/
-
-
-
+#endif
-/*---------------------------- timer.h ---------------------------*/
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
-#ifndef __timer_H
-#define __timer_H
-/*---------------------------- timer.h ---------------------------*/
+//---------------------------- timer.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.
+//
+//---------------------------- timer.h ---------------------------
+#ifndef __deal2__timer_h
+#define __deal2__timer_h
/**
double cumulative_time;
- /**
+/**
* Store whether the timer is presently
* running.
*/
};
-
-
-
-/*---------------------------- timer.h ---------------------------*/
-/* end of #ifndef __timer_H */
#endif
-/*---------------------------- timer.h ---------------------------*/