JaRMoS  1.1
Java Reduced Model Simulations
 All Classes Namespaces Files Functions Variables Enumerator Groups Pages
rb.ComplexRBSystem Class Reference

RB system class for complex-valued fields. More...

Inheritance diagram for rb.ComplexRBSystem:
rb.RBSystem jarmos.ModelBase

Public Member Functions

void loadOfflineData_rbappmit (AModelManager m) throws IOException
 
double RB_solve (int N)
 
double[][] get_RBsolution ()
 
double get_RB_output (int n_output, boolean Rpart)
 
double get_RB_output_error_bound (int n_output, boolean Rpart)
 
SimulationResult getSimulationResults ()
 Returns the results of the complex RB simulation. More...
 
SimulationResult getSweepSimResults ()
 
boolean is_derived_output ()
 
void cal_derived_output ()
 
- Public Member Functions inherited from rb.RBSystem
 RBSystem ()
 Constructor. More...
 
FieldVector< Complex > complex_eval_theta_q_a ()
 
Complex complex_eval_theta_q_a (int q)
 
Complex complex_eval_theta_q_f (int q)
 
Complex complex_eval_theta_q_l (int n, int q)
 
int get_N ()
 
double get_RB_output (int n_output, boolean Rpart)
 
double get_RB_output_error_bound (int n_output, boolean Rpart)
 
double get_SCM_lower_bound ()
 
RealVector getInitialCoefficients (int N)
 Returns the initial conditions solution coefficients for RB size N. More...
 
int getNBF ()
 
int getNumOutputs ()
 
Parameters getParams ()
 Returns the system's parameters object. More...
 
int getQa ()
 
int getQf ()
 TODO: if all affine_functions implement the IAffineFunctions interface, just call the getQf method of the local instance. More...
 
int getQuL ()
 
SimulationResult getSimulationResults ()
 Constructs the true solution from the most recent RB reduced solution using the full Z data and current coefficients. More...
 
double getSweepIncrement ()
 Returns the increment used during the last parameter sweep or zero if there hasn't been any. More...
 
double[][] getSweepOutputBounds ()
 
double[][] getSweepOutputs ()
 
SimulationResult getSweepSimResults ()
 
int getTotalTimesteps ()
 TODO check where this is used. More...
 
int getVisualNumTimesteps ()
 
void loadOfflineData (AModelManager m) throws MathReaderException, ModelManagerException, IOException
 Loads the offline data for the RBSystem. More...
 
float[] rbappmitCustomMeshTransform (double[] mu, float[] x)
 Custom mesh transformation method of old rbappmit-models. More...
 
int performSweep (int sweepIndex, int N)
 Performs a parameter sweep with automatic guess of the number of parameter sweeps. More...
 
int performSweep (int sweepIndex, int N, int numSweepPts)
 Performs a parameter sweep for the current RB system. More...
 
final boolean readConfiguration (AModelManager m)
 
void set_n_basis_functions (int _N)
 
void setPrimarySCM (RBSCMSystem scm_system)
 Set the primary SCM. More...
 
double computeRBSolution (int N)
 Performs a reduced basis simulation and stores the results locally. More...
 
double thetaQa (int q)
 Evaluate theta_q_a (for the q^th bilinear form) at the current parameter. More...
 
double thetaQa (int q, double t)
 
double thetaQf (int i)
 
double thetaQf (int i, double t)
 
double thetaQl (int k, int i)
 
double thetaQl (int k, int i, double t)
 
- Public Member Functions inherited from jarmos.ModelBase
void loadOfflineData (AModelManager m) throws MathReaderException, ModelManagerException, IOException
 Loads the model's offline data. More...
 
GeometryData getGeometry ()
 The model's geometry data. More...
 
int getNumDoFFields ()
 Returns the number of degree-of-freedom fields generated/computed by the model. More...
 

Public Attributes

Complex[] RB_outputs
 
Complex[] RB_output_error_bounds
 
Complex[][] output_dual_norms
 
- Public Attributes inherited from rb.RBSystem
Class< IAffineFunctionsaffineFunctionsClass
 The Class object for the affine functions class. More...
 
IAffineFunctions affineFunctionsInstance
 The member object that defines the parameter-dependent functions for the affine expansion of the left-hand, right-hand side and outputs. More...
 
boolean isReal = true
 
