The MNE class provides wrapper functions to stay consistent with mne matlab toolbox.
More...
#include <mne.h>
|
static VectorXd * | combine_xyz (const VectorXd &vec) |
|
static qint32 | find_source_space_hemi (MNEHemisphere &p_Hemisphere) |
|
static qint32 | get_current_comp (FiffInfo *info) |
|
static SparseMatrix< double > * | make_block_diag (const MatrixXd &A, qint32 n) |
|
static bool | make_compensator (const FiffInfo &info, fiff_int_t from, fiff_int_t to, FiffCtfComp &ctf_comp, bool exclude_comp_chs=false) |
|
static fiff_int_t | make_projector (const QList< FiffProj > &projs, const QStringList &ch_names, MatrixXd &proj, const QStringList &bads=defaultQStringList, MatrixXd &U=defaultMatrixXd) |
|
static qint32 | make_projector (FiffInfo &info, MatrixXd &proj) |
|
static bool | patch_info (MNEHemisphere &p_Hemisphere) |
|
static MNEInverseOperator | prepare_inverse_operator (MNEInverseOperator &orig, qint32 nave, float lambda2, bool dSPM, bool sLORETA=false) |
|
static bool | read_events (QIODevice &p_IODevice, MatrixXi &eventlist) |
|
static bool | read_cov (FiffStream *p_pStream, FiffDirTree &p_Node, fiff_int_t cov_kind, FiffCov &p_covData) |
|
static bool | read_inverse_operator (QIODevice &p_pIODevice, MNEInverseOperator &inv) |
|
static bool | read_forward_solution (QIODevice &p_IODevice, MNEForwardSolution &fwd, bool force_fixed=false, bool surf_ori=false, const QStringList &include=defaultQStringList, const QStringList &exclude=defaultQStringList) |
|
static bool | read_source_spaces (FiffStream::SPtr &p_pStream, bool add_geom, FiffDirTree &p_Tree, MNESourceSpace &p_SourceSpace) |
|
static bool | read_bem_surface (FiffStream::SPtr &p_pStream, bool add_geom, FiffDirTree &p_Tree, QList< MNESurface::SPtr > &p_Surfaces) |
|
static QList< FiffChInfo > | set_current_comp (QList< FiffChInfo > &chs, fiff_int_t value) |
|
static bool | transform_source_space_to (MNESourceSpace *p_pMNESourceSpace, fiff_int_t dest, FiffCoordTrans &trans) |
|
static void | transpose_named_matrix (FiffNamedMatrix *mat) |
|
The MNE class provides wrapper functions to stay consistent with mne matlab toolbox.
DECLARE MNE WRAPPER CLASS
Definition at line 103 of file mne.h.
virtual MNELIB::MNE::~MNE |
( |
| ) |
|
|
inlinevirtual |
dtor
Definition at line 112 of file mne.h.
static VectorXd* MNELIB::MNE::combine_xyz |
( |
const VectorXd & |
vec | ) |
|
|
inlinestatic |
mne_combine_xyz
MNE toolbox root function
Wrapper for the MNEMath::combine_xyz static function
Compute the three Cartesian components of a vector together
- Parameters
-
[in] | vec | Input row vector [ x1 y1 z1 ... x_n y_n z_n ] |
- Returns
- Output vector [x1^2+y1^2+z1^2 ... x_n^2+y_n^2+z_n^2 ]
Definition at line 129 of file mne.h.
static qint32 MNELIB::MNE::find_source_space_hemi |
( |
MNEHemisphere & |
p_Hemisphere | ) |
|
|
inlinestatic |
mne_block_diag - decoding part
MNE toolbox root function
Wrapper for the MNEForwardSolution::extract_block_diag static function mne_find_source_space_hemi
MNE toolbox root function
Wrapper for the MNESourceSpace::find_source_space_hemi static function
Returns the hemisphere id (FIFFV_MNE_SURF_LEFT_HEMI or FIFFV_MNE_SURF_RIGHT_HEMI) for a source space.
- Parameters
-
[in] | p_Hemisphere | The hemisphere to investigate |
- Returns
- the deduced hemisphere id
Definition at line 158 of file mne.h.
static qint32 MNELIB::MNE::get_current_comp |
( |
FiffInfo * |
info | ) |
|
|
inlinestatic |
mne_get_current_comp
MNE toolbox root function
Wrapper for the FiffInfo get_current_comp member function
Get the current compensation in effect in the data
- Parameters
-
[in] | info | Fiff measurement info |
- Returns
- the current compensation
Definition at line 177 of file mne.h.
static SparseMatrix<double>* MNELIB::MNE::make_block_diag |
( |
const MatrixXd & |
A, |
|
|
qint32 |
n |
|
) |
| |
|
inlinestatic |
mne_block_diag - encoding part
MNE toolbox root function
Wrapper for the MNEForwardSolution::make_block_diag static function
Make a sparse block diagonal matrix
Returns a sparse block diagonal, diagonalized from the elements in "A". "A" is ma x na, comprising bdn=(na/"n") blocks of submatrices. Each submatrix is ma x "n", and these submatrices are placed down the diagonal of the matrix.
- Parameters
-
[in,out] | A | Matrix which should be diagonlized |
[in,out] | n | Columns of the submatrices |
- Returns
- A sparse block diagonal, diagonalized from the elements in "A".
Definition at line 202 of file mne.h.
static bool MNELIB::MNE::make_compensator |
( |
const FiffInfo & |
info, |
|
|
fiff_int_t |
from, |
|
|
fiff_int_t |
to, |
|
|
FiffCtfComp & |
ctf_comp, |
|
|
bool |
exclude_comp_chs = false |
|
) |
| |
|
inlinestatic |
mne_make_compensator
MNE toolbox root function
Wrapper for the FiffInfo make_compensator member function
Create a compensation matrix to bring the data from one compensation state to another
- Parameters
-
[in] | info | measurement info as returned by the fif reading routines |
[in] | from | compensation in the input data |
[in] | to | desired compensation in the output |
[out] | ctf_comp | Compensation Matrix |
[in] | exclude_comp_chs | exclude compensation channels from the output (optional) |
- Returns
- true if succeeded, false otherwise
Definition at line 225 of file mne.h.
static fiff_int_t MNELIB::MNE::make_projector |
( |
const QList< FiffProj > & |
projs, |
|
|
const QStringList & |
ch_names, |
|
|
MatrixXd & |
proj, |
|
|
const QStringList & |
bads = defaultQStringList , |
|
|
MatrixXd & |
U = defaultMatrixXd |
|
) |
| |
|
inlinestatic |
make_projector
MNE toolbox root function
Wrapper for the FiffInfo::make_projector static function There exists also a member function which should be preferred: make_projector(MatrixXd& proj, MatrixXd& U = defaultUMatrix)
Make an SSP operator
- Parameters
-
[in] | projs | A set of projection vectors |
[in] | ch_names | A cell array of channel names |
[out] | proj | The projection operator to apply to the data |
[in] | bads | Bad channels to exclude |
[out] | U | The orthogonal basis of the projection vectors (optional) |
- Returns
- nproj - How many items in the projector
Definition at line 250 of file mne.h.
static qint32 MNELIB::MNE::make_projector |
( |
FiffInfo & |
info, |
|
|
MatrixXd & |
proj |
|
) |
| |
|
inlinestatic |
mne_make_projector_info
MNE toolbox root function
Wrapper for the FiffInfo make_projector_info(MatrixXd& proj) member function
Make a SSP operator using the meas info
- Parameters
-
[in] | info | Fiff measurement info |
[out] | proj | The projection operator to apply to the data |
- Returns
- nproj - How many items in the projector
Definition at line 270 of file mne.h.
static bool MNELIB::MNE::patch_info |
( |
MNEHemisphere & |
p_Hemisphere | ) |
|
|
inlinestatic |
mne_patch_info
MNE toolbox root function
Wrapper for the MNESourceSpace::patch_info static function
- Parameters
-
[in,out] | p_Hemisphere | The source space. |
- Returns
- true if succeeded, false otherwise
Definition at line 287 of file mne.h.
mne_prepare_inverse_operator
MNE toolbox root function
Wrapper for the MNEInverseOperator prepare_inverse_operator member function
Prepare for actually computing the inverse
- Parameters
-
[in] | orig | The inverse operator structure read from a file |
[in] | nave | Number of averages (scales the noise covariance) |
[in] | lambda2 | The regularization factor |
[in] | dSPM | Compute the noise-normalization factors for dSPM? |
[in] | sLORETA | Compute the noise-normalization factors for sLORETA? |
- Returns
- the prepared inverse operator
Definition at line 310 of file mne.h.
mne_read_bem_surface
MNE toolbox root function
Wrapper for the MNESurface::read static function
Reads a BEM surface from a fif stream
- Parameters
-
[in] | p_pStream | The open fiff file |
[in] | add_geom | Add geometry information to the source spaces |
[in] | p_Tree | Search for the source spaces here |
[out] | p_Surfaces | The read bem surfaces |
- Returns
- true if succeeded, false otherwise
Definition at line 438 of file mne.h.
mne_read_cov
MNE toolbox root function
Wrapper for the FiffStream read_cov member function
Reads a covariance matrix from a fiff file
- Parameters
-
[in] | p_pStream | an open fiff file |
[in] | p_Node | look for the matrix in here |
[in] | cov_kind | what kind of a covariance matrix do we want? |
[out] | p_covData | the read covariance matrix |
- Returns
- true if succeeded, false otherwise
Definition at line 348 of file mne.h.
bool MNE::read_events |
( |
QIODevice & |
p_IODevice, |
|
|
MatrixXi & |
eventlist |
|
) |
| |
|
static |
mne_read_events
MNE toolbox root function
Read an event list from a fif file
- Parameters
-
[in] | p_IODevice | The I/O device to read from |
[out] | eventlist | The read eventlist m x 3; with m events; colum: 1 - position in samples, 3 - eventcode |
- Returns
- true if succeeded, false otherwise
Definition at line 68 of file mne.cpp.
static bool MNELIB::MNE::read_forward_solution |
( |
QIODevice & |
p_IODevice, |
|
|
MNEForwardSolution & |
fwd, |
|
|
bool |
force_fixed = false , |
|
|
bool |
surf_ori = false , |
|
|
const QStringList & |
include = defaultQStringList , |
|
|
const QStringList & |
exclude = defaultQStringList |
|
) |
| |
|
inlinestatic |
mne_read_forward_solution
MNE toolbox root function
Wrapper for the MNEForwardSolution::read_forward_solution static function
Reads a forward solution from a fif file
- Parameters
-
[in] | p_IODevice | A fiff IO device like a fiff QFile or QTCPSocket |
[out] | fwd | A forward solution from a fif file |
[in] | force_fixed | Force fixed source orientation mode? (optional) |
[in] | surf_ori | Use surface based source coordinate system? (optional) |
[in] | include | Include these channels (optional) |
[in] | exclude | Exclude these channels (optional) |
- Returns
- true if succeeded, false otherwise
Definition at line 392 of file mne.h.
static bool MNELIB::MNE::read_inverse_operator |
( |
QIODevice & |
p_pIODevice, |
|
|
MNEInverseOperator & |
inv |
|
) |
| |
|
inlinestatic |
mne_read_inverse_operator
MNE toolbox root function
Wrapper for the MNEInverseOperator::read_inverse_operator static function
Reads the inverse operator decomposition from a fif file
- Parameters
-
[in] | p_pIODevice | A fiff IO device like a fiff QFile or QTCPSocket |
[out] | inv | The read inverse operator |
- Returns
- true if succeeded, false otherwise
Definition at line 368 of file mne.h.
mne_read_forward_solution
MNE toolbox root function
Wrapper for the MNESourceSpace::read_source_spaces static function
Reads source spaces from a fif file
- Parameters
-
[in] | p_pStream | The open fiff file |
[in] | add_geom | Add geometry information to the source spaces |
[in] | p_Tree | Search for the source spaces here |
[out] | p_SourceSpace | The read source spaces |
- Returns
- true if succeeded, false otherwise
Definition at line 415 of file mne.h.
static QList<FiffChInfo> MNELIB::MNE::set_current_comp |
( |
QList< FiffChInfo > & |
chs, |
|
|
fiff_int_t |
value |
|
) |
| |
|
inlinestatic |
mne_set_current_comp
MNE toolbox root function
Wrapper for the FiffInfo::set_current_comp static function Consider taking the member function of a FiffInfo set_current_comp(fiff_int_t value), when compensation should be applied to the channels of FiffInfo
Set the current compensation value in the channel info structures
- Parameters
-
[in] | chs | fiff channel info list |
[in] | value | compensation value |
- Returns
- the current compensation
Definition at line 461 of file mne.h.
mne_transform_source_space_to
MNE toolbox root function
Wrapper for the MNESourceSpace transform_source_space_to member function
Transforms source space data to the desired coordinate system
- Parameters
-
[in,out] | p_pMNESourceSpace | the source space which is should be transformed |
[in] | dest | destination check code |
[in] | trans | transformation information |
- Returns
- true if succeeded, false otherwise
Definition at line 482 of file mne.h.
mne_transpose_named_matrix
MNE toolbox root function
Wrapper for the FiffNamedMatrix transpose_named_matrix member function
Transpose a named matrix (FiffNamedMatrix)
- Parameters
-
[in,out] | mat | FiffNamedMatrix which shoul be transposed. |
Definition at line 500 of file mne.h.
The documentation for this class was generated from the following files:
- D:/Users/Christoph/GitHub/mne-cpp/MNE/mne/mne.h
- D:/Users/Christoph/GitHub/mne-cpp/MNE/mne/mne.cpp