CAccessHelper< TypeIn, TypeOut > | Helper class that describes how not vector data TypeIn are stored inside vector data TypeOut |
Caccomp_pred< T > | Compare predicate based on accomp to use in STL |
Caggregate_it< it1, it2, value_t > | Aggregate iterator (two iterators are aggregated in one) |
CAlgebraicParser | This class allows to parse and calculate algebraic expression with + - * /, brackets () and some constants and functions |
►CapComponent | Class that controls general behaviour of all components of the library |
►CBaseDetectorSet | Base class for detectors |
CDetectorSet< vset_tt, xfer_t > | Detectors recording field values in points sequence vset_t |
►CFieldsRecorder | Class for recording data |
CFileRecorder | This class records fields to the binary file |
►CTextRecorder< vset_t > | This class records fields to the text file |
CTextFluxRecorder< vset_t > | This class records fields fluxes through the surface defined by v_set to the text file |
CemFourierRecorder | Perform Fourier-on-fly transformation |
CInterpTransfer< arg_tt, container_tt, base_tt, index_tt, vec_alignement > | Class for interpolation transfers (for example, between CPU domains in parallel simulation or between meshes in multigrid-approach) |
Cvtk_writer< data_accessor_t > | Saving grid data in VTK format |
CapConfig | Configuration settings |
CapDump | Class for requesting dumps of objects and components (including geometric) into files |
CapDuplConfig | Configuration for setting elementary cell duplication in dumps |
CapMPIComm | Interface to work with MPI |
CapMPIHandler | For parallel version apMPIHandler has a MPI communicator |
CapParaviewSceneConfig | Interface class for configuring VTK outputs |
CapTimer | Timer that can be started, stopped and measure its working time usually timer corresponds to some process, for example solving number of equations timer can be part of some timers hierarchy which corresponds to hierarchy of processes, for example solving of some equations is part of modeling of some physical process (upper level process), but it has as a part solving of one particular equation (lower level process) |
Carray_mngptr< T > | Array of managed pointers |
►CArray_Np< T, N > | N-dimensional array, pointer based |
CArray_NFp< T, N > | N-dimensional array with flipping, pointer based |
CArray_Nt< T, N > | N-dimensional array with std::vector storage |
Carray_stor_t< T, N > | Array storage class for a vector followinfg storage_prototype |
Carray_stor_t< cdouble, N > | |
Carray_stor_t< int, N > | |
Carray_stor_t< vec_type, N > | |
Carray_store_t< T, num > | Storage class for array storage |
Carray_store_t< Vector_Nt< vec_type, N >, num > | |
Cctlist::internal::AssertValue< AssertionValue, Args > | Helper class for readable assertion output for templates |
Cav_comm_t | Struct for use in average_files |
►Cbase_iterator< value_t > | Base class for virtual iterators |
Cvirtual_iterator< iterator_t, value_t > | Virtualizator for iterators |
Cbase_iterator< Vector_3 > | |
►Cbase_optimizer | Base optimizer class |
Cmd_grad_optimizer< term_t > | Gradient descent with parabolic minima search |
CBasis_N< N > | Basis in N-dimensional space |
CBasis_N< reg_t::dimension > | |
Cbasis_volume_t< T, N > | Auxilliary class for evaluating basis volume |
CBoxSurfaceSet | Sequence corresponding to the grid located at some sides of the cube (maximal number of sides is 6) |
Ccall_if< condition > | Template to use in compile-time branch selection |
Ccall_if< false > | Specialization for false condition, does nothing.
|
Cctlist::internal::Call_if< false > | Specialization for false condition, does nothing.
|
Cctlist::internal::Call_if_noreturn< false > | There is no method to check result of the function if we don't know right arguments Thus we should use call_if_noreturn insted of declaring everything as overloads in one class |
Cctlist::internal::CallHelper< index, Item > | It's better to split functions instead of putting them together |
Ccomb_range_t< iT > | Iterates over all combinations of numbers from 0 to count[i] in each direction |
CInterpTransfer< arg_tt, container_tt, base_tt, index_tt, vec_alignement >::comm_t | Manages two buffers: to send (receive) value to (from) another processor |
Ccomp_function< arg_t, result_t, comp_t > | Used to construct max_function and min_function |
►Ccomp_function< arg_t, result_t, std::greater< result_t > > | |
Cmax_function< arg_t, result_t > | Maximal value of given functions |
►Ccomp_function< arg_t, result_t, std::less< result_t > > | |
Cmin_function< arg_t, result_t > | Minimal value of given functions |
Cctlist::internal::ConcatCTList< typename, typename > | Helper class to concatenate CTLists |
Ccontainer_arg< container_t > | Which can be either T* or container_t & |
►Ccontainer_set< T, cont_t, comp_pr > | Container which stores only unique values (or group of values) of some type T by function inset_ind (insert_group) |
Cvector_indexed< T, less_pr, index_t > | The functionality is the same as for container_set |
CContour< point_it, store_t, edge_it, edge_t > | Basic contour interface |
CContour< contour_projection_it< contour_t::point_iterator >, range_store_t< contour_projection_it< contour_t::point_iterator > >, generic_edge_it< contour_projection_it< contour_t::point_iterator > >, typename generic_edge_it< contour_projection_it< contour_t::point_iterator > >::edge > | |
CContour< modified_value_it< indexed_it< src_point_it, index_it >, transform_t >, range_store_t< modified_value_it< indexed_it< src_point_it, index_it >, transform_t > >, generic_edge_it< modified_value_it< indexed_it< src_point_it, index_it >, transform_t > >, typename generic_edge_it< modified_value_it< indexed_it< src_point_it, index_it >, transform_t > >::edge > | |
CContour< point_it, range_store_t< point_it >, generic_edge_it< point_it >, typename generic_edge_it< point_it >::edge > | |
►CContour< point_it, store_t, edge_it, edge_t > | |
CContour_N< point_it, Vector_2, store_t, edge_it, edge_t > | Contour_N specialization for 2D |
CContour_N< point_it, Vector_3, store_t, edge_it, edge_t > | Contour_N specialization for 3D |
CContour< Vector_Nt< vec_type, 3 > *, range_store_t< Vector_Nt< vec_type, 3 > * >, generic_edge_it< Vector_Nt< vec_type, 3 > * >, typename generic_edge_it< Vector_Nt< vec_type, 3 > * >::edge > | |
CContour< Vector_Nt< vec_type, N > *, array_store_t< Vector_Nt< vec_type, N >, num >, generic_edge_it< Vector_Nt< vec_type, N > * >, typename generic_edge_it< Vector_Nt< vec_type, N > * >::edge > | |
Ccontour_projection_it< point_it > | 2D points iterator as a projection of given 3D points iterator on 2D coordinate system defined by its origin, and axes x, y
|
Ccontour_projection_it< contour_t::point_iterator > | |
CCopyConstruct | Helper struct to initialize method of FixList |
CCTList< Args > | The compile time list |
CCTList< Args... > | |
CcudaDeviceProp | Detecting the parameters and device |
CcVector_Nt< T, N > | Complex N-dimensional vector of type T with some useful operations |
CCylinderSurfaceSet | Sequence corresponding to the grid at the cylinder surface |
Cdata_accessor_interface_t | Interface description for data_accessor as template parameter for vtk_writer |
►Cdata_pack< T, comp_pr, set_t, index_t > | Class for packing data of the type T |
Cgroup_pack< T, comp_pr, set_t, index_t, group_pr > | Packer optimized to pack groups of data |
Cdata_pack< T1 > | |
Cdata_pack< T2 > | |
►Cdata_unpacked< T, cont_t, index_t > | Stores data in some container of the the type cont_t |
Cgroup_unpacked< T, cont_t, index_t > | Stores groups of data in some container of the the type cont_t Number of elements in a group is packed in npack |
Cdata_unpacked< index_t > | |
CapParaviewSceneConfig::descr_t | Configurations for different polydata objects |
CDiagnosticPointer< T, LocalInterface, Interfaces > | LocalInterface made reverse compatible with CopyInterfaces of the LocalPointer |
CDumbPointer< T, CopyInterface > | Basic pointer with all method of LocalPointer Defined |
CDumbPointer< iterator > | |
CDumbPointer< pair_pack, PackerMergeInterface< pair_pack > > | |
CDumbPointer< size_t > | |
CDumbPointer< typename packer_t::iterator > | |
Cdup_it< iterator, checker_t > | Duplicator: duplicates each entry in the sequence nd times |
CFacetedSurfaceData::edge_index_it | Iterates over edge indicies for all facets |
Cedge_t< point_it > | Stores two vertices of the edge |
►Centry_filter< inp_t > | Class for building filter chains |
►Clogic_filter< inp_t, pred_t > | Links the chain with logical predicate |
Crange_filter< inp_t, pred_t, lesseq_t > | Links the chain with logical predicate |
Ceq_minus_second< Type > | Template for v=-der operation in WavePacket::int2phys_der |
Ceq_second< Type > | Template for v=der operation in WavePacket::int2phys_der |
Cequal_from_less_pr< T, less_pr > | Two values are assumed to be equal, if none of them is less than other |
Cfile_manager | Files manager |
Cfirst_it< pair_it > | Returns the first pair value of iterate pairs |
CFixList< Args > | Compile time list with a set of bit flags to enable or disable certain elements |
Cgeneric_edge_it< point_it > | Contour edges iterator, based on contour start and end vertices iterators |
CGlobalPointer< T > | Pointer to some global data we want to access from all threads |
CGnuDumper | Test class to dump bodies |
CGridSpline< arg_t, grid_t > | TODO: check dimensions with nnodes<3 !!! |
CGridSpline< arg_t, grid_t > | |
Cindex_pack< index_tt > | This packer is optimized for packing integer sequences with the same increment |
Cindex_pack< index_t > | |
Cindex_pack< int > | |
Cindexed_it< rand_it, indexer_it > | Forward-iterating a random acces iterator via index set increment, comparison operators are applied to indexer *it returns the value from rand_it by incrementing begin with the current index |
►Cindexed_it< src_point_it, index_it > | |
Cmodified_value_it< indexed_it< src_point_it, index_it >, transform_t > | |
CInitMehtod | Helper struct to initialize method of FixList |
Cinterp_t< num > | Interpolation of num-dimensional body in our model 2D bodies are interpolated by VecContour<2> and 3D bodies are interpolated by array of Polyhedron_3 |
Cinterp_transfer_packer_ift< container_tt > | Interface definition for interpolation transfer packer |
CInterpolation< coef_tt, index_tt > | Class for interpolation (set of indices in some array and coefficients) |
CInterpPacker< coef_tt, val_t, index_tt > | Class to pack Interpolations with STL-like interface (iterators, which are returned by begin and end) |
CInterpTransfer< arg_tt, container_tt, base_tt, index_tt, vec_alignement >::irequest_t | Interpolation request |
Citer_pack< iter_t > | Translates a selected set of iterator values into an iterator |
Citer_pack< packed_it > | |
►Cdata_pack< T, comp_pr, set_t, index_t >::iterator | Packer for indices of stored elements in vset |
Cgroup_pack< T, comp_pr, set_t, index_t, group_pr >::iterator | Total number of packed elements |
Cinterp_transfer_packer_ift< container_tt >::iterator | Iterator interface |
CLockGuard< Lock > | Locks a Lock on LockGuard construction and unlocks on LockGuard destruction |
CLockGuard< MockLock > | |
Clog_exception_traits< exc_t > | Traits structure to deduce exception level and name from exception class by default all exceptions have vblFATAL level |
Clog_exception_traits< enum vbLEVELS > | VbLEVELS exceptions act as integers |
Clog_exception_traits< int > | Integer exceptions have the level equal to their value |
Cloop_it< iterator, checker_t > | Looper: loops the sequence after nd iterations, counts the loop number (iter) |
►Cmessage_logger | Logger class to control (computational) function behaviour when something requiring user attention has happened |
Cstdfile_logger | Message logger for which std and error streams may be specified |
Cvector_logger | This is a compound logger |
Cmngarg< T > | Auxiliary class used as an argument for condtructor and functions set / reset of smart pointers (mng_ptr, sh_ptr) |
Cmngptr< T > | Managed pointer |
Cmngptr< apConfig > | |
Cmngptr< apDump > | |
Cmngptr< apMPIComm > | |
Cmngptr< apParaviewSceneConfig > | |
Cmngptr< apRunLog > | |
Cmngptr< base_t > | |
Cmngptr< Box > | |
Cmngptr< char > | |
Cmngptr< entry_filter > | |
Cmngptr< FieldsRecorder > | |
Cmngptr< grid_t > | |
Cmngptr< int > | |
Cmngptr< long > | |
Cmngptr< Plane_Nt > | |
Cmngptr< Polyhedron_3 > | |
Cmngptr< reg_t > | |
Cmngptr< Region > | |
Cmngptr< SeqRecord > | |
Cmngptr< Tensor< arg_t > > | |
Cmngptr< term_t > | |
Cmngptr< value_tt > | |
Cmngptr< vec_type > | |
Cmngptr< Vector_3 > | |
Cmngptr< Vector_Nt > | |
Cmngptr< VecTransform > | |
Cmngptr< vset_t > | |
CMockLock | Like lock but doesn't lock anything |
Cmodified_value_it< base_it, operation_t > | Iterator modifying the returned value by an operation |
CNewCopyConstructInterface< T > | Helper class for LocalPointer |
CNewCopyConstructInterface< vector_t > | |
Cnint< Num > | Class representing natural compile-time constant number>=0, set to 0 if intialized <0 |
Cnogroup_it< packer_it > | Packer iterator group categories no groups defined |
Cnormplanes_it< edge_it > | Iterator at planes normal to the contour plane and passing through edges of the contour Used in ProjectSimplex only |
Cpack_t< T, index_t > | This template helps to easily switch between packing and not packing |
Cpack_t< coef_t, index_t > | |
Cpack_t< index_t, index_t > | |
CPackerCopyMergeInterface< Packer > | Interface for using vector_packer with local pointer |
Cpackit_traits< T * > | Default for all pointers |
►Cpair_pack< T1, T2, packer_t1, packer_t2, pair_tt, index_t > | Class for packing pairs of data of two different types |
Citer_data_pack< packed_it, T, packer_t, pair_tt > | Class for packing iterator together with some packed data |
Cpair_pack< T1, T2, data_pack< T1 >, data_pack< T2 >, refpair< packer_t1::value_t, packer_t2::value_t > > | |
Cpencil< T, container_t > | Class for controlling one-dimensional data arrays of type T the array can be managed and copied by reference (ref counting used) compatible with vector<T> used as container |
Cpencil< double > | |
CPlane_Nt< T, N > | Base plane class implementing N-dimensional plane equation \(\vec{n}\vec{x}+d=0\) |
CBox_N< N >::point_it | Iterator at 6 vertices of the box |
Cpolyhedron_cat | Convex linear figure (3D polyhedron) |
Cprocess_detail< inp_t, out_t > | Template base class for collecting process variables identified by their symbolic names into output vector |
►Cprocess_detail< double, double > | |
CapRunLog | Collection of timers and data about memory used by different operations |
Cptr_container< T > | Making container of a pointer (to look like a vector) |
Cptr_container< double > | |
Cptr_stor_t< T > | Pointer storage class for a vector followinfg storage_prototype |
Crange_store_t< point_it > | Storage class used as template parameter in Contour |
Crange_store_t< contour_projection_it< contour_t::point_iterator > > | |
Crange_store_t< modified_value_it< indexed_it< src_point_it, index_it >, transform_t > > | |
Crange_store_t< Vector_Nt< vec_type, 3 > * > | |
Crecmatrix< T > | Rectangular matrix |
Crecmatrix< long > | |
Crefmap< key_tt, T > | Map of dynamic objects and flag, which define the action with dynamic objects if function clear is called: 0 - not delete, 1 - delete |
Crefpair< T1, T2 > | Both types stored by reference |
Crefvector< T > | Vector of dynamic objects and flag, which define the action with dynamic objects if function clear is called: 0 - do not delete, nonzero - delete, 8 (bit flag set) - delete as array |
Crefvector< apTimer > | |
Crefvector< cgrid_t > | |
Crefvector< emTimer > | |
Crefvector< fun_t > | |
Crefvector< InterpTransfer::comm_t > | |
►Crefvector< message_logger > | |
Cvector_logger | This is a compound logger |
Crefvector< xfer_t > | |
Crefvpair< T1, T2 > | First type is stored by reference, the second by value |
CRegDumper< N > | Abstract class with Dump and InterpolateRegion functionality |
►CRegDumper< reg_t::dimension > | |
CRegionDumper< reg_t > | Implementation of RegDumper for particular body |
►CRegion< N > | N-dimensional body |
►CBox_N< 3 > | |
CBox | Orthogonal box, see documentation to Box_N |
CCylinder< Circle > | |
►CPolyhedron< Plane_3 * > | |
CPolyhedron_3 | Polyhedron as array of planes |
►CSphere_N< 2 > | |
CCircle | Circle, 2D sphere |
►CSphere_N< 3 > | |
CSphere | 3D sphere |
CBox_N< N > | Regular n-dimensional parallelepiped with edges parallel to coordinate axis |
►CCompositeRegion< N > | Union of arbitrary number of regions |
CRegionIntersection< N > | Intersection of arbitrary number of regions |
CRegionUnion< N > | Union of arbitrary number of regions |
CConfinedRegion< reg_tt > | Intersection of polyhedron with arbitrary other region |
►CCylinder< base_tt > | Cylinder with arbitrary 2D base of the type base_t Cylinder axis passes the point origin and directed along vector n Axes of 2D plane which contain the base are directed along vector x and y Base is specified in 2D coordinate system defined by origin, x and y Vector n is perpendicular to x and y (cylinder axis is perpendicular to the base) "Tilted" cylinder with axis not perpendicular to the base can be specified using template StretchedRegion |
CCone< base_tt > | Cone with arbitrary 2D base of the type base_tt Cone axis passes the point origin and directed along vector n Axes of 2D plane which contain the base are directed along vector x and y Base is specified in 2D coordinate system defined by origin, x and y Vector n is perpendicular to x and y (cone axis is perpendicular to the base) Top of the cone is origin+L*n "Tilted" cone with axis not perpendicular to the base can be specified using template StretchedRegion |
CInverse< reg_tt > | Complement to the region in 3D space |
CPolygon_2 | Polygon |
CPolyhedron< plane_itt > | Polyhedron defined as a set of planes |
CSphere_N< N > | N-dimensional sphere |
CRegion< reg_t::dimension > | |
►CRegion< reg_tt::dimension > | |
CStretchedRegion< reg_tt > | Region obtained from region reg by shift and linear transformation specified by matrix basis |
Cremove_if_it< iter1, iter2, pred_t > | Iterator removing some subsequence (beg2,end2) from the basic sequence (beg1,end1) if comparison predicate returns false |
CInterpTransfer< arg_tt, container_tt, base_tt, index_tt, vec_alignement >::reqpair_t | First element - bufer for MPI_Request in MPI_Send, second element - buffer for MPI_Request for MPI_Recv |
►Crestorer | Base class for saving (reading) internal data to (from) the file using finction save_data (load_data) |
CBaseDetectorSet | Base class for detectors |
CFieldsRecorder | Class for recording data |
CInterpPacker< coef_tt, val_t, index_tt >::second_it< pair_it > | Records interpolation from a map (key - index, value - coefficient) |
Csecond_it< pair_it > | Returns the first pair value of iterate pairs |
Cseq_data_pack< iter_t, T, packer_t > | Class for packing pairs (iterator,data) of two different types |
►CSeqRecord | Class for storing slices of data_t values d: i <– sequence length (size_t) i <– number of slices (size_t) d d d d d d <– slice0 d d d d d d <– slice1, etc |
CQPLTRecord | Access to QPLT data format |
Cshptr< T, delete_t > | Smart pointer |
Cshptr< T, delete_arr< T > > | |
Cskiper_it< iterator, checker_t > | Skips some of the numbers, returned as false by checker Checker MUST return true for out_of range indicies |
CSpaceVectorSet | En This class stores all elements of the sequence |
Csphere_cat | Sphere |
CSphereSurfaceSet | Sequence corresponding to the grid at the sphere surface |
CStaticInterpolation< coef_t, N, index_t > | Simple implementation of interpolation form (but not efficient in terms of used memory) |
Cstorage_prototype | Storage template prototype for a vector |
Ctransition< reg_t > | Function that continuosly changes from 0 to 1 near surface of region reg (used to specify alloys in Microvolt) |
►CUniformGrid< value_tt, interleave, index_t, data_structure_t > | Uniform grid in space |
CVecGrid< VECSIZE, value_tt, index_t > | Vector-packed uniform grid with spans |
CZGrid< VECSIZE, value_tt, index_t, CUBESIZE > | Z-ordered vector-packed grid |
CUniformGrid< value_tt, 1, long, Vec_data_t< long, VECSIZE > > | |
CUniformGrid< value_tt, 1, long, Z_data_t< long, VECSIZE > > | |
CUniformGrid< value_tt, 1, ptrdiff_t > | |
CUniformGrid< vec_type > | |
CUniformGrid< Vector_3 > | |
CUniformGrid< Vector_Nt > | |
►CUniformGridIt< parent_grid_t, index_t > | Iterator going through all points in the grid range corresponding to nst, nen |
CVecGridIt< parent_grid_t, index_t > | Iterator going through all points in the grid range corresponding to nst, nen |
CZGridIt< parent_grid_t, index_t > | Iterator going through all points in the grid range corresponding to nst, nen |
Cunknown_cat | Generic category |
Cvalue_it< T, incr_op, decr_op > | Incremental iterator (to use together with index sets) increment/decrement operators are applied to the value returns the value itself when calling *it |
CVariate_3< Multiplexer, num1, sz1, num2, sz2, num3, sz3 > | Variation with abstract number classes. See Variate_3i for inteer version |
CVariate_3i< Multiplexer, vnum1, vsz1, vnum2, vsz2, vnum3, vsz3 > | Entry point to multiplexing procedure: The functions Multiplexer::start_axis, Multiplexer::step_axis, Multiplexer::item Multiplexer::end_axis are compile-time iterated in a nested 3-dimensional loop |
Cvec_less< vec_t > | Comparison in the order of components |
Cvec_prod_traits< T, N > | Traits class for vector product |
Cvec_store_t< T > | Storage class for vector storage |
Cvec_store_t< Vector_Nt< vec_type, 3 > > | |
Cvec_store_t< Vector_Nt< vec_type, N > > | |
CVector_Nt< T, N, storage_t > | N-dimensional vector of the type T and some useful operations |
CVector_Nt< cdouble, 3 > | |
CVector_Nt< int, 3 > | |
CVector_Nt< int, N > | |
CVector_Nt< vec_type, 2 > | |
CVector_Nt< vec_type, 3 > | |
CVector_Nt< vec_type, N > | |
Cvector_packer_t< TypeIn, TypeOut, vecsize, Access > | Packer for vector data of type TypeOut |
►CVecTransform | Basic class for vector transformation (default is no change) |
CVecHomothety | Vector homothety |
CVecShift | Vector constant shift |
Cvint< Num > | Class representing arbitrary compile-time constant integer number |
CVirtualCopyInterface< T > | EmFixTFSF Interface for LocalPointer |
Cvolume_integral_const_t | Volume integral of constant space density |
Cvolume_integral_grid_t | Returns an integral of function recorded on a grid data over a volume enclosed between p1 and p2 |
Cvrefpair< T1, T2 > | First type is stored by value, the second by reference |
CVTS_Control | Provides variable time stepping control together with the logging at equidistant time intervals |
CWavePacket | Wavepacket is w(x)=exp(-a*x^2+b*x+lz) |