|
| Eigen::VectorXd | onlineCoeffs (Eigen::MatrixXd mu) |
| |
| Eigen::MatrixXd | onlineCoeffsA (Eigen::MatrixXd mu) |
| |
| Eigen::MatrixXd | onlineCoeffsB (Eigen::MatrixXd mu) |
| |
| | HyperReduction (label n_modes, label n_nodes, Eigen::VectorXi initialSeeds, word problemName, SnapshotsLists &&...snapshotsLists) |
| | Construct HyperReduction class, interpolation-based.
|
| |
| | HyperReduction (label n_modes, label n_nodes, unsigned int vectorial_dim, label n_cells, Eigen::VectorXi initialSeeds, word problemName) |
| | Construct HyperReduction class.
|
| |
| | HyperReduction (label n_modes, label n_nodes, Eigen::VectorXi initialSeeds, word problemName, SnapshotsLists &&...snapshotsLists) |
| | Construct HyperReduction class, interpolation-based.
|
| |
| | HyperReduction (label n_modes, label n_nodes, unsigned int vectorial_dim, label n_cells, Eigen::VectorXi initialSeeds, word problemName) |
| | Construct HyperReduction class.
|
| |
| void | offlineGappyDEIM (Eigen::MatrixXd &snapshotsModes, Eigen::VectorXd &normalizingWeights) |
| | Methods implemented: 'GappyDEIM' from "DEIM, Chaturantabut, Saifon, and Danny C. Sorensen. "Nonlinear model reduction via discrete empirical interpolation.
|
| |
| void | offlineGappyDEIM (Eigen::MatrixXd &snapshotsModes, Eigen::VectorXd &normalizingWeights, word folderMethodName) |
| |
| void | offlineECP (Eigen::MatrixXd &snapshotsModes, Eigen::VectorXd &normalizingWeights) |
| | Methods implemented: 'ECP' from "ECP, Hernandez, Joaquin Alberto, Manuel Alejandro Caicedo, and Alex Ferrer. "Dimensional hyper-reduction of nonlinear finite element models via empirical cubature.
|
| |
| void | offlineECP (Eigen::MatrixXd &snapshotsModes, Eigen::VectorXd &normalizingWeights, word folderMethodName) |
| |
| void | initSeeds (Eigen::VectorXd mp_not_mask, std::set< label > nodePointsSet) |
| | TODO.
|
| |
| void | computeLS (Eigen::MatrixXd &J, Eigen::MatrixXd &JWhole, Eigen::VectorXd &b, Eigen::VectorXd &q) |
| | TODO.
|
| |
| void | getModesSVD (SnapshotsListTuple &SnapshotsListTuple, Eigen::MatrixXd &modesSVD, Eigen::VectorXd &fieldWeights, bool saveModesFlag=false) |
| | TODO.
|
| |
| void | getModesSVD (SnapshotsListTuple &snapshotsListTuple, Eigen::MatrixXd &modesSVD, Eigen::VectorXd &fieldWeights, Eigen::MatrixXd &modesSVDBoundary, Eigen::VectorXd &fieldWeightsBoundary, bool saveModesFlag) |
| | TODO.
|
| |
| void | updateNodes (Eigen::SparseMatrix< double > &P, label &ind_max, Eigen::VectorXd &mp_not_mask) |
| | TODO.
|
| |
| void | stackSnapshots (SnapshotsList sList, Eigen::MatrixXd &snapshotsMatrix, Eigen::VectorXd &fieldWeights) |
| | TODO.
|
| |
| void | stackSnapshotsBoundary (SnapshotsList sList, List< Eigen::MatrixXd > &snapshotsMatrixBoundary, List< Eigen::VectorXd > &fieldWeightsBoundary) |
| | TODO.
|
| |
| void | saveModes (SnapshotsList sList, Eigen::MatrixXd &snapshotsMatrix, unsigned int &rowIndex, unsigned int &modeIndex, word folder) |
| | TODO.
|
| |
| void | saveModes (SnapshotsList sList, Eigen::MatrixXd &snapshotsMatrix, Eigen::MatrixXd &snapshotsMatrixBoundary, unsigned int &rowIndex, unsigned int &rowIndexBoundary, unsigned int &modeIndex, word folder) |
| | TODO.
|
| |
| void | stackNames (SnapshotsList sList) |
| | TODO.
|
| |
| void | stackDimensions (SnapshotsList sList) |
| | TODO.
|
| |
| void | sumDimensions (double sum, SnapshotsList sList) |
| | TODO.
|
| |
| void | evaluatePinv (Eigen::SparseMatrix< double > &Projector, Eigen::MatrixXd &Modes, Eigen::VectorXd &fieldWeights) |
| | Compute the pseudo-inverse of the matrix M restricted with the projector P.
|
| |
| void | evaluateWPU (Eigen::SparseMatrix< double > &Projector, Eigen::MatrixXd &Modes, Eigen::VectorXd &fieldWeights, Eigen::VectorXd &quadratureWeights) |
| | Compute the pseudo-inverse of the matrix M restricted with the projector P.
|
| |
| void | generateSubmesh (label layers, const fvMesh &mesh) |
| | Compute the submesh common to all fields in SnapshotsLists.
|
| |
| List< label > | global2local (List< label > &points, fvMeshSubset &submesh) |
| | Get local indices in the submesh from indices in the global ones.
|
| |
| autoPtr< FieldType > | interpolateField (const FieldType &field) |
| | TODO.
|
| |
| constexpr unsigned int | get_field_dim () |
| | TODO.
|
| |
| constexpr unsigned int | compute_vectorial_dim (LastList x) |
| | TODO.
|
| |
| constexpr unsigned int | compute_vectorial_dim (List &&head, RemainingLists &&...tail) |
| | TODO.
|
| |
| void | eigen2fields (Eigen::VectorXd &eFields, FieldsArgs &&... oFields) |
| | TODO.
|
| |
| void | initReshapeMat (Eigen::SparseMatrix< double > &reshapeMat) |
| | TODO.
|
| |
| void | createMasks (bool offlineStage=true) |
| | TODO.
|
| |
| void | getSnapMatrix (Eigen::MatrixXd &snapMatrix, Eigen::VectorXd &fieldWeights) |
| | TODO.
|
| |
| void | getSnapMatrix (Eigen::MatrixXd &snapMatrix, Eigen::VectorXd &fieldWeights, List< Eigen::MatrixXd > &snapMatrixBoundary, List< Eigen::VectorXd > &fieldWeightsBoundary) |
| | TODO.
|
| |
| label | getNcells (label sizeM) |
| |
| label | getNcells (label sizeM) |
| |
| | DEIM (PtrList< fvScalarMatrix > &SnapShotsMatrix, label MaxModes, word FunctionName, word FieldName) |
| | Construct DEIM for non-linear function.
|
| |
| | DEIM (PtrList< fvScalarMatrix > &SnapShotsMatrix, label MaxModesA, label MaxModesB, word MatrixName) |
| | Construct DEIM for matrix with non-linear dependency.
|
| |
| S | generateSubmesh (label layers, const fvMesh &mesh, S field, label secondTime=0) |
| | Function to generate the submesh for the nonlinear function case.
|
| |
| S | generateSubmeshMatrix (label layers, const fvMesh &mesh, S field, label secondTime=0) |
| | Function to generate the submesh for the nonlinear matrix function case (RHS)
|
| |
| S | generateSubmeshVector (label layers, const fvMesh &mesh, S field, label secondTime=0) |
| | Function to generate the submesh for the nonlinear matrix function case (LHS)
|
| |
| F | generateSubField (F &field) |
| | Function to generate a a subfield in the location of the magic points.
|
| |
| F | generateSubFieldMatrix (F &field) |
| | Function to generate a a subfield in the location of the magic points computed for the Matrix (LHS)
|
| |
| F | generateSubFieldVector (F &field) |
| | Function to generate a a subfield in the location of the magic points computed for the Matrix (RHS)
|
| |
| void | onlineCoeffs () |
| | Function to get the onlineCoeffs of the DEIM approx.
|
| |
| List< label > | global2local (List< label > &points, fvMeshSubset &submesh) |
| | Get local indices in the submeshe from indices in the global ones.
|
| |
| void | check3DIndices (label &ind_rowA, label &ind_colA, label &xyz_rowA, label &xyz_colA) |
| | check3DIndices in case of three dimensional fields
|
| |
| void | check3DIndices (label &ind_rowA, label &xyz_rowA) |
| | check3DIndices in case of three dimensional fields
|
| |
| label | getNcells (label sizeM) |
| | get the number of cells from the dimension of a LHS matrix
|
| |
| label | getNcells (label sizeM) |
| |
| label | getNcells (label sizeM) |
| |
| void | setMagicPoints (labelList &newMagicPoints, labelList &newxyz) |
| | Function to set the magic points externally.
|
| |
|
| Eigen::VectorXd | theta |
| |
| PtrList< volScalarField > | fields |
| |
| autoPtr< volScalarField > | subField |
| |
| PtrList< volScalarField > | fieldsA |
| |
| autoPtr< volScalarField > | fieldA |
| |
| autoPtr< volScalarField > | fieldB |
| |
| PtrList< volScalarField > | fieldsB |
| |
| word | methodName |
| |
| unsigned int | vectorial_dim |
| |
| unsigned int | sumFieldsDim |
| |
| ITHACAparameters * | para |
| |
| label | n_boundary_patches |
| |
| List< label > | n_boundary_cells_list |
| |
| label | n_boundary_cells |
| |
| label | n_modes |
| | The maximum number of modes to be considered.
|
| |
| label | n_nodes |
| | The maximum number of modes to be considered.
|
| |
| label | n_snapshots |
| | The length of the snapshots lists.
|
| |
| Eigen::VectorXi | initialSeeds |
| |
| Eigen::VectorXi | nodes |
| |
| word | problemName |
| | The name of the non-linear function e.g. HR_method/residual.
|
| |
| SnapshotsListTuple | snapshotsListTuple |
| | The snapshots matrix containing the nonlinear function or operator.
|
| |
| List< word > | fieldNames |
| | Names of the fields.
|
| |
| List< unsigned int > | fieldDims |
| | Dimensions of the fields.
|
| |
| label | n_cells |
| | Int Number of Cells;.
|
| |
| label | n_cellsSubfields |
| | Int Number of Cells in submeshes;.
|
| |
| autoPtr< IOList< label > > | nodePoints |
| | Nodes in the case of the a nonlinear function.
|
| |
| autoPtr< IOList< labelList > > | totalNodePoints |
| | List of label lists of the nodes and corresponding surrounding nodes.
|
| |
| autoPtr< IOList< label > > | uniqueNodePoints |
| | List of the unique indices of the nodes that define the submesh.
|
| |
| word | folderProblem |
| | Folder for the HR problem.
|
| |
| word | folderMethod |
| | Folder for the selected HR method.
|
| |
| List< label > | localNodePoints |
| | Indices of the local node points in the subMesh.
|
| |
| Eigen::MatrixXd | basisMatrix |
| | Orthonormal basis of HR.
|
| |
| Eigen::VectorXd | normalizingWeights |
| |
| Eigen::MatrixXd | renormalizedBasisMatrix |
| | Renormalized basis of HR.
|
| |
| Eigen::MatrixXd | pinvPU |
| |
| Eigen::MatrixXd | wPU |
| |
| Eigen::VectorXd | eigenValueseig |
| |
| Eigen::SparseMatrix< double > | P |
| | The P matrix of the HyperReduction method. The nodes are ordered in the order of insertion during the greedy procedure. The components related to the same node follow immediately.
|
| |
| Eigen::SparseMatrix< double > | field2submesh |
| |
| Eigen::SparseMatrix< double > | submesh2nodes |
| |
| Eigen::VectorXi | submesh2nodesMask |
| |
| Eigen::VectorXd | quadratureWeights |
| | Quadrature weights. Ordered in the same order of matrix P.
|
| |
| autoPtr< fvMeshSubset > | submesh |
| | Submesh of the HyperReduction method.
|
| |
| autoPtr< volVectorField > | submesh_field |
| | Submeshes.
|
| |
| Eigen::MatrixXd | MatrixOnline |
| | Online Matrix.
|
| |
| PtrList< fvScalarMatrix > | SnapShotsMatrix |
| | The snapshots matrix containing the nonlinear function or operator.
|
| |
| PtrList< fvScalarMatrix > | modes |
| | The POD modes of the DEIM procedure that can be.
|
| |
| std::tuple< List< Eigen::SparseMatrix< double > >, List< Eigen::VectorXd > > | Matrix_Modes |
| | Matrix Modes.
|
| |
| label | MaxModes |
| | The maximum number of modes to be considered.
|
| |
| label | MaxModesA |
| |
| label | MaxModesB |
| |
| word | FunctionName |
| | The name of the non-linear function.
|
| |
| double | tolerance |
| | A given tolerance.
|
| |
| label | Ncells |
| | Int Number of Cells;.
|
| |
| bool | source |
| | source
|
| |
| word | MatrixName |
| | The name of the matrix.
|
| |
| Eigen::MatrixXd | MatrixModes |
| | The matrix containing the modes.
|
| |
| autoPtr< IOList< label > > | magicPoints |
| | Magic points in the case of the a nonlinear function.
|
| |
| autoPtr< IOList< label > > | magicPointsArow |
| | Magic points in the case of the a matrix function (rows indices)
|
| |
| autoPtr< IOList< label > > | magicPointsAcol |
| | Magic points in the case of the a matrix function (cols indices)
|
| |
| autoPtr< IOList< label > > | magicPointsB |
| | Magic points in the case of the a matrix function, right hand side.
|
| |
| word | Folder |
| | Folder for nonlinear functions.
|
| |
| word | FolderM |
| | Folder in the matrix case.
|
| |
| Eigen::VectorXd | theta |
| | Online vector.
|
| |
| Eigen::VectorXd | thetaA |
| | Online vector.
|
| |
| Eigen::VectorXd | thetaB |
| | Online vector.
|
| |
| Eigen::MatrixXd | MatrixOnline |
| | Online Matrices.
|
| |
| List< Eigen::SparseMatrix< double > > | MatrixOnlineA |
| | Online Matrices.
|
| |
| Eigen::MatrixXd | MatrixOnlineB |
| | Online Matrices.
|
| |
| Eigen::MatrixXd | U |
| | The U matrix of the DEIM method.
|
| |
| List< Eigen::SparseMatrix< double > > | UA |
| | The U matrix of the DEIM method.
|
| |
| Eigen::MatrixXd | UB |
| | The U matrix of the DEIM method.
|
| |
| autoPtr< IOList< labelList > > | totalMagicPoints |
| | Magic points and indices of the surrounding layers.
|
| |
| autoPtr< IOList< labelList > > | totalMagicPointsA |
| | Magic points and indices of the surrounding layers.
|
| |
| autoPtr< IOList< labelList > > | totalMagicPointsB |
| | Magic points and indices of the surrounding layers.
|
| |
| autoPtr< IOList< label > > | uniqueMagicPoints |
| | List of unique indices that define the submesh.
|
| |
| autoPtr< IOList< label > > | uniqueMagicPointsA |
| | List of unique indices that define the submesh.
|
| |
| autoPtr< IOList< label > > | uniqueMagicPointsB |
| | List of unique indices that define the submesh.
|
| |
| autoPtr< IOList< label > > | xyz |
| | Definition of the x, y, z coordinate of the identified element in the matrix or source term 0 for x, 1 for y, 2 for z.
|
| |
| autoPtr< IOList< label > > | xyz_Arow |
| | Definition of the x, y, z coordinate of the identified element in the matrix or source term 0 for x, 1 for y, 2 for z.
|
| |
| autoPtr< IOList< label > > | xyz_Acol |
| | Definition of the x, y, z coordinate of the identified element in the matrix or source term 0 for x, 1 for y, 2 for z.
|
| |
| autoPtr< IOList< label > > | xyz_B |
| | Definition of the x, y, z coordinate of the identified element in the matrix or source term 0 for x, 1 for y, 2 for z.
|
| |
| List< label > | localMagicPoints |
| | Indices of the local magic points in the subMesh.
|
| |
| List< label > | localMagicPointsArow |
| | Indices of the local magic points in the subMesh.
|
| |
| List< label > | localMagicPointsAcol |
| | Indices of the local magic points in the subMesh.
|
| |
| List< label > | localMagicPointsB |
| | Indices of the local magic points in the subMesh.
|
| |
| Eigen::SparseMatrix< double > | P |
| | The P matrix of the DEIM method.
|
| |
| List< Eigen::SparseMatrix< double > > | PA |
| | The P matrix of the DEIM method.
|
| |
| Eigen::SparseMatrix< double > | PB |
| | The P matrix of the DEIM method.
|
| |
| autoPtr< fvMeshSubset > | submesh |
| | Submesh of the DEIM method.
|
| |
| autoPtr< fvMeshSubset > | submeshA |
| | Submesh of the DEIM method.
|
| |
| autoPtr< fvMeshSubset > | submeshB |
| | Submesh of the DEIM method.
|
| |
| bool | runSubMesh |
| | Bool variable to check if the SubMesh is available.
|
| |
| bool | runSubMeshA |
| | Bool variable to check if the SubMesh is available.
|
| |
| bool | runSubMeshB |
| | Bool variable to check if the SubMesh is available.
|
| |