RBSCMSystem mRbScmSystem
 A reference to the SCM system. More...
 
Class<?> oldAffFcnCl
 
Object oldAffFcnObj
 
double[][] output_dual_norms
 This array stores the dual norms for each output. More...
 
double[] RB_output_error_bounds
 The vector storing the RB error bounds in the steady-state case. More...
 
double[][] RB_output_error_bounds_all_k
 The output error bounds at all time levels. More...
 
double[] RB_outputs
 The vector storing the RB output values in the steady-state case. More...
 
double[][] RB_outputs_all_k
 The outputs at all time levels. More...
 
boolean return_rel_error_bound
 Boolean flag to indicate whether RB_solve returns an absolute or relative error bound. More...
 

Protected Member Functions

void initialize_data_vectors ()
 
double compute_residual_dual_norm (int N)
 
double compute_output_dual_norm (int i, double t)
 
- Protected Member Functions inherited from rb.RBSystem
double compute_output_dual_norm (int i, double t)
 Compute the dual norm of the i^th output function at the current parameter value. More...
 
double compute_residual_dual_norm (int N)
 Compute the dual norm of the residual for the solution saved in RB_solution_vector. More...
 
double[][] get_RBsolution ()
 
double get_SCM_from_AffineFunction ()
 A private helper function to get the SCM from AffineFunctions in the case that SCM_TYPE = NONE. More...
 
int getQl (int output_index)
 TODO: if all affine_functions implement the IAffineFunctions interface, just call the getQl method of the local instance. More...
 
float[][] getAffLinTransformationData (double[] mu)
 Returns a float array of transformation data for each node, using the specified parameter mu. More...
 
boolean hasCustomMeshTransform ()
 
boolean hasAffLinTransformationData ()
 
void initialize_data_vectors ()
 Resize the vectors that store solution data and output data. More...
 
void loadOfflineData_rbappmit (AModelManager m) throws IOException
 
void loadOfflineDataJRB (AModelManager m) throws IOException
 
double RB_solve (int N)
 Perform online solve with the N RB basis functions, for the set of parameters in current_params, where 1 <= N <= RB_size. More...
 
void readConfigurationJRB (AModelManager m)
 
void readConfigurationRBAppMIT (GetPot infile)
 
double residual_scaling_denom (double alpha_LB)
 Specifies the residual scaling on the denominator to be used in the a posteriori error bound. More...
 
void setParams (Parameters p)
 Only used to set the current parameters object for an SCMSystem, as this also inherits from the RBBase class. More...
 

Protected Attributes

FieldVector< Complex > RB_solution
 
FieldVector< Complex >[][] RB_output_vectors
 
FieldMatrix< Complex >[] RB_A_q_vector
 
FieldVector< Complex >[] RB_F_q_vector
 
FieldVector< Complex > theta_a
 
Complex[] Fq_representor_norms
 
Complex[][][] Fq_Aq_representor_norms
 
Complex[][][] Aq_Aq_representor_norms
 
Complex[][][] Z_vector
 
Complex[][] uL_vector
 
- Protected Attributes inherited from rb.RBSystem
double[][][] Aq_Aq_representor_norms
 
int current_N
 
double[][][] Fq_Aq_representor_norms
 
double[] Fq_representor_norms
 Arrays storing the residual representor inner products to be used in computing the residuals in the Online stage. More...
 
float[][][] fullBasisVectors
 
RealMatrix[] RB_A_q_vector
 Dense matrices for the RB computations. More...
 
RealVector[] RB_F_q_vector
 Dense vector for the RHS. More...
 
RealVector[][] RB_output_vectors
 The vectors storing the RB output vectors. More...
 
RealVector RB_solution
 The RB solution vector. More...
 
double[][][] RB_sweep_solution
 
float[][] uL_vector
 
List< MeshTransformtransforms
 
- Protected Attributes inherited from jarmos.ModelBase
FieldDescriptor[] logicalFieldTypes
 The logical output fields of the model, each collecting one ore more model DoF's into a related unit, like displacements which have 2-3 DoF-fields (x,y,z) More...
 

Package Functions

Complex get_complex_soln_coeff (int i)
 
- Package Functions inherited from rb.RBSystem
double get_SCM_upper_bound ()
 
double get_soln_coeff (int i)
 

Detailed Description

RB system class for complex-valued fields.

Author
Daniel Wirtz
Date
07.08.2013

