// $Id$
// Version: $Name$
//
-// Copyright (C) 2005, 2006 by the deal.II authors and Christian Kamm
+// Copyright (C) 2005, 2006, 2007 by the deal.II authors and Christian Kamm
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
class TestFunction : public Function<2>
{
public:
- TestFunction() : Function<2>() {};
+ TestFunction() : Function<2>() {}
virtual double value(const Point<2> &p,
const unsigned int) const
- { return std::sin(3.14159*p(0))*std::sin(3.14159*p(1)); };
+ { return std::sin(3.14159*p(0))*std::sin(3.14159*p(1)); }
};
int main()
Triangulation<2>::active_cell_iterator it = both_tria.begin_active();
it->set_refine_flag();
(++it)->set_refine_flag();
- for(int i = 1; i < 8; ++i, ++it);
+ for(int i = 1; i < 8; ++i, ++it)
+ ;
it->set_coarsen_flag();
(++it)->set_coarsen_flag();
(++it)->set_coarsen_flag();
// $Id$
// Version: $Name$
//
-// Copyright (C) 2003, 2004, 2005 by the deal.II authors
+// Copyright (C) 2003, 2004, 2005, 2007 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
r = std::sqrt( x*x + y*y );
return 0.5 * ( 1 - std::tanh( ( r - 0.5 )
/( 2*M_SQRT2 * delta ) ) ) ;
- };
+ }
};
// $Id$
// Version: $Name$
//
-// Copyright (C) 2004 by the deal.II authors
+// Copyright (C) 2004, 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 MySquareFunction : public Function<dim>
{
public:
- MySquareFunction () : Function<dim>(2) {};
+ MySquareFunction () : Function<dim>(2) {}
virtual double value (const Point<dim> &p,
const unsigned int component) const
- { return (component+1)*p.square(); };
+ { return (component+1)*p.square(); }
virtual void vector_value (const Point<dim> &p,
Vector<double> &values) const
{ values(0) = value(p,0);
- values(1) = value(p,1); };
+ values(1) = value(p,1); }
};
// $Id$
// Version: $Name$
//
-// Copyright (C) 2004, 2006 by the deal.II authors
+// Copyright (C) 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 MySquareFunction : public Function<dim>
{
public:
- MySquareFunction () : Function<dim>(2) {};
+ MySquareFunction () : Function<dim>(2) {}
virtual double value (const Point<dim> &p,
const unsigned int component) const
- { return (component+1)*p.square(); };
+ { return (component+1)*p.square(); }
virtual void vector_value (const Point<dim> &p,
Vector<double> &values) const
{ values(0) = value(p,0);
- values(1) = value(p,1); };
+ values(1) = value(p,1); }
};
// $Id$
// Version: $Name$
//
-// Copyright (C) 2004 by the deal.II authors
+// Copyright (C) 2004, 2007 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
public:
virtual double value (const Point<dim> &p,
const unsigned int component) const
- { return (component+1)*p.square()+1; };
+ { return (component+1)*p.square()+1; }
virtual void vector_value (const Point<dim> &p,
Vector<double> &values) const
- { values(0) = value(p,0); };
+ { values(0) = value(p,0); }
};
public:
virtual double value (const Point<dim> &p,
const unsigned int component) const
- { return std::exp (p(0)); };
+ { return std::exp (p(0)); }
virtual void vector_value (const Point<dim> &p,
Vector<double> &values) const
- { values(0) = value(p,0); };
+ { values(0) = value(p,0); }
};
// $Id$
// Version: $Name$
//
-// Copyright (C) 2004 by the deal.II authors
+// Copyright (C) 2004, 2007 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
public:
virtual double value (const Point<dim> &p,
const unsigned int component) const
- { return (component+1)*p.square()+1; };
+ { return (component+1)*p.square()+1; }
virtual void vector_value (const Point<dim> &p,
Vector<double> &values) const
- { values(0) = value(p,0); };
+ { values(0) = value(p,0); }
};
public:
virtual double value (const Point<dim> &p,
const unsigned int component) const
- { return std::exp (p(0)); };
+ { return std::exp (p(0)); }
virtual void vector_value (const Point<dim> &p,
Vector<double> &values) const
- { values(0) = value(p,0); };
+ { values(0) = value(p,0); }
};
// $Id$
// Version: $Name$
//
-// Copyright (C) 2004, 2006 by the deal.II authors
+// Copyright (C) 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
public:
virtual double value (const Point<dim> &p,
const unsigned int component) const
- { return (component+1)*p.square()+1; };
+ { return (component+1)*p.square()+1; }
virtual void vector_value (const Point<dim> &p,
Vector<double> &values) const
- { values(0) = value(p,0); };
+ { values(0) = value(p,0); }
};
public:
virtual double value (const Point<dim> &p,
const unsigned int component) const
- { return std::exp (p(0)); };
+ { return std::exp (p(0)); }
virtual void vector_value (const Point<dim> &p,
Vector<double> &values) const
- { values(0) = value(p,0); };
+ { values(0) = value(p,0); }
};
// $Id$
// Version: $Name$
//
-// Copyright (C) 2004, 2006 by the deal.II authors
+// Copyright (C) 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
public:
virtual double value (const Point<dim> &p,
const unsigned int component) const
- { return (component+1)*p.square()+1; };
+ { return (component+1)*p.square()+1; }
virtual void vector_value (const Point<dim> &p,
Vector<double> &values) const
- { values(0) = value(p,0); };
+ { values(0) = value(p,0); }
};
public:
virtual double value (const Point<dim> &p,
const unsigned int component) const
- { return std::exp (p(0)); };
+ { return std::exp (p(0)); }
virtual void vector_value (const Point<dim> &p,
Vector<double> &values) const
- { values(0) = value(p,0); };
+ { values(0) = value(p,0); }
};
// $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 Beta
{
public:
- Beta () {};
+ Beta () {}
void value_list (const std::vector<Point<dim> > &points,
std::vector<Point<dim> > &values) 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 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) 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
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.) {}
};
static
// $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 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>() {};
+ 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) 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 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) 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 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) 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
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) 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 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;
// deformed_projection.h,v 1.3 2003/06/09 16:00:38 wolf Exp
// Version:
//
-// Copyright (C) 2003, 2005, 2006 by the deal.II authors
+// Copyright (C) 2003, 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
public:
TestMap1 (const unsigned int n_components) :
Function<dim> (n_components)
- {};
+ {}
- virtual ~TestMap1 () {};
+ virtual ~TestMap1 () {}
virtual double value (const Point<dim> &p,
const unsigned int component = 0) const;
/* fe_tools_test.cc,v 1.6 2003/04/09 15:49:54 wolf Exp */
/* Version: */
/* */
-/* Copyright (C) 1999, 2000, 2001, 2002, 2003, 2005 by the deal.II authors */
+/* Copyright (C) 1999, 2000, 2001, 2002, 2003, 2005, 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 TestFunction: public Function<2>
{
public:
- TestFunction() {};
- virtual ~TestFunction() {};
+ TestFunction() {}
+ virtual ~TestFunction() {}
virtual double value(const Point<2> &p,
const unsigned int component) const;
// rt_approximation_01.cc,v 1.3 2003/06/09 16:00:38 wolf Exp
// Version:
//
-// Copyright (C) 2003, 2005, 2006 by the deal.II authors
+// Copyright (C) 2003, 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
public:
TestMap1 (const unsigned int n_components) :
Function<dim> (n_components)
- {};
+ {}
- virtual ~TestMap1 () {};
+ virtual ~TestMap1 () {}
virtual double value (const Point<dim> &p,
const unsigned int component = 0) const;
TestDef1 (const unsigned int n_components, const double ph) :
Function<dim> (n_components),
phi (ph)
- {};
+ {}
- virtual ~TestDef1 () {};
+ virtual ~TestDef1 () {}
virtual double value (const Point<dim> &p,
const unsigned int component = 0) const;
TestDef2 (const unsigned int n_components, const double sc) :
Function<dim> (n_components),
scale (sc)
- {};
+ {}
- virtual ~TestDef2 () {};
+ virtual ~TestDef2 () {}
virtual double value (const Point<dim> &p,
const unsigned int component = 0) const;
TestDef3 (const unsigned int n_components, const double sc) :
Function<dim> (n_components),
scale (sc)
- {};
+ {}
- virtual ~TestDef3 () {};
+ virtual ~TestDef3 () {}
virtual double value (const Point<dim> &p,
const unsigned int component = 0) const;
}
polys.push_back (Polynomials::Polynomial<double> (coeff));
}
- };
+ }
- virtual ~TestPoly () {};
+ virtual ~TestPoly () {}
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;
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 Function<dim>
{
public:
- RightHandSide () : Function<dim> () {};
+ RightHandSide () : 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) 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 Beta
{
public:
- Beta () {};
+ Beta () {}
void value_list (const std::vector<Point<dim> > &points,
std::vector<Point<dim> > &values) 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>() {};
+ 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) 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 Coefficient : public Function<dim>
{
public:
- Coefficient () : Function<dim>() {};
+ Coefficient () : Function<dim>() {}
virtual double value (const Point<dim> &p,
const unsigned int component = 0) const;