MESSAGE(STATUS "Proceed to test definitions")
+
+#a-framework
+#all-headers
ADD_SUBDIRECTORY(aniso)
ADD_SUBDIRECTORY(base)
-#ADD_SUBDIRECTORY(bits)
+#benchmarks
+#bits
ADD_SUBDIRECTORY(codim_one)
+#deal.II
+#distributed_grids
+#fail
+#fe
+#gla
+#grid
+#hp
+#hsl
+#integrators
+#lac
+#lapack
+#lib
+#matrix_free
+#mesh_converter
+#metis
+#mpi
+#multigrid
+#petsc
+#serialization
+#slepc
+#trilinos
+#umfpack
--- /dev/null
+DEAL_II_PICKUP_TESTS()
#include <math.h>
#include <string>
-std::ofstream logfile("bem/output");
+std::ofstream logfile("output");
template<int spacedim>
class BEM
{
- read_grid("grids/circle_R10.inp");
+ read_grid("SOURCE_DIR/grids/circle_R10.inp");
Point<spacedim> p;
HyperBallBoundary<spacedim-1, spacedim> boundary(p,10.);
// dataout.add_data_vector(smooth_solution, "quadratic_potential");
// dataout.build_patches(fe_q.degree);
// char outname[50];
-// sprintf(outname, "bem/bem_gradient.vtk");
+// sprintf(outname, "bem_gradient.vtk");
// std::ofstream file(outname);
// dataout.write_vtk(file);
// dataout.write_vtk(logfile);
using namespace std;
-ofstream logfile("bem_integration/output");
+ofstream logfile("output");
template <int dim>
int main ()
{
- ofstream logfile("boundary_indicator_01/output");
+ ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
#include <fstream>
#include <string>
-std::ofstream logfile("data_out/output");
+std::ofstream logfile("output");
template <int dim, int spacedim>
deallog.attach(logfile);
deallog.depth_console(0);
deallog << "Test<1,2>" << std::endl;
- test<1,2>("grids/circle_2.inp");
+ test<1,2>("SOURCE_DIR/grids/circle_2.inp");
deallog << "Test<2,3>" << std::endl;
- test<2,3>("grids/sphere_2.inp");
+ test<2,3>("SOURCE_DIR/grids/sphere_2.inp");
return 0;
}
#include <deal.II/lac/vector.h>
#include <deal.II/numerics/data_out.h>
-std::ofstream logfile("data_out_02/output");
+std::ofstream logfile("output");
int main ()
GridIn<dim,dim+1> grid_in;
grid_in.attach_triangulation (triangulation);
- std::ifstream fname("data_out_02/square.msh");
+ std::ifstream fname("square.msh");
grid_in.read_msh (fname);
dof_handler.distribute_dofs (fe);
#include <deal.II/numerics/vector_tools.h>
#include <deal.II/fe/mapping_q.h>
-std::ofstream logfile("data_out_03/output");
+std::ofstream logfile("output");
template <int dim>
class Identity : public Function<dim>
+++ /dev/null
-$MeshFormat
-2.1 0 8
-$EndMeshFormat
-$Nodes
-4
-1 0 0 0
-2 1 0 0
-3 1 1 0
-4 0 1 0
-$EndNodes
-$Elements
-4
-1 1 3 0 1 0 1 2
-2 1 3 0 1 0 2 3
-3 1 3 0 1 0 3 4
-4 1 3 0 1 0 4 1
-$EndElements
int main ()
{
- ofstream logfile("direction_flag_01/output");
+ ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
- ofstream logfile("direction_flag_02/output");
+ ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
- ofstream logfile("direction_flag_03/output");
+ ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
- std::ofstream logfile ("error_estimator_01/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- ofstream logfile("extract_boundary_mesh_00/output");
+ ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
- ofstream logfile("extract_boundary_mesh_01/output");
+ ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
- ofstream logfile("extract_boundary_mesh_02/output");
+ ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
- ofstream logfile("extract_boundary_mesh_03/output");
+ ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
- ofstream logfile("extract_boundary_mesh_04/output");
+ ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
- ofstream logfile("extract_boundary_mesh_05/output");
+ ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
- ofstream logfile("extract_boundary_mesh_06/output");
+ ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
- std::ofstream logfile("extract_boundary_mesh_07/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
- std::ofstream logfile("fe_dgq_prolongation_01/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
#include <deal.II/base/quadrature_lib.h>
#include <deal.II/numerics/data_out.h>
-std::ofstream logfile("fe_values_extractor_01/output");
+std::ofstream logfile("output");
int main ()
+++ /dev/null
-$MeshFormat
-2.1 0 8
-$EndMeshFormat
-$Nodes
-4
-1 0 0 0
-2 1 0 0
-3 1 1 0
-4 0 1 0
-$EndNodes
-$Elements
-4
-1 1 3 0 1 0 1 2
-2 1 3 0 1 0 2 3
-3 1 3 0 1 0 3 4
-4 1 3 0 1 0 4 1
-$EndElements
-std::ofstream logfile("gradients/output");
+std::ofstream logfile("output");
template <int dim, int spacedim>
void test(std::string filename)
deallog.threshold_double(1.e-12);
deallog<<"Test <1,2>"<<std::endl;
- test<1,2>("grids/circle_4.inp");
+ test<1,2>("SOURCE_DIR/grids/circle_4.inp");
deallog<<std::endl;
deallog<<"Test <2,3>"<<std::endl;
- test<2,3>("grids/sphere_1.inp");
+ test<2,3>("SOURCE_DIR/grids/sphere_1.inp");
-// test<2,3>("grids/sphere_2.inp");
-// test<2,3>("grids/sphere_3.inp");
-// test<2,3>("grids/sphere_4.inp");
+// test<2,3>("SOURCE_DIR/grids/sphere_2.inp");
+// test<2,3>("SOURCE_DIR/grids/sphere_3.inp");
+// test<2,3>("SOURCE_DIR/grids/sphere_4.inp");
return 0;
}
-std::ofstream logfile("gradients_1/output");
+std::ofstream logfile("output");
template <int dim, int spacedim>
void test(std::string filename, unsigned int degree = 1)
deallog.threshold_double(1.e-12);
deallog<<"Test <1,2>, Q1, Q2, Q3"<<std::endl;
- test<1,2>("grids/circle_4.inp",1);
- test<1,2>("grids/circle_4.inp",2);
- test<1,2>("grids/circle_4.inp",3);
+ test<1,2>("SOURCE_DIR/grids/circle_4.inp",1);
+ test<1,2>("SOURCE_DIR/grids/circle_4.inp",2);
+ test<1,2>("SOURCE_DIR/grids/circle_4.inp",3);
deallog<<std::endl;
deallog<<"Test <2,3>, Q1, Q2, Q3"<<std::endl;
- test<2,3>("grids/sphere_1.inp",1);
- test<2,3>("grids/sphere_1.inp",2);
- test<2,3>("grids/sphere_1.inp",3);
+ test<2,3>("SOURCE_DIR/grids/sphere_1.inp",1);
+ test<2,3>("SOURCE_DIR/grids/sphere_1.inp",2);
+ test<2,3>("SOURCE_DIR/grids/sphere_1.inp",3);
return 0;
#include <string>
-std::ofstream logfile("grid_in_out/output");
+std::ofstream logfile("output");
template <int dim, int spacedim>
void test(std::string filename)
deallog.attach(logfile);
deallog.depth_console(0);
- test<1,2>("grids/circle_1.inp");
- test<2,3>("grids/square.inp");
- test<2,3>("grids/sphere_1.inp");
+ test<1,2>("SOURCE_DIR/grids/circle_1.inp");
+ test<2,3>("SOURCE_DIR/grids/square.inp");
+ test<2,3>("SOURCE_DIR/grids/sphere_1.inp");
return 0;
}
#include <string>
-std::ofstream logfile("grid_in_out_02/output");
+std::ofstream logfile("output");
template <int dim, int spacedim>
void test(std::string filename)
deallog.attach(logfile);
deallog.depth_console(0);
- test<2,3>("grids/square.inp");
- test<2,3>("grids/sphere_1.inp");
+ test<2,3>("SOURCE_DIR/grids/square.inp");
+ test<2,3>("SOURCE_DIR/grids/sphere_1.inp");
return 0;
}
#include <string>
-std::ofstream logfile("grid_in_out_03/output");
+std::ofstream logfile("output");
template <int dim, int spacedim>
void test(std::string filename)
deallog.attach(logfile);
deallog.depth_console(0);
- test<2,3>("grids/square.inp");
- test<2,3>("grids/sphere_1.inp");
+ test<2,3>("SOURCE_DIR/grids/square.inp");
+ test<2,3>("SOURCE_DIR/grids/sphere_1.inp");
return 0;
}
#include <fstream>
#include <string>
-std::ofstream logfile("grid_refinement/output");
+std::ofstream logfile("output");
template <int dim, int spacedim>
void test(std::string filename)
deallog.depth_console(0);
deallog << "Test<1,2>" << std::endl;
- test<1,2>("grids/circle_1.inp");
+ test<1,2>("SOURCE_DIR/grids/circle_1.inp");
deallog << std::endl << "Test<1,2>" << std::endl;
- test<2,3>("grids/sphere_1.inp");
+ test<2,3>("SOURCE_DIR/grids/sphere_1.inp");
return 0;
}
int main ()
{
- std::ofstream logfile("hanging_nodes_01/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
- std::ofstream logfile("hanging_nodes_02/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
- std::ofstream logfile("hanging_nodes_03/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
#include <math.h>
-std::ofstream logfile("integrate_log/output");
+std::ofstream logfile("output");
double test(const unsigned int n,
const unsigned int exponent,
using namespace std;
-std::ofstream logfile("integrate_log_2/output");
+std::ofstream logfile("output");
// Returns the following integral: /int_0^1 x^N * ln(|x-point|/alpha) dx
const unsigned int j,
const unsigned int vertex_index);
-ofstream logfile("integrate_one_over_r/output");
+ofstream logfile("output");
int main()
{
#include <string>
-std::ofstream logfile("interpolate_boundary_values_01/output");
+std::ofstream logfile("output");
template <int dim, int spacedim>
void test(std::string filename)
deallog.attach(logfile);
deallog.depth_console(0);
- test<2,3>("grids/square.inp");
- test<2,3>("grids/sphere_1.inp");
+ test<2,3>("SOURCE_DIR/grids/square.inp");
+ test<2,3>("SOURCE_DIR/grids/sphere_1.inp");
return 0;
}
#include <string>
-std::ofstream logfile("interpolate_boundary_values_01_vector_valued/output");
+std::ofstream logfile("output");
template <int dim>
class X : public Function<dim>
deallog.attach(logfile);
deallog.depth_console(0);
- test<2,3>("grids/square.inp");
- test<2,3>("grids/sphere_1.inp");
+ test<2,3>("SOURCE_DIR/grids/square.inp");
+ test<2,3>("SOURCE_DIR/grids/sphere_1.inp");
return 0;
}
#include <string>
-std::ofstream logfile("interpolate_boundary_values_02/output");
+std::ofstream logfile("output");
void test()
{
#include <string>
-std::ofstream logfile("interpolate_boundary_values_02_vector_valued/output");
+std::ofstream logfile("output");
template <int dim>
class X : public Function<dim>
#include <string>
-std::ofstream logfile("interpolate_boundary_values_03/output");
+std::ofstream logfile("output");
void test()
{
using namespace dealii;
-std::ofstream logfile("interpolate_boundary_values_1d_closed_ring/output");
+std::ofstream logfile("output");
void test()
{
#include <fstream>
#include <string>
-std::ofstream logfile("interpolation/output");
+std::ofstream logfile("output");
template <int dim, int spacedim>
for (unsigned int n=1; n<8; ++n)
{
deallog << "Test<1,2>, finite element q_" << n << std::endl;
- test<1,2>("grids/circle_2.inp",n);
+ test<1,2>("SOURCE_DIR/grids/circle_2.inp",n);
deallog << "Test<1,2>, finite element q_" << n << std::endl;
- test<2,3>("grids/sphere_2.inp",n);
+ test<2,3>("SOURCE_DIR/grids/sphere_2.inp",n);
}
return 0;
}
#include <string>
-std::ofstream logfile("interpolation_2/output");
+std::ofstream logfile("output");
template <int dim, int spacedim>
deallog.depth_console(0);
deallog << "Test<1,2>" << std::endl;
- test<1,2>("grids/circle_2.inp");
+ test<1,2>("SOURCE_DIR/grids/circle_2.inp");
deallog << "Test<1,2>" << std::endl;
- test<2,3>("grids/sphere_2.inp");
+ test<2,3>("SOURCE_DIR/grids/sphere_2.inp");
return 0;
}
#include <string>
-std::ofstream logfile("interpolation_3/output");
+std::ofstream logfile("output");
// Test interpolation on system of finite elements.
deallog.depth_console(0);
deallog << "Test<1,2>" << std::endl;
- test<1,2>("grids/circle_2.inp");
+ test<1,2>("SOURCE_DIR/grids/circle_2.inp");
deallog << "Test<1,2>" << std::endl;
- test<2,3>("grids/sphere_2.inp");
+ test<2,3>("SOURCE_DIR/grids/sphere_2.inp");
return 0;
}
int main ()
{
- std::ofstream logfile("mapping_01/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
- std::ofstream logfile("mapping_02/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
- std::ofstream logfile("mapping_03/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
#include <fstream>
#include <string>
-std::ofstream logfile("mapping_q1/output");
+std::ofstream logfile("output");
template <int dim, int spacedim>
void test(std::string filename)
deallog.attach(logfile);
deallog.depth_console(0);
- test<1,2>("grids/circle_1.inp");
- test<2,3>("grids/square.inp");
- test<2,3>("grids/sphere_1.inp");
+ test<1,2>("SOURCE_DIR/grids/circle_1.inp");
+ test<2,3>("SOURCE_DIR/grids/square.inp");
+ test<2,3>("SOURCE_DIR/grids/sphere_1.inp");
return 0;
}
#include <fstream>
#include <string>
-std::ofstream logfile("mapping_q1_eulerian/output");
+std::ofstream logfile("output");
template <int dim, int spacedim>
void test(std::string filename)
deallog.attach(logfile);
deallog.depth_console(0);
- test<1,2>("grids/circle_1.inp");
- test<2,3>("grids/square.inp");
- test<2,3>("grids/sphere_1.inp");
+ test<1,2>("SOURCE_DIR/grids/circle_1.inp");
+ test<2,3>("SOURCE_DIR/grids/square.inp");
+ test<2,3>("SOURCE_DIR/grids/sphere_1.inp");
return 0;
}
#include <fstream>
#include <string>
-std::ofstream logfile("mapping_q_eulerian/output");
+std::ofstream logfile("output");
template <int dim, int spacedim>
void test(std::string filename, unsigned int degree)
deallog.attach(logfile);
deallog.depth_console(0);
- test<1,2>("grids/circle_1.inp",1);
- test<1,2>("grids/circle_1.inp",2);
- test<2,3>("grids/square.inp",1);
- test<2,3>("grids/square.inp",2);
- test<2,3>("grids/sphere_1.inp",1);
-// test<2,3>("grids/problem.inp",1);
- test<2,3>("grids/sphere_1.inp",2);
+ test<1,2>("SOURCE_DIR/grids/circle_1.inp",1);
+ test<1,2>("SOURCE_DIR/grids/circle_1.inp",2);
+ test<2,3>("SOURCE_DIR/grids/square.inp",1);
+ test<2,3>("SOURCE_DIR/grids/square.inp",2);
+ test<2,3>("SOURCE_DIR/grids/sphere_1.inp",1);
+// test<2,3>("SOURCE_DIR/grids/problem.inp",1);
+ test<2,3>("SOURCE_DIR/grids/sphere_1.inp",2);
return 0;
}
#include <string>
-std::ofstream logfile("mean_value/output");
+std::ofstream logfile("output");
template <int dim, int spacedim>
int main ()
{
- std::ofstream logfile("mesh_bug/output");
+ std::ofstream logfile("output");
Triangulation<2,3> tria;
GridIn<2,3> gi;
gi.attach_triangulation(tria);
- std::ifstream infile("mesh_bug/cmp/generic");
+ std::ifstream infile("cmp/generic");
gi.read(infile);
const std::vector<Point<3> > &vertices = tria.get_vertices();
int main ()
{
- std::ofstream logfile("normal_vectors_01/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
#include <string>
-std::ofstream logfile("projection/output");
+std::ofstream logfile("output");
template <int dim, int spacedim>
for (unsigned int n=1; n<5; n++)
{
deallog << "Test<1,2>, continous finite element q_" << n << std::endl;
- test<1,2>("grids/circle_2.inp",n);
+ test<1,2>("SOURCE_DIR/grids/circle_2.inp",n);
deallog << "Test<2,3>, continous finite element q_" << n << std::endl;
- test<2,3>("grids/sphere_2.inp",n);
+ test<2,3>("SOURCE_DIR/grids/sphere_2.inp",n);
}
return 0;
}
#include <string>
-std::ofstream logfile("projection_dgp/output");
+std::ofstream logfile("output");
template <int dim, int spacedim>
for (unsigned int n=1; n<5; n++)
{
deallog << "Test<1,2>, continous finite element q_" << n << std::endl;
- test<1,2>("grids/circle_2.inp",n);
+ test<1,2>("SOURCE_DIR/grids/circle_2.inp",n);
deallog << "Test<2,3>, continous finite element q_" << n << std::endl;
- test<2,3>("grids/sphere_2.inp",n);
+ test<2,3>("SOURCE_DIR/grids/sphere_2.inp",n);
}
return 0;
}
#include <string>
-std::ofstream logfile("renumber_component_wise_01/output");
+std::ofstream logfile("output");
template <int dim, int spacedim>
void test(std::string filename)
deallog.attach(logfile);
deallog.depth_console(0);
- test<2,3>("grids/square.inp");
- test<2,3>("grids/sphere_1.inp");
+ test<2,3>("SOURCE_DIR/grids/square.inp");
+ test<2,3>("SOURCE_DIR/grids/sphere_1.inp");
return 0;
}
int main ()
{
- std::ofstream logfile("solution_transfer_01/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
#include <fstream>
#include <string>
-std::ofstream logfile("surface/output");
+std::ofstream logfile("output");
// Computes the area and the outer normals of circles and spheres
// which are more and more refined, and prints the error on the
deallog.depth_console(0);
deallog<<"Test <1,2>"<<std::endl;
- test<1,2>("grids/circle_1.inp");
- test<1,2>("grids/circle_2.inp");
- test<1,2>("grids/circle_3.inp");
- test<1,2>("grids/circle_4.inp");
+ test<1,2>("SOURCE_DIR/grids/circle_1.inp");
+ test<1,2>("SOURCE_DIR/grids/circle_2.inp");
+ test<1,2>("SOURCE_DIR/grids/circle_3.inp");
+ test<1,2>("SOURCE_DIR/grids/circle_4.inp");
deallog<<"Test <2,3>"<<std::endl;
- test<2,3>("grids/sphere_1.inp");
- test<2,3>("grids/sphere_2.inp");
- test<2,3>("grids/sphere_3.inp");
- test<2,3>("grids/sphere_4.inp");
+ test<2,3>("SOURCE_DIR/grids/sphere_1.inp");
+ test<2,3>("SOURCE_DIR/grids/sphere_2.inp");
+ test<2,3>("SOURCE_DIR/grids/sphere_3.inp");
+ test<2,3>("SOURCE_DIR/grids/sphere_4.inp");
return 0;
}
#include<deal.II/lac/full_matrix.h>
#include<deal.II/base/tensor.h>
-std::ofstream logfile("tensor_matrix_conversion/output");
+std::ofstream logfile("output");
template <typename number>
#include <fstream>
#include <string>
-std::ofstream logfile("torus_01/output");
+std::ofstream logfile("output");
int main ()
int main ()
{
- std::ofstream logfile("transform_01/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);