// ---------------------------------------------------------------------
//
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
for (unsigned int q=0; q<quadrature.size(); ++q)
{
Assert ((fe_face_values1.quadrature_point(q)-
- fe_face_values2.quadrature_point(q)).square()
+ fe_face_values2.quadrature_point(q)).norm_square()
< 1e-20,
ExcInternalError());
// ---------------------------------------------------------------------
//
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
deallog << " " << c << " [" << q << "] [" << pp << ']'
<< std::endl;
- Assert ((p-pp).square() < 1e-15*1e-15, ExcInternalError());
+ Assert ((p-pp).norm_square() < 1e-15*1e-15, ExcInternalError());
Assert (GeometryInfo<dim>::is_inside_unit_cell (p) ==
GeometryInfo<dim>::is_inside_unit_cell (pp),
ExcInternalError());
// ---------------------------------------------------------------------
//
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
deallog << " " << fe_face_values1.quadrature_point(q)
<< std::endl;
Assert ((fe_face_values1.quadrature_point(q)-
- fe_face_values2.quadrature_point(q)).square()
+ fe_face_values2.quadrature_point(q)).norm_square()
< 1e-20,
ExcInternalError());
}
// ---------------------------------------------------------------------
//
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
point_1(0) = 0.5;
point_2(0) = -0.5;
- if (((p-point_1).square() < 0.2*0.2) ||
- ((p-point_2).square() < 0.2*0.2))
+ if (((p-point_1).norm_square() < 0.2*0.2) ||
+ ((p-point_2).norm_square() < 0.2*0.2))
values(0) = 1;
else
values(0) = 0;
- if (p.square() < 0.2*0.2)
+ if (p.norm_square() < 0.2*0.2)
values(1) = 1;
else
values(1) = 0;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2001 - 2014 by the deal.II authors
+// Copyright (C) 2001 - 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
Point<3> m(2,2,2);
Point<3> v(3,3,3);
- double r=std::sqrt((m-v).square()),
+ double r=std::sqrt((m-v).norm_square()),
h=r-1.5,
pi=std::acos(-1.);
Boundary<3> *boundary1=new HyperBallBoundary<3>(m, r);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2001 - 2014 by the deal.II authors
+// Copyright (C) 2001 - 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
Point<2> radius = c1_values.quadrature_point(i);
radius /= std::sqrt(radius.square());
- Assert ((radius-c1_values.normal_vector(i)).square() < 1e-14,
+ Assert ((radius-c1_values.normal_vector(i)).norm_square() < 1e-14,
ExcInternalError());
};
};
// ---------------------------------------------------------------------
//
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
for (unsigned int q=0; q<quadrature.size(); ++q)
{
Assert ((fe_face_values1.quadrature_point(q)-
- fe_face_values2.quadrature_point(q)).square()
+ fe_face_values2.quadrature_point(q)).norm_square()
< 1e-20,
ExcInternalError());
fe_face_values2.JxW(q)) < 1e-15,
ExcInternalError());
Assert ((fe_face_values1.normal_vector(q) +
- fe_face_values2.normal_vector(q)).square()
+ fe_face_values2.normal_vector(q)).norm_square()
< 1e-20,
ExcInternalError());
}
// ---------------------------------------------------------------------
//
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
<< std::endl;
Assert ((fe_face_values1.quadrature_point(q)-
- fe_face_values2.quadrature_point(q)).square()
+ fe_face_values2.quadrature_point(q)).norm_square()
< 1e-20,
ExcInternalError());
// ---------------------------------------------------------------------
//
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
<< std::endl;
Assert ((fe_face_values1.quadrature_point(q)-
- fe_face_values2.quadrature_point(q)).square()
+ fe_face_values2.quadrature_point(q)).norm_square()
< 1e-20,
ExcInternalError());
// ---------------------------------------------------------------------
//
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
point_1(0) = 0.5;
point_2(0) = -0.5;
- if (((p-point_1).square() < 0.2*0.2) ||
- ((p-point_2).square() < 0.2*0.2))
+ if (((p-point_1).norm_square() < 0.2*0.2) ||
+ ((p-point_2).norm_square() < 0.2*0.2))
values(0) = 1;
else
values(0) = 0;
- if (p.square() < 0.2*0.2)
+ if (p.norm_square() < 0.2*0.2)
values(1) = 1;
else
values(1) = 0;