datafunc/conv_flux.m [code] | |
datafunc/conv_flux_linearization.m [code] | |
datafunc/diffusivity.m [code] | |
datafunc/diffusivity_cached.m [code] | Compute diffusivity tensor for geometry transformation and store results in a cache |
datafunc/dirichlet_values.m [code] | UDIRICHLET = DIRICHLET_VALUES([X],[Y], MODEL) Examples dirichlet_values([0,1,2],[1,1,1],struct(name_dirichlet_values , homogeneous , ... c_dir , 1)) dirichlet_values([0:0.1:1],[0],struct(name_dirichlet_values , xstripes , ... c_dir , [0 1 2], ... dir_borders , [0.3 0.6])) dirichlet_values([0:0.1:1],[0],struct(name_dirichlet_values , box , ... c_dir , 1, ... dir_box_xrange , [0.3 0.6], ... dir_box_yrange , [-0.1 0.1])) |
datafunc/eval_affine_decomp.m [code] | |
datafunc/geometry_transformation.m [code] | |
datafunc/gradient_approx.m [code] | |
datafunc/gradient_approx2.m [code] | |
datafunc/gradient_approx_matrix.m [code] | |
datafunc/init_values.m [code] | |
datafunc/inv_geo_trans_derivative.m [code] | Computes entries of a geometry transformation function's inverse transposed jacobian |
datafunc/myspline.m [code] | |
datafunc/neuman_values.m [code] | |
datafunc/output_functional.m [code] | |
datafunc/output_functional_boundary_integral.m [code] | |
datafunc/reaction.m [code] | |
datafunc/velocity.m [code] | |
datafunc/+TwoPhaseData/BrooksCorey.m [code] | |
datafunc/+TwoPhaseData/Interface.m [code] | |
datafunc/+TwoPhaseData/Michel.m [code] | |
datafunc/+TwoPhaseData/MichelPrsLin.m [code] | |
datafunc/+TwoPhaseData/MichelSimple.m [code] | |
datafunc/auxiliary/cache_velocity_matrixfile_extract.m [code] | |
datafunc/auxiliary/check_or_generate_velocity_matrixfile.m [code] | |
datafunc/auxiliary/clear_all_caches.m [code] | This function clears the caches generated for caching of gradient data in evolution schemes |
datafunc/auxiliary/velocity_matrixfile_extract.m [code] | |
datafunc/conv_flux/conv_flux_affine_decomposed.m [code] | Function evaluating a function in the list of global coordinates specified in the columns of glob |
datafunc/conv_flux/conv_flux_brooks_corey.m [code] | Convective flux for Buckley-Leverett problem with Brooks-Corey functions |
datafunc/conv_flux/conv_flux_brooks_corey_derivative.m [code] | Convective flux for Buckley-Leverett problem with Brooks-Corey functions |
datafunc/conv_flux/conv_flux_brooks_corey_simple.m [code] | Convective flux for Buckley-Leverett problem with Brooks-Corey functions |
datafunc/conv_flux/conv_flux_brooks_corey_simple_derivative.m [code] | Convective flux for Buckley-Leverett problem with Brooks-Corey functions |
datafunc/conv_flux/conv_flux_buckley_leverett.m [code] | Convective flux for Buckley-Leverett problem |
datafunc/conv_flux/conv_flux_buckley_leverett_derivative.m [code] | |
datafunc/conv_flux/conv_flux_burgers.m [code] | Function computing the convective flux of a Burgers problem |
datafunc/conv_flux/conv_flux_burgers_parabola.m [code] | Convective flux of a Burgers problem |
datafunc/conv_flux/conv_flux_forward_difference.m [code] | Function computing the derivative of a convective flux by forward difference |
datafunc/conv_flux/conv_flux_gdl2.m [code] | Function computing the convective flux of a convection problem |
datafunc/conv_flux/conv_flux_linear.m [code] | Function computing the convective flux of a convection problem |
datafunc/conv_flux/conv_flux_to_be_distributed_in_single_files.m [code] | |
datafunc/conv_flux/conv_flux_velocity_matrixfile.m [code] | Function computing the convective flux of a convection problem |
datafunc/diffusivity/diffusivity_buckley_leverett.m [code] | |
datafunc/diffusivity/diffusivity_buckley_leverett_derivative.m [code] | |
datafunc/diffusivity/diffusivity_buckley_leverett_simple.m [code] | |
datafunc/diffusivity/diffusivity_buckley_leverett_simple_derivative.m [code] | |
datafunc/diffusivity/diffusivity_composite.m [code] | |
datafunc/diffusivity/diffusivity_composite_components.m [code] | Glob is a npoints times 2 matrix |
datafunc/diffusivity/diffusivity_exponential.m [code] | |
datafunc/diffusivity/diffusivity_exponential_derivative.m [code] | |
datafunc/diffusivity/diffusivity_homogeneous.m [code] | |
datafunc/diffusivity/diffusivity_linear_gradient2.m [code] | |
datafunc/diffusivity/diffusivity_richards_nonlinear.m [code] | |
datafunc/diffusivity/diffusivity_zero.m [code] | |
datafunc/diffusivity_tensor/diffusivity_tensor_richards.m [code] | |
datafunc/diffusivity_tensor/diffusivity_tensor_zero.m [code] | |
datafunc/dirichlet_values/dirichlet_values_affine_decomposed.m [code] | |
datafunc/dirichlet_values/dirichlet_values_homogeneous.m [code] | Function computing homogeneous dirichlet-values by pointwise evaluations |
datafunc/dirichlet_values/dirichlet_values_leftright.m [code] | |
datafunc/dirichlet_values/dirichlet_values_quarter_of_five.m [code] | |
datafunc/dirichlet_values/dirichlet_values_uplow.m [code] | |
datafunc/dirichlet_values/dirichlet_values_weighted_boxes.m [code] | |
datafunc/dirichlet_values/dirichlet_values_weighted_boxes_coefficients.m [code] | |
datafunc/dirichlet_values/dirichlet_values_weighted_boxes_components.m [code] | |
datafunc/init_values/exact_function_heat_equation.m [code] | |
datafunc/init_values/exact_function_plaplace.m [code] | This is the first function from http://eqworld.ipmnet.ru/en/solutions/npde/npde1201.pdf |
datafunc/init_values/init_values_affine_decomposed.m [code] | |
datafunc/init_values/init_values_as_dirichlet.m [code] | |
datafunc/init_values/init_values_bars.m [code] | |
datafunc/init_values/init_values_bl.m [code] | |
datafunc/init_values/init_values_blobs.m [code] | |
datafunc/init_values/init_values_gradient_box.m [code] | Init value function with a gradient box profile in Y-direction as output |
datafunc/init_values/init_values_grey_image.m [code] | |
datafunc/init_values/init_values_homogeneous.m [code] | |
datafunc/init_values/init_values_old_to_be_split_in_files.m [code] | |
datafunc/init_values/init_values_transformed_blobs.m [code] | |
datafunc/init_values/init_values_transformed_blobs_richards.m [code] | |
datafunc/init_values/init_values_wave.m [code] | |
datafunc/init_values/init_values_waveproduct.m [code] | Product of two sinus waves in both coordinate directions |
datafunc/neumann_values/neumann_values_affine_decomposed.m [code] | |
datafunc/neumann_values/neumann_values_homogeneous.m [code] | |
datafunc/neumann_values/neumann_values_outflow.m [code] | |
datafunc/neumann_values/neumann_values_pressure_gdl.m [code] | |
datafunc/neumann_values/neumann_values_rightflow.m [code] | |
datafunc/neumann_values/neumann_values_zero.m [code] | |
datafunc/output_functional/output_function_box_mean.m [code] | |
datafunc/output_functional/output_functional_volume_integral.m [code] | |
datafunc/velocity/velocity_affine_decomposed.m [code] | |
datafunc/velocity/velocity_parabola.m [code] | Parabolic velocity field |
datafunc/velocity/velocity_richards.m [code] | |
datafunc/velocity/velocity_to_be_distributed_in_single_files.m [code] | |
datafunc/velocity/velocity_transport.m [code] | |
demos/demo_cubegrid.m [code] | Demo_cubegrid small script demonstrating the possibilities of the cubegrid class |
demos/demo_edge_quad.m [code] | Demonstration of the edge-quadratures over a grid |
demos/demo_femdiscfunc.m [code] | |
demos/demo_interpol.m [code] | |
demos/demo_ldgfunc.m [code] | |
demos/demo_quadratures.m [code] | Small script demonstrating interval integration of polynomials of degree pdeg with quadratures of degreed qdeg |
demos/demo_rb_gui.m [code] | |
demos/demo_rb_nonlin_symmetry.m [code] | Demo_rb_nonlin_symmetry |
demos/demo_rb_richards_fv.m [code] | A small script demonstrating the online phase of the two models from the diploma thesis "Reduzierte-Basis Methoden für unges\"{a}ttigte Grundwasserstr"{o}mungen" |
demos/demo_rb_riemann_burgers.m [code] | Demo_rb_riemann_burgers |
demos/demo_rb_steps.m [code] | Small collection of RBmatlab's rb-simulation abilities please inspect the source-file during execution, as the main purpose is to demonstrate the possibilities of RBmatlab's rb-philosophy |
demos/demo_rectgrid.m [code] | Small script demonstrating the possibilities of the rectgrid class |
demos/demo_thermalblock.m [code] | Demo_thermalblock |
demos/demo_triagrid.m [code] | Small script demonstrating the possibilities of the triagrid class |
demos/rbmatlabdemos.m [code] | RBMATLABDEMOS Set up rbmatlab command line demos. This GUI lets you start some common rbmatlab demos |
discfunc/+Fv/+TwoPhase/DivergenceSpace.m [code] | |
discfunc/+Fv/+TwoPhase/PressureMean.m [code] | |
discfunc/+Fv/+TwoPhase/SaturationSpace.m [code] | |
discfunc/+Fv/+TwoPhase/VelocitySpace.m [code] | |
discfunc/common/basis_orthonormalization_matrix.m [code] | |
discfunc/common/copy_model_data_to_plot_params.m [code] | Helper function copying extracting relevant information for plot_params from the model |
discfunc/common/copy_model_descr_to_plot_params.m [code] | |
discfunc/common/df_func_difference_sqr.m [code] | |
discfunc/common/disc_init_values.m [code] | |
discfunc/common/func_phi_product.m [code] | |
discfunc/common/ILocalizedOperator.m [code] | |
discfunc/common/inner_product.m [code] | |
discfunc/common/inner_product_matrix.m [code] | |
discfunc/common/ISeparableFunction.m [code] | |
discfunc/common/ISeparableOperator.m [code] | |
discfunc/common/l2project.m [code] | |
discfunc/common/LocalizedOperatorDefault.m [code] | |
discfunc/common/plot_discfunc.m [code] | |
discfunc/common/plot_sequence.m [code] | Plotting a sequence of data slices on polygonal 2d grid (constructed from params if empty) and providing a slider for changing between the data slices |
discfunc/common/plot_subplot_sequence.m [code] | Plotting a sequence of data slices on polygonal 2d grid (constructed from params if empty) and providing a slider for changing between the data slices |
discfunc/common/SeparableFunctionDefault.m [code] | |
discfunc/fem/evaluate_gradient.m [code] | |
discfunc/fem/fem_basis_weight_matrix.m [code] | |
discfunc/fem/fem_evaluate.m [code] | |
discfunc/fem/fem_evaluate_basis.m [code] | |
discfunc/fem/fem_evaluate_basis_function.m [code] | |
discfunc/fem/fem_evaluate_scalar_basis_derivative.m [code] | |
discfunc/fem/fem_evaluate_scalar_basis_function_derivative.m [code] | |
discfunc/fem/fem_global_dof_index.m [code] | Function computing the local-to-global dof map of a fem discrete function |
discfunc/fem/fem_h10_norm.m [code] | |
discfunc/fem/fem_h1_norm.m [code] | |
discfunc/fem/fem_interpol_global.m [code] | |
discfunc/fem/fem_interpol_local.m [code] | |
discfunc/fem/fem_l2_boundary_inner_product_matrix.m [code] | Function computing the matrix of the l2 inner product on the boundary specified through elind and edgeind. elind and edgeind have to be vectors of the same length |
discfunc/fem/fem_l2_norm.m [code] | |
discfunc/fem/fem_laplace.m [code] | |
discfunc/fem/fem_matrix_adv_integral_kernel.m [code] | |
discfunc/fem/fem_matrix_boundary_part_assembly.m [code] | Auxiliary function assembling the boundary integral components of system matrix A note: cell-array valued kernels can be integrated |
discfunc/fem/fem_matrix_diff_integral_kernel.m [code] | |
discfunc/fem/fem_matrix_neumann_integral_kernel.m [code] | |
discfunc/fem/fem_matrix_parts_assembly.m [code] | |
discfunc/fem/fem_matrix_reac_integral_kernel.m [code] | |
discfunc/fem/fem_matrix_robin_integral_kernel.m [code] | |
discfunc/fem/fem_matrix_volume_part_assembly.m [code] | |
discfunc/fem/fem_ndofs.m [code] | |
discfunc/fem/fem_ndofs_per_element.m [code] | |
discfunc/fem/fem_operators.m [code] | |
discfunc/fem/fem_operators_output.m [code] | |
discfunc/fem/fem_operators_output_boundary_integral.m [code] | |
discfunc/fem/fem_operators_output_volume_integral.m [code] | |
discfunc/fem/fem_plot_dofmap.m [code] | |
discfunc/fem/fem_rhs_boundary_part_assembly.m [code] | |
discfunc/fem/fem_rhs_neumann_integral_kernel.m [code] | |
discfunc/fem/fem_rhs_parts_assembly.m [code] | |
discfunc/fem/fem_rhs_robin_integral_kernel.m [code] | |
discfunc/fem/fem_rhs_volume_part_assembly.m [code] | |
discfunc/fem/fem_scalar_component.m [code] | |
discfunc/fem/femdiscfunc.m [code] | |
discfunc/fem/feminfo.m [code] | |
discfunc/fem/H10_scalar_product_matrix.m [code] | This routine computes the stiffness matrix for a constant c=1. K_one = int_omega (grad phi_j) . grad phi_i dx |
discfunc/fem/lagrange_nodes_edges.m [code] | |
discfunc/fem/lagrange_nodes_edges_llcoord.m [code] | |
discfunc/fem/lagrange_nodes_lcoord.m [code] | |
discfunc/fv/Contents.m [code] | FV |
discfunc/fv/fv_coercivity_bound.m [code] | |
discfunc/fv/fv_conv_diff.m [code] | |
discfunc/fv/fv_conv_diff_explicit_space.m [code] | Fv_conv_diff_explicit_space(U,NU_ind,grid,model) |
discfunc/fv/fv_conv_diff_step.m [code] | |
discfunc/fv/fv_conv_explicit_space.m [code] | Fv_conv_explicit_space(U,NU_ind,grid,params) function applying an FV-space-discretization operator starting from old values U corresponding to the geometry given in grid producing a new vector of elementwise scalars NU but only on for the subelements with numbers given in NU_ind. If NU_ind is empty, all new values NU are determined, i.e. length(NU) = length(U) = grid.nelements |
discfunc/fv/fv_conv_flux_linearization_matrix.m [code] | |
discfunc/fv/fv_conv_flux_matrix.m [code] | Function computing the flux matrix of a convection problem. simply reformatting the grid data suitably for pointwise evaluation by conv_flux. As evaluation points the points of suitable gauss-quadratures are chosen. The degree can be chosen in the model structure |
discfunc/fv/fv_diff_explicit_space.m [code] | Fv_diff_explicit_space(U,NU_ind,grid,params) |
discfunc/fv/fv_element_mean.m [code] | Function computing the element averages of a discrete function U in the grid elements with indices I. Most arguments are dummy, but required for more general discrete functions, e.g. p1, etc |
discfunc/fv/fv_error.m [code] | |
discfunc/fv/fv_estimate_coercivity_alpha.m [code] | |
discfunc/fv/fv_evaluate_basis.m [code] | |
discfunc/fv/fv_explicit_space.m [code] | |
discfunc/fv/fv_frechet_operators_conv_flux_waterflow_upwind.m [code] | Computes a jacobian of implicit non-linear convective contributions to time evolution matrices at a point (S,U) |
discfunc/fv/fv_frechet_operators_diff_flux_pressure_gradient.m [code] | Computes a jacobian of implicit non-linear convective contributions to time evolution matrices at a point (P,S) |
discfunc/fv/fv_frechet_operators_diff_implicit_gradient.m [code] | Computes a jacobian of implicit non-linear diffusion contributions to time evolution matrices at a point U |
discfunc/fv/fv_frechet_operators_diff_implicit_gradient2.m [code] | Computes a jacobian of implicit non-linear diffusion contributions to time evolution matrices at a point U |
discfunc/fv/fv_frechet_operators_diff_implicit_gradient3.m [code] | Computes a jacobian of implicit non-linear diffusion contributions to time evolution matrices at a point U |
discfunc/fv/fv_h1_inner_product_matrix.m [code] | Function computing the h1 inner product matrix for fv-functions on the grid |
discfunc/fv/fv_implicit_space.m [code] | Fv_implicit_space(model, model_data, U, [NU_ind]) |
discfunc/fv/fv_init_values.m [code] | |
discfunc/fv/fv_inner_product.m [code] | |
discfunc/fv/fv_inner_product_matrix.m [code] | |
discfunc/fv/fv_l1l2_error.m [code] | |
discfunc/fv/fv_l2_error.m [code] | Function computing the l2-error between the two fv-functions or function sequences in U1,U2 |
discfunc/fv/fv_l2l2_error.m [code] | |
discfunc/fv/fv_l2project.m [code] | Func to the fv space. A quadrature of degree qdeg is used |
discfunc/fv/fv_linfty_error.m [code] | Compute the infinity-norm error between two Dof vectors |
discfunc/fv/fv_local_mass_matrix_rect.m [code] | |
discfunc/fv/fv_local_mass_matrix_tria.m [code] | |
discfunc/fv/fv_mass_matrix.m [code] | |
discfunc/fv/fv_num_conv_flux.m [code] | |
discfunc/fv/fv_num_conv_flux_engquist_osher.m [code] | Function computing a numerical convective Engquist-Osher flux matrix |
discfunc/fv/fv_num_conv_flux_lax_friedrichs.m [code] | Function computing a numerical convective Lax-Friedrichs flux matrix |
discfunc/fv/fv_num_conv_flux_waterflow_upwind.m [code] | |
discfunc/fv/fv_num_diff_flux.m [code] | |
discfunc/fv/fv_num_diff_flux_gradient.m [code] | Computes a numerical diffusive flux for a diffusion problem |
discfunc/fv/fv_num_diff_flux_gradient_tensor.m [code] | Computes a numerical diffusive flux for a diffusion problem including a tensor |
discfunc/fv/fv_num_diff_flux_pressure_gradient.m [code] | Computes a numerical diffusive flux for a diffusion problem |
discfunc/fv/fv_operators_conv_explicit_engquist_osher.m [code] | Computes convection contribution to finite volume time evolution matrices, or their Frechet derivative |
discfunc/fv/fv_operators_conv_explicit_lax_friedrichs.m [code] | Computes convection contribution to finite volume time evolution matrices, or their Frechet derivative |
discfunc/fv/fv_operators_conv_flux_waterflow_upwind.m [code] | Computes convection contribution to finite volume time evolution matrices, or their Frechet derivative |
discfunc/fv/fv_operators_diff_implicit_gradient.m [code] | Computes diffusion contributions to finite volume time evolution matrices, or their Frechet derivative |
discfunc/fv/fv_operators_diff_implicit_gradient2.m [code] | Computes diffusion contributions to finite volume time evolution matrices, or their Frechet derivative |
discfunc/fv/fv_operators_diff_implicit_gradient_tensor.m [code] | |
discfunc/fv/fv_operators_implicit.m [code] | |
discfunc/fv/fv_operators_implicit_explicit.m [code] | |
discfunc/fv/fv_operators_neumann_explicit.m [code] | Computes a neumann contribution matrix for finite volume time evolution operators, or their Frechet derivative |
discfunc/fv/fv_operators_output.m [code] | Function returning components, coefficients, and complete operator for a linear output functional on fv discrete functions |
discfunc/fv/fv_operators_zero.m [code] | |
discfunc/fv/fv_plot.m [code] | Routine plotting a single fv function of fv_functions |
discfunc/fv/fv_search_max_lxf_lambda.m [code] | |
discfunc/fv/fv_space_operator.m [code] | Fv_space_operator(model,model_data,U,NU_ind,grid,weights) |
discfunc/fv/fv_two_phase_es.m [code] | |
discfunc/fv/fv_two_phase_hess_fun.m [code] | |
discfunc/fv/fv_two_phase_imp.m [code] | |
discfunc/fv/fv_two_phase_space.m [code] | |
discfunc/fv/reaction_term.m [code] | |
discfunc/ldg/ldg_basis_orthonormalization_matrix.m [code] | |
discfunc/ldg/ldg_basis_weight_matrix.m [code] | |
discfunc/ldg/ldg_conv_detailed_simulation.m [code] | |
discfunc/ldg/ldg_edge_flux_operator_fct.m [code] | |
discfunc/ldg/ldg_edge_num_flux_matrix.m [code] | |
discfunc/ldg/ldg_element_flux_operator_fct.m [code] | |
discfunc/ldg/ldg_evaluate.m [code] | |
discfunc/ldg/ldg_evaluate_basis.m [code] | |
discfunc/ldg/ldg_evaluate_basis_derivative.m [code] | |
discfunc/ldg/ldg_evaluate_scalar_basis_derivative.m [code] | |
discfunc/ldg/ldg_inv_mass_matrix.m [code] | |
discfunc/ldg/ldg_l2error.m [code] | |
discfunc/ldg/ldg_l2project.m [code] | |
discfunc/ldg/ldg_local_mass_matrix.m [code] | |
discfunc/ldg/ldg_mass_matrix.m [code] | |
discfunc/ldg/ldg_ndofs.m [code] | |
discfunc/ldg/ldg_ndofs_per_element.m [code] | |
discfunc/ldg/ldg_numerical_flux_operator_fct.m [code] | |
discfunc/ldg/ldg_operators_adv_explicit.m [code] | |
discfunc/ldg/ldg_operators_explicit.m [code] | |
discfunc/ldg/ldg_params.m [code] | |
discfunc/ldg/ldg_plot.m [code] | |
discfunc/ldg/ldg_scalar_component.m [code] | |
discfunc/ldg/ldg_zero.m [code] | |
discfunc/ldg/ldginfo.m [code] | |
discfunc/ldg/@ldgdiscfunc/display.m [code] | |
discfunc/ldg/@ldgdiscfunc/evaluate.m [code] | |
discfunc/ldg/@ldgdiscfunc/ldgdiscfunc.m [code] | |
discfunc/ldg/@ldgdiscfunc/subsasgn.m [code] | |
discfunc/ldg/@ldgdiscfunc/subsref.m [code] | |
doxygen/developers.c [code] | |
doxygen/doxygen.m [code] | Here comes a short description text |
doxygen/dummyclasses.c [code] | |
doxygen/groups.c [code] | |
doxygen/maindoc.c [code] | |
doxygen/namespaces.c [code] | |
doxygen/praktikum.c [code] | |
fakeMPI/FakeMPI.m [code] | |
general/CacheableObject.m [code] | |
general/gplmm.m [code] | Global projected Levenberg-Marquard method |
general/htdoc.m [code] | Opens mtoc++ documentation in a browser |
general/MatlabDocMaker.m [code] | |
general/merge_model_plot_params.m [code] | |
general/newton_raphson.m [code] | Global projected Levenberg-Marquard method |
general/rbmatlabhome.m [code] | |
general/rbmatlabresult.m [code] | |
general/rbmatlabtemp.m [code] | |
general/remote_function.m [code] | |
general/show_abstract_members.m [code] | Displays unimplemented abstract methods of class with name class_name |
general/+DataTree/CreatorDefault.m [code] | |
general/+DataTree/DefaultNode.m [code] | |
general/+DataTree/DummyLeafNode.m [code] | |
general/+DataTree/DummyMerger.m [code] | |
general/+DataTree/ICreator.m [code] | |
general/+DataTree/IdMapNode.m [code] | |
general/+DataTree/ILeafNode.m [code] | |
general/+DataTree/INode.m [code] | |
general/+DataTree/LeafDescription.m [code] | |
general/+DataTree/NullCreator.m [code] | |
general/+DataTree/PpartNode.m [code] | |
general/+DataTree/ScalarCreator.m [code] | |
general/+DataTree/TpartNode.m [code] | |
general/+Postprocess/plot_as_tikzfile.m [code] | Postprocesses a figure and write out an image and a text file that can be included in TeX documents |
general/+Postprocess/plot_trajectories.m [code] | Function generating a tikz graphic showing trajectories for certain selected parameters |
general/+Postprocess/+StochasticAssessment/Assessment.m [code] | |
general/+Postprocess/+StochasticAssessment/Output.m [code] | |
general/basic/add_to_array.m [code] | |
general/basic/copy_field_if_exists.m [code] | |
general/basic/count_column_frequency.m [code] | |
general/basic/couple_N_and_M_by_c.m [code] | Modifies the reduced basis size fields of model by a single variable |
general/basic/detect_duplicate_rows.m [code] | |
general/basic/disp_deprecated.m [code] | |
general/basic/find_corresp.m [code] | |
general/basic/isequal_ignore_handles.m [code] | |
general/basic/isequal_ignore_handles_nan_treatment.m [code] | |
general/basic/lincomb_sequence.m [code] | |
general/basic/lincomb_sequence2.m [code] | |
general/basic/lincomb_sequence3.m [code] | |
general/basic/matrix2str.m [code] | |
general/basic/print_datatable.m [code] | |
general/basic/repmatrows.m [code] | |
general/basic/sin_sym.m [code] | |
general/basic/structcmp.m [code] | |
general/basic/structcpy.m [code] | Copies the fields of structure s2 into structure s1. If the field to be copied does not exist in s1 yet, a field with the appropriate name is created |
general/basic/subblock_sequence.m [code] | |
general/basic/test_affine_decomp.m [code] | |
general/filecaching/cache.m [code] | |
general/filecaching/filecache_clear.m [code] | |
general/filecaching/filecache_function.m [code] | Function used for file-caching other function calls |
general/filecaching/filecache_path.m [code] | |
general/filecaching/tictoc_wrapper.m [code] | |
general/geometry/area_triangle.m [code] | |
general/geometry/circumcenter_triangle.m [code] | |
general/geometry/cubequadrature.m [code] | Integration of function func over reference cube == unit cube. by Gaussian quadrature exactly integrating polynoms of poldeg |
general/geometry/dist_point_line.m [code] | |
general/geometry/get_intervalquadrature_points.m [code] | Returns local quadrature points and corresponding weights for a Gaussian quadrature rule for a function defined on a 1d interval |
general/geometry/get_quadrature_weights_1d.m [code] | Returns local quadrature points and corresponding weights for a Gaussian quadrature rule for a function defined on a 1d interval |
general/geometry/intervalquadrature.m [code] | Integration of function func over reference interval == unit interval. by Gaussian quadrature exactly integrating polynoms of poldeg |
general/geometry/quadrature.m [code] | |
general/geometry/spline_select.m [code] | |
general/geometry/triaquadrature.m [code] | |
general/geometry/XPartMap.m [code] | |
general/help/class_help.m [code] | Prints out class structure and documentation for a given classname or object |
general/postprocess/plot_as_tikzfile.m [code] | Postprocesses a figure and write out an image and a text file that can be included in TeX documents |
general/postprocess/plot_error_landscape.m [code] | Plots an output structure generated by stochastic_error_estimation() |
general/vecmat/delzerocolumns.m [code] | Function deleting zero-columns from matrix X |
general/vecmat/find_vector.m [code] | |
general/vecmat/gram_matrix.m [code] | |
general/vecmat/improve_conditioning.m [code] | |
general/vecmat/model_orthonormalize.m [code] | |
general/vecmat/model_orthonormalize_gram_schmidt.m [code] | |
general/vecmat/model_orthonormalize_qr.m [code] | |
general/vecmat/model_PCA_fixspace.m [code] | |
general/vecmat/orthonormalize.m [code] | |
general/vecmat/orthonormalize_chol.m [code] | |
general/vecmat/orthonormalize_gram_schmidt.m [code] | |
general/vecmat/orthonormalize_old.m [code] | |
general/vecmat/orthonormalize_qr.m [code] | |
general/vecmat/PCA_fixspace.m [code] | |
general/vecmat/power_vector2.m [code] | |
general/vecmat/power_vector2_derivative.m [code] | |
general/vecmat/rand_uniform.m [code] | |
general/vecmat/regular_submatrix_indices.m [code] | |
general/vecmat/spblkdiag.m [code] | |
general/vecmat/svds_batch.m [code] | |
general/vecmat/veccomp1.m [code] | |
general/vecmat/veccomp2.m [code] | |
general/vecmat/vectorset_difference.m [code] | |
general/verbosity/verbose.m [code] | This function displays messages depending on a message-id and/or a level. Aditionally you can set/reset the level-filer and add ore remove message-ids to the include and exclude lists |
grid/@cubegrid/check_consistency.m [code] | |
grid/@cubegrid/coord2leaf_element.m [code] | |
grid/@cubegrid/cubegrid.m [code] | |
grid/@cubegrid/demo.m [code] | |
grid/@cubegrid/display.m [code] | |
grid/@cubegrid/get.m [code] | |
grid/@cubegrid/get_edges.m [code] | |
grid/@cubegrid/get_leafgids.m [code] | |
grid/@cubegrid/get_ranges_of_element.m [code] | |
grid/@cubegrid/get_volume.m [code] | |
grid/@cubegrid/gid2lid.m [code] | |
grid/@cubegrid/lid2gid.m [code] | |
grid/@cubegrid/plot.m [code] | |
grid/@cubegrid/plot_grid.m [code] | |
grid/@cubegrid/plot_leafelement_data.m [code] | |
grid/@cubegrid/plot_leafvertex_data.m [code] | |
grid/@cubegrid/refine.m [code] | |
grid/@cubegrid/remove_duplicate_vertices.m [code] | |
grid/@gridbase/check_consistency.m [code] | |
grid/@gridbase/display.m [code] | |
grid/@gridbase/edge_quad_eval.m [code] | |
grid/@gridbase/edge_quad_eval_mean.m [code] | |
grid/@gridbase/edge_quad_points.m [code] | |
grid/@gridbase/get_edge_points.m [code] | |
grid/@gridbase/get_enbi.m [code] | |
grid/@gridbase/gridbase.m [code] | |
grid/@gridbase/gridpart.m [code] | |
grid/@gridbase/inspect.m [code] | |
grid/@gridbase/plot_element_data.m [code] | |
grid/@gridbase/plot_element_data_sequence.m [code] | |
grid/@gridbase/plot_polygon_grid.m [code] | |
grid/@gridbase/plot_vertex_data.m [code] | |
grid/@gridbase/set_boundary_types.m [code] | |
grid/@onedgrid/gridpart.m [code] | |
grid/@onedgrid/onedgrid.m [code] | |
grid/@rectgrid/demo.m [code] | |
grid/@rectgrid/isequal.m [code] | |
grid/@rectgrid/local2global.m [code] | |
grid/@rectgrid/plot.m [code] | |
grid/@rectgrid/rectgrid.m [code] | |
grid/@rectgrid/set_nbi.m [code] | |
grid/@triagrid/aff_trafo_glob2loc.m [code] | |
grid/@triagrid/aff_trafo_loc2glob.m [code] | |
grid/@triagrid/aff_trafo_orig2ref.m [code] | |
grid/@triagrid/demo.m [code] | |
grid/@triagrid/display.m [code] | |
grid/@triagrid/global2local.m [code] | |
grid/@triagrid/gridpart.m [code] | |
grid/@triagrid/llocal2local.m [code] | |
grid/@triagrid/local2global.m [code] | |
grid/@triagrid/micro2macro_map.m [code] | |
grid/@triagrid/plot.m [code] | |
grid/@triagrid/set_nbi.m [code] | |
grid/@triagrid/triagrid.m [code] | |
grid/alu3d/cog_elements_alu3d_hexa.m [code] | |
grid/alu3d/cog_faces_alu3d_hexa.m [code] | |
grid/alu3d/coord_faces_alu3d_hexa.m [code] | |
grid/alu3d/cut_alu3d_hexa.m [code] | |
grid/alu3d/face_in_matrix.m [code] | |
grid/alu3d/load_alu3d_hexa.m [code] | |
grid/alu3d/merge_alu3d_hexa.m [code] | |
grid/alu3d/plot_bnd_alu3d_hexa.m [code] | |
grid/alu3d/save_alu3d_hexa.m [code] | |
grid/common/compute_edge_indices.m [code] | Edge index matrix. This matrix maps each edge specified by the tuple (element_id, local_edge_id) to a unique and continuous edge index enumeration |
grid/common/construct_grid.m [code] | |
grid/common/index_ext.m [code] | |
grid/common/plot_data_sequence.m [code] | |
models/elliptic_discrete_model.m [code] | |
models/minimal_ei_descr.m [code] | |
models/nonlin_symmetry_descr.m [code] | |
models/poisson_model.m [code] | |
models/richards_fv_bg_descr.m [code] | |
models/richards_fv_descr.m [code] | Non-linear evolution equation with geometry transformation and an example of the Richards equation |
models/riemann_burgers_descr.m [code] | |
models/thermalblock_descr.m [code] | Thermal Block example similar as described in the book of A.T. patera and G. Rozza (just one parameter more) |
models/twophase_descr.m [code] | |
models/+ThermalBlock/DetailedModel.m [code] | |
models/common/default_plot_control.m [code] | DEFAULT_PLOT_CONTROL M-file for default_plot_control.fig DEFAULT_PLOT_CONTROL, by itself, creates a new DEFAULT_PLOT_CONTROL or raises the existing singleton* |
models/common/demo_rb_gui.m [code] | Reduced basis demo with sliders |
models/common/detailed_ei_rb_proj_simulation.m [code] | |
models/common/detailed_ei_simulation.m [code] | |
models/common/detailed_simulation.m [code] | |
models/common/dune_demo_rb_gui.m [code] | Reduced basis demo with sliders for a remotely running DUNE-rb server application |
models/common/gen_detailed_data.m [code] | |
models/common/gen_model_data.m [code] | |
models/common/gen_reduced_data.m [code] | |
models/common/model_default.m [code] | Model = model_default(model) |
models/common/optimize.m [code] | Opt_data = optimize(model, model_data, detailed_data, reduced_data) |
models/common/plot_detailed_data.m [code] | |
models/common/plot_sim_data.m [code] | Function performing the plot of the simulation results as specified in model |
models/common/postprocess_gravity.m [code] | Subtracts a previously added addent induced by gravitational effects |
models/common/rb_init_values.m [code] | |
models/common/rb_init_values_separable.m [code] | Function computing initial values for a reduced simulation |
models/common/rb_operators.m [code] | |
models/common/rb_reconstruction.m [code] | |
models/common/rb_simulation.m [code] | |
models/common/renew_model.m [code] | Change fields of old param structure to new model structure with excessive use of function pointers |
models/common/unitcube.m [code] | Function adding fields to model for generating a 2D rectgrid with 100 x 100 elements on the unit-square |
models/convdiff/convdiff_descr.m [code] | |
models/convdiff/convdiff_dune_descr.m [code] | Convection diffusion example using dune-rb for high dimensional computations and data structures |
models/inspiration/elliptic_debug_model.m [code] | |
models/inspiration/fem_poisson.m [code] | |
models/inspiration/praktikum_ellipt_model.m [code] | Small example of a model, i.e. a structure describing the data functions and geometry information of a general elliptic equation consisting of diffusion, convection, reaction equation: |
models/inspiration/praktikum_poisson_model.m [code] | Small example of a model, i.e. a structure describing the data functions and geometry information of a general elliptic equation consisting of diffusion, convection, reaction equation: |
models/inspiration/quadratic_poisson_model.m [code] | Quadratic poisson equation on unit interval |
rbasis/+LinEvol/DetailedData.m [code] | |
rbasis/+LinEvol/@DetailedModel/detailed_simulation.m [code] | |
rbasis/+LinEvol/@DetailedModel/DetailedModel.m [code] | |
rbasis/+LinEvol/@DetailedModel/gen_model_data.m [code] | |
rbasis/+LinEvol/@DetailedModel/plot_sim_data.m [code] | |
rbasis/+LinEvol/@ReducedData/rb_operators.m [code] | |
rbasis/+LinEvol/@ReducedData/ReducedData.m [code] | |
rbasis/+LinEvol/@ReducedModel/rb_simulation_impl.m [code] | |
rbasis/+LinEvol/@ReducedModel/ReducedModel.m [code] | |
rbasis/+LinEvolDune/DetailedModel.m [code] | |
rbasis/+LinEvolDune/ReducedData.m [code] | |
rbasis/+LinEvolDune/ReducedModel.m [code] | |
rbasis/+LinStat/descr_default.m [code] | Function initializing some fields of a lin-stat model |
rbasis/+LinStat/DetailedData.m [code] | |
rbasis/+LinStat/ReducedData.m [code] | |
rbasis/+LinStat/@DetailedModel/detailed_simulation.m [code] | |
rbasis/+LinStat/@DetailedModel/DetailedModel.m [code] | |
rbasis/+LinStat/@DetailedModel/gen_model_data.m [code] | |
rbasis/+LinStat/@DetailedModel/plot_sim_data.m [code] | |
rbasis/+LinStat/@ReducedModel/rb_simulation.m [code] | |
rbasis/+LinStat/@ReducedModel/ReducedModel.m [code] | |
rbasis/+NonlinEvol/descr_default.m [code] | Default discretization description for problems |
rbasis/+NonlinEvol/DetailedData.m [code] | |
rbasis/+NonlinEvol/EiRbReducedDataNode.m [code] | |
rbasis/+NonlinEvol/EiReducedDataNode.m [code] | |
rbasis/+NonlinEvol/RbReducedDataNode.m [code] | |
rbasis/+NonlinEvol/@DetailedModel/detailed_simulation.m [code] | |
rbasis/+NonlinEvol/@DetailedModel/DetailedModel.m [code] | |
rbasis/+NonlinEvol/@DetailedModel/gen_model_data.m [code] | |
rbasis/+NonlinEvol/@DetailedModel/plot_sim_data.m [code] | |
rbasis/+NonlinEvol/@ReducedData/rb_operators.m [code] | |
rbasis/+NonlinEvol/@ReducedData/ReducedData.m [code] | |
rbasis/+NonlinEvol/@ReducedModel/rb_simulation_impl.m [code] | |
rbasis/+NonlinEvol/@ReducedModel/ReducedModel.m [code] | |
rbasis/+TwoPhaseFlow/descr_default.m [code] | Default discretization description for problems |
rbasis/+TwoPhaseFlow/DetailedData.m [code] | |
rbasis/+TwoPhaseFlow/DetailedLeafNode.m [code] | |
rbasis/+TwoPhaseFlow/EiRbReducedDataNode.m [code] | |
rbasis/+TwoPhaseFlow/EiReducedDataNode.m [code] | |
rbasis/+TwoPhaseFlow/RbReducedDataNode.m [code] | |
rbasis/+TwoPhaseFlow/@DetailedModel/detailed_simulation.m [code] | |
rbasis/+TwoPhaseFlow/@DetailedModel/detailed_simulation_galerkin.m [code] | |
rbasis/+TwoPhaseFlow/@DetailedModel/detailed_simulation_impes.m [code] | |
rbasis/+TwoPhaseFlow/@DetailedModel/DetailedModel.m [code] | |
rbasis/+TwoPhaseFlow/@DetailedModel/gen_model_data.m [code] | |
rbasis/+TwoPhaseFlow/@DetailedModel/plot_sim_data.m [code] | |
rbasis/+TwoPhaseFlow/@ReducedData/ReducedData.m [code] | |
rbasis/+TwoPhaseFlow/@ReducedModel/rb_reconstruction.m [code] | |
rbasis/+TwoPhaseFlow/@ReducedModel/rb_simulation_impes_impl.m [code] | |
rbasis/+TwoPhaseFlow/@ReducedModel/rb_simulation_impl.m [code] | |
rbasis/+TwoPhaseFlow/@ReducedModel/ReducedModel.m [code] | |
rbasis/basisgen/animate_basisgen.m [code] | |
rbasis/basisgen/animate_basisgen_error.m [code] | |
rbasis/basisgen/SimpleDetailedData.m [code] | |
rbasis/basisgen/+Greedy/Algorithm.m [code] | |
rbasis/basisgen/+Greedy/Checkpoint.m [code] | |
rbasis/basisgen/+Greedy/Combined.m [code] | |
rbasis/basisgen/+Greedy/EiTpart.m [code] | |
rbasis/basisgen/+Greedy/Interface.m [code] | |
rbasis/basisgen/+Greedy/MetaInterface.m [code] | |
rbasis/basisgen/+Greedy/TrainingSetAdaptation.m [code] | |
rbasis/basisgen/+Greedy/+DataTree/Info.m [code] | |
rbasis/basisgen/+Greedy/+DataTree/+Detailed/DuneRBLeafNode.m [code] | |
rbasis/basisgen/+Greedy/+DataTree/+Detailed/EILeafNode.m [code] | |
rbasis/basisgen/+Greedy/+DataTree/+Detailed/IdMapNode.m [code] | |
rbasis/basisgen/+Greedy/+DataTree/+Detailed/IInjectableNode.m [code] | |
rbasis/basisgen/+Greedy/+DataTree/+Detailed/ILeafNode.m [code] | |
rbasis/basisgen/+Greedy/+DataTree/+Detailed/InfoNode.m [code] | |
rbasis/basisgen/+Greedy/+DataTree/+Detailed/INode.m [code] | |
rbasis/basisgen/+Greedy/+DataTree/+Detailed/PODEILeafNode.m [code] | |
rbasis/basisgen/+Greedy/+DataTree/+Detailed/PpartNode.m [code] | |
rbasis/basisgen/+Greedy/+DataTree/+Detailed/RBLeafNode.m [code] | |
rbasis/basisgen/+Greedy/+DataTree/+Detailed/TpartNode.m [code] | |
rbasis/basisgen/+Greedy/+DataTree/+Reduced/IdMapNode.m [code] | |
rbasis/basisgen/+Greedy/+DataTree/+Reduced/SeparableFunctionNode.m [code] | |
rbasis/basisgen/+Greedy/+DataTree/+Reduced/SeparableOperatorNode.m [code] | |
rbasis/basisgen/+Greedy/+DataTree/+Reduced/TpartNode.m [code] | |
rbasis/basisgen/+Greedy/+Plugin/Default.m [code] | |
rbasis/basisgen/+Greedy/+Plugin/EI.m [code] | |
rbasis/basisgen/+Greedy/+Plugin/EICommon.m [code] | |
rbasis/basisgen/+Greedy/+Plugin/EIPOD.m [code] | |
rbasis/basisgen/+Greedy/+Plugin/InjectedTpart.m [code] | |
rbasis/basisgen/+Greedy/+Plugin/Interface.m [code] | |
rbasis/basisgen/+Greedy/+Plugin/POD.m [code] | |
rbasis/basisgen/+Greedy/+Plugin/PODCommon.m [code] | |
rbasis/basisgen/+Greedy/+Plugin/PODDune.m [code] | |
rbasis/basisgen/+Greedy/+Plugin/PODEI.m [code] | |
rbasis/basisgen/+Greedy/+Plugin/SummedEI.m [code] | |
rbasis/basisgen/+Greedy/+User/FVDetailedModelDefault.m [code] | |
rbasis/basisgen/+Greedy/+User/IDetailedData.m [code] | |
rbasis/basisgen/+Greedy/+User/IDetailedModel.m [code] | |
rbasis/basisgen/+Greedy/+User/IReducedDataNode.m [code] | |
rbasis/basisgen/+Greedy/+User/IReducedModel.m [code] | |
rbasis/basisgen/+Greedy/+User/ReducedData.m [code] | |
rbasis/basisgen/+ParameterSampling/Interface.m [code] | |
rbasis/basisgen/+ParameterSampling/IRefineable.m [code] | |
rbasis/basisgen/+ParameterSampling/Random.m [code] | |
rbasis/basisgen/+ParameterSampling/Single.m [code] | |
rbasis/basisgen/+ParameterSampling/Uniform.m [code] | |
rbasis/basisgen/+SnapshotsGenerator/Cached.m [code] | |
rbasis/basisgen/+SnapshotsGenerator/MergedSpaceOpEvals.m [code] | |
rbasis/basisgen/+SnapshotsGenerator/Random.m [code] | |
rbasis/basisgen/+SnapshotsGenerator/SpaceOpEvals.m [code] | |
rbasis/basisgen/+SnapshotsGenerator/Trajectories.m [code] | |
rbasis/basisgen/rbmodels/+Test/DetailedData.m [code] | |
rbasis/basisgen/rbmodels/+Test/DetailedModel.m [code] | |
rbasis/basisgen/rbmodels/+Test/ReducedData.m [code] | |
rbasis/basisgen/rbmodels/+Test/ReducedModel.m [code] | |
rbasis/common/dune_rb_init_data_basis.m [code] | |
rbasis/common/dune_RB_init_data_basis_old.m [code] | |
rbasis/common/dune_rb_init_values.m [code] | |
rbasis/common/dune_set_mu.m [code] | Sets the parameter mu in dune-rb |
rbasis/common/eval_affine_decomp.m [code] | |
rbasis/common/eval_affine_decomp_general.m [code] | |
rbasis/common/extract_reduced_data_subset.m [code] | |
rbasis/common/get_mu.m [code] | |
rbasis/common/get_mu_default.m [code] | |
rbasis/common/get_rb_size.m [code] | |
rbasis/common/get_rb_size_default.m [code] | |
rbasis/common/init_model.m [code] | |
rbasis/common/load_detailed_simulation.m [code] | Load single trajectory of previously saved results |
rbasis/common/plot_error_estimator.m [code] | |
rbasis/common/plot_mu_frequency.m [code] | |
rbasis/common/rb_init_values_default.m [code] | |
rbasis/common/rb_output_functional_prep.m [code] | |
rbasis/common/rb_plot_detailed_data.m [code] | |
rbasis/common/rb_plot_interpolation_points.m [code] | |
rbasis/common/rb_plot_output_estimation.m [code] | |
rbasis/common/rb_plot_reconstruction.m [code] | |
rbasis/common/rb_reconstruction_default.m [code] | (trivial) function computing a detailed reconstruction by linear combination of the coefficients in the simulation data with the orthonormal reduced basis RB |
rbasis/common/rb_test_convergence.m [code] | Rb_test_convergence(detailed_data,model) |
rbasis/common/rb_test_error.m [code] | |
rbasis/common/rb_test_estimator.m [code] | |
rbasis/common/rb_test_indicator.m [code] | M_test,[savepath]) |
rbasis/common/save_detailed_simulation_finals.m [code] | |
rbasis/common/save_detailed_simulations.m [code] | Perform loop over detailed simulations and save results or check consistency with existing saved results |
rbasis/common/set_mu.m [code] | |
rbasis/common/set_mu_default.m [code] | |
rbasis/common/set_mu_general.m [code] | |
rbasis/common/set_mu_in_model_and_base_model_old.m [code] | |
rbasis/common/set_time.m [code] | |
rbasis/common/set_time_default.m [code] | |
rbasis/interface/gen_detailed_model.m [code] | Generates an IDetailedModel instance from a description structure |
rbasis/interface/gen_models.m [code] | Generates an IDetailedModel and an IReducedModel instance from description structures |
rbasis/interface/gen_reduced_model.m [code] | Generates an IReducedModel instance from a description structure |
rbasis/interface/IDetailedData.m [code] | |
rbasis/interface/IDetailedModel.m [code] | |
rbasis/interface/IModel.m [code] | |
rbasis/interface/IReducedData.m [code] | |
rbasis/interface/IReducedModel.m [code] | |
scripts/compute_gdl_velocity2.m [code] | Script computing a velocity field for simple gdl model by solving a laplace problem with suitable boundary conditions |
scripts/convdiff.m [code] | Small script demonstrating the convdiff example from the M2AN Paper, that is also implemented in Dune. Later it will be possible to use the Dune implementation through a mex interface |
scripts/duneconvdiff.m [code] | Small script demonstrating the convdiff example from the M2AN Paper, that is also implemented in Dune. Later it will be possible to use the Dune implementation through a mex interface. Martin Drohmann 06.05.2009 based on burgers_fv.m by Bernard Haasdonk 14.8.2007 |
scripts/gen_nonlin_symmetry_mpg.m [code] | Small script generating a movie of simulation sequences |
scripts/nonlin_symmetry.m [code] | Small script demonstrating the burgers equation with explicit fv discretization and RB model reduction example is meant to demonstrate automatic symmetry detection by the algorithm. These results are presented at HYP2008 |
scripts/quadr_nonlin_script.m [code] | |
scripts/richards_fv.m [code] | Small script demonstrating the richards equation with explicit fv discretization and RB model reduction Bernard Haasdonk 14.8.2007 |
scripts/riemann_burgers.m [code] | Script demonstrating the burgers equation with explicit fv discretization, empirical interpolation and RB model reduction |
scripts/thermalblock.m [code] | Thermalblock example step 1: detailed simulation with different parameters step 2: reduced basis simulation step 3: demo_rb_gui |
scripts/steps/step10_plot_trajectories.m [code] | Script generating a tikz graphic showing trajectories for certain selected parameters |
scripts/steps/step1_detailed_simulation.m [code] | Script performing a single detailed simulation and plotting it |
scripts/steps/step2_empirical_interpolation.m [code] | Script constructing a collateral reduced basis space for localized space operators |
scripts/steps/step3_detailed_ei_simulation.m [code] | Script performing a detailed simulation with empirical interpolated operators comparing the result with a regular detailed simulation |
scripts/steps/step4_dummy_reduced_basis.m [code] | Script constructing a reduced basis from a single trajectory and performing a detailed simulation where the data is projected on the dummy reduced basis space after each time step |
scripts/steps/step5_rb_generation.m [code] | Script constructing a reduced basis space |
scripts/steps/step6_demo_rb_gui.m [code] | Script comparing time for a reduced and a detailed simulation and starting the demonstration GUI |
scripts/steps/step7_error_landscape.m [code] | Script generating error landscapes by computing the true error of reduced simulations vs. detailed simulations for given test parameters over differing basis sizes |
scripts/steps/step8_estimator_landscape.m [code] | Script generating landscapes plot data by computing the error estimator of reduced simulations for given test parameters over differing basis sizes |
test/gradient_approx_matrix_common_settings.m [code] | |
test/test_all.m [code] | |
test/test_basisgen_init.m [code] | |
test/test_cacheable_object.m [code] | Test for the CacheableObject class |
test/test_checkpointing.m [code] | Executes some tests for the Checkpoint class |
test/test_data_tree.m [code] | |
test/test_ei_detailed.m [code] | |
test/test_fail.m [code] | Stupid script for producing an error for testing the try catch functionality |
test/test_fakeMPI_basisgen.m [code] | |
test/test_gradient_approx.m [code] | Performing a test of the gradient_approx routine |
test/test_gradient_approx_matrix.m [code] | Performing a test of the gradient_approx routine |
test/test_indexed_node.m [code] | |
test/test_ldg_derivative.m [code] | |
test/test_ldg_orthogonality.m [code] | |
test/test_ldgfunc.m [code] | |
test/test_lebesgue.m [code] | This is a script showing the ei_detailed construction for a function which empirically interpolated turns out to have the worst possible Lebesgue constant |
test/test_linear_convection.m [code] | U_t + b*Du + cu = 0, u(x,0) = u0. u0 is 1 inside a box and 0 otherwise. This box gets transported in direction b with a slowing term c. returns 1, if error to exact solution is "small enough". returns 0 otherwise |
test/test_matlab_convdiff.m [code] | Routines. In particular simulation without diffusion must be 10 times faster!! returns 1, if test is OK, 0 otherwise |
test/test_orthonormalize.m [code] | Generating a time-sequence of data and orthogonalizing this. returns 1, if test is OK, 0 otherwise |
test/test_power_vector2.m [code] | Function testing the powervectors and its derivatives, i.e. check whether finite difference approximates the derivative |
test/test_rb_basisgen.m [code] | Test showing a simple greedy basis generation |
test/test_rb_lin_evol.m [code] | |
test/test_rb_local_ext.m [code] | Interpolation point are selected during the reduced_data generation phase |
test/test_rb_richards_fv.m [code] | |
test/test_stochastic_assessment.m [code] | |
test/test_subgrid_operators.m [code] | |
test/test_two_phase_datafunc.m [code] | Performing a test of the correct implementation of derivatives in TwoPhaseData class |
test/test_twophase_jacobian.m [code] | Performing a test of the correct implementation of derivatives in TwoPhaseData class |
test/test_xpart_map.m [code] | Test for the XPartMap class |
test/+LebesgueTest/DetailedModel.m [code] | |
test/+LebesgueTest/ReducedModel.m [code] | |