SlideShare a Scribd company logo
moritam51@gmail.com
multiphaseEulerFoamについて
moritam51@gmail.com
はじめに
• OpenFOAMの多相流には多数のソルバーがあるがmultiphaseEulerFoamについ
て基礎理論,Keywordとの対応について調べた.
• 多相流において連続相に対して分散相の割合が大きい場合は、各相間の相互作
用を考慮し、連続相と分散相ともに場の方程式で表現するEuler-Euler法で取り
扱う.multiphaseEulerFoamはEuler-Euler法のソルバーである.
• multiphaseInterFoamとチュートリアルを比較して特徴について考えた.特に、圧
縮係数、仮想質量の影響を取り上げた.
連続相と分散相
連続相 分散相
項目 Euler-Lagrange Euler-Euler
分散相割合 小 大
連続相 場の方程式 場の方程式
分散相 粒子の方程式 場の方程式
相互作用 分散相のみ 両相あり
分散相/連続相 例
固体/気体 粒子空気搬送,サイクロン分離,流動層,石炭燃焼
固体/液体 粒子分離、フィルター
液体/気体 スプレー噴射,ディーゼル燃料噴射
気体/液体 気泡槽,バブリング
液体/液体 非溶解液体の分離、液液抽出
ソルバー概要(OpenFOAM v1812)
parameter interFoam interMixingFoam mutiphaseInterFoam multiphaseEulerFoam
非圧縮性流体 〇 〇 〇 〇
圧縮性流体 × × × 〇
相数 2 3 ≧3 ≧3
混合 非混合 混合 非混合 非混合
運動方程式 1 1 1 各相
VOF法 〇 〇 〇 〇
表面張力 〇 〇 〇 〇
相互作用 × × × 〇
damBreak4phaseFine(endTime=6sec)
multiphaseInterFoam multiphaseEulerFoam
ExectionTime=2082sec ExectionTime=6873sec
✓ multiphaseInterFoamでは分離が遅い
✓ 計算時間は3.3倍速い
phases air oil water mercury
density(kg/m3) 1 500 1000 13529
0.584m角
mixerVessel2D
(endTime=20sec,omega=10.472rad/s,d=0.2m)
alpha.air alpha.oil alpha.water alpha.mercury
multiphaseInterFoam(初期条件:各成分を4領域に配置)
multiphaseEulerFoam(初期条件:均一混合)
初期条件を均一混合とすると分離しない
mixerVessel2D
(endTime=20sec,omega=10.472rad/s,d=0.2m)
alpha.air alpha.oil alpha.water alpha.mercury
multiphaseInterFoam(初期条件:各成分を4領域に等分割配置)
multiphaseEulerFoam(初期条件:各成分を4領域に等分割配置)
Governing Equations of phases
𝜕𝛼𝑘
𝜕𝑡
+ 𝑢𝑘 ∙ ∇𝛼𝑘= 0
𝜕 𝜌𝑘𝛼𝑘𝑢𝑘 𝛼𝑘
𝜕𝑡
+ 𝜌𝑘𝛼𝑘𝑢𝑘 ∙ ∇ 𝑢𝑘 = −𝛼𝑘∇𝑝 + ∇ ∙ 𝜇𝑘𝛼𝑘𝑢𝑘 + 𝜌𝑘𝛼𝑘 Ԧ
𝑔 + Ԧ
𝐹𝑠,𝑘 + Ԧ
𝐹𝐷,𝑘
𝜕𝛼𝑘
𝜕𝑡
+ 𝑢 ∙ ∇𝛼𝑘 = 0
𝜕 𝜌𝑢
𝜕𝑡
+ 𝜌𝑢 ∙ ∇ 𝑢 = −∇𝑝 + ∇ ∙ 𝜇𝑢 + 𝜌 Ԧ
𝑔 + റ
𝐹𝑠
multiphaseInterFoam
multiphaseEulerFoam
表面張力
表面張力 抗力
✓ multiphaseEulerFoamでは、他相の分散相による抗力を導入し各相の運動方程式を解く
圧縮速度の導入(interFoamの場合)
𝜕𝛼1
𝜕𝑡
+ 𝑢 ∙ ∇𝛼1= 0
𝜕𝛼1
𝜕𝑡
+ 𝑢 ∙ ∇𝛼1 +∇ ∙ 𝑢𝑐𝛼1𝛼2 = 0
✓ 界面形状を精密化するため圧縮速度を導入
✓ 連続の式に仮想的な付加項を追加
✓ αは0-1なので界面以外で本項の影響は少ない
圧縮速度(界面を圧縮する法線方向速度)
𝑢𝑐 = 𝑐𝐴𝑙𝑝ℎ𝑎 ∙ 𝑢 ∙ 𝑛 𝑛 =
∇𝛼
∇𝛼
𝛼 = 0
𝑛
𝑢𝑐
𝑢
damBreakFine(interFoam)
cAlpha=1 cAlpha=0
Drag Force(抗力)
𝐹𝐷𝑘 = 𝛼𝑐𝛼𝑑𝐾 𝑢𝑑 − 𝑢𝑐
𝐾 =
3
4
𝜌𝑐𝐶𝐷
𝑢𝑑 − 𝑢𝑐
𝑑𝑑
𝐶𝐷 = ቐ
24 1 + 0.15𝑅𝑒0.683
𝑅𝑒
𝑅𝑒 ≤ 1000
0.44 𝑅𝑒 > 1000
Schiller and Naumann
記号 説明
𝛼𝑐 連続相の質量分率
𝛼𝑑 分散相の質量分率
𝑢𝑐 連続相の速度
𝑢𝑑 分散相の速度
𝜌𝑐 連続相の密度
𝐶𝐷 抗力係数
𝑑𝑑 分散相の直径
𝑅𝑒 粒子周り流れレイノルズ数
仮想質量
𝜌𝑠
4𝑎3
3
𝑑𝑈
𝑑𝑡
= 𝐹𝐷 + 𝑃
𝑃 = ඾ 𝑝(𝑛 ∙ 𝑑𝑆) = ඾ −𝜌
𝜕𝜙
𝜕𝑡
+
1
2
𝑞2 = −
1
2
𝜌
4𝑎3
3
𝑑𝑈
𝑑𝑡
速度ポテンシャル 𝜙 = −
1
2
𝑈𝑎3
𝑟2 𝑐𝑜𝑠𝜃
𝑈(𝑡)
球(密度𝜌𝑠,半径𝑎)が静止流体中を
自由に移動
𝜌𝑠
4𝑎3
3
+
1
2
𝜌
4𝑎3
3
𝑑𝑈
𝑑𝑡
= 𝐹𝐷
仮想質量
非定常効果、あたかも球が押しのけた流体の質量の1/2だけ質量が増加したように球が運動
𝐹𝐷 + 𝑃
transportPropeties
phases
(
water
{
nu 1e-06;
kappa 1e-06;
Cp 4195;
rho 1000;
diameterModel constant;
constantCoeffs
{
d 1e-3;
}
}
diameterModel
✓ 分散相で使う粒子径の指定
✓ d=0とすると発散する⇒分散相の影響は抜けない
✓ constantかisothermalを選択
✓ isothermalは気体用
✓ isothermalCoeffsで初期粒子径と圧力d0,p0を指定
する。
相と物性値の設定
ここではwaterだけだが残りのoil,air,mercuryも設定する
(動粘性係数、熱拡散係数、比熱、密度)
sigmas
(
(air water) 0.07
(air oil) 0.07
(air mercury) 0.07
(water oil) 0
(water mercury) 0
(oil mercury) 0
);
interfaceCompression
(
(air water) 1
(air oil) 1
(air mercury) 1
(water oil) 1
(water mercury) 1
(oil mercury) 1
);
virtualMass
(
(air water) 0.5
(air oil) 0.5
(air mercury) 0.5
(water oil) 0.5
(water mercury) 0.5
(oil mercury) 0.5
);
表面張力
仮想質量
界面圧縮
全ての界面ペアについて物性値を指定
drag
(
(air water)
{
type blended;
air
{
type SchillerNaumann;
residualPhaseFraction 0;
residualSlip 0;
}
water
{
type SchillerNaumann;
residualPhaseFraction 0;
residualSlip 0;
}
residualPhaseFraction 1e-2;
residualSlip 1e-2;
}
連続相と分散相の混合
連成時の収束閾値
blendedを指定すると
これらを指定しなくて
はいけない
抗力モデルの指定、4相なので6つの組み合わせについて指定する
次のキーワードが選択可
Ergun
Gibilaro
GidaspowErgunWenYu
GidaspowSchillerNaumann
SchillerNaumann
SyamlalOBrien
WenYu
blended
interface
mixerVessel2D Air
(endTime=20sec,omega=10.472rad/s,d=0.2m)
mutiphaseInterFoam multiphaseEulerFoam
(圧縮速度=×,仮想質量=〇)
multiphaseEulerFoam
(圧縮速度=〇,仮想質量=×)
multiphaseEulerFoam
(圧縮速度=〇,仮想質量=〇)
mixerVessel2D Oil
(endTime=20sec,omega=10.472rad/s,d=0.2m)
mutiphaseInterFoam multiphaseEulerFoam
(圧縮速度=×,仮想質量=〇)
multiphaseEulerFoam
(圧縮速度=〇,仮想質量=×)
multiphaseEulerFoam
(圧縮速度=〇,仮想質量=〇)
mixerVessel2D Water
(endTime=20sec,omega=10.472rad/s,d=0.2m)
mutiphaseInterFoam multiphaseEulerFoam
(圧縮速度=×,仮想質量=〇)
multiphaseEulerFoam
(圧縮速度=〇,仮想質量=×)
multiphaseEulerFoam
(圧縮速度=〇,仮想質量=〇)
mixerVessel2D Mercury
(endTime=20sec,omega=10.472rad/s,d=0.2m)
mutiphaseInterFoam multiphaseEulerFoam
(圧縮速度=×,仮想質量=〇)
multiphaseEulerFoam
(圧縮速度=〇,仮想質量=×)
multiphaseEulerFoam
(圧縮速度=〇,仮想質量=〇)
おわり
// Standard face-flux compression coefficient
surfaceScalarField phic(mixture.cAlpha()*mag(phi/mesh.magSf()));
// Add the optional isotropic compression contribution
if (icAlpha > 0)
{
phic *= (1.0 - icAlpha);
phic += (mixture.cAlpha()*icAlpha)*fvc::interpolate(mag(U));
}
// Add the optional shear compression contribution
if (scAlpha > 0)
{
phic +=
scAlpha*mag(mesh.delta() & fvc::interpolate(symm(fvc::grad(U))));
}
phic:圧縮速度
圧縮速度
𝜙𝑐 = 𝛼𝑐
𝜙
റ
𝑆
等方性圧縮速度
𝜙𝑖𝑐 = 𝛼𝑐 1 − 𝛼𝑖𝑐 𝜙𝑐 + 𝛼𝑖𝑐 𝑢 𝑓
剪断圧縮速度
𝜙s𝑐 = 𝛼𝑠𝑐
1
2
റ
𝑑 ∙ ∇𝑢 + 𝑢𝑇
𝑓
𝛼𝑐は圧縮係数。(0~1)
𝛼𝑖𝑐は等方性圧縮係数。(0~1)
𝛼𝑠𝑐は剪断圧縮係数。(0~1)
𝜙𝑐 = 𝜙𝑖𝑐 + 𝜙𝑠𝑐
// Set the time blending factor, 1 for Euler
scalar cnCoeff = 1.0/(1.0 + ocCoeff);
// Calculate the Crank-Nicolson off-centred volumetric flux
if (ocCoeff > 0)
{
phiCN = cnCoeff*phi + (1.0 - cnCoeff)*phi.oldTime();
}
phiCN:標準流量
phiCNは時間的にEuler法とCrank-Nicolson法をブレンドして定義
surfaceScalarField phir(phic*mixture.nHatf());
tmp<surfaceScalarField> talphaPhi1Un
(
fvc::flux
(
phiCN(),
cnCoeff*alpha1 + (1.0 - cnCoeff)*alpha1.oldTime(),
alphaScheme
)
+ fvc::flux
(
-fvc::flux(-phir, alpha2, alpharScheme),
alpha1,
alpharScheme
)
);
talphaPhi1Un:圧縮速度を考慮した対流項
word alphaScheme("div(phi,alpha)");
word alpharScheme("div(phirb,alpha)");
alphaPhi10 = talphaPhi1Un;
MULES::explicitSolve
(
geometricOneField(),
alpha1,
phiCN,
alphaPhi10,
Sp,
(Su + divU*min(alpha1(), scalar(1)))(),
1,
0
);
alpha2 = 1.0 - alpha1;
mixture.correct();
MULESによる解法
• OpenFOAMのVOF法ではMULES(Multidimensional
universal limiter for explicit solution)を使用
• MULESはFCT(Flux Corrected Transport)理論を応用
• 低精度流束𝐹𝐿と高精度流束𝐹𝐻から修正流束を求める
• MULESの重み係数𝜆は局所流束の最大と最小から決定
𝜕𝛼
𝜕𝑡
= ∇ ∙ 𝛼𝒗 𝛼𝑖
𝑛+1
= 𝛼𝑖
𝑛
−
∆𝑡
𝑉
∙ ∑𝐹𝑐
𝐹 = 𝛼𝒗 ∙ 𝑺 𝑓
𝐹𝑐 = 𝐹𝐿 + 𝜆 ∙ 𝐹𝐻 − 𝐹𝐿

More Related Content

What's hot

OpenFOAMにおける相変化解析
OpenFOAMにおける相変化解析OpenFOAMにおける相変化解析
OpenFOAMにおける相変化解析
takuyayamamoto1800
 
Turbulence Models in OpenFOAM
Turbulence Models in OpenFOAMTurbulence Models in OpenFOAM
Turbulence Models in OpenFOAM
Fumiya Nozaki
 
ParaviewでのParticle Tracerを用いた可視化
ParaviewでのParticle Tracerを用いた可視化ParaviewでのParticle Tracerを用いた可視化
ParaviewでのParticle Tracerを用いた可視化
takuyayamamoto1800
 
OpenFOAM -回転領域を含む流体計算 (Rotating Geometry)-
OpenFOAM -回転領域を含む流体計算 (Rotating Geometry)-OpenFOAM -回転領域を含む流体計算 (Rotating Geometry)-
OpenFOAM -回転領域を含む流体計算 (Rotating Geometry)-
Fumiya Nozaki
 
OpenFOAMソルバの実行時ベイズ最適化
OpenFOAMソルバの実行時ベイズ最適化OpenFOAMソルバの実行時ベイズ最適化
OpenFOAMソルバの実行時ベイズ最適化
Masashi Imano
 
Boundary Conditions in OpenFOAM
Boundary Conditions in OpenFOAMBoundary Conditions in OpenFOAM
Boundary Conditions in OpenFOAM
Fumiya Nozaki
 
OpenFOAMにおけるDEM計算の力モデルの解読
OpenFOAMにおけるDEM計算の力モデルの解読OpenFOAMにおけるDEM計算の力モデルの解読
OpenFOAMにおけるDEM計算の力モデルの解読
takuyayamamoto1800
 
Paraviewの等高面を綺麗に出力する
Paraviewの等高面を綺麗に出力するParaviewの等高面を綺麗に出力する
Paraviewの等高面を綺麗に出力する
takuyayamamoto1800
 
OpenFOAM -空間の離散化と係数行列の取り扱い(Spatial Discretization and Coefficient Matrix)-
OpenFOAM -空間の離散化と係数行列の取り扱い(Spatial Discretization and Coefficient Matrix)-OpenFOAM -空間の離散化と係数行列の取り扱い(Spatial Discretization and Coefficient Matrix)-
OpenFOAM -空間の離散化と係数行列の取り扱い(Spatial Discretization and Coefficient Matrix)-Fumiya Nozaki
 
OpenFOAMの壁関数
OpenFOAMの壁関数OpenFOAMの壁関数
OpenFOAMの壁関数
Fumiya Nozaki
 
Mixer vessel by cfmesh
Mixer vessel by cfmeshMixer vessel by cfmesh
Mixer vessel by cfmesh
Etsuji Nomura
 
OpenFOAM LES乱流モデルカスタマイズ
OpenFOAM LES乱流モデルカスタマイズOpenFOAM LES乱流モデルカスタマイズ
OpenFOAM LES乱流モデルカスタマイズ
mmer547
 
Setting and Usage of OpenFOAM multiphase solver (S-CLSVOF)
Setting and Usage of OpenFOAM multiphase solver (S-CLSVOF)Setting and Usage of OpenFOAM multiphase solver (S-CLSVOF)
Setting and Usage of OpenFOAM multiphase solver (S-CLSVOF)
takuyayamamoto1800
 
OpenFOAM v2.3.0のチュートリアル 『oscillatingInletACMI2D』
OpenFOAM v2.3.0のチュートリアル 『oscillatingInletACMI2D』OpenFOAM v2.3.0のチュートリアル 『oscillatingInletACMI2D』
OpenFOAM v2.3.0のチュートリアル 『oscillatingInletACMI2D』
Fumiya Nozaki
 
OpenFOAMのチュートリアルを作ってみた#1 『くさび油膜効果の計算』
OpenFOAMのチュートリアルを作ってみた#1 『くさび油膜効果の計算』OpenFOAMのチュートリアルを作ってみた#1 『くさび油膜効果の計算』
OpenFOAMのチュートリアルを作ってみた#1 『くさび油膜効果の計算』
Fumiya Nozaki
 
OpenFOAM の cyclic、cyclicAMI、cyclicACMI 条件について
OpenFOAM の cyclic、cyclicAMI、cyclicACMI 条件についてOpenFOAM の cyclic、cyclicAMI、cyclicACMI 条件について
OpenFOAM の cyclic、cyclicAMI、cyclicACMI 条件についてFumiya Nozaki
 
Tutorial to set up a case for chtMultiRegionFoam in OpenFOAM 2.0.0
Tutorial to set up a case for chtMultiRegionFoam in OpenFOAM 2.0.0Tutorial to set up a case for chtMultiRegionFoam in OpenFOAM 2.0.0
Tutorial to set up a case for chtMultiRegionFoam in OpenFOAM 2.0.0
ARPIT SINGHAL
 
OpenFOAMのDEM解析のpatchInteractionModelクラスの解読
OpenFOAMのDEM解析のpatchInteractionModelクラスの解読OpenFOAMのDEM解析のpatchInteractionModelクラスの解読
OpenFOAMのDEM解析のpatchInteractionModelクラスの解読
takuyayamamoto1800
 
About chtMultiRegionFoam
About chtMultiRegionFoam About chtMultiRegionFoam
About chtMultiRegionFoam
守淑 田村
 

What's hot (20)

OpenFOAMにおける相変化解析
OpenFOAMにおける相変化解析OpenFOAMにおける相変化解析
OpenFOAMにおける相変化解析
 
Turbulence Models in OpenFOAM
Turbulence Models in OpenFOAMTurbulence Models in OpenFOAM
Turbulence Models in OpenFOAM
 
ParaviewでのParticle Tracerを用いた可視化
ParaviewでのParticle Tracerを用いた可視化ParaviewでのParticle Tracerを用いた可視化
ParaviewでのParticle Tracerを用いた可視化
 
OpenFOAM -回転領域を含む流体計算 (Rotating Geometry)-
OpenFOAM -回転領域を含む流体計算 (Rotating Geometry)-OpenFOAM -回転領域を含む流体計算 (Rotating Geometry)-
OpenFOAM -回転領域を含む流体計算 (Rotating Geometry)-
 
OpenFOAMソルバの実行時ベイズ最適化
OpenFOAMソルバの実行時ベイズ最適化OpenFOAMソルバの実行時ベイズ最適化
OpenFOAMソルバの実行時ベイズ最適化
 
Boundary Conditions in OpenFOAM
Boundary Conditions in OpenFOAMBoundary Conditions in OpenFOAM
Boundary Conditions in OpenFOAM
 
OpenFOAMにおけるDEM計算の力モデルの解読
OpenFOAMにおけるDEM計算の力モデルの解読OpenFOAMにおけるDEM計算の力モデルの解読
OpenFOAMにおけるDEM計算の力モデルの解読
 
Paraviewの等高面を綺麗に出力する
Paraviewの等高面を綺麗に出力するParaviewの等高面を綺麗に出力する
Paraviewの等高面を綺麗に出力する
 
OpenFOAM -空間の離散化と係数行列の取り扱い(Spatial Discretization and Coefficient Matrix)-
OpenFOAM -空間の離散化と係数行列の取り扱い(Spatial Discretization and Coefficient Matrix)-OpenFOAM -空間の離散化と係数行列の取り扱い(Spatial Discretization and Coefficient Matrix)-
OpenFOAM -空間の離散化と係数行列の取り扱い(Spatial Discretization and Coefficient Matrix)-
 
OpenFOAMの壁関数
OpenFOAMの壁関数OpenFOAMの壁関数
OpenFOAMの壁関数
 
Mixer vessel by cfmesh
Mixer vessel by cfmeshMixer vessel by cfmesh
Mixer vessel by cfmesh
 
interFoamの検証
interFoamの検証interFoamの検証
interFoamの検証
 
OpenFOAM LES乱流モデルカスタマイズ
OpenFOAM LES乱流モデルカスタマイズOpenFOAM LES乱流モデルカスタマイズ
OpenFOAM LES乱流モデルカスタマイズ
 
Setting and Usage of OpenFOAM multiphase solver (S-CLSVOF)
Setting and Usage of OpenFOAM multiphase solver (S-CLSVOF)Setting and Usage of OpenFOAM multiphase solver (S-CLSVOF)
Setting and Usage of OpenFOAM multiphase solver (S-CLSVOF)
 
OpenFOAM v2.3.0のチュートリアル 『oscillatingInletACMI2D』
OpenFOAM v2.3.0のチュートリアル 『oscillatingInletACMI2D』OpenFOAM v2.3.0のチュートリアル 『oscillatingInletACMI2D』
OpenFOAM v2.3.0のチュートリアル 『oscillatingInletACMI2D』
 
OpenFOAMのチュートリアルを作ってみた#1 『くさび油膜効果の計算』
OpenFOAMのチュートリアルを作ってみた#1 『くさび油膜効果の計算』OpenFOAMのチュートリアルを作ってみた#1 『くさび油膜効果の計算』
OpenFOAMのチュートリアルを作ってみた#1 『くさび油膜効果の計算』
 
OpenFOAM の cyclic、cyclicAMI、cyclicACMI 条件について
OpenFOAM の cyclic、cyclicAMI、cyclicACMI 条件についてOpenFOAM の cyclic、cyclicAMI、cyclicACMI 条件について
OpenFOAM の cyclic、cyclicAMI、cyclicACMI 条件について
 
Tutorial to set up a case for chtMultiRegionFoam in OpenFOAM 2.0.0
Tutorial to set up a case for chtMultiRegionFoam in OpenFOAM 2.0.0Tutorial to set up a case for chtMultiRegionFoam in OpenFOAM 2.0.0
Tutorial to set up a case for chtMultiRegionFoam in OpenFOAM 2.0.0
 
OpenFOAMのDEM解析のpatchInteractionModelクラスの解読
OpenFOAMのDEM解析のpatchInteractionModelクラスの解読OpenFOAMのDEM解析のpatchInteractionModelクラスの解読
OpenFOAMのDEM解析のpatchInteractionModelクラスの解読
 
About chtMultiRegionFoam
About chtMultiRegionFoam About chtMultiRegionFoam
About chtMultiRegionFoam
 

More from 守淑 田村

FMU4FOAM
FMU4FOAMFMU4FOAM
FMU4FOAM
守淑 田村
 
multiDimAMR
multiDimAMRmultiDimAMR
multiDimAMR
守淑 田村
 
Inter flowによる軸対称milkcrown解析
Inter flowによる軸対称milkcrown解析Inter flowによる軸対称milkcrown解析
Inter flowによる軸対称milkcrown解析
守淑 田村
 
Basiliskによる軸対称milk crown解析
Basiliskによる軸対称milk crown解析Basiliskによる軸対称milk crown解析
Basiliskによる軸対称milk crown解析
守淑 田村
 
An investigation about interFoam performance
An investigation about interFoam performanceAn investigation about interFoam performance
An investigation about interFoam performance
守淑 田村
 
自宅PCでinterFoamを使ってミルククラウンの計算ができるかやってみた
自宅PCでinterFoamを使ってミルククラウンの計算ができるかやってみた自宅PCでinterFoamを使ってミルククラウンの計算ができるかやってみた
自宅PCでinterFoamを使ってミルククラウンの計算ができるかやってみた
守淑 田村
 
PreCICE CHT with OpenFOAM and CalculiX
PreCICE CHT with OpenFOAM and CalculiXPreCICE CHT with OpenFOAM and CalculiX
PreCICE CHT with OpenFOAM and CalculiX
守淑 田村
 
FSI analysis with preCICE (OpenFOAM and CalculiX)
FSI analysis with preCICE (OpenFOAM and CalculiX) FSI analysis with preCICE (OpenFOAM and CalculiX)
FSI analysis with preCICE (OpenFOAM and CalculiX)
守淑 田村
 
1D steady flow simulation in gas pipelines by using Calculix
1D steady flow simulation in gas pipelines by using Calculix1D steady flow simulation in gas pipelines by using Calculix
1D steady flow simulation in gas pipelines by using Calculix
守淑 田村
 
Dakota+openFoam1
Dakota+openFoam1Dakota+openFoam1
Dakota+openFoam1
守淑 田村
 
moveEngineTopoChangerMesh1
moveEngineTopoChangerMesh1moveEngineTopoChangerMesh1
moveEngineTopoChangerMesh1
守淑 田村
 
MoveEnginetopochangerMesh2
MoveEnginetopochangerMesh2MoveEnginetopochangerMesh2
MoveEnginetopochangerMesh2
守淑 田村
 

More from 守淑 田村 (12)

FMU4FOAM
FMU4FOAMFMU4FOAM
FMU4FOAM
 
multiDimAMR
multiDimAMRmultiDimAMR
multiDimAMR
 
Inter flowによる軸対称milkcrown解析
Inter flowによる軸対称milkcrown解析Inter flowによる軸対称milkcrown解析
Inter flowによる軸対称milkcrown解析
 
Basiliskによる軸対称milk crown解析
Basiliskによる軸対称milk crown解析Basiliskによる軸対称milk crown解析
Basiliskによる軸対称milk crown解析
 
An investigation about interFoam performance
An investigation about interFoam performanceAn investigation about interFoam performance
An investigation about interFoam performance
 
自宅PCでinterFoamを使ってミルククラウンの計算ができるかやってみた
自宅PCでinterFoamを使ってミルククラウンの計算ができるかやってみた自宅PCでinterFoamを使ってミルククラウンの計算ができるかやってみた
自宅PCでinterFoamを使ってミルククラウンの計算ができるかやってみた
 
PreCICE CHT with OpenFOAM and CalculiX
PreCICE CHT with OpenFOAM and CalculiXPreCICE CHT with OpenFOAM and CalculiX
PreCICE CHT with OpenFOAM and CalculiX
 
FSI analysis with preCICE (OpenFOAM and CalculiX)
FSI analysis with preCICE (OpenFOAM and CalculiX) FSI analysis with preCICE (OpenFOAM and CalculiX)
FSI analysis with preCICE (OpenFOAM and CalculiX)
 
1D steady flow simulation in gas pipelines by using Calculix
1D steady flow simulation in gas pipelines by using Calculix1D steady flow simulation in gas pipelines by using Calculix
1D steady flow simulation in gas pipelines by using Calculix
 
Dakota+openFoam1
Dakota+openFoam1Dakota+openFoam1
Dakota+openFoam1
 
moveEngineTopoChangerMesh1
moveEngineTopoChangerMesh1moveEngineTopoChangerMesh1
moveEngineTopoChangerMesh1
 
MoveEnginetopochangerMesh2
MoveEnginetopochangerMesh2MoveEnginetopochangerMesh2
MoveEnginetopochangerMesh2
 

Recently uploaded

Fundamentals of Programming and Language Processors
Fundamentals of Programming and Language ProcessorsFundamentals of Programming and Language Processors
Fundamentals of Programming and Language Processors
Rakesh Kumar R
 
Unveiling the Advantages of Agile Software Development.pdf
Unveiling the Advantages of Agile Software Development.pdfUnveiling the Advantages of Agile Software Development.pdf
Unveiling the Advantages of Agile Software Development.pdf
brainerhub1
 
Microservice Teams - How the cloud changes the way we work
Microservice Teams - How the cloud changes the way we workMicroservice Teams - How the cloud changes the way we work
Microservice Teams - How the cloud changes the way we work
Sven Peters
 
8 Best Automated Android App Testing Tool and Framework in 2024.pdf
8 Best Automated Android App Testing Tool and Framework in 2024.pdf8 Best Automated Android App Testing Tool and Framework in 2024.pdf
8 Best Automated Android App Testing Tool and Framework in 2024.pdf
kalichargn70th171
 
原版定制美国纽约州立大学奥尔巴尼分校毕业证学位证书原版一模一样
原版定制美国纽约州立大学奥尔巴尼分校毕业证学位证书原版一模一样原版定制美国纽约州立大学奥尔巴尼分校毕业证学位证书原版一模一样
原版定制美国纽约州立大学奥尔巴尼分校毕业证学位证书原版一模一样
mz5nrf0n
 
Transform Your Communication with Cloud-Based IVR Solutions
Transform Your Communication with Cloud-Based IVR SolutionsTransform Your Communication with Cloud-Based IVR Solutions
Transform Your Communication with Cloud-Based IVR Solutions
TheSMSPoint
 
openEuler Case Study - The Journey to Supply Chain Security
openEuler Case Study - The Journey to Supply Chain SecurityopenEuler Case Study - The Journey to Supply Chain Security
openEuler Case Study - The Journey to Supply Chain Security
Shane Coughlan
 
What is Augmented Reality Image Tracking
What is Augmented Reality Image TrackingWhat is Augmented Reality Image Tracking
What is Augmented Reality Image Tracking
pavan998932
 
socradar-q1-2024-aviation-industry-report.pdf
socradar-q1-2024-aviation-industry-report.pdfsocradar-q1-2024-aviation-industry-report.pdf
socradar-q1-2024-aviation-industry-report.pdf
SOCRadar
 
GraphSummit Paris - The art of the possible with Graph Technology
GraphSummit Paris - The art of the possible with Graph TechnologyGraphSummit Paris - The art of the possible with Graph Technology
GraphSummit Paris - The art of the possible with Graph Technology
Neo4j
 
Essentials of Automations: The Art of Triggers and Actions in FME
Essentials of Automations: The Art of Triggers and Actions in FMEEssentials of Automations: The Art of Triggers and Actions in FME
Essentials of Automations: The Art of Triggers and Actions in FME
Safe Software
 
Webinar On-Demand: Using Flutter for Embedded
Webinar On-Demand: Using Flutter for EmbeddedWebinar On-Demand: Using Flutter for Embedded
Webinar On-Demand: Using Flutter for Embedded
ICS
 
Empowering Growth with Best Software Development Company in Noida - Deuglo
Empowering Growth with Best Software  Development Company in Noida - DeugloEmpowering Growth with Best Software  Development Company in Noida - Deuglo
Empowering Growth with Best Software Development Company in Noida - Deuglo
Deuglo Infosystem Pvt Ltd
 
LORRAINE ANDREI_LEQUIGAN_HOW TO USE WHATSAPP.pptx
LORRAINE ANDREI_LEQUIGAN_HOW TO USE WHATSAPP.pptxLORRAINE ANDREI_LEQUIGAN_HOW TO USE WHATSAPP.pptx
LORRAINE ANDREI_LEQUIGAN_HOW TO USE WHATSAPP.pptx
lorraineandreiamcidl
 
KuberTENes Birthday Bash Guadalajara - Introducción a Argo CD
KuberTENes Birthday Bash Guadalajara - Introducción a Argo CDKuberTENes Birthday Bash Guadalajara - Introducción a Argo CD
KuberTENes Birthday Bash Guadalajara - Introducción a Argo CD
rodomar2
 
OpenMetadata Community Meeting - 5th June 2024
OpenMetadata Community Meeting - 5th June 2024OpenMetadata Community Meeting - 5th June 2024
OpenMetadata Community Meeting - 5th June 2024
OpenMetadata
 
Revolutionizing Visual Effects Mastering AI Face Swaps.pdf
Revolutionizing Visual Effects Mastering AI Face Swaps.pdfRevolutionizing Visual Effects Mastering AI Face Swaps.pdf
Revolutionizing Visual Effects Mastering AI Face Swaps.pdf
Undress Baby
 
Vitthal Shirke Java Microservices Resume.pdf
Vitthal Shirke Java Microservices Resume.pdfVitthal Shirke Java Microservices Resume.pdf
Vitthal Shirke Java Microservices Resume.pdf
Vitthal Shirke
 
ALGIT - Assembly Line for Green IT - Numbers, Data, Facts
ALGIT - Assembly Line for Green IT - Numbers, Data, FactsALGIT - Assembly Line for Green IT - Numbers, Data, Facts
ALGIT - Assembly Line for Green IT - Numbers, Data, Facts
Green Software Development
 
Graspan: A Big Data System for Big Code Analysis
Graspan: A Big Data System for Big Code AnalysisGraspan: A Big Data System for Big Code Analysis
Graspan: A Big Data System for Big Code Analysis
Aftab Hussain
 

Recently uploaded (20)

Fundamentals of Programming and Language Processors
Fundamentals of Programming and Language ProcessorsFundamentals of Programming and Language Processors
Fundamentals of Programming and Language Processors
 
Unveiling the Advantages of Agile Software Development.pdf
Unveiling the Advantages of Agile Software Development.pdfUnveiling the Advantages of Agile Software Development.pdf
Unveiling the Advantages of Agile Software Development.pdf
 
Microservice Teams - How the cloud changes the way we work
Microservice Teams - How the cloud changes the way we workMicroservice Teams - How the cloud changes the way we work
Microservice Teams - How the cloud changes the way we work
 
8 Best Automated Android App Testing Tool and Framework in 2024.pdf
8 Best Automated Android App Testing Tool and Framework in 2024.pdf8 Best Automated Android App Testing Tool and Framework in 2024.pdf
8 Best Automated Android App Testing Tool and Framework in 2024.pdf
 
原版定制美国纽约州立大学奥尔巴尼分校毕业证学位证书原版一模一样
原版定制美国纽约州立大学奥尔巴尼分校毕业证学位证书原版一模一样原版定制美国纽约州立大学奥尔巴尼分校毕业证学位证书原版一模一样
原版定制美国纽约州立大学奥尔巴尼分校毕业证学位证书原版一模一样
 
Transform Your Communication with Cloud-Based IVR Solutions
Transform Your Communication with Cloud-Based IVR SolutionsTransform Your Communication with Cloud-Based IVR Solutions
Transform Your Communication with Cloud-Based IVR Solutions
 
openEuler Case Study - The Journey to Supply Chain Security
openEuler Case Study - The Journey to Supply Chain SecurityopenEuler Case Study - The Journey to Supply Chain Security
openEuler Case Study - The Journey to Supply Chain Security
 
What is Augmented Reality Image Tracking
What is Augmented Reality Image TrackingWhat is Augmented Reality Image Tracking
What is Augmented Reality Image Tracking
 
socradar-q1-2024-aviation-industry-report.pdf
socradar-q1-2024-aviation-industry-report.pdfsocradar-q1-2024-aviation-industry-report.pdf
socradar-q1-2024-aviation-industry-report.pdf
 
GraphSummit Paris - The art of the possible with Graph Technology
GraphSummit Paris - The art of the possible with Graph TechnologyGraphSummit Paris - The art of the possible with Graph Technology
GraphSummit Paris - The art of the possible with Graph Technology
 
Essentials of Automations: The Art of Triggers and Actions in FME
Essentials of Automations: The Art of Triggers and Actions in FMEEssentials of Automations: The Art of Triggers and Actions in FME
Essentials of Automations: The Art of Triggers and Actions in FME
 
Webinar On-Demand: Using Flutter for Embedded
Webinar On-Demand: Using Flutter for EmbeddedWebinar On-Demand: Using Flutter for Embedded
Webinar On-Demand: Using Flutter for Embedded
 
Empowering Growth with Best Software Development Company in Noida - Deuglo
Empowering Growth with Best Software  Development Company in Noida - DeugloEmpowering Growth with Best Software  Development Company in Noida - Deuglo
Empowering Growth with Best Software Development Company in Noida - Deuglo
 
LORRAINE ANDREI_LEQUIGAN_HOW TO USE WHATSAPP.pptx
LORRAINE ANDREI_LEQUIGAN_HOW TO USE WHATSAPP.pptxLORRAINE ANDREI_LEQUIGAN_HOW TO USE WHATSAPP.pptx
LORRAINE ANDREI_LEQUIGAN_HOW TO USE WHATSAPP.pptx
 
KuberTENes Birthday Bash Guadalajara - Introducción a Argo CD
KuberTENes Birthday Bash Guadalajara - Introducción a Argo CDKuberTENes Birthday Bash Guadalajara - Introducción a Argo CD
KuberTENes Birthday Bash Guadalajara - Introducción a Argo CD
 
OpenMetadata Community Meeting - 5th June 2024
OpenMetadata Community Meeting - 5th June 2024OpenMetadata Community Meeting - 5th June 2024
OpenMetadata Community Meeting - 5th June 2024
 
Revolutionizing Visual Effects Mastering AI Face Swaps.pdf
Revolutionizing Visual Effects Mastering AI Face Swaps.pdfRevolutionizing Visual Effects Mastering AI Face Swaps.pdf
Revolutionizing Visual Effects Mastering AI Face Swaps.pdf
 
Vitthal Shirke Java Microservices Resume.pdf
Vitthal Shirke Java Microservices Resume.pdfVitthal Shirke Java Microservices Resume.pdf
Vitthal Shirke Java Microservices Resume.pdf
 
ALGIT - Assembly Line for Green IT - Numbers, Data, Facts
ALGIT - Assembly Line for Green IT - Numbers, Data, FactsALGIT - Assembly Line for Green IT - Numbers, Data, Facts
ALGIT - Assembly Line for Green IT - Numbers, Data, Facts
 
Graspan: A Big Data System for Big Code Analysis
Graspan: A Big Data System for Big Code AnalysisGraspan: A Big Data System for Big Code Analysis
Graspan: A Big Data System for Big Code Analysis
 

About multiphaseEulerFoam