Definition at line 48 of file ComplexRBSystem.java.

Member Function Documentation

void rb.ComplexRBSystem.cal_derived_output ( )

Definition at line 748 of file ComplexRBSystem.java.

double rb.ComplexRBSystem.compute_output_dual_norm ( int  i,
double  t 
)
protected
See Also
rb.RBSystem::compute_output_dual_norm(int, double) TODO: make use of the t variable and change the complex_eval_theta etc

Definition at line 556 of file ComplexRBSystem.java.

double rb.ComplexRBSystem.compute_residual_dual_norm ( int  N)
protected

Definition at line 491 of file ComplexRBSystem.java.

Complex rb.ComplexRBSystem.get_complex_soln_coeff ( int  i)
package

Definition at line 578 of file ComplexRBSystem.java.

double rb.ComplexRBSystem.get_RB_output ( int  n_output,
boolean  Rpart 
)

Definition at line 594 of file ComplexRBSystem.java.

double rb.ComplexRBSystem.get_RB_output_error_bound ( int  n_output,
boolean  Rpart 
)

Definition at line 602 of file ComplexRBSystem.java.

double [][] rb.ComplexRBSystem.get_RBsolution ( )

Definition at line 583 of file ComplexRBSystem.java.

SimulationResult rb.ComplexRBSystem.getSimulationResults ( )

Returns the results of the complex RB simulation.

Formerly, the returned float[][] array was again sorted into visualization data in RBVisualization.onCreate. As there have only been rbAppMIT models with complex field data, which has been split into real, imaginary and norm field values for visualization, this new method is the native way of transforming the results into ComplexSolutionFields, however many there may be. For each field the visualization will automatically create views for real, imaginary and norm value fields.

Definition at line 619 of file ComplexRBSystem.java.

SimulationResult rb.ComplexRBSystem.getSweepSimResults ( )

Definition at line 668 of file ComplexRBSystem.java.

void rb.ComplexRBSystem.initialize_data_vectors ( )
protected

Definition at line 370 of file ComplexRBSystem.java.

boolean rb.ComplexRBSystem.is_derived_output ( )

Definition at line 726 of file ComplexRBSystem.java.

void rb.ComplexRBSystem.loadOfflineData_rbappmit ( AModelManager  m) throws IOException

Definition at line 73 of file ComplexRBSystem.java.

double rb.ComplexRBSystem.RB_solve ( int  N)

Definition at line 377 of file ComplexRBSystem.java.

Member Data Documentation

Complex [][][] rb.ComplexRBSystem.Aq_Aq_representor_norms
protected

Definition at line 67 of file ComplexRBSystem.java.

Complex [][][] rb.ComplexRBSystem.Fq_Aq_representor_norms
protected

Definition at line 66 of file ComplexRBSystem.java.

Complex [] rb.ComplexRBSystem.Fq_representor_norms
protected

Definition at line 65 of file ComplexRBSystem.java.

Complex [][] rb.ComplexRBSystem.output_dual_norms

Definition at line 58 of file ComplexRBSystem.java.

FieldMatrix<Complex> [] rb.ComplexRBSystem.RB_A_q_vector
protected

Definition at line 60 of file ComplexRBSystem.java.

FieldVector<Complex> [] rb.ComplexRBSystem.RB_F_q_vector
protected

Definition at line 61 of file ComplexRBSystem.java.

Complex [] rb.ComplexRBSystem.RB_output_error_bounds

Definition at line 54 of file ComplexRBSystem.java.

FieldVector<Complex> [][] rb.ComplexRBSystem.RB_output_vectors
protected

Definition at line 59 of file ComplexRBSystem.java.

Complex [] rb.ComplexRBSystem.RB_outputs

Definition at line 53 of file ComplexRBSystem.java.

FieldVector<Complex> rb.ComplexRBSystem.RB_solution
protected

Definition at line 56 of file ComplexRBSystem.java.

FieldVector<Complex> rb.ComplexRBSystem.theta_a
protected

Definition at line 63 of file ComplexRBSystem.java.

Complex [][] rb.ComplexRBSystem.uL_vector
protected

Definition at line 70 of file ComplexRBSystem.java.

Complex [][][] rb.ComplexRBSystem.Z_vector
protected

Definition at line 69 of file ComplexRBSystem.java.


The documentation for this class was generated from the following file: