TP 2019 What Is New
TP 2019 What Is New
Autodesk and Moldflow are registered trademarks or trademarks of Autodesk, Inc., and/or its subsidiaries and/or affiliates in the USA and/or
other countries. All other brand names, product names, or trademarks belong to their respective holders. Autodesk reserves the right to alter
product and services offerings, and specifications and pricing at any time without notice, and is not responsible for typographical or graphical
errors that may appear in this document.
Assembly analysis
Automatic mesh type classifier
Advection Solver application programming interface (API)
Reactive Microcellular Injection Molding (with PU Foaming)
Anisotropic Thermo-Viscoelastic Residual Stress Model
Tiger Stripe Prediction
The following features were carried over from the last technology preview
release:
Underflow diagnostic
Retractable core-pin support
Mesh aggregation for buckling analysis
Fiber concentration
Annealing analysis with viscoelastic material properties for midplane and dual-
domain
Shrinkage calibrated coefficient of thermal expansion for unfilled semi-
crystalline materials
Thickness shrinkage scheme for residual stress accuracy improvement
Prerequisite
Autodesk Moldflow 2019 Synergy and Insight need to be installed for Autodesk
Moldflow 2019 technology preview to work.
Assembly analysis
Introduction
In some industrial applications such as automobiles, aircraft and home
appliances, it is essential to meet tight dimensional tolerances after the
injection molded components are mounted into the designed position [6].
Injection molding process-induced shrinkage and warpage may cause the
manufactured part to deviate from the designed nominal shape and size. For
the flexible plastics part, forces could be applied to bring them back to the
nominal position during the assembly. Sometimes injection molded
components’ warpage problem can be eliminated once they are mounted by
over-constrained assemblies. On the other hand, the flat components could
become distorted during the compliant assembly due to the unexpected
shrinkage magnitude during injection molding process. For example, when the
front door trim panel in the prototype stage assembled with sheet metal (as
shown in Figure 1), the desirable uniform clearance is not achieved, and the
gap is beyond the tolerance requirement of geometric dimensioning and tolerancing
(GD&T). Predicting the deformation and stress of injection molded components after
being mounted into designed position can be a valuable design tool for identifying the
problem and optimizing the design.
Figure 1. Assembled automotive door at prototype stage (Courtesy of ChangAn
Automotive Group)
Simulation Theory
With the cavity mesh scaled up using the material’s nominal shrinkage S, the
imposed displacement U at mounting nodes can be derived as:
U= (X’-C) S/(1+S)
The algorithms have been implemented for the midplane solution, dual-domain
solution and three-dimensional solution [1]. Both the small deflection analysis
and buckling analysis are valid for the application.
The workflow for calculating the deformation and stress after the components
are mounted into the designed positions can be summarized as:
The Deflection result will include the effects of the assembly constraints. In addition, a
new “Deviation from part design” in the warpage results shows the geometric
deviation between the final mounted part and the original part design (geometry
before scaling up to compensate for molding shrinkage).
Numerical Examples
To compensate the shrinkage in the injection molding process, the mold cavity
is scaled up by the material nominal shrinkage. From the shrinkage simulation,
the plate will shrink by about 1.34%. If we use 1.34% as the material nominal
shrinkage for cavity scaling-up, we can get a molded part very close to the
designed size. Using the proposed approach, the predicted deformation after
mounting the plate at four corners are shown in Figure 2. It shows that the
geometric deviation from the original design is nearly zero. However, if 1% is
used for material nominal shrinkage for cavity scaling-up, the molded part will
be too small. When it is forcefully mounted at four corners, the molded plate
has been in tension. The predicted deformation after the mounting is shown in
Figure 3. The edges of the plate are slightly bowed in.
On the other hand, if 2% is used for material nominal shrinkage for cavity
scaling-up, the molded part will be too large. When it is forcefully mounted at
four corners, the molded plate has been in compression. The predicted
deformation after the mounting is shown in Figure 4. The edges of the plate are
slightly bowed out. Figure 5. shows the predicted compressive stress level.
Figure 4. Deformation after mounting with 2.0% cavity scaling-up
The cooling, filling. packing, fiber orientation and residual stress and
warpage analyses were performed on three-dimensional model. The average
fiber orientation results are shown in Figure 9. For the normal warpage analysis
without considering assembly constraints, the predicted deformed shape is
shown in Figure 10, which showed quite significant distortion on the left side of
the edge.
Figure 9. Predicted average fiber orientation
Figure 11. Final geometric deviation from designed shape and size after
assembly
References
Zhiliang Fan, Russel Speight. Deformation and stress prediction of injection molded
components after being mounted into designed position, SPE ANTEC Proceedings,
Orlando, Florida (2018)
Automatic mesh type classifier
An automatic mesh type classifier has been included in Moldflow 2019 TP.
Instead of choosing mesh type only based on match ratio as before, the new
algorithm uses a combination of new measures to capture 3D features. It was
developed based on hundreds of surface meshes classified manually by
Moldflow experts. The accuracy of automatic classification has been improved
to 93%.
Mesh type recommendation can be found by Mesh Statistics and Mesh Match
Diagnostics in Synergy.
.
Advection Solver application programming interface (API)
In 2019 Technical Preview release we have added a solver API for applying an
arbitrary advection equation. The api can be used for research in different
areas including crystallization, fiber orientation, bending breakage and
migration, multiple component co-injection, etc. Currently the new api is not
fully supported for beam elements.
As a simple example we use just the transport equation for the residence time
that can be written as:
𝐷
R=1
𝐷𝑡
R(t=0) =0
R (Inj Nodes)=0,
where R is the residence time.
The solver API code that implements the described equation is simply looks
like:
//A simple example of using advection solver API: calculating residence time
//At the injection node the residence time is zero
//The evolution equation is dx/dt=1
We have tested the new api on a plate. The predicted residence time “Solver
API User nodal plot 1” at the end of fill looks like:
Figure 1 Predicted residence time at the end of fill obtained using solver api
UserFieldExample1.
As expected the residence time is the highest on the surface of the part while
in the core zone closed to the injection node the residence time is the lowest.
𝐷 −𝐸𝑎𝑐𝑡
𝐷𝑡
𝛼 = 𝐾(1 − 𝛼)exp( 𝑅𝑇
),
where 𝛼 is the degree of temperature degradation, K and 𝐸𝑎𝑐𝑡 are parameters.
Initially the degradation is zero. The heart of the solver api code is:
Kinetic equation:
//First order Arrhenius equation
extern "C" void STDCALL SolverUserHb3dUserNodeFieldsEvolution(double* dXdt, double const*
X, size_t nodeID, size_t Lam) {
// Residence time dXdt=1
double T; //Temperature
if (SolverUtilityHb3dGetNodeScalarResult(nodeID, "Temperature", &T)>0) {
T += 273.0;
dXdt[0] = k0*(1.0 - X[0])*exp(-Eact / R / T);
}
else {
//Report error
std::wostringstream Message1;
Message1 << L"Cannot find node with ID " << nodeID;
SolverUtilityHb3dFail(Message1.str().c_str());
}
}
There is also a simple code for reading the kinetic parameters from the
SOLVER_API string. For details load the provided Program
Files\Autodesk\Moldflow Insight Scandium
2019\data\solverapi\MoldflowUserFunctions_UserfieldExample2.vcxproj
project.
A user can specify the kinetic parameters 𝐸𝑎𝑐𝑡 and K for thermal destruction via
the “General text” string. E.g. 𝐸𝑎𝑐𝑡 = 160𝑘𝐽/𝑚𝑜𝑙 and K=8.8E15 can be set as:
Figure 2 Entering kinetic parameters for thermal destruction using solver api
UserfieldExample2
For a square plate the api would predict final thermal destruction showing
“burn marks” near injectors:
//Using viscosity calculaor to get CrossWLF viscosity and mulipying it on the thermal
destruction term
//The thermal destruction TG is obtaine by using utility function
SolverUtilityHb3dGetUserNodeField
//Implementation for 3D nodes
extern "C" double STDCALL SolverUserHb3dViscosityAtNode(double temperature, double
shearRate, double pressure, size_t nodeId)
{
// Compute viscosity at given temperature, shear rate and pressure.
assert(viscosityCalculator);
assert(temperature > -273.15);
assert(shearRate >= 0.0);
assert(pressure > -101325.0);
// Using viscosity calculaor to get CrossWLF viscosity and mulipying it on the thermal
destruction term
//The thermal destruction TG is obtaine by using utility function
SolverUtilityHb3dGetUserNodeField
//Implementation of laminated nodes
extern "C" double STDCALL SolverUserHb3dViscosityAtLaminateOfNode(double temperature,
double shearRate, double pressure, size_t nodeId, unsigned int gridId)
{
// Compute viscosity at given temperature, shear rate and pressure.
assert(viscosityCalculator);
assert(temperature > -273.15);
assert(shearRate >= 0.0);
assert(pressure > -101325.0);
// Using viscosity calculaor to get CrossWLF viscosity and mulipying it on the thermal
destruction term
//The thermal destruction TG is obtaine by using utility function
SolverUtilityHb3dGetUserNodeField
//Implementation for 3D elements
extern "C" double STDCALL SolverUserHb3dViscosityAtElement(double temperature, double
shearRate, double pressure, size_t elementId)
{
// Compute viscosity at given temperature, shear rate and pressure.
assert(viscosityCalculator);
assert(temperature > -273.15);
assert(shearRate >= 0.0);
assert(pressure > -101325.0);
//First lets calculate average TG
double lTG = 0.0;
size_t lCount = SolverUtilityHb3dGetConnectedNodeCount(elementId);
if (lCount > 0) {
size_t* lNode=new size_t [lCount];
SolverUtilityHb3dGetConnectedNodeIds(elementId, lNode);
for (int i = 0; i < lCount; i++) {
double lTG_node = SolverUtilityHb3dGetUserNodeField(lNode[i], 0, 0);
lTG += lTG_node / (double)lCount;
}
delete[] lNode;
}
// In power law example, pressure is not used.
return viscosityCalculator->CalculateViscosity(shearRate, temperature, 0.0)*pow((1.0 +
lTG), -3.4);
}
A user is supposed to provide kinetic parameters K and Eact in the general
configuration string and the parameters for the WLF equation in the viscosity
configuration string:
We run simulation for a custom double-T intersection mold there the shear
heating in the runners creates flow imbalance in otherwise naturally balanced
mold. Without thermal destruction simulation significantly under-predicts the
disbalance and the hypothesis is that taking into account thermal degradation
could improve the prediction.
We did simulation with different K_0 and E=170E3 J/mol.
If we estimate the uneven filling as the maximal difference in filling time
between branches we have the following results:
2019 TP provides also an ability for the user to calculate their own custom fiber
distribution. This feature is illustrated by provided FiberExample1 where a user
can set a constant fiber orientation in every node:
// A simple example of using user-calculated fiber orientation:
//Just setting harcoded fiber orientation for all nodes
extern "C" void STDCALL SolverUserHb3dFiberOrientation(size_t nodeID, size_t Lam, double*
axx, double* ayy, double* axy, double* axz, double* ayz)
{
//Just setting fixed fiber orientation
*axx = 0.75;
*ayy = 0.2;
*axy = 0.02;
*axz = 0.02;
*axz = 0.02;
}
This user-provided fiber orientation will be used instead of those predicted by
the solver in calculations of mechanical properties, CTE, shrinkage and
warpage. They also be used in all fiber-related plots.
The functionality is intended to be used together with the tools for advection
solver api described above and can be used to implement custom fiber
orientation models. To facilitate creation of custom fiber models the api can
access a new fiber orientation configuration string with the parameters of the
model and the evolution function can access the deformation rate tensor: the
parameter often used in fiber orientation calculations.
As an example, the following solver api code would plot the nine components
of the tensor gradients:
#include "MoldflowUserFunctions.h"
#include <string>
#include <cassert>
#include <sstream>
#include <vector>
#include "MoldflowSolverUtility.h"
#ifdef _WIN32
#define STDCALL __stdcall
#else
#define STDCALL
#endif
(b)
Figure 3: For regular reactive microcellular injection molding: (a) page 1 and
(2) page 2.
For the analysis sequences for CFM (Chemical Foaming Molding), the
process settings are shown in Figure 4. This is for the case where the foaming
gas is generated during molding at the cavity by chemical reaction. For CFM,
only constant number of cells per volume is supported (no bubble nucleation
model is supported).
(a)
(b)
Figure 4: For CFM (Chemical Foaming Molding) analysis sequence: (a) page 1
and (b) page 2.
For CFM analysis, the initial filling method can be selected as shown in
Figure 5(a). This is how the initial filling of the cavity will be done. For CFM
process (such as PU foaming), initially, a small portion of the cavity is filled.
And the initially filled region is expanded to fill the whole cavity by foaming
gas generation, bubble nucleation and growth. The initial filling can be done by
injection or by initial charge. When the initial filling is done by injection,
process settings (such as filling method, V/P switch-over and packing/holding
control) can be assigned as shown in Figure 5(b). Typically, V/P switch-over will
occur at low volume filled for CFM cases.
When the initial filling is done by initial charge, the initially filled region
can be specified by clicking the 3D elements, and select “Initially filled” for the
elements that are filled initially as shown in Figure 5(c).
(a)
(b)
(c)
Figure 5: Selecting the “initial filling method” for CFM cases: (a) Selection of
initial filling method, (b) Filling method setting for initial filling “By injection”
case and (c) assigning the initially filled status for 3D elements.
For CFM, the “Foaming gas generation” method can be selected as shown
in Figure 6. It can be by “PU Foaming” or “General chemical blowing agent
reaction.
(1)
Another is the blowing reaction (which generates foaming gas (CO 2)) as
described by the following reaction.
(2)
For any other reaction cases, “General chemical blowing agent” reaction
method can be selected.
For “PU foaming” case, PU foaming data can be specified as in Figure 7.
Figure 7(a) represent the data needed for PU foaming analysis. The data
needed include “initial water concentration”, “initial OH concentration”, “initial
NCO concentration”. These are by weight %. It also requires “initial dissolved
CO2 concentration”. This is the amount of CO2 gas that can be dissolved in the
melt before nucleation. “Equivalent weight of OH” and “Equivalent weight of
NCO” also need to be assigned.
Optionally, phase changing physical blowing agent (PBA) can also be added
for the blowing reaction. In this case, the “PBA data if using PBA” box can be
checked, and the appropriate data can be specified as in Figure 7(b). The
required data for PBA include “MB” (molecular weight of the blowing agent gas
generated from PBA), “Mno” (initial average molecular weight of the
polymerizing mixture), “Density, BL” (the density of the physical blowing agent
in liquid or solid form), “Heat capacity, BL” (heat capacity of the physical
blowing agent in liquid or solid form), and “Heat capacity, BL” (heat capacity of
the foaming gas generated from physical blowing agent). It also requires
“TB,A” and “TB,B”. These are for the following relation:
Where, XBL is for the mole fraction of the blowing agent in liquid phase, and T B
is for boiling temperature of blowing agent. It also requires “Heat of reaction”
and “Initial liquid PBA mass ratio”.
(a)
(b)
Figure 7: For PU foaming case: (a) PU foaming data, (b) PBA data.
An Example Case
One example case is a PU foaming case in a rectangular geometry as
shown in Figure 10(a). This case is from Mitani et al (Polymer Engineering and
Science, v. 43, 2003). The length of the plate is 1100 mm, and the width is 300
mm. The thickness is either 35 or 65 mm. The mold temperature is 30C, initial
melt temperature is 30C. 9.1% of the cavity is filled initially by injection. The
initial water concentration is 0.906%, initial OH concentration is 45.31%, and
the initial NCO concentration is 53.78%. The equivalent weight of OH is 153.7,
and the equivalent weight of NCO is 135. No PBA is used in this case. The
number of cells was assumed to be 1.0x1012 /m3.
The simulation result (fill pattern) is shown in Figure 10(b).
(a) (b)
Figure 10: (a) The mesh used for PU foaming simulation, and (b) the filling
pattern obtained from simulation.
Simulation Technology
The in-mold residual stress will relax a certain amount depending on the
temperature history during cooling, and it can only be predicted by the thermo-
viscoelastic model. The constitutive equation can be written as
rs T
ij t Cijrs (t ) ( ) ) (
t
rs )d
0
For polymer materials, two commonly-used models for the shift factor are the
WLF model and the Arrhenius model. As we can see from Figure 2, it is not
appropriate to fit the shift factor data to a single model over a complete
temperature range, though it is quite common that only one set of shift factor
parameters is given in literature or material database. A more rational
approach is to use two different models for fitting the shift factors over two
different temperature ranges. For example, for amorphous material, the WLF
equation can be used to describe the time-temperature shift factor with the
temperature ranging from Tg to Tg+100o C. For temperatures outside the above
range, an Arrhenius expression can be used. To avoid introducing errors during
the model fitting, a tabulated form for describing the temperature-dependence
of the shift factors is preferred as the input in our implementation.
If these data are not available in the database for the chosen material but you
have the data, you can input these data manually. The relaxation spectrum
values should be the relative dimensionless modulus such that .
With these options on, the viscoelastic residual stress model will be used in the
flow and warpage analyses.
Figure 3 . GUI for viscoelastic residual stress model
Numerical example
The case is a rectangular strip part, molded using an ABS material, Novodur
P2X of Bayer (Figure 4). The processing conditions and measurement of the
residual stresses with the layer removal method were reported in detail in
reference [2]. The mold cooling was slightly asymmetrical, with wall
temperatures of 51.85°C/47.85°C.
There are two time-temperature shift equations for shifting the relaxation data
to the appropriate temperature in [2]: the WLF-shift is used when T is not less
than Tg, and a special exponential relationship is used when T is less than Tg.
In our implementation, only the tabulated form, WLF equation and Arrhenius
equation are implemented, and therefore these two shift equations of the
material are replaced with an equivalent tabulated temperature-time shift
relationship in Table 1, which can be readily used for our algorithm.
The dimensionless relaxation spectrum data for equation (3) is listed in table 2.
For better capturing the pressure and temperature history and frozen layer
growth in a gap-wise direction, 20 layers of tetrahedral elements are used.
There are 520311 tetrahedral elements in the mesh. Both the thermo-viscous-
elastic residual stress model and the thermo-viscoelastic residual stress model
were run.
References
1. Zhiliang Fan, Russel Speight. Effect of Stress Relaxation on Shrinkage and Warpage
of Injection Molded Parts, SPE ANTEC Proceedings, Orlando, Florida (2018)
Some injection molded parts show visible surface marks which are
characterised as alternating bands of glossy and dull stripes aligned
perpendicular to the flow direction and with the sequence of gloss and dull
bands inverted on the underside of the part. This defect is commonly known as
“Tiger Stripes”.
Bulters and Schepens [1] at DSM showed experimentally that the Tiger Stripe
pattern was caused by oscillations of an unstable flow front. However, the
existence of flow front oscillations is not by itself considered to be a sufficient
condition for the visibility of Tiger Stripes. Hirano et al.[2] established that the
variations in gloss were caused by the stretch of rubber additive particles in
the polymer, with alternating opposing bands of stretch and non-stretch
caused by the flow front oscillations (see Figure 1). Polymer grades which do
not contain neither such rubber particles nor other additive particles which can
be oriented or stretched by the oscillating flow front will not display visible
Tiger Stripes even if a flow front instability exists during filling.
Figure 1: Alternating stretch pattern due to flow front instability. (Hirano et
al.[2])
The Tiger Stripe prediction feature is available as part of a Fill analysis (or
Fill+Pack analysis) for 3D mesh types. Two new result plots are provided by the
Tiger Stripe feature: A “Flow front stability factor” result and a “Tiger stripe
region” result. Both these results are automatically added to the default list of
displayed results.
The Flow front stability factor result (Figure 2) can be used to identify the
regions where the likelihood of Tiger Stripe is highest. This result scales a
measure of the conditions leading to flow front instability against the stability
threshold parameter. Stability factor results below 1 indicate regions where a
flow front instability is not expected. Regions of the part with the highest flow
front stability factor are the areas where the likelihood of flow front instability
leading to Tiger Stripes is expected to be highest. However, Tigers Stripes are
not expected close to the gate because the amplitude of the osciallation will
still be weak.
Figure 2: Flow front stability factor result
The Tiger stripe region result (Figure 3) will display a banded pattern in those
regions where the flow front stability factor exceeds 1 and the distance from
the gate is great enough to allow the instability to develop into strong
oscillations. Tiger Stripe bands are not expected close to the gate even if the
flow front instability factor is greater than 1 because the initial oscillations are
weak and do not contact the mold surfaces.
The width of banding depends on the thickness and flow front speed. However,
whether a flow front instability causes visible gloss bands will depend on the
filler composition of the polymer grade. For some polymer grades, a flow front
instability may not lead to significant gloss level banding. The prediction of
this visibility characteristic is not considered in this Tiger Stripe technology
preview.
Figure 3: Tiger stripe region result, 5mm node spacing
The prediction of the flow front stability factor and the regions of potential
Tiger Stripes will be performed for all filling analyses. No user selection is
required to enable this calculation.
In the polymer grade’s material properties, a tab is provided which displays the
properties relevant to Tiger Stripe prediction. (See Figure 4). Viscoelastic
properties and the Tiger Stripe instability threshold can be viewed and edited
on this tab.
Figure 4: Tiger Stripe Material data tab.
The viscoelastic relaxation spectrum follows the same model definition as used
by the viscoelastic stress relaxation feature. If the viscoelastic relaxation
spectrum data is not available, a characteristic relaxation time will be
estimated from the non-Newtonian Cross-WLF viscosity model.
The Tiger Stripe instability threshold parameter is the threshold value of the
characteristic describing the tendency for flow front instability. When this
characteristic exceeds the threshold value (i.e. their ratio is greater than 1), a
flow front instability is expected. It is anticipated that the Tiger Stripe
instability threshold will be tuned for each polymer grade based on observed
Tiger Stripe behaviours from molded parts. Such identification of an optimized
threshold parameter will be specific to whether the characteristic relaxation
time is from measured viscoelastic data or estimated from the Cross-WLF
viscosity model. If the Tiger Stripe instability threshold is not specified, a
default value of 2.6 will be used. Analyses run which include the Tiger Stripe
feature will report the used Tiger Stripe instability threshold in the analysis log
(Figure 5).
References
Underflow diagnostic
You can now easily check the results of 3D filling simulation to find whether an
underflow occurs during filling of your part and what region is affected.
Underflow
Underflow is when a flow front reverses direction. It occurs when flow fronts
from two directions meet, pause momentarily, then one of the flows reverses
direction and flows back between the outer frozen layers. When the flow
reverses direction the frozen layer partly re-melts due to shear heating. This
flow reversal gives poor part quality, both from surface appearance and
structural viewpoints.
Underflow often occurs near weld and meld lines but may happen
independently from them.
Severity of underflow
In the present release the software calculates the “severity of underflow”
parameter calculated by the following formula:
𝑡
‖∫0 𝑓𝑖𝑙 𝑣⃑(𝑡)𝑑𝑡‖
𝑆𝑢 = 1 − 𝑡
∫0 𝑓𝑖𝑙 ‖𝑣⃑(𝑡)‖𝑑𝑡
Where 𝑆𝑢 is the severity of underflow, 𝑣⃑(𝑡) is melt velocity vector and 𝑡𝑓𝑖𝑙 is the filling time.
Severity of underflow is always between zero and one. The value of zero shows that melt
velocity has been always in the same direction while the large values indicate that velocity
significantly change direction so a significant underflow occurs.
Our observations show that if severity of underflow is lower than an empirical value of 0.05
no signs of underflow occur.
If somewhere in the part severity of underflow exceed this empirical value, then WARNING
313412 is written to the log file showing the maximal and average severity of
underflow, an additional result is created showing the distribution of
underflow severity in the molding.
What to do
Example
The filling time and velocity show that melt changes velocity when the flow
fronts meet in the middle between the two injection points:
With the new underflow diagnostic results, we immediately see that underflow
occurs from the log files:
The underflow severity plot immediately identifies the area there underflow
occurs:
Since the maximal underflow is quite large (0.83) and underflow occurs in a
large and prominent region the injection mold should be rebalanced by moving
injection points or by balancing melt flow between those points.
You now can simulate injection molding with retractable core pins.
Injection molds with retractable pin supporting inserts are used for moldings
that completely cover inserts. Common examples of such moldings are golf
balls where injection molded plastic covers rubber inserts.
Polymer pressure on the rubber inserts causes their deformation while even
the slightest imbalance in the melt flow - e.g. originated from different flow
paths from the sprue towards the gates causes a shift of the inserts that in
turn causes a stronger imbalance, causing higher shift etc. The progressively
increasing imbalance of flow may cause a significant shift of the rubber inserts,
warpage of the balls, variations of the plastic thickness, etc. Those factors are
critically important for the quality of the balls, thus, prediction of the
deformations and shifts of the inserts is an important part of the mold filling
analysis.
The retractable supports are also quite usable for limiting the effect of the core
shift if the cores are not rigid enough to sustain molding pressure. Since
limiting the core shift effects is the main motivation for putting the retractable
pins the prediction of the core shift effects is very important for such molding
processes too.
We take into account retractable core pins as retractable constraints (A) that
are excluded from the analysis after some retraction time. The approach does
not require the user to model the geometry of the support pins themself, while
the second approach is more accurate, allowing to account for the deformation
of the retractable pins themself.
Case Study
The simulation shows that displacements of the rubber insert approach 0.55
mm prior to retraction of the supports (see Figure 3)
The case study shows the importance of the core shift analysis for the molds
with retractable insert supports.
What to do?
Core shift analysis with retractable core pins predicts the displacements of the
inserts after the injection molding. If the displacement values are not
acceptable you have to redesign the injection mold probably using more
retractable pins and better balanced injection, sometimes modification of
injection molding process parameters may help.
The user can check the mesh aggregation option when the buckling analysis
type is chosen in the Warp Settings page of the Process Settings Wizard as
shown below.
Fiber concentration
Introduction
The fiber segregation effect is known when injecting fiber reinforced plastic. It
is commonly observed that there are more fibers in the core region while less
fibers in the shear region. Such phenomenon is believed to be caused by shear
induced migration.
The fiber concentration is solved in conjunction with 3D flow solution. Once
complete the fiber concentration field is used for composites mechanical
property calculation. The fiber concentration together with fiber orientation
and fiber breakage determine the mechanical properties and thermal
expansion coefficients of the composites, which are important factors to the
final part warpage and subsequent structure analysis
The fiber concentration module employs the suspension balance model (SBM)
to predict the fiber segregation effect. In SBM the particle normal stress
gradient is believed to be the driven force for particles to migrate, hence the
shear induced fiber segregation and convection of fiber concentration from
upstream to downstream can both be considered.
The SBM model was first proposed by Nott et al, and further improvements
were made by Morris. SBM models the fluid and particle as two phases, but the
full Naiver-Stokes equations are only solved on the suspension (fluid and
particle mixture), and one extra particle-phase mass balance equation, which is
similar to a transport equation, is needed [1] [2] [3].
∂ρ
+ ∇ ∙ (ρV) = 0
∂t (1)
DV
ρ = −∇P + ∇ ∙ τ + ρg
Dt (2)
DT
ρCp = ∇ ∙ (k∇T) + τ: ∇V
Dt
DP (3)
+ βT
Dt
∂∅
∂t
+ V ∙ ∇∅ = −∇ ∙ j⊥ (4)
Σp = −η0 ηn γ̇ Q (6)
ηn is the particle normal stress viscosity; Tensor Q defines the anisotropy of the
normal stress; γ̇ is shear rate;
(7)
ηn = K n (∅⁄∅m )2 (1 − ∅⁄∅m )−2
λ1 0 0
Q =[ 0 λ2 0]
0 0 λ3 (8)
2
γ̇ = √2E: E (9)
The fiber segregation can be modelled by the SBM model, but problem is that
SBM requires the particles to be tiny hard spheres but fibers are not. The way
to resolve this problem is to use an equivalent sphere to represent the fiber.
The radius of the equivalent sphere 𝑅𝑒 is calculated based on the volume of the
fiber.
4 1
𝜋𝑅𝑒 3 = 4 𝜋𝑑 2 𝑙 (10)
3
The fiber concentration does not impact the suspension viscosity, fiber
orientation or fiber breakage, but the mechanical property calculation takes the
non-uniform fiber concentration into account.
The fiber concentration feature can be enabled from the fiber solver
parameters entry which is shown in figure 1
Figure 1 Fiber concentration entry
The fiber property page has been extended to include the fiber concentration
related parameters which are shown in figures 2 and 3.
Initial fiber volume fraction is calculated via fiber weight fraction, material
solid density, and fiber density. Using material solid density for calculating the
initial volume concentration makes the volume concentration result match the
mechanical property calculation without fiber concentration feature being
turned on.
∅𝑖𝑛𝑖𝑡 is the initial fiber volume fraction; 𝑤 is the fiber weight fraction;𝜌𝑠 is the
material density of solid state; 𝜌𝑓 is the fiber density;
The fiber equivalent radius can be determined from equation (10). The default
value is 0.02mm.
Particle normal stress coefficients can be found in equations (6) to (8). The
particle normal stress can be determined from experiments and in Moldflow K n
is given 3.0 by default for fiber concentration calculation; 𝜆1 , 𝜆2 , 𝑎𝑛𝑑𝜆3 are 1.0,
0.8 and 0.5 by default.
Run the flow analysis with the fiber concentration turned on. Once completed
there is a new result named “Fiber volume concentration” in the default result
list. One demonstrative plot is given in fig 4 to show the fiber segregation
through the thickness of the plate. It can be seen that the lowest fiber
concentration is the shear region while the highest fiber concentration is at the
center of the plate.
Given the fiber concentration is no longer uniform through the part the
mechanical properties and thermal expansion coefficients prediction of the
composites have also been modified to take the non-uniformed concentration
into account. Figures 5, 6 and 7 show the plots through thickness of the fiber
concentration, the tensile modulus and thermal expansion coefficient (CTE) in
the first principle direction comparison between the case without fiber
concentration and the case which has the fiber concentration on. It can be seen
that previously as of the fiber alignment at the shear region hence the tensile
modulus in the first principle is maximum and the CTE is minimal, while the
core region shows the opposite result as it is least aligned there; However, with
the non-uniformed fiber concentration being taken into account it relieves
such effect as there is less fiber in the shear region now but more fiber in the
core region.
References
Workflow
To run annealing analysis, “Add reflow profile for annealing analysis” option
needs to be checked as in Figure 1(a). The reflow profile can be specified as in
Figure 1(b).
(a)
(b)
Figure 1: (a) “Add reflow profile for annealing analysis” option and (b) an
example of reflow temperature profile.
Example Case
The example is for a simple rectangular plate case shown in figure 3. The
material is PS. The mold temperature is 35°C, and the melt temperature is
218°C. Mid-plane mesh is used for the analysis. For this case, the reflow profile
shown in figure 1(b) is used.
Figure 3: Mesh used in the example case study.
The warpage calculation results (without and with reflow) are shown in Figure
4. For this case, the warpage has decreased after reflow.
(a)
(b)
Figure 4: (a) Calculated warpage result without reflow and (b) with reflow.
Shrinkage calibrated coefficient of thermal expansion for
unfilled semi-crystalline materials
This scheme uses the part thickness information to assist the shrinkage
calculation in the 3D warpage simulation when using the 3D residual stress
shrinkage model. It is particularly useful for better warpage prediction for
parts with corner-like geometrical features. This alternative scheme is
available if the Uncorrected residual stress is selected as the 3D shrinkage
model option. To activate this scheme, check the UI option in the Warp Analysis
tab of the Thermoplastics injection molding solver parameters (3D) dialogue as
shown below.
Below is an example of how the alternative scheme helps improve the warpage
prediction of a box part, for which the shrinkages between the centres of edges
are measured and compared. The example is a box part with a fiber-filled Poly
Propylene material injection molded with conformal cooling. Four different
mold temperatures are tested in the example. The simulation results are
obtained with the 3D mesh type.
In this technology preview release, the thickness shrinkage scheme is
improved and is extended to fiber-filled materials.
Limitation:
The scheme of thickness shrinkage calculation is not available for the Generic
shrinkage model.