#integrators
ADD_SUBDIRECTORY(lac)
#lib
-#matrix_free
+ADD_SUBDIRECTORY(matrix_free)
#mesh_converter
ADD_SUBDIRECTORY(multigrid)
#serialization
--- /dev/null
+DEAL_II_PICKUP_TESTS()
#include "create_mesh.h"
-std::ofstream logfile("compress_constraints/output");
+std::ofstream logfile("output");
#include "create_mesh.h"
-std::ofstream logfile("compress_mapping/output");
+std::ofstream logfile("output");
#include "../tests.h"
#include <deal.II/base/function.h>
-std::ofstream logfile("copy/output");
+std::ofstream logfile("output");
#include "matrix_vector_common.h"
#include "../tests.h"
-std::ofstream logfile("estimate_condition_number_mass/output");
+std::ofstream logfile("output");
#include <deal.II/matrix_free/matrix_free.h>
#include <deal.II/matrix_free/fe_evaluation.h>
#include "../tests.h"
-std::ofstream logfile("get_functions_cartesian/output");
+std::ofstream logfile("output");
#include "get_functions_common.h"
#include "../tests.h"
-std::ofstream logfile("get_functions_circle/output");
+std::ofstream logfile("output");
#include "get_functions_common.h"
#include "../tests.h"
-std::ofstream logfile("get_functions_constraints/output");
+std::ofstream logfile("output");
#include "get_functions_common.h"
#include <deal.II/base/function.h>
#include "create_mesh.h"
-std::ofstream logfile("get_functions_float/output");
+std::ofstream logfile("output");
#include "get_functions_common.h"
#include "../tests.h"
-std::ofstream logfile("get_functions_gl/output");
+std::ofstream logfile("output");
#include "get_functions_common.h"
#include "../tests.h"
-std::ofstream logfile("get_functions_mappingq/output");
+std::ofstream logfile("output");
#include "get_functions_common.h"
#include <iostream>
-std::ofstream logfile("get_functions_multife/output");
+std::ofstream logfile("output");
template <int dim, int fe_degree, int n_q_points_1d=fe_degree+1, typename Number=double>
#include <iostream>
-std::ofstream logfile("get_functions_multife2/output");
+std::ofstream logfile("output");
template <int dim, int fe_degree, int n_q_points_1d=fe_degree+1, typename Number=double>
#include <deal.II/numerics/vector_tools.h>
#include <deal.II/base/function.h>
-std::ofstream logfile("get_functions_q_hierarchical/output");
+std::ofstream logfile("output");
#include "get_functions_common.h"
#include "../tests.h"
-std::ofstream logfile("get_functions_rect/output");
+std::ofstream logfile("output");
#include "get_functions_common.h"
#include <fstream>
#include <iostream>
-std::ofstream logfile("get_functions_variants/output");
+std::ofstream logfile("output");
template <int dim, int fe_degree, typename Number>
#include <fstream>
#include <iostream>
-std::ofstream logfile("get_values_plain/output");
+std::ofstream logfile("output");
template <int dim, int fe_degree, int n_q_points_1d=fe_degree+1, typename Number=double>
#include <iostream>
-std::ofstream logfile("integrate_functions/output");
+std::ofstream logfile("output");
template <int dim, int fe_degree, typename Number>
#include <iostream>
-std::ofstream logfile("integrate_functions_multife/output");
+std::ofstream logfile("output");
template <int dim, int fe_degree, typename Number>
#include <iostream>
-std::ofstream logfile("integrate_functions_multife2/output");
+std::ofstream logfile("output");
template <int dim, int fe_degree, typename Number>
#include "../tests.h"
-std::ofstream logfile("matrix_vector_01/output");
+std::ofstream logfile("output");
#include "matrix_vector_common.h"
#include "../tests.h"
#include <deal.II/base/function.h>
-std::ofstream logfile("matrix_vector_02/output");
+std::ofstream logfile("output");
#include "matrix_vector_common.h"
#include "../tests.h"
#include <deal.II/base/function.h>
-std::ofstream logfile("matrix_vector_03/output");
+std::ofstream logfile("output");
#include "matrix_vector_common.h"
#include "../tests.h"
-std::ofstream logfile("matrix_vector_04/output");
+std::ofstream logfile("output");
#include "matrix_vector_common.h"
#include "../tests.h"
-std::ofstream logfile("matrix_vector_05/output");
+std::ofstream logfile("output");
#include "matrix_vector_common.h"
#include <deal.II/base/function.h>
#include "create_mesh.h"
-std::ofstream logfile("matrix_vector_06/output");
+std::ofstream logfile("output");
#include "matrix_vector_common.h"
#include <deal.II/base/function.h>
#include <deal.II/fe/fe_dgq.h>
-std::ofstream logfile("matrix_vector_07/output");
+std::ofstream logfile("output");
#include "matrix_vector_common.h"
#include <deal.II/base/function.h>
#include "create_mesh.h"
-std::ofstream logfile("matrix_vector_08/output");
+std::ofstream logfile("output");
#include "matrix_vector_common.h"
#include <deal.II/base/function.h>
#include "create_mesh.h"
-std::ofstream logfile("matrix_vector_09/output");
+std::ofstream logfile("output");
#include "matrix_vector_common.h"
#include "../tests.h"
-std::ofstream logfile("matrix_vector_curl/output");
+std::ofstream logfile("output");
#include <deal.II/matrix_free/matrix_free.h>
#include <deal.II/matrix_free/fe_evaluation.h>
#include "../tests.h"
-std::ofstream logfile("matrix_vector_div/output");
+std::ofstream logfile("output");
#include <deal.II/matrix_free/matrix_free.h>
#include <deal.II/matrix_free/fe_evaluation.h>
#include "../tests.h"
-std::ofstream logfile("matrix_vector_float/output");
+std::ofstream logfile("output");
#include "create_mesh.h"
#include "matrix_vector_common.h"
#include "../tests.h"
-std::ofstream logfile("matrix_vector_hp/output");
+std::ofstream logfile("output");
#include "matrix_vector_common.h"
#include <deal.II/hp/dof_handler.h>
#include "../tests.h"
-std::ofstream logfile("matrix_vector_mg/output");
+std::ofstream logfile("output");
#include "matrix_vector_common.h"
#include <deal.II/multigrid/mg_tools.h>
#include "../tests.h"
-std::ofstream logfile("matrix_vector_stokes/output");
+std::ofstream logfile("output");
#include <deal.II/matrix_free/matrix_free.h>
#include <deal.II/matrix_free/fe_evaluation.h>
#include "../tests.h"
-std::ofstream logfile("matrix_vector_stokes_noflux/output");
+std::ofstream logfile("output");
#include <deal.II/matrix_free/matrix_free.h>
#include <deal.II/matrix_free/fe_evaluation.h>
#include "../tests.h"
-std::ofstream logfile("no_index_initialize/output");
+std::ofstream logfile("output");
#include <deal.II/matrix_free/matrix_free.h>
#include <deal.II/matrix_free/fe_evaluation.h>
#include <fstream>
#include <iostream>
-std::ofstream logfile("quadrature_points/output");
+std::ofstream logfile("output");
template <int dim, int fe_degree>
int main ()
{
- std::ofstream logfile("step-37/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision (3);
deallog.threshold_double(1e-10);
#include <deal.II/base/function.h>
#include "create_mesh.h"
-std::ofstream logfile("thread_correctness/output");
+std::ofstream logfile("output");
#include "matrix_vector_common.h"
#include "../tests.h"
-std::ofstream logfile("thread_correctness_hp/output");
+std::ofstream logfile("output");
#include "create_mesh.h"
#include "matrix_vector_common.h"
#include <deal.II/fe/mapping_q_eulerian.h>
-std::ofstream logfile("update_mapping_only/output");
+std::ofstream logfile("output");
#include "get_functions_common.h"