Class Component

java.lang.Object
neqsim.thermo.component.Component
All Implemented Interfaces:
Serializable, Cloneable, ComponentInterface, ThermodynamicConstantsInterface
Direct Known Subclasses:
ComponentEos, ComponentGE, ComponentHydrate, ComponentHydrateKluda, ComponentIdealGas

public abstract class Component extends Object implements ComponentInterface

Abstract Component class.

Author:
Even Solbraa
See Also:
  • Field Details

    • serialVersionUID

      private static final long serialVersionUID
      Serialization version UID.
      See Also:
    • logger

      static org.apache.logging.log4j.Logger logger
      Logger object for class.
    • MMHG_TO_BAR

      private static final double MMHG_TO_BAR
      Conversion factor from mmHg to bar.
      See Also:
    • surfTensInfluenceParam

      double[] surfTensInfluenceParam
    • index

      protected int index
      Index number of Component in database.
    • componentNumber

      protected int componentNumber
      Index number of Component in Phase object component array.
    • componentName

      protected String componentName
      Name of component.
    • componentType

      private String componentType
      Type of component. Can be "normal", "TBP", "plus", "ion", but what does "HC", "inert" and "Component?" do?
    • z

      protected double z
      Mole fraction of Component in System.
    • x

      protected double x
      Mole fraction of Component in Phase.
    • numberOfMoles

      protected double numberOfMoles
      Number of moles of Component in System. Ideally numberOfMoles = totalNumberOfMoles * z.
    • numberOfMolesInPhase

      protected double numberOfMolesInPhase
      Number of moles of Component in Phase. Ideally totalNumberOfMoles * x * beta.
    • K

      protected double K
    • attractiveTermNumber

      protected int attractiveTermNumber
    • numberOfAssociationSites

      protected int numberOfAssociationSites
    • associationVolume

      protected double associationVolume
    • associationEnergy

      protected double associationEnergy
    • aCPA

      protected double aCPA
    • bCPA

      protected double bCPA
    • mCPA

      protected double mCPA
    • srkacentricFactor

      protected double srkacentricFactor
    • referenceStateType

      protected String referenceStateType
    • associationScheme

      protected String associationScheme
    • antoineLiqVapPresType

      protected String antoineLiqVapPresType
    • formulae

      private String formulae
    • CASnumber

      private String CASnumber
    • elements

      protected Element elements
    • isTBPfraction

      protected boolean isTBPfraction
    • isPlusFraction

      protected boolean isPlusFraction
    • isNormalComponent

      protected boolean isNormalComponent
    • isIon

      protected boolean isIon
    • isHydrateFormer

      private boolean isHydrateFormer
    • waxFormer

      private boolean waxFormer
    • qPure

      protected double qPure
    • voli

      protected double voli
    • calcActivity

      protected int calcActivity
    • solidCheck

      protected boolean solidCheck
      Check for solid phase and do solid phase calculations.
    • dqPuredT

      protected double dqPuredT
    • dqPuredTdT

      protected double dqPuredTdT
    • racketZCPA

      private double racketZCPA
    • criticalCompressibilityFactor

      private double criticalCompressibilityFactor
    • volumeCorrectionConst

      private double volumeCorrectionConst
    • volumeCorrection

      private Double volumeCorrection
    • volumeCorrectionT

      private double volumeCorrectionT
    • volumeCorrectionT_CPA

      private double volumeCorrectionT_CPA
    • criticalPressure

      protected double criticalPressure
    • criticalTemperature

      protected double criticalTemperature
    • molarMass

      protected double molarMass
    • acentricFactor

      protected double acentricFactor
    • normalLiquidDensity

      protected double normalLiquidDensity
    • fugacityCoefficient

      protected double fugacityCoefficient
    • debyeDipoleMoment

      protected double debyeDipoleMoment
    • viscosityCorrectionFactor

      protected double viscosityCorrectionFactor
    • criticalVolume

      protected double criticalVolume
    • racketZ

      protected double racketZ
    • gibbsEnergyOfFormation

      protected double gibbsEnergyOfFormation
    • criticalViscosity

      protected double criticalViscosity
    • referencePotential

      protected double referencePotential
    • viscosityFrictionK

      protected double viscosityFrictionK
    • liquidViscosityModel

      protected int liquidViscosityModel
    • ionicCharge

      protected int ionicCharge
    • referenceEnthalpy

      private double referenceEnthalpy
    • parachorParameter

      protected double parachorParameter
    • normalBoilingPoint

      protected double normalBoilingPoint
    • sphericalCoreRadius

      protected double sphericalCoreRadius
    • standardDensity

      protected double standardDensity
    • AntoineASolid

      protected double AntoineASolid
    • AntoineBSolid

      protected double AntoineBSolid
    • AntoineCSolid

      protected double AntoineCSolid
    • liquidViscosityParameter

      protected double[] liquidViscosityParameter
    • liquidConductivityParameter

      protected double[] liquidConductivityParameter
    • henryCoefParameter

      protected double[] henryCoefParameter
    • dielectricParameter

      protected double[] dielectricParameter
    • schwartzentruberParams

      protected double[] schwartzentruberParams
    • matiascopemanParams

      protected double[] matiascopemanParams
    • matiascopemanParamsPR

      protected double[] matiascopemanParamsPR
    • TwuCoonParams

      protected double[] TwuCoonParams
    • matiascopemanSolidParams

      protected double[] matiascopemanSolidParams
    • matiascopemanParamsUMRPRU

      protected double[] matiascopemanParamsUMRPRU
    • lennardJonesMolecularDiameter

      protected double lennardJonesMolecularDiameter
    • lennardJonesEnergyParameter

      protected double lennardJonesEnergyParameter
    • stokesCationicDiameter

      protected double stokesCationicDiameter
    • paulingAnionicDiameter

      protected double paulingAnionicDiameter
    • orginalNumberOfAssociationSites

      private int orginalNumberOfAssociationSites
    • dfugdt

      protected double dfugdt
    • dfugdp

      protected double dfugdp
    • dfugdn

      protected double[] dfugdn
    • dfugdx

      public double[] dfugdx
    • AntoineA

      double AntoineA
    • AntoineB

      double AntoineB
    • AntoineC

      double AntoineC
    • AntoineD

      double AntoineD
    • AntoineE

      double AntoineE
    • CpA

      private double CpA
    • CpB

      private double CpB
    • CpC

      private double CpC
    • CpD

      private double CpD
    • CpE

      private double CpE
    • CpSolid

      private double[] CpSolid
    • CpLiquid

      private double[] CpLiquid
    • heatOfFusion

      private double heatOfFusion
    • triplePointDensity

      double triplePointDensity
    • triplePointPressure

      double triplePointPressure
    • triplePointTemperature

      private double triplePointTemperature
    • meltingPointTemperature

      double meltingPointTemperature
    • idealGasEnthalpyOfFormation

      private double idealGasEnthalpyOfFormation
    • idealGasGibbsEnergyOfFormation

      double idealGasGibbsEnergyOfFormation
    • idealGasAbsoluteEntropy

      double idealGasAbsoluteEntropy
    • Hsub

      double Hsub
    • solidDensityCoefs

      double[] solidDensityCoefs
    • liquidDensityCoefs

      double[] liquidDensityCoefs
    • heatOfVaporizationCoefs

      double[] heatOfVaporizationCoefs
    • mSAFTi

      protected double mSAFTi
    • sigmaSAFTi

      protected double sigmaSAFTi
    • epsikSAFT

      protected double epsikSAFT
    • associationVolumeSAFT

      private double associationVolumeSAFT
    • associationEnergySAFT

      private double associationEnergySAFT
  • Constructor Details

    • Component

      public Component(int number, double TC, double PC, double M, double a, double moles)

      Constructor for Component.

      Parameters:
      number - a int. Not used.
      TC - Critical temperature [K]
      PC - Critical pressure [bara]
      M - Molar mass
      a - Acentric factor
      moles - Total number of moles of component.
    • Component

      public Component(String name, double moles, double molesInPhase, int compIndex)

      Constructor for Component.

      Parameters:
      name - Name of component.
      moles - Total number of moles of component.
      molesInPhase - Number of moles in phase.
      compIndex - Index number of component in phase object component array.
  • Method Details

    • createComponent

      public void createComponent(String name, double moles, double molesInPhase, int compIndex)

      Helper function to create component. Typically called from constructors.

      Specified by:
      createComponent in interface ComponentInterface
      Parameters:
      name - Name of component.
      moles - Total number of moles of component in system.
      molesInPhase - Number of moles in phase.
      compIndex - Index number of component in phase object component array.
    • insertComponentIntoDatabase

      public void insertComponentIntoDatabase(String databaseName)

      Insert this component into NeqSim component database.

      Specified by:
      insertComponentIntoDatabase in interface ComponentInterface
      Parameters:
      databaseName - Name of database. Not in use, overwritten as comptemp.
    • clone

      public Component clone()

      clone.

      Specified by:
      clone in interface ComponentInterface
      Overrides:
      clone in class Object
      Returns:
      a ComponentInterface object
    • addMolesChemReac

      public void addMolesChemReac(double dn, double totdn)

      Change the number of moles of component of phase, i.e., numberOfMolesInPhase, and total number of moles of component in system, i.e., numberOfMoles with separate amounts.

      Specified by:
      addMolesChemReac in interface ComponentInterface
      Parameters:
      dn - Number of moles of component to add to phase
      totdn - Number of moles of component to add to system
    • setProperties

      public void setProperties(ComponentInterface component)

      setProperties.

      Specified by:
      setProperties in interface ComponentInterface
      Parameters:
      component - a ComponentInterface object
    • init

      public void init(double temperature, double pressure, double totalNumberOfMoles, double beta, int initType)

      Initialize component.

      Specified by:
      init in interface ComponentInterface
      Parameters:
      temperature - Temperature in unit ?. Used to calculate K.
      pressure - Pressure in unit ?. Used to calculate K.
      totalNumberOfMoles - Total number of moles of component.
      beta - Beta value, i.e.,
      initType - Init type. Calculate K, z, x if type == 0.
    • getElements

      public Element getElements()

      getElements.

      Specified by:
      getElements in interface ComponentInterface
      Returns:
      a Element object
    • Finit

      public void Finit(PhaseInterface phase, double temp, double pres, double totMoles, double beta, int numberOfComponents, int initType)

      Finit.

      Specified by:
      Finit in interface ComponentInterface
      Parameters:
      phase - a PhaseInterface object
      temp - a double
      pres - a double
      totMoles - a double
      beta - a double
      numberOfComponents - a int
      initType - a int
    • getx

      public final double getx()

      Getter for property x, i.e., the mole fraction of a component in a specific phase. For the mole fraction for a specific phase see ComponentInterface.getz() NB! init(0) must be called first from system.

      Specified by:
      getx in interface ComponentInterface
      Returns:
      a double
    • getz

      public final double getz()

      Getter for property z, i.e., the mole fraction of a component in the fluid. For the mole fraction for a specific phase see ComponentInterface.getx() NB! init(0) must be called first from system.

      Specified by:
      getz in interface ComponentInterface
      Returns:
      a double
    • setz

      public final void setz(double z)

      setz.

      Specified by:
      setz in interface ComponentInterface
      Parameters:
      z - a double
    • getReferencePotential

      public final double getReferencePotential()

      getReferencePotential.

      Specified by:
      getReferencePotential in interface ComponentInterface
      Returns:
      a double
    • setReferencePotential

      public final void setReferencePotential(double ref)

      setReferencePotential.

      Specified by:
      setReferencePotential in interface ComponentInterface
      Parameters:
      ref - a double
    • getK

      public final double getK()

      The distribution coefficient y/x between gas and liquid for a component. NB! init must be called first.

      Specified by:
      getK in interface ComponentInterface
      Returns:
      a double
    • getHeatOfFusion

      public final double getHeatOfFusion()

      getHeatOfFusion.

      Specified by:
      getHeatOfFusion in interface ComponentInterface
      Returns:
      a double
    • getHeatOfVapourization

      public double getHeatOfVapourization(double temp)

      getHeatOfVapourization.

      Specified by:
      getHeatOfVapourization in interface ComponentInterface
      Parameters:
      temp - a double
      Returns:
      a double
    • getTriplePointDensity

      public final double getTriplePointDensity()

      getTriplePointDensity.

      Specified by:
      getTriplePointDensity in interface ComponentInterface
      Returns:
      a double
    • getTriplePointPressure

      public final double getTriplePointPressure()

      getTriplePointPressure.

      Specified by:
      getTriplePointPressure in interface ComponentInterface
      Returns:
      a double
    • getTriplePointTemperature

      public final double getTriplePointTemperature()

      getTriplePointTemperature.

      Specified by:
      getTriplePointTemperature in interface ComponentInterface
      Returns:
      a double
    • getMeltingPointTemperature

      public final double getMeltingPointTemperature()

      getMeltingPointTemperature.

      Specified by:
      getMeltingPointTemperature in interface ComponentInterface
      Returns:
      a double
    • getIdealGasEnthalpyOfFormation

      public final double getIdealGasEnthalpyOfFormation()

      getIdealGasEnthalpyOfFormation.

      Specified by:
      getIdealGasEnthalpyOfFormation in interface ComponentInterface
      Returns:
      a double
    • getIdealGasGibbsEnergyOfFormation

      public final double getIdealGasGibbsEnergyOfFormation()

      getIdealGasGibbsEnergyOfFormation.

      Specified by:
      getIdealGasGibbsEnergyOfFormation in interface ComponentInterface
      Returns:
      a double
    • getIdealGasAbsoluteEntropy

      public final double getIdealGasAbsoluteEntropy()

      getIdealGasAbsoluteEntropy.

      Specified by:
      getIdealGasAbsoluteEntropy in interface ComponentInterface
      Returns:
      a double
    • getTC

      public final double getTC()

      Returns the critical temperature of the component.

      Specified by:
      getTC in interface ComponentInterface
      Returns:
      The critical temperature of the component in Kelvin.
    • getTC

      public final double getTC(String unit)

      Returns the critical temperature of the component.

      Specified by:
      getTC in interface ComponentInterface
      Parameters:
      unit - Unit of return temperature
      Returns:
      The critical temperature of the component in specified unit.
    • setTC

      public final void setTC(double val)

      setTC.

      Specified by:
      setTC in interface ComponentInterface
      Parameters:
      val - a double
    • setTC

      public final void setTC(double val, String unit)

      setTC.

      Specified by:
      setTC in interface ComponentInterface
      Parameters:
      val - a double
      unit - a String
    • setPC

      public final void setPC(double val)

      Setter for critical pressure.

      Specified by:
      setPC in interface ComponentInterface
      Parameters:
      val - Critical pressure in unit bara.
    • setPC

      public final void setPC(double val, String unit)

      Setter for critical pressure in specified unit.

      Specified by:
      setPC in interface ComponentInterface
      Parameters:
      val - Critical pressure in unit specified by unit.
      unit - Engineering unit.
    • getComponentName

      public final String getComponentName()

      Getter for property componentName.

      Specified by:
      getComponentName in interface ComponentInterface
      Returns:
      a String object
    • getReferenceStateType

      public final String getReferenceStateType()

      getReferenceStateType.

      Specified by:
      getReferenceStateType in interface ComponentInterface
      Returns:
      a String object
    • getPC

      public final double getPC()

      Returns the critical pressure of the component.

      Specified by:
      getPC in interface ComponentInterface
      Returns:
      The critical pressure of the component in unit bara.
    • getPC

      public final double getPC(String unit)

      Returns the critical pressure of the component.

      Specified by:
      getPC in interface ComponentInterface
      Parameters:
      unit - Unit of return pressure
      Returns:
      The critical pressure of the component in specified unit.
    • getGibbsEnergyOfFormation

      public double getGibbsEnergyOfFormation()

      getGibbsEnergyOfFormation.

      Specified by:
      getGibbsEnergyOfFormation in interface ComponentInterface
      Returns:
      a double
    • getDiElectricConstant

      public double getDiElectricConstant(double temperature)

      getDiElectricConstant.

      Specified by:
      getDiElectricConstant in interface ComponentInterface
      Parameters:
      temperature - a double
      Returns:
      a double
    • getDiElectricConstantdT

      public double getDiElectricConstantdT(double temperature)

      getDiElectricConstantdT.

      Specified by:
      getDiElectricConstantdT in interface ComponentInterface
      Parameters:
      temperature - a double
      Returns:
      a double
    • getDiElectricConstantdTdT

      public double getDiElectricConstantdTdT(double temperature)

      getDiElectricConstantdTdT.

      Specified by:
      getDiElectricConstantdTdT in interface ComponentInterface
      Parameters:
      temperature - a double
      Returns:
      a double
    • getDebyeDipoleMoment

      public double getDebyeDipoleMoment()

      This function handles the retrieval of a chemical’s dipole moment. Dipole moment, [debye] as a double

      Specified by:
      getDebyeDipoleMoment in interface ComponentInterface
      Returns:
      a double
    • getIonicCharge

      public final double getIonicCharge()

      getIonicCharge.

      Specified by:
      getIonicCharge in interface ComponentInterface
      Returns:
      a double
    • setViscosityAssociationFactor

      public final void setViscosityAssociationFactor(double val)

      setViscosityAssociationFactor.

      Specified by:
      setViscosityAssociationFactor in interface ComponentInterface
      Parameters:
      val - a double
    • getRacketZ

      public final double getRacketZ()

      getRacketZ.

      Specified by:
      getRacketZ in interface ComponentInterface
      Returns:
      a double
    • getVolumeCorrectionConst

      public double getVolumeCorrectionConst()

      getVolumeCorrectionConst.

      Specified by:
      getVolumeCorrectionConst in interface ComponentInterface
      Returns:
      a double
    • getNormalLiquidDensity

      public double getNormalLiquidDensity()

      getNormalLiquidDensity.

      Specified by:
      getNormalLiquidDensity in interface ComponentInterface
      Returns:
      a double
    • getNormalLiquidDensity

      public double getNormalLiquidDensity(String unit)

      getNormalLiquidDensity.

      Specified by:
      getNormalLiquidDensity in interface ComponentInterface
      Parameters:
      unit - i String with unit of return return a double
      Returns:
      a double
    • getViscosityCorrectionFactor

      public double getViscosityCorrectionFactor()

      getViscosityCorrectionFactor.

      Specified by:
      getViscosityCorrectionFactor in interface ComponentInterface
      Returns:
      a double
    • getViscosityFrictionK

      public double getViscosityFrictionK()
      Get component specific friction factor used in friction-theory viscosity model.
      Specified by:
      getViscosityFrictionK in interface ComponentInterface
      Returns:
      friction factor
    • setViscosityFrictionK

      public void setViscosityFrictionK(double viscosityFrictionK)
      Set component specific friction factor used in friction-theory viscosity model.
      Specified by:
      setViscosityFrictionK in interface ComponentInterface
      Parameters:
      viscosityFrictionK - friction factor
    • getCriticalVolume

      public double getCriticalVolume()

      getCriticalVolume.

      Specified by:
      getCriticalVolume in interface ComponentInterface
      Returns:
      a double
    • getLiquidViscosityModel

      public final int getLiquidViscosityModel()

      getLiquidViscosityModel.

      Specified by:
      getLiquidViscosityModel in interface ComponentInterface
      Returns:
      a int
    • getParachorParameter

      public final double getParachorParameter()

      getParachorParameter.

      Specified by:
      getParachorParameter in interface ComponentInterface
      Returns:
      a double
    • setParachorParameter

      public final void setParachorParameter(double parachorParameter)

      setParachorParameter.

      Specified by:
      setParachorParameter in interface ComponentInterface
      Parameters:
      parachorParameter - a double
    • setLiquidViscosityModel

      public final void setLiquidViscosityModel(int modelNumber)

      setLiquidViscosityModel.

      Specified by:
      setLiquidViscosityModel in interface ComponentInterface
      Parameters:
      modelNumber - a int
    • setLiquidViscosityParameter

      public final void setLiquidViscosityParameter(double number, int i)

      setLiquidViscosityParameter.

      Specified by:
      setLiquidViscosityParameter in interface ComponentInterface
      Parameters:
      number - a double
      i - a int
    • getLiquidViscosityParameter

      public final double getLiquidViscosityParameter(int i)

      getLiquidViscosityParameter.

      Specified by:
      getLiquidViscosityParameter in interface ComponentInterface
      Parameters:
      i - a int
      Returns:
      a double
    • setLiquidConductivityParameter

      public void setLiquidConductivityParameter(double number, int i)

      setLiquidConductivityParameter.

      Specified by:
      setLiquidConductivityParameter in interface ComponentInterface
      Parameters:
      number - a double
      i - a int
    • getLiquidConductivityParameter

      public double getLiquidConductivityParameter(int i)

      getLiquidConductivityParameter.

      Specified by:
      getLiquidConductivityParameter in interface ComponentInterface
      Parameters:
      i - a int
      Returns:
      a double
    • getLennardJonesMolecularDiameter

      public double getLennardJonesMolecularDiameter()

      getLennardJonesMolecularDiameter.

      Specified by:
      getLennardJonesMolecularDiameter in interface ComponentInterface
      Returns:
      Units in m*e10
    • getLennardJonesEnergyParameter

      public double getLennardJonesEnergyParameter()

      getLennardJonesEnergyParameter.

      Specified by:
      getLennardJonesEnergyParameter in interface ComponentInterface
      Returns:
      a double
    • getHsub

      public double getHsub()

      getHsub.

      Specified by:
      getHsub in interface ComponentInterface
      Returns:
      a double
    • getCCsolidVaporPressure

      public double getCCsolidVaporPressure(double temperature)

      getCCsolidVaporPressure. Calculates the pure comonent solid vapor pressure (bar) with the C-C equation, based on Hsub Should only be used in the valid temperature range below the triple point (specified in component database).

      Specified by:
      getCCsolidVaporPressure in interface ComponentInterface
      Parameters:
      temperature - a double
      Returns:
      Calculated solid vapor pressure in bar.
    • getCCsolidVaporPressuredT

      public double getCCsolidVaporPressuredT(double temperature)

      getCCsolidVaporPressuredT. Calculates the DT of pure comonent solid vapor pressure (bar) with the C-C equation, based on Hsub Should only be used in the valid temperature range below the triple point (specified in component database).

      Specified by:
      getCCsolidVaporPressuredT in interface ComponentInterface
      Parameters:
      temperature - a double
      Returns:
      Calculated solid vapor pressure in bar.
    • getPureComponentSolidDensity

      public double getPureComponentSolidDensity(double temperature)

      getPureComponentSolidDensity. Calculates the pure component solid density in kg/liter Should only be used in the valid temperature range (specified in component database).

      Specified by:
      getPureComponentSolidDensity in interface ComponentInterface
      Parameters:
      temperature - a double
      Returns:
      pure component solid density in kg/liter
    • getPureComponentLiquidDensity

      public double getPureComponentLiquidDensity(double temperature)

      getPureComponentLiquidDensity. Calculates the pure component liquid density in kg/liter Should only be used in the valid temperature range (specified in component database). This method seems to give bad results at the moment

      Specified by:
      getPureComponentLiquidDensity in interface ComponentInterface
      Parameters:
      temperature - a double
      Returns:
      pure component liquid density in kg/liter
    • getPureComponentHeatOfVaporization

      public double getPureComponentHeatOfVaporization(double temperature)
      Calculates the pure component heat of vaporization in J/mol.
      Specified by:
      getPureComponentHeatOfVaporization in interface ComponentInterface
      Parameters:
      temperature - a double
      Returns:
      a double
    • setx

      public final void setx(double newx)

      setx.

      Specified by:
      setx in interface ComponentInterface
      Parameters:
      newx - a double
    • setNumberOfmoles

      public final void setNumberOfmoles(double newmoles)

      setNumberOfmoles.

      Specified by:
      setNumberOfmoles in interface ComponentInterface
      Parameters:
      newmoles - a double
    • setNumberOfMolesInPhase

      public final void setNumberOfMolesInPhase(double totmoles)

      setNumberOfMolesInPhase.

      Specified by:
      setNumberOfMolesInPhase in interface ComponentInterface
      Parameters:
      totmoles - a double
    • getNumberOfmoles

      public final double getNumberOfmoles()

      getNumberOfmoles.

      Specified by:
      getNumberOfmoles in interface ComponentInterface
      Returns:
      a double
    • getMolarMass

      public final double getMolarMass()
      Get molar mass of component.
      Specified by:
      getMolarMass in interface ComponentInterface
      Returns:
      molar mass in unit kg/mol
    • getMolarMass

      public double getMolarMass(String unit)
      Get molar mass of component.
      Specified by:
      getMolarMass in interface ComponentInterface
      Parameters:
      unit - a String
      Returns:
      molar mass in unit kg/mol
    • getNumberOfMolesInPhase

      public final double getNumberOfMolesInPhase()

      getNumberOfMolesInPhase.

      Specified by:
      getNumberOfMolesInPhase in interface ComponentInterface
      Returns:
      a double
    • getRate

      public double getRate(String unitName)

      getRate.

      Specified by:
      getRate in interface ComponentInterface
      Parameters:
      unitName - a String object
      Returns:
      a double
    • setK

      public final void setK(double newK)

      setK.

      Specified by:
      setK in interface ComponentInterface
      Parameters:
      newK - a double
    • getFugacityCoefficient

      public final double getFugacityCoefficient()

      getFugacityCoefficient.

      Specified by:
      getFugacityCoefficient in interface ComponentInterface
      Returns:
      a double
    • fugcoef

      public double fugcoef(PhaseInterface phase)

      Calculate, set and return fugacity coefficient.

      Specified by:
      fugcoef in interface ComponentInterface
      Parameters:
      phase - a PhaseInterface object to get fugacity coefficient of.
      Returns:
      Fugacity coefficient
    • logfugcoefdT

      public double logfugcoefdT(PhaseInterface phase)

      logfugcoefdT.

      Specified by:
      logfugcoefdT in interface ComponentInterface
      Parameters:
      phase - a PhaseInterface object
      Returns:
      a double
    • logfugcoefdP

      public double logfugcoefdP(PhaseInterface phase)

      logfugcoefdP.

      Specified by:
      logfugcoefdP in interface ComponentInterface
      Parameters:
      phase - a PhaseInterface object
      Returns:
      a double
    • logfugcoefdN

      public double[] logfugcoefdN(PhaseInterface phase)

      logfugcoefdN.

      Specified by:
      logfugcoefdN in interface ComponentInterface
      Parameters:
      phase - a PhaseInterface object
      Returns:
      an array of type double
    • logfugcoefdNi

      public double logfugcoefdNi(PhaseInterface phase, int k)

      logfugcoefdNi.

      Specified by:
      logfugcoefdNi in interface ComponentInterface
      Parameters:
      phase - a PhaseInterface object
      k - a int
      Returns:
      a double
    • getdfugdt

      public double getdfugdt()

      getdfugdt.

      Specified by:
      getdfugdt in interface ComponentInterface
      Returns:
      a double
    • getdfugdp

      public double getdfugdp()

      getdfugdp.

      Specified by:
      getdfugdp in interface ComponentInterface
      Returns:
      a double
    • setdfugdt

      public void setdfugdt(double val)

      setdfugdt.

      Specified by:
      setdfugdt in interface ComponentInterface
      Parameters:
      val - a double
    • setdfugdp

      public void setdfugdp(double val)

      setdfugdp.

      Specified by:
      setdfugdp in interface ComponentInterface
      Parameters:
      val - a double
    • setdfugdn

      public void setdfugdn(int i, double val)

      setdfugdn.

      Specified by:
      setdfugdn in interface ComponentInterface
      Parameters:
      i - a int
      val - a double
    • setdfugdx

      public void setdfugdx(int i, double val)

      setdfugdx.

      Specified by:
      setdfugdx in interface ComponentInterface
      Parameters:
      i - a int
      val - a double
    • getAcentricFactor

      public double getAcentricFactor()

      getAcentricFactor.

      Specified by:
      getAcentricFactor in interface ComponentInterface
      Returns:
      a double
    • reducedTemperature

      public double reducedTemperature(double temperature)
      Returns the reduced temperature (T/Tc) for a given temperature.
      Specified by:
      reducedTemperature in interface ComponentInterface
      Parameters:
      temperature - Temperature in Kelvin
      Returns:
      reduced temperature []
    • reducedPressure

      public double reducedPressure(double pressure)
      Returns the reduced pressure (P/Pc) for a given pressure.
      Specified by:
      reducedPressure in interface ComponentInterface
      Parameters:
      pressure - Pressure in bara
      Returns:
      reduced pressure []
    • getdfugdx

      public double getdfugdx(int i)

      getdfugdx.

      Specified by:
      getdfugdx in interface ComponentInterface
      Parameters:
      i - a int
      Returns:
      a double
    • getdfugdn

      public double getdfugdn(int i)

      getdfugdn.

      Specified by:
      getdfugdn in interface ComponentInterface
      Parameters:
      i - a int
      Returns:
      a double
    • getIndex

      public int getIndex()

      getIndex.

      Specified by:
      getIndex in interface ComponentInterface
      Returns:
      a int
    • getComponentNumber

      public int getComponentNumber()

      Getter for property componentNumber.

      Specified by:
      getComponentNumber in interface ComponentInterface
      Returns:
      Index number of component in phase object component array.
    • getGibbsEnergy

      public final double getGibbsEnergy(double temperature, double pressure)

      getGibbsEnergy.

      Specified by:
      getGibbsEnergy in interface ComponentInterface
      Parameters:
      temperature - a double
      pressure - a double
      Returns:
      a double
    • getChemicalPotentialIdealReference

      public final double getChemicalPotentialIdealReference(PhaseInterface phase)

      getChemicalPotentialIdealReference.

      Specified by:
      getChemicalPotentialIdealReference in interface ComponentInterface
      Parameters:
      phase - a PhaseInterface object
      Returns:
      a double
    • getChemicalPotential

      public final double getChemicalPotential(double temperature, double pressure)

      getChemicalPotential.

      Specified by:
      getChemicalPotential in interface ComponentInterface
      Parameters:
      temperature - a double
      pressure - a double
      Returns:
      a double
    • getChemicalPotential

      public double getChemicalPotential(PhaseInterface phase)

      getChemicalPotential.

      Specified by:
      getChemicalPotential in interface ComponentInterface
      Parameters:
      phase - a PhaseInterface object
      Returns:
      a double
    • getFugacitydN

      public final double getFugacitydN(int i, PhaseInterface phase)

      getFugacitydN.

      Parameters:
      i - a int
      phase - a PhaseInterface object
      Returns:
      a double
    • getChemicalPotentialdNTV

      public final double getChemicalPotentialdNTV(int i, PhaseInterface phase)

      getChemicalPotentialdNTV.

      Specified by:
      getChemicalPotentialdNTV in interface ComponentInterface
      Parameters:
      i - a int
      phase - a PhaseInterface object
      Returns:
      a double
    • getChemicalPotentialdN

      public final double getChemicalPotentialdN(int i, PhaseInterface phase)

      getChemicalPotentialdN.

      Specified by:
      getChemicalPotentialdN in interface ComponentInterface
      Parameters:
      i - a int
      phase - a PhaseInterface object
      Returns:
      a double
    • getChemicalPotentialdP

      public final double getChemicalPotentialdP()

      getChemicalPotentialdP.

      Specified by:
      getChemicalPotentialdP in interface ComponentInterface
      Returns:
      a double
    • getChemicalPotentialdP

      public final double getChemicalPotentialdP(int i, PhaseInterface phase)

      getChemicalPotentialdP.

      Parameters:
      i - a int
      phase - a PhaseInterface object
      Returns:
      a double
    • getChemicalPotentialdT

      public final double getChemicalPotentialdT(PhaseInterface phase)

      getChemicalPotentialdT.

      Specified by:
      getChemicalPotentialdT in interface ComponentInterface
      Parameters:
      phase - a PhaseInterface object
      Returns:
      a double
    • getChemicalPotentialdV

      public final double getChemicalPotentialdV(PhaseInterface phase)

      getChemicalPotentialdV.

      Specified by:
      getChemicalPotentialdV in interface ComponentInterface
      Parameters:
      phase - a PhaseInterface object
      Returns:
      a double
    • setComponentNumber

      public void setComponentNumber(int numb)

      Setter for property componentNumber.

      Specified by:
      setComponentNumber in interface ComponentInterface
      Parameters:
      numb - Index number of component in phase object component array.
    • getAntoineVaporPressure

      public double getAntoineVaporPressure(double temp)

      getAntoineVaporPressure.

      Specified by:
      getAntoineVaporPressure in interface ComponentInterface
      Parameters:
      temp - a double
      Returns:
      a double
    • getAntoineVaporPressuredT

      public double getAntoineVaporPressuredT(double temp)

      getAntoineVaporPressuredT.

      Specified by:
      getAntoineVaporPressuredT in interface ComponentInterface
      Parameters:
      temp - a double
      Returns:
      a double
    • getAntoineVaporTemperature

      public double getAntoineVaporTemperature(double pres)

      getAntoineVaporTemperature.

      Specified by:
      getAntoineVaporTemperature in interface ComponentInterface
      Parameters:
      pres - a double
      Returns:
      a double
    • getHresTP

      public final double getHresTP(double temperature)

      getHresTP.

      Specified by:
      getHresTP in interface ComponentInterface
      Parameters:
      temperature - a double
      Returns:
      a double
    • getGresTP

      public final double getGresTP(double temperature)

      getGresTP.

      Specified by:
      getGresTP in interface ComponentInterface
      Parameters:
      temperature - a double
      Returns:
      a double
    • getSresTP

      public final double getSresTP(double temperature)

      getSresTP.

      Specified by:
      getSresTP in interface ComponentInterface
      Parameters:
      temperature - a double
      Returns:
      a double
    • getCp0

      public final double getCp0(double temperature)

      Return the ideal-gas molar heat capacity of a chemical using polynomial regressed coefficients as described by Poling, Bruce E. The Properties of Gases and Liquids. 5th edition. New York: McGraw-Hill Professional, 2000.

      Specified by:
      getCp0 in interface ComponentInterface
      Parameters:
      temperature - a double
      Returns:
      ideal gas Cp for the component in the specific phase [J/molK]
    • getCv0

      public final double getCv0(double temperature)

      getCv0.

      Specified by:
      getCv0 in interface ComponentInterface
      Parameters:
      temperature - a double
      Returns:
      ideal gas Cv for the component in the specific phase [J/molK]
    • getHID

      public final double getHID(double T)

      getHID.

      Specified by:
      getHID in interface ComponentInterface
      Parameters:
      T - a double
      Returns:
      a double
    • getEnthalpy

      public final double getEnthalpy(double temperature)

      getEnthalpy.

      Specified by:
      getEnthalpy in interface ComponentInterface
      Parameters:
      temperature - a double
      Returns:
      a double
    • getIdEntropy

      public double getIdEntropy(double temperature)

      getIdEntropy.

      Specified by:
      getIdEntropy in interface ComponentInterface
      Parameters:
      temperature - a double
      Returns:
      a double
    • getEntropy

      public double getEntropy(double temperature, double pressure)

      getEntropy.

      Specified by:
      getEntropy in interface ComponentInterface
      Parameters:
      temperature - a double
      pressure - a double
      Returns:
      a double
    • getName

      public final String getName()

      Getter for property componentName, i.e., normalized component name.

      Specified by:
      getName in interface ComponentInterface
      Returns:
      a String object
    • setAcentricFactor

      public void setAcentricFactor(double val)

      setAcentricFactor.

      Specified by:
      setAcentricFactor in interface ComponentInterface
      Parameters:
      val - a double
    • setRacketZ

      public void setRacketZ(double val)

      setRacketZ.

      Specified by:
      setRacketZ in interface ComponentInterface
      Parameters:
      val - a double
    • setAttractiveTerm

      public void setAttractiveTerm(int i)

      setAttractiveTerm.

      Specified by:
      setAttractiveTerm in interface ComponentInterface
      Parameters:
      i - a int
    • getAttractiveTerm

      public AttractiveTermInterface getAttractiveTerm()

      getAttractiveTerm.

      Specified by:
      getAttractiveTerm in interface ComponentInterface
      Returns:
      a AttractiveTermInterface object
    • getSchwartzentruberParams

      public final double[] getSchwartzentruberParams()

      getSchwartzentruberParams.

      Specified by:
      getSchwartzentruberParams in interface ComponentInterface
      Returns:
      an array of type double
    • setSchwartzentruberParams

      public final void setSchwartzentruberParams(int i, double param)

      setSchwartzentruberParams.

      Specified by:
      setSchwartzentruberParams in interface ComponentInterface
      Parameters:
      i - a int
      param - a double
    • getTwuCoonParams

      public final double[] getTwuCoonParams()

      getTwuCoonParams.

      Specified by:
      getTwuCoonParams in interface ComponentInterface
      Returns:
      an array of type double
    • setTwuCoonParams

      public final void setTwuCoonParams(int i, double param)

      setTwuCoonParams.

      Specified by:
      setTwuCoonParams in interface ComponentInterface
      Parameters:
      i - a int
      param - a double
    • fugcoefDiffPresNumeric

      public double fugcoefDiffPresNumeric(PhaseInterface phase, int numberOfComponents, double temperature, double pressure)

      fugcoefDiffPresNumeric.

      Specified by:
      fugcoefDiffPresNumeric in interface ComponentInterface
      Parameters:
      phase - a PhaseInterface object
      numberOfComponents - a int
      temperature - a double
      pressure - a double
      Returns:
      a double
    • fugcoefDiffTempNumeric

      public double fugcoefDiffTempNumeric(PhaseInterface phase, int numberOfComponents, double temperature, double pressure)

      fugcoefDiffTempNumeric.

      Specified by:
      fugcoefDiffTempNumeric in interface ComponentInterface
      Parameters:
      phase - a PhaseInterface object
      numberOfComponents - a int
      temperature - a double
      pressure - a double
      Returns:
      a double
    • getIonicDiameter

      public final double getIonicDiameter()

      getIonicDiameter.

      Returns:
      a double
    • getStokesCationicDiameter

      public double getStokesCationicDiameter()

      getStokesCationicDiameter.

      Specified by:
      getStokesCationicDiameter in interface ComponentInterface
      Returns:
      a double
    • setStokesCationicDiameter

      public void setStokesCationicDiameter(double stokesCationicDiameter)

      setStokesCationicDiameter.

      Specified by:
      setStokesCationicDiameter in interface ComponentInterface
      Parameters:
      stokesCationicDiameter - a double
    • getPaulingAnionicDiameter

      public final double getPaulingAnionicDiameter()

      getPaulingAnionicDiameter.

      Specified by:
      getPaulingAnionicDiameter in interface ComponentInterface
      Returns:
      a double
    • setPaulingAnionicDiameter

      public void setPaulingAnionicDiameter(double paulingAnionicDiameter)
      Setter for property paulingAnionicDiameter.
      Parameters:
      paulingAnionicDiameter - New value of property paulingAnionicDiameter.
    • getAttractiveTermNumber

      public final int getAttractiveTermNumber()

      getAttractiveTermNumber.

      Specified by:
      getAttractiveTermNumber in interface ComponentInterface
      Returns:
      a int
    • getVoli

      public double getVoli()

      getVoli.

      Specified by:
      getVoli in interface ComponentInterface
      Returns:
      a double
    • setVoli

      public void setVoli(double molarVol)

      Setter for the field voli.

      Parameters:
      molarVol - a double
    • getMatiascopemanParams

      public final double getMatiascopemanParams(int index)
      Indexed getter for property matiascopemanParams.
      Parameters:
      index - Index of the property.
      Returns:
      Value of the property at index.
    • getMatiascopemanParams

      public final double[] getMatiascopemanParams()

      getMatiascopemanParams.

      Specified by:
      getMatiascopemanParams in interface ComponentInterface
      Returns:
      an array of type double
    • getMatiascopemanParamsPR

      public final double[] getMatiascopemanParamsPR()

      Getter for the field matiascopemanParamsPR.

      Returns:
      an array of type double
    • setMatiascopemanParamsPR

      public void setMatiascopemanParamsPR(int index, double matiascopemanParams)

      Setter for the field matiascopemanParamsPR.

      Parameters:
      index - a int
      matiascopemanParams - a double
    • setMatiascopemanParams

      public void setMatiascopemanParams(int index, double matiascopemanParams)

      setMatiascopemanParams.

      Specified by:
      setMatiascopemanParams in interface ComponentInterface
      Parameters:
      index - a int
      matiascopemanParams - a double
    • setMatiascopemanParams

      public void setMatiascopemanParams(double[] matiascopemanParams)

      setMatiascopemanParams.

      Specified by:
      setMatiascopemanParams in interface ComponentInterface
      Parameters:
      matiascopemanParams - an array of type double
    • setFugacityCoefficient

      public void setFugacityCoefficient(double val)

      setFugacityCoefficient.

      Specified by:
      setFugacityCoefficient in interface ComponentInterface
      Parameters:
      val - a double
    • getNumberOfAssociationSites

      public final int getNumberOfAssociationSites()

      getNumberOfAssociationSites.

      Specified by:
      getNumberOfAssociationSites in interface ComponentInterface
      Returns:
      a int
    • setNumberOfAssociationSites

      public void setNumberOfAssociationSites(int numberOfAssociationSites)

      setNumberOfAssociationSites.

      Specified by:
      setNumberOfAssociationSites in interface ComponentInterface
      Parameters:
      numberOfAssociationSites - a int
    • seta

      public void seta(double a)

      seta.

      Specified by:
      seta in interface ComponentInterface
      Parameters:
      a - a double
    • setb

      public void setb(double b)

      setb.

      Specified by:
      setb in interface ComponentInterface
      Parameters:
      b - a double
    • getAssociationVolume

      public final double getAssociationVolume()

      getAssociationVolume.

      Specified by:
      getAssociationVolume in interface ComponentInterface
      Returns:
      a double
    • setAssociationVolume

      public void setAssociationVolume(double associationVolume)

      setAssociationVolume.

      Specified by:
      setAssociationVolume in interface ComponentInterface
      Parameters:
      associationVolume - a double
    • getAssociationEnergy

      public final double getAssociationEnergy()

      getAssociationEnergy.

      Specified by:
      getAssociationEnergy in interface ComponentInterface
      Returns:
      a double
    • setAssociationEnergy

      public void setAssociationEnergy(double associationEnergy)

      setAssociationEnergy.

      Specified by:
      setAssociationEnergy in interface ComponentInterface
      Parameters:
      associationEnergy - a double
    • getNormalBoilingPoint

      public double getNormalBoilingPoint()

      Getter for property NormalBoilingPoint.

      Specified by:
      getNormalBoilingPoint in interface ComponentInterface
      Returns:
      The normal boiling point of the component with unit Kelvin
    • getNormalBoilingPoint

      public double getNormalBoilingPoint(String unit)

      Getter for property NormalBoilingPoint.

      Specified by:
      getNormalBoilingPoint in interface ComponentInterface
      Parameters:
      unit - Unit of return pressure
      Returns:
      The normal boiling point of the component in specified unit.
    • setNormalBoilingPoint

      public void setNormalBoilingPoint(double normalBoilingPoint)

      setNormalBoilingPoint.

      Specified by:
      setNormalBoilingPoint in interface ComponentInterface
      Parameters:
      normalBoilingPoint - a double with unit Kelvin
    • getStandardDensity

      public double getStandardDensity()
      Getter for property standardDensity.
      Returns:
      Value of property standardDensity.
    • setStandardDensity

      public void setStandardDensity(double standardDensity)
      Setter for property standardDensity.
      Parameters:
      standardDensity - New value of property standardDensity.
    • getAntoineASolid

      public double getAntoineASolid()

      getAntoineASolid.

      Specified by:
      getAntoineASolid in interface ComponentInterface
      Returns:
      a double
    • setAntoineASolid

      public void setAntoineASolid(double AntoineASolid)

      setAntoineASolid.

      Specified by:
      setAntoineASolid in interface ComponentInterface
      Parameters:
      AntoineASolid - a double
    • getAntoineBSolid

      public double getAntoineBSolid()

      getAntoineBSolid.

      Specified by:
      getAntoineBSolid in interface ComponentInterface
      Returns:
      a double
    • setAntoineBSolid

      public void setAntoineBSolid(double AntoineBSolid)

      setAntoineBSolid.

      Specified by:
      setAntoineBSolid in interface ComponentInterface
      Parameters:
      AntoineBSolid - a double
    • getAntoineCSolid

      public double getAntoineCSolid()

      getAntoineCSolid.

      Specified by:
      getAntoineCSolid in interface ComponentInterface
      Returns:
      a double
    • setAntoineCSolid

      public void setAntoineCSolid(double AntoineCSolid)

      setAntoineCSolid.

      Specified by:
      setAntoineCSolid in interface ComponentInterface
      Parameters:
      AntoineCSolid - a double
    • getSolidVaporPressure

      public final double getSolidVaporPressure(double temperature)

      getSolidVaporPressure.

      Specified by:
      getSolidVaporPressure in interface ComponentInterface
      Parameters:
      temperature - a double
      Returns:
      a double
    • getSolidVaporPressuredT

      public final double getSolidVaporPressuredT(double temperature)

      getSolidVaporPressuredT.

      Specified by:
      getSolidVaporPressuredT in interface ComponentInterface
      Parameters:
      temperature - a double
      Returns:
      a double
    • getSphericalCoreRadius

      public final double getSphericalCoreRadius()

      getSphericalCoreRadius.

      Specified by:
      getSphericalCoreRadius in interface ComponentInterface
      Returns:
      a double
    • setComponentName

      public void setComponentName(String componentName)

      Setter for property componentName.

      Specified by:
      setComponentName in interface ComponentInterface
      Parameters:
      componentName - a String object
    • setLennardJonesEnergyParameter

      public void setLennardJonesEnergyParameter(double lennardJonesEnergyParameter)

      setLennardJonesEnergyParameter.

      Specified by:
      setLennardJonesEnergyParameter in interface ComponentInterface
      Parameters:
      lennardJonesEnergyParameter - a double
    • setLennardJonesMolecularDiameter

      public void setLennardJonesMolecularDiameter(double lennardJonesMolecularDiameter)

      setLennardJonesMolecularDiameter.

      Specified by:
      setLennardJonesMolecularDiameter in interface ComponentInterface
      Parameters:
      lennardJonesMolecularDiameter - a double
    • setSphericalCoreRadius

      public void setSphericalCoreRadius(double sphericalCoreRadius)

      setSphericalCoreRadius.

      Specified by:
      setSphericalCoreRadius in interface ComponentInterface
      Parameters:
      sphericalCoreRadius - a double
    • calcActivity

      public boolean calcActivity()

      calcActivity.

      Specified by:
      calcActivity in interface ComponentInterface
      Returns:
      a boolean
    • isIsTBPfraction

      public boolean isIsTBPfraction()

      isIsTBPfraction.

      Specified by:
      isIsTBPfraction in interface ComponentInterface
      Returns:
      a boolean
    • isHydrocarbon

      public boolean isHydrocarbon()

      isHydrocarbon.

      Specified by:
      isHydrocarbon in interface ComponentInterface
      Returns:
      a boolean
    • setIsTBPfraction

      public void setIsTBPfraction(boolean isTBPfraction)

      setIsTBPfraction.

      Specified by:
      setIsTBPfraction in interface ComponentInterface
      Parameters:
      isTBPfraction - a boolean
    • setIsAllTypesFalse

      protected void setIsAllTypesFalse()

      setIsAllTypesFalse.

    • isIsPlusFraction

      public boolean isIsPlusFraction()

      isIsPlusFraction.

      Specified by:
      isIsPlusFraction in interface ComponentInterface
      Returns:
      a boolean
    • setIsPlusFraction

      public void setIsPlusFraction(boolean isPlusFraction)

      setIsPlusFraction.

      Specified by:
      setIsPlusFraction in interface ComponentInterface
      Parameters:
      isPlusFraction - a boolean
    • isIsNormalComponent

      public boolean isIsNormalComponent()

      isIsNormalComponent.

      Specified by:
      isIsNormalComponent in interface ComponentInterface
      Returns:
      a boolean
    • isInert

      public boolean isInert()

      isInert.

      Specified by:
      isInert in interface ComponentInterface
      Returns:
      a boolean
    • setIsNormalComponent

      public void setIsNormalComponent(boolean isNormalComponent)

      setIsNormalComponent.

      Specified by:
      setIsNormalComponent in interface ComponentInterface
      Parameters:
      isNormalComponent - a boolean
    • isIsIon

      public boolean isIsIon()

      isIsIon.

      Specified by:
      isIsIon in interface ComponentInterface
      Returns:
      a boolean
    • setIsIon

      public void setIsIon(boolean isIon)

      setIsIon.

      Specified by:
      setIsIon in interface ComponentInterface
      Parameters:
      isIon - a boolean
    • setNormalLiquidDensity

      public void setNormalLiquidDensity(double normalLiquidDensity)

      setNormalLiquidDensity.

      Specified by:
      setNormalLiquidDensity in interface ComponentInterface
      Parameters:
      normalLiquidDensity - a double
    • setMolarMass

      public void setMolarMass(double molarMass)

      setMolarMass.

      Specified by:
      setMolarMass in interface ComponentInterface
      Parameters:
      molarMass - a double
    • setMolarMass

      public void setMolarMass(double value, String unit)

      setMolarMass.

      Specified by:
      setMolarMass in interface ComponentInterface
      Parameters:
      value - a double
      unit - a String
    • doSolidCheck

      public final boolean doSolidCheck()

      Getter for field solidCheck.

      Specified by:
      doSolidCheck in interface ComponentInterface
      Returns:
      a boolean
    • setSolidCheck

      public void setSolidCheck(boolean checkForSolids)

      Setter for field solidCheck.

      Specified by:
      setSolidCheck in interface ComponentInterface
      Parameters:
      checkForSolids - Set true to do solid phase check and calculations
    • getAssociationScheme

      public String getAssociationScheme()

      getAssociationScheme.

      Specified by:
      getAssociationScheme in interface ComponentInterface
      Returns:
      a String object
    • setAssociationScheme

      public void setAssociationScheme(String associationScheme)

      setAssociationScheme.

      Specified by:
      setAssociationScheme in interface ComponentInterface
      Parameters:
      associationScheme - a String object
    • getComponentType

      public String getComponentType()

      getComponentType.

      Specified by:
      getComponentType in interface ComponentInterface
      Returns:
      a String object
    • getHenryCoef

      public double getHenryCoef(double temperature)

      getHenryCoef. Getter for property Henrys Coefficient. Unit is bar. ln H = C1 + C2/T + C3lnT + C4*T

      Specified by:
      getHenryCoef in interface ComponentInterface
      Parameters:
      temperature - a double
      Returns:
      Henrys Coefficient in bar
    • getHenryCoefdT

      public double getHenryCoefdT(double temperature)

      getHenryCoefdT.

      Specified by:
      getHenryCoefdT in interface ComponentInterface
      Parameters:
      temperature - a double
      Returns:
      a double
    • getHenryCoefParameter

      public double[] getHenryCoefParameter()

      getHenryCoefParameter.

      Specified by:
      getHenryCoefParameter in interface ComponentInterface
      Returns:
      an array of type double
    • setHenryCoefParameter

      public void setHenryCoefParameter(double[] henryCoefParameter)

      setHenryCoefParameter.

      Specified by:
      setHenryCoefParameter in interface ComponentInterface
      Parameters:
      henryCoefParameter - an array of type double
    • getMatiascopemanSolidParams

      public double[] getMatiascopemanSolidParams()

      getMatiascopemanSolidParams.

      Specified by:
      getMatiascopemanSolidParams in interface ComponentInterface
      Returns:
      an array of type double
    • setMatiascopemanSolidParams

      public void setMatiascopemanSolidParams(double[] matiascopemanSolidParams)
      Setter for property matiascopemanSolidParams.
      Parameters:
      matiascopemanSolidParams - New value of property matiascopemanSolidParams.
    • getPureComponentCpSolid

      public double getPureComponentCpSolid(double temperature)

      getPureComponentCpSolid.

      Specified by:
      getPureComponentCpSolid in interface ComponentInterface
      Parameters:
      temperature - a double
      Returns:
      a double
    • getPureComponentCpLiquid

      public double getPureComponentCpLiquid(double temperature)

      getPureComponentCpLiquid.

      Specified by:
      getPureComponentCpLiquid in interface ComponentInterface
      Parameters:
      temperature - a double
      Returns:
      a double
    • setCriticalVolume

      public void setCriticalVolume(double criticalVolume)

      setCriticalVolume.

      Specified by:
      setCriticalVolume in interface ComponentInterface
      Parameters:
      criticalVolume - a double
    • getCriticalViscosity

      public double getCriticalViscosity()

      getCriticalViscosity.

      Specified by:
      getCriticalViscosity in interface ComponentInterface
      Returns:
      a double
    • setCriticalViscosity

      public void setCriticalViscosity(double criticalViscosity)

      setCriticalViscosity.

      Specified by:
      setCriticalViscosity in interface ComponentInterface
      Parameters:
      criticalViscosity - a double
    • getMolarity

      public double getMolarity(PhaseInterface phase)

      getMolarity.

      Specified by:
      getMolarity in interface ComponentInterface
      Parameters:
      phase - a PhaseInterface object
      Returns:
      a double
    • getMolality

      public double getMolality(PhaseInterface phase)

      getMolality.

      Specified by:
      getMolality in interface ComponentInterface
      Parameters:
      phase - a PhaseInterface object
      Returns:
      a double
    • isHydrateFormer

      public boolean isHydrateFormer()

      isHydrateFormer.

      Specified by:
      isHydrateFormer in interface ComponentInterface
      Returns:
      a boolean
    • setIsHydrateFormer

      public void setIsHydrateFormer(boolean isHydrateFormer)

      setIsHydrateFormer.

      Specified by:
      setIsHydrateFormer in interface ComponentInterface
      Parameters:
      isHydrateFormer - a boolean
    • getmSAFTi

      public double getmSAFTi()

      getmSAFTi.

      Specified by:
      getmSAFTi in interface ComponentInterface
      Returns:
      a double
    • setmSAFTi

      public void setmSAFTi(double mSAFTi)

      setmSAFTi.

      Specified by:
      setmSAFTi in interface ComponentInterface
      Parameters:
      mSAFTi - a double
    • getSigmaSAFTi

      public double getSigmaSAFTi()

      getSigmaSAFTi.

      Specified by:
      getSigmaSAFTi in interface ComponentInterface
      Returns:
      a double
    • setSigmaSAFTi

      public void setSigmaSAFTi(double sigmaSAFTi)

      setSigmaSAFTi.

      Specified by:
      setSigmaSAFTi in interface ComponentInterface
      Parameters:
      sigmaSAFTi - a double
    • getEpsikSAFT

      public double getEpsikSAFT()

      getEpsikSAFT.

      Specified by:
      getEpsikSAFT in interface ComponentInterface
      Returns:
      a double
    • setEpsikSAFT

      public void setEpsikSAFT(double epsikSAFT)

      setEpsikSAFT.

      Specified by:
      setEpsikSAFT in interface ComponentInterface
      Parameters:
      epsikSAFT - a double
    • getAssociationVolumeSAFT

      public double getAssociationVolumeSAFT()

      getAssociationVolumeSAFT.

      Specified by:
      getAssociationVolumeSAFT in interface ComponentInterface
      Returns:
      a double
    • setAssociationVolumeSAFT

      public void setAssociationVolumeSAFT(double associationVolumeSAFT)

      setAssociationVolumeSAFT.

      Specified by:
      setAssociationVolumeSAFT in interface ComponentInterface
      Parameters:
      associationVolumeSAFT - a double
    • getAssociationEnergySAFT

      public double getAssociationEnergySAFT()

      getAssociationEnergySAFT.

      Specified by:
      getAssociationEnergySAFT in interface ComponentInterface
      Returns:
      a double
    • setAssociationEnergySAFT

      public void setAssociationEnergySAFT(double associationEnergySAFT)

      setAssociationEnergySAFT.

      Specified by:
      setAssociationEnergySAFT in interface ComponentInterface
      Parameters:
      associationEnergySAFT - a double
    • getCriticalCompressibilityFactor

      public double getCriticalCompressibilityFactor()

      getCriticalCompressibilityFactor.

      Specified by:
      getCriticalCompressibilityFactor in interface ComponentInterface
      Returns:
      a double
    • setCriticalCompressibilityFactor

      public void setCriticalCompressibilityFactor(double criticalCompressibilityFactor)

      setCriticalCompressibilityFactor.

      Specified by:
      setCriticalCompressibilityFactor in interface ComponentInterface
      Parameters:
      criticalCompressibilityFactor - a double
    • getSurfaceTenisionInfluenceParameter

      public double getSurfaceTenisionInfluenceParameter(double temperature)

      getSurfaceTenisionInfluenceParameter.

      Specified by:
      getSurfaceTenisionInfluenceParameter in interface ComponentInterface
      Parameters:
      temperature - a double
      Returns:
      a double
    • setSurfTensInfluenceParam

      public void setSurfTensInfluenceParam(int factNum, double val)

      setSurfTensInfluenceParam.

      Specified by:
      setSurfTensInfluenceParam in interface ComponentInterface
      Parameters:
      factNum - a int
      val - a double
    • getSurfTensInfluenceParam

      public double getSurfTensInfluenceParam(int factNum)

      getSurfTensInfluenceParam.

      Specified by:
      getSurfTensInfluenceParam in interface ComponentInterface
      Parameters:
      factNum - a int
      Returns:
      a double
    • isWaxFormer

      public boolean isWaxFormer()

      isWaxFormer.

      Specified by:
      isWaxFormer in interface ComponentInterface
      Returns:
      a boolean
    • setWaxFormer

      public void setWaxFormer(boolean waxFormer)

      setWaxFormer.

      Specified by:
      setWaxFormer in interface ComponentInterface
      Parameters:
      waxFormer - a boolean
    • setHeatOfFusion

      public void setHeatOfFusion(double heatOfFusion)

      setHeatOfFusion.

      Specified by:
      setHeatOfFusion in interface ComponentInterface
      Parameters:
      heatOfFusion - a double
    • setTriplePointTemperature

      public void setTriplePointTemperature(double triplePointTemperature)

      setTriplePointTemperature.

      Specified by:
      setTriplePointTemperature in interface ComponentInterface
      Parameters:
      triplePointTemperature - a double
    • setComponentType

      public void setComponentType(String componentType)

      setComponentType.

      Specified by:
      setComponentType in interface ComponentInterface
      Parameters:
      componentType - a String object
    • isIsHydrateFormer

      public boolean isIsHydrateFormer()

      isIsHydrateFormer.

      Returns:
      the isHydrateFormer
    • getReferenceEnthalpy

      public double getReferenceEnthalpy()

      Getter for the field referenceEnthalpy.

      Returns:
      the referenceEnthalpy
    • setReferenceEnthalpy

      public void setReferenceEnthalpy(double referenceEnthalpy)

      Setter for the field referenceEnthalpy.

      Parameters:
      referenceEnthalpy - the referenceEnthalpy to set
    • getCpA

      public double getCpA()

      getCpA.

      Specified by:
      getCpA in interface ComponentInterface
      Returns:
      a double
    • setCpA

      public void setCpA(double CpA)

      setCpA.

      Specified by:
      setCpA in interface ComponentInterface
      Parameters:
      CpA - a double
    • getCpB

      public double getCpB()

      getCpB.

      Specified by:
      getCpB in interface ComponentInterface
      Returns:
      a double
    • setCpB

      public void setCpB(double CpB)

      setCpB.

      Specified by:
      setCpB in interface ComponentInterface
      Parameters:
      CpB - a double
    • getCpC

      public double getCpC()

      getCpC.

      Specified by:
      getCpC in interface ComponentInterface
      Returns:
      a double
    • setCpC

      public void setCpC(double CpC)

      setCpC.

      Specified by:
      setCpC in interface ComponentInterface
      Parameters:
      CpC - a double
    • getCpD

      public double getCpD()

      getCpD.

      Specified by:
      getCpD in interface ComponentInterface
      Returns:
      a double
    • setCpD

      public void setCpD(double CpD)

      setCpD.

      Specified by:
      setCpD in interface ComponentInterface
      Parameters:
      CpD - a double
    • getFormulae

      public String getFormulae()

      getFormulae.

      Specified by:
      getFormulae in interface ComponentInterface
      Returns:
      a String object
    • setFormulae

      public void setFormulae(String formulae)

      setFormulae.

      Specified by:
      setFormulae in interface ComponentInterface
      Parameters:
      formulae - a String object
    • getCASnumber

      public String getCASnumber()

      getCASnumber.

      Specified by:
      getCASnumber in interface ComponentInterface
      Returns:
      a String object
    • setCASnumber

      public void setCASnumber(String CASnumber)

      setCASnumber.

      Specified by:
      setCASnumber in interface ComponentInterface
      Parameters:
      CASnumber - a String object
    • getOrginalNumberOfAssociationSites

      public int getOrginalNumberOfAssociationSites()

      getOrginalNumberOfAssociationSites.

      Specified by:
      getOrginalNumberOfAssociationSites in interface ComponentInterface
      Returns:
      a int
    • getdrhodN

      public double getdrhodN()

      getdrhodN.

      Specified by:
      getdrhodN in interface ComponentInterface
      Returns:
      a double
    • getCpE

      public double getCpE()

      getCpE.

      Specified by:
      getCpE in interface ComponentInterface
      Returns:
      a double
    • setCpE

      public void setCpE(double CpE)

      setCpE.

      Specified by:
      setCpE in interface ComponentInterface
      Parameters:
      CpE - a double
    • getRacketZCPA

      public double getRacketZCPA()

      getRacketZCPA.

      Specified by:
      getRacketZCPA in interface ComponentInterface
      Returns:
      a double
    • setRacketZCPA

      public void setRacketZCPA(double racketZCPA)

      setRacketZCPA.

      Specified by:
      setRacketZCPA in interface ComponentInterface
      Parameters:
      racketZCPA - a double
    • getVolumeCorrectionT

      public double getVolumeCorrectionT()

      getVolumeCorrectionT.

      Specified by:
      getVolumeCorrectionT in interface ComponentInterface
      Returns:
      a double
    • getVolumeCorrection

      public double getVolumeCorrection()

      getVolumeCorrection.

      Specified by:
      getVolumeCorrection in interface ComponentInterface
      Returns:
      a double
    • hasVolumeCorrection

      protected boolean hasVolumeCorrection()
      Check if a volume correction has been explicitly specified.
      Returns:
      true if an explicit correction value has been provided.
    • setVolumeCorrectionConst

      public void setVolumeCorrectionConst(double getVolumeCorrectionConst)

      setVolumeCorrectionConst.

      Specified by:
      setVolumeCorrectionConst in interface ComponentInterface
      Parameters:
      getVolumeCorrectionConst - a double
    • setVolumeCorrection

      public void setVolumeCorrection(double volumeCorrection)

      setVolumeCorrection.

      Specified by:
      setVolumeCorrection in interface ComponentInterface
      Parameters:
      volumeCorrection - a double
    • setVolumeCorrectionT

      public void setVolumeCorrectionT(double volumeCorrectionT)

      setVolumeCorrectionT.

      Specified by:
      setVolumeCorrectionT in interface ComponentInterface
      Parameters:
      volumeCorrectionT - a double
    • getVolumeCorrectionT_CPA

      public double getVolumeCorrectionT_CPA()

      getVolumeCorrectionT_CPA.

      Specified by:
      getVolumeCorrectionT_CPA in interface ComponentInterface
      Returns:
      a double
    • setVolumeCorrectionT_CPA

      public void setVolumeCorrectionT_CPA(double volumeCorrectionT_CPA)

      setVolumeCorrectionT_CPA.

      Specified by:
      setVolumeCorrectionT_CPA in interface ComponentInterface
      Parameters:
      volumeCorrectionT_CPA - a double
    • setIdealGasEnthalpyOfFormation

      public void setIdealGasEnthalpyOfFormation(double idealGasEnthalpyOfFormation)

      setIdealGasEnthalpyOfFormation.

      Specified by:
      setIdealGasEnthalpyOfFormation in interface ComponentInterface
      Parameters:
      idealGasEnthalpyOfFormation - a double
    • getFlowRate

      public double getFlowRate(String flowunit)
      method to return flow rate of a component.
      Specified by:
      getFlowRate in interface ComponentInterface
      Parameters:
      flowunit - Supported units are kg/sec, kg/min, kg/hr, tonnes/year, m3/sec, m3/min, m3/hr, mole/sec, mole/min, mole/hr
      Returns:
      flow rate in specified unit
    • getTotalFlowRate

      public double getTotalFlowRate(String flowunit)
      method to return total flow rate of a component.
      Specified by:
      getTotalFlowRate in interface ComponentInterface
      Parameters:
      flowunit - Supported units are kg/sec, kg/min, kg/hr, mole/sec, mole/min, mole/hr
      Returns:
      total flow rate in specified unit
    • getMatiascopemanParamsUMRPRU

      public final double[] getMatiascopemanParamsUMRPRU()
      Indexed getter for property matiascopemanParamsUMRPRU.
      Returns:
      array of doubles
    • equals

      public boolean equals(Object obj)
      Overrides:
      equals in class Object