/* $Id$ */
/* Version: $Name$ */
/* */
-/* Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors */
+/* Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2007 by the deal.II authors */
/* */
/* This file is subject to QPL and may not be distributed */
/* without copyright and license information. Please refer */
class Beta
{
public:
- Beta () {};
+ Beta () {}
void value_list (const std::vector<Point<dim> > &points,
std::vector<Point<dim> > &values) const;
};
/* $Id$ */
/* Version: $Name$ */
/* */
-/* Copyright (C) 2001, 2002, 2003, 2004, 2006 by the deal.II authors */
+/* Copyright (C) 2001, 2002, 2003, 2004, 2006, 2007 by the deal.II authors */
/* */
/* This file is subject to QPL and may not be distributed */
/* without copyright and license information. Please refer */
class Solution : public Function<dim>
{
public:
- Solution () : Function<dim> () {};
+ Solution () : Function<dim> () {}
virtual double value (const Point<dim> &p,
const unsigned int component) const;
class RightHandSide : public Function<dim>
{
public:
- RightHandSide () : Function<dim> () {};
+ RightHandSide () : Function<dim> () {}
virtual double value (const Point<dim> &p,
const unsigned int component) const;
/* $Id$ */
/* Version: $Name$ */
/* */
-/* Copyright (C) 2002, 2003, 2004, 2005, 2006 by the deal.II authors */
+/* Copyright (C) 2002, 2003, 2004, 2005, 2006, 2007 by the deal.II authors */
/* */
/* This file is subject to QPL and may not be distributed */
/* without copyright and license information. Please refer */
template <class Traits, int dim>
struct SetUp : public SetUpBase<dim>
{
- SetUp () {};
+ SetUp () {}
virtual
const Function<dim> & get_boundary_values () const;
class BoundaryValues : public Function<dim>
{
public:
- BoundaryValues () : Function<dim> () {};
+ BoundaryValues () : Function<dim> () {}
virtual double value (const Point<dim> &p,
const unsigned int component) const;
class RightHandSide : public Function<dim>
{
public:
- RightHandSide () : Function<dim> () {};
+ RightHandSide () : Function<dim> () {}
virtual double value (const Point<dim> &p,
const unsigned int component) const;
class RightHandSide : public ConstantFunction<dim>
{
public:
- RightHandSide () : ConstantFunction<dim> (1.) {};
+ RightHandSide () : ConstantFunction<dim> (1.) {}
};
// Finally a function to
/* $Id$ */
/* Version: $Name$ */
/* */
-/* Copyright (C) 2002, 2003, 2004, 2006 by the deal.II authors */
+/* Copyright (C) 2002, 2003, 2004, 2006, 2007 by the deal.II authors */
/* */
/* This file is subject to QPL and may not be distributed */
/* without copyright and license information. Please refer */
class InitializationValues : public Function<1>
{
public:
- InitializationValues () : Function<1>() {};
+ InitializationValues () : Function<1>() {}
virtual double value (const Point<1> &p,
const unsigned int component = 0) const;
/* $Id$ */
/* Version: $Name$ */
/* */
-/* Copyright (C) 2005, 2006 by the deal.II authors */
+/* Copyright (C) 2005, 2006, 2007 by the deal.II authors */
/* */
/* This file is subject to QPL and may not be distributed */
/* without copyright and license information. Please refer */
class RightHandSide : public Function<dim>
{
public:
- RightHandSide () : Function<dim>(1) {};
+ RightHandSide () : Function<dim>(1) {}
virtual double value (const Point<dim> &p,
const unsigned int component = 0) const;
class PressureBoundaryValues : public Function<dim>
{
public:
- PressureBoundaryValues () : Function<dim>(1) {};
+ PressureBoundaryValues () : Function<dim>(1) {}
virtual double value (const Point<dim> &p,
const unsigned int component = 0) const;
class ExactSolution : public Function<dim>
{
public:
- ExactSolution () : Function<dim>(dim+1) {};
+ ExactSolution () : Function<dim>(dim+1) {}
virtual void vector_value (const Point<dim> &p,
Vector<double> &value) const;
/* $Id$ */
/* Version: $Name$ */
/* */
-/* Copyright (C) 2006 by the deal.II authors */
+/* Copyright (C) 2006, 2007 by the deal.II authors */
/* */
/* This file is subject to QPL and may not be distributed */
/* without copyright and license information. Please refer */
class PressureRightHandSide : public Function<dim>
{
public:
- PressureRightHandSide () : Function<dim>(1) {};
+ PressureRightHandSide () : Function<dim>(1) {}
virtual double value (const Point<dim> &p,
const unsigned int component = 0) const;
class PressureBoundaryValues : public Function<dim>
{
public:
- PressureBoundaryValues () : Function<dim>(1) {};
+ PressureBoundaryValues () : Function<dim>(1) {}
virtual double value (const Point<dim> &p,
const unsigned int component = 0) const;
class SaturationBoundaryValues : public Function<dim>
{
public:
- SaturationBoundaryValues () : Function<dim>(1) {};
+ SaturationBoundaryValues () : Function<dim>(1) {}
virtual double value (const Point<dim> &p,
const unsigned int component = 0) const;
class InitialValues : public Function<dim>
{
public:
- InitialValues () : Function<dim>(dim+2) {};
+ InitialValues () : Function<dim>(dim+2) {}
virtual double value (const Point<dim> &p,
const unsigned int component = 0) const;
class InitialValuesU : public Function<dim>
{
public:
- InitialValuesU () : Function<dim>() {};
+ InitialValuesU () : Function<dim>() {}
virtual double value (const Point<dim> &p,
const unsigned int component = 0) const;
class InitialValuesV : public Function<dim>
{
public:
- InitialValuesV () : Function<dim>() {};
+ InitialValuesV () : Function<dim>() {}
virtual double value (const Point<dim> &p,
const unsigned int component = 0) const;
class RightHandSide : public Function<dim>
{
public:
- RightHandSide () : Function<dim>() {};
+ RightHandSide () : Function<dim>() {}
virtual double value (const Point<dim> &p,
const unsigned int component = 0) const;
class BoundaryValuesU : public Function<dim>
{
public:
- BoundaryValuesU () : Function<dim>() {};
+ BoundaryValuesU () : Function<dim>() {}
virtual double value (const Point<dim> &p,
const unsigned int component = 0) const;
class BoundaryValuesV : public Function<dim>
{
public:
- BoundaryValuesV () : Function<dim>() {};
+ BoundaryValuesV () : Function<dim>() {}
virtual double value (const Point<dim> &p,
const unsigned int component = 0) const;
class InitialValuesP : public Function<dim>
{
public:
- InitialValuesP () : Function<dim>() {};
+ InitialValuesP () : Function<dim>() {}
virtual double value (const Point<dim> &p,
const unsigned int component = 0) const;
/* $Id$ */
-/* Copyright (C) 2006 by the deal.II authors */
+/* Copyright (C) 2006, 2007 by the deal.II authors */
/* Author: Ivan Christov, Wolfgang Bangerth, Texas A&M University, 2006 */
/* */
/* This file is subject to QPL and may not be distributed */
{
public:
ExactSolution (const unsigned int n_components = 1,
- const double time = 0.) : Function<dim>(n_components, time) {};
+ const double time = 0.) : Function<dim>(n_components, time) {}
virtual double value (const Point<dim> &p,
const unsigned int component = 0) const;
};
class RightHandSide : public Function<dim>
{
public:
- RightHandSide () : Function<dim> () {};
+ RightHandSide () : Function<dim> () {}
virtual double value (const Point<dim> &p,
const unsigned int component) const;
/* $Id$ */
/* Version: $Name$ */
/* */
-/* Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors */
+/* Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007 by the deal.II authors */
/* */
/* This file is subject to QPL and may not be distributed */
/* without copyright and license information. Please refer */
class RightHandSide : public Function<dim>
{
public:
- RightHandSide () : Function<dim>() {};
+ RightHandSide () : Function<dim>() {}
virtual double value (const Point<dim> &p,
const unsigned int component = 0) const;
class BoundaryValues : public Function<dim>
{
public:
- BoundaryValues () : Function<dim>() {};
+ BoundaryValues () : Function<dim>() {}
virtual double value (const Point<dim> &p,
const unsigned int component = 0) const;
/* $Id$ */
/* Version: $Name$ */
/* */
-/* Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2006 by the deal.II authors */
+/* Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2006, 2007 by the deal.II authors */
/* */
/* This file is subject to QPL and may not be distributed */
/* without copyright and license information. Please refer */
class Coefficient : public Function<dim>
{
public:
- Coefficient () : Function<dim>() {};
+ Coefficient () : Function<dim>() {}
virtual double value (const Point<dim> &p,
const unsigned int component = 0) const;
/* $Id$ */
/* Version: $Name$ */
/* */
-/* Copyright (C) 2000, 2001, 2002, 2003, 2004, 2006 by the deal.II authors */
+/* Copyright (C) 2000, 2001, 2002, 2003, 2004, 2006, 2007 by the deal.II authors */
/* */
/* This file is subject to QPL and may not be distributed */
/* without copyright and license information. Please refer */
class Coefficient : public Function<dim>
{
public:
- Coefficient () : Function<dim>() {};
+ Coefficient () : Function<dim>() {}
virtual double value (const Point<dim> &p,
const unsigned int component = 0) const;
/* $Id$ */
/* Version: $Name$ */
/* */
-/* Copyright (C) 2000, 2001, 2002, 2003, 2004, 2006 by the deal.II authors */
+/* Copyright (C) 2000, 2001, 2002, 2003, 2004, 2006, 2007 by the deal.II authors */
/* */
/* This file is subject to QPL and may not be distributed */
/* without copyright and license information. Please refer */
protected SolutionBase<dim>
{
public:
- Solution () : Function<dim>() {};
+ Solution () : Function<dim>() {}
virtual double value (const Point<dim> &p,
const unsigned int component = 0) const;
protected SolutionBase<dim>
{
public:
- RightHandSide () : Function<dim>() {};
+ RightHandSide () : Function<dim>() {}
virtual double value (const Point<dim> &p,
const unsigned int component = 0) const;
/* $Id$ */
/* Version: $Name$ */
/* */
-/* Copyright (C) 2000, 2001, 2002, 2003, 2004, 2006 by the deal.II authors */
+/* Copyright (C) 2000, 2001, 2002, 2003, 2004, 2006, 2007 by the deal.II authors */
/* */
/* This file is subject to QPL and may not be distributed */
/* without copyright and license information. Please refer */
class AdvectionField : public TensorFunction<1,dim>
{
public:
- AdvectionField () : TensorFunction<1,dim> () {};
+ AdvectionField () : TensorFunction<1,dim> () {}
virtual Tensor<1,dim> value (const Point<dim> &p) const;
class RightHandSide : public Function<dim>
{
public:
- RightHandSide () : Function<dim>() {};
+ RightHandSide () : Function<dim>() {}
virtual double value (const Point<dim> &p,
const unsigned int component = 0) const;
class BoundaryValues : public Function<dim>
{
public:
- BoundaryValues () : Function<dim>() {};
+ BoundaryValues () : Function<dim>() {}
virtual double value (const Point<dim> &p,
const unsigned int component = 0) const;
// $Id$
// Version: $Name$
//
-// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
+// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
const bool /*use_default_residual*/ = true)
:
max_basis_size(max_basis_size)
- {};
+ {}
/**
* Maximum number of