if (true)
{
std::vector<unsigned int> tmp(new_numbers);
- sort (tmp.begin(), tmp.end());
+ std::sort (tmp.begin(), tmp.end());
std::vector<unsigned int>::const_iterator p = tmp.begin();
unsigned int i = 0;
for (; p!=tmp.end(); ++p, ++i)
if (true)
{
std::vector<unsigned int> tmp(new_numbers);
- sort (tmp.begin(), tmp.end());
+ std::sort (tmp.begin(), tmp.end());
std::vector<unsigned int>::const_iterator p = tmp.begin();
unsigned int i = 0;
for (; p!=tmp.end(); ++p, ++i)
// altogether
Assert(false, ExcNotImplemented());
- const double a = 1./(1+sqrt(3)); // equilibrate cell sizes at transition
- // from the inner part to the radial
- // cells
+ const double a = 1./(1+std::sqrt(3)); // equilibrate cell sizes at transition
+ // from the inner part to the radial
+ // cells
const unsigned int n_vertices = 16;
const Point<3> vertices[n_vertices]
= {
// assert minimum touch count is at
// least two
- if (! (* (min_element(vertex_touch_count.begin(),
- vertex_touch_count.end())) >= 2))
+ if (! (* (std::min_element(vertex_touch_count.begin(),
+ vertex_touch_count.end())) >= 2))
{
// clear will only work if
// there are no
// first compute a random shift vector
for (unsigned int d=0; d<dim; ++d)
- shift_vector(d) = rand()*1.0/RAND_MAX;
+ shift_vector(d) = std::rand()*1.0/RAND_MAX;
shift_vector *= factor * minimal_length[vertex] /
- sqrt(shift_vector.square());
+ std::sqrt(shift_vector.square());
// finally move the vertex
vertices[vertex] += shift_vector;
template <int dim>
double TriaObjectAccessor<3, dim>::diameter () const
{
- return sqrt(std::max( std::max((vertex(6)-vertex(0)).square(),
- (vertex(7)-vertex(1)).square()),
- std::max((vertex(4)-vertex(2)).square(),
- (vertex(5)-vertex(3)).square()) ));
+ return std::sqrt(std::max( std::max((vertex(6)-vertex(0)).square(),
+ (vertex(7)-vertex(1)).square()),
+ std::max((vertex(4)-vertex(2)).square(),
+ (vertex(5)-vertex(3)).square()) ));
};
typename std::vector<Point<dim> > &points) const
{
const unsigned int n=points.size(),
- m=static_cast<unsigned int>(sqrt(n));
+ m=static_cast<unsigned int>(std::sqrt(n));
// is n a square number
Assert(m*m==n, ExcInternalError());
// HyperBallBoundary
for (unsigned int i=0; i<n; ++i)
{
- points[i] *= r / sqrt(points[i].square());
+ points[i] *= r / std::sqrt(points[i].square());
points[i] += center;
}
}
const Triangulation<3>::quad_iterator &quad,
std::vector<Point<3> > &points) const
{
- unsigned int m=static_cast<unsigned int> (sqrt(points.size()));
+ unsigned int m=static_cast<unsigned int> (std::sqrt(points.size()));
Assert(points.size()==m*m, ExcInternalError());
std::vector<Point<3> > lp3(m);
DerivativeApproximation::SecondDerivative<1>::
derivative_norm (const Derivative &d)
{
- return fabs (d[0][0]);
+ return std::fabs (d[0][0]);
};
#endif
};
for (unsigned int s=0; s<n_solution_vectors; ++s)
- (*errors[s])(cell_index) = sqrt((*errors[s])(cell_index));
+ (*errors[s])(cell_index) = std::sqrt((*errors[s])(cell_index));
};